Home
last modified time | relevance | path

Searched refs:m_mat (Results 1 – 25 of 230) sorted by relevance

12345678910

/dports/graphics/wdune/wdune-1.926/src/
H A DMatrix.cpp87 r.x = m_mat[0][0]*v.x + m_mat[1][0]*v.y + m_mat[2][0]*v.z + m_mat[3][0]; in operator *()
91 r.y = m_mat[0][1]*v.x + m_mat[1][1]*v.y + m_mat[2][1]*v.z + m_mat[3][1]; in operator *()
95 r.z = m_mat[0][2]*v.x + m_mat[1][2]*v.y + m_mat[2][2]*v.z + m_mat[3][2]; in operator *()
103 r.x = m_mat[0][0]*v.x + m_mat[1][0]*v.y + m_mat[2][0]*v.z + m_mat[3][0]; in operator *()
104 r.y = m_mat[0][1]*v.x + m_mat[1][1]*v.y + m_mat[2][1]*v.z + m_mat[3][1]; in operator *()
105 r.z = m_mat[0][2]*v.x + m_mat[1][2]*v.y + m_mat[2][2]*v.z + m_mat[3][2]; in operator *()
118 r.x = m_mat[0][0]*v.x + m_mat[1][0]*v.y + m_mat[2][0]*v.z + m_mat[3][0]; in operator *()
119 r.y = m_mat[0][1]*v.x + m_mat[1][1]*v.y + m_mat[2][1]*v.z + m_mat[3][1]; in operator *()
120 r.z = m_mat[0][2]*v.x + m_mat[1][2]*v.y + m_mat[2][2]*v.z + m_mat[3][2]; in operator *()
216 r.m_mat[0][0] = r.m_mat[1][1] = r.m_mat[2][2] = r.m_mat[3][3] = 1.0f; in identity()
[all …]
/dports/games/vamos/vamos-0.7.1/geometry/
H A DThree_Matrix.cc300 = m_mat [0][0] * m_mat [1][1] * m_mat [2][2] in invert()
301 + m_mat [0][1] * m_mat [1][2] * m_mat [2][0] in invert()
318 (m_mat [1][1] * m_mat [2][2] - m_mat [1][2] * m_mat [2][1]) / det; in invert()
320 (m_mat [1][2] * m_mat [2][0] - m_mat [1][0] * m_mat [2][2]) / det; in invert()
322 (m_mat [1][0] * m_mat [2][1] - m_mat [1][1] * m_mat [2][0]) / det; in invert()
324 (m_mat [2][1] * m_mat [0][2] - m_mat [2][2] * m_mat [0][1]) / det; in invert()
326 (m_mat [2][2] * m_mat [0][0] - m_mat [2][0] * m_mat [0][2]) / det; in invert()
328 (m_mat [2][0] * m_mat [0][1] - m_mat [2][1] * m_mat [0][0]) / det; in invert()
330 (m_mat [0][1] * m_mat [1][2] - m_mat [0][2] * m_mat [1][1]) / det; in invert()
332 (m_mat [0][2] * m_mat [1][0] - m_mat [0][0] * m_mat [1][2]) / det; in invert()
[all …]
/dports/multimedia/kodi/xbmc-19.3-Matrix/xbmc/cores/VideoPlayer/VideoRenderers/VideoShaders/
H A DConversionMatrix.cpp113 Copy(m_mat, src); in CMatrix()
125 Copy(m_mat, src.m_mat); in operator =()
148 return m_mat; in __anon951207f00102()
155 Invert(ret.m_mat, m_mat); in Invert()
180 ret.m_mat[i][j] += m_mat[i][k] * other[k][j]; in operator *()
247 m_mat[0][0] = x; in CScale()
248 m_mat[1][1] = y; in CScale()
249 m_mat[2][2] = z; in CScale()
277 m_mat[0][0] = a11; m_mat[0][1] = a12; m_mat[0][2] = a13; in ConversionToRGB()
278 m_mat[1][0] = -Kr/CbDen; m_mat[1][1] = -Kg/CbDen; m_mat[1][2] = 0.5; in ConversionToRGB()
[all …]
/dports/graphics/pcl-pointclouds/pcl-pcl-1.12.0/surface/src/on_nurbs/
H A Dsparse_mat.cpp54 it_row = m_mat.begin (); in get()
76 it_row = m_mat.find (i); in get()
116 m_mat.erase (it_row); in set()
122 m_mat[i][j] = v; in set()
134 it_row = m_mat.find (i); in deleteRow()
136 m_mat.erase (it_row); in deleteRow()
146 it_row = m_mat.begin (); in deleteColumn()
163 if (m_mat.empty ()) in size()
173 it_row = m_mat.begin (); in size()
184 it_row = m_mat.end (); in size()
[all …]
/dports/math/eigen3/eigen-3.3.9/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/math/stanmath/math-4.2.0/lib/eigen_3.3.9/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/math/R-cran-RcppEigen/RcppEigen/inst/include/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/devel/upp/upp/uppsrc/plugin/Eigen/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/math/libsemigroups/libsemigroups-1.3.7/extern/eigen-3.3.7/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/science/pcmsolver/pcmsolver-1.3.0/external/eigen3/include/eigen3/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/misc/opennn/opennn-5.0.5/eigen/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/misc/openmvg/openMVG-2.0/src/third_party/eigen/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/devel/taskflow/taskflow-3.2.0/3rd-party/eigen-3.3.7/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/cad/PrusaSlicer/PrusaSlicer-version_2.3.3/src/eigen/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/math/py-pystan/pystan-2.19.0.0/pystan/stan/lib/stan_math/lib/eigen_3.3.3/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/external/eigen3/include/eigen3/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/math/gismo/gismo-21.12.0/external/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h77 if (m_matIsLoaded) return m_mat; in matrix()
80 if ( !loadMarket(m_mat, matrix_file)) in matrix()
84 return m_mat; in matrix()
97 MatrixType tmp(m_mat); in matrix()
103 MatrixType tmp(m_mat); in matrix()
107 return m_mat; in matrix()
123 m_rhs.resize(m_mat.cols()); in rhs()
130 m_refX.resize(m_mat.cols()); in rhs()
132 m_rhs = m_mat * m_refX; in rhs()
155 m_refX.resize(m_mat.cols()); in refX()
[all …]
/dports/math/gismo/gismo-21.12.0/src/gsCore/
H A DgsAffineFunction.hpp28 m_mat.setZero(dim,dim); in gsAffineFunction()
33 m_mat(dir(i),i) = o[i] ? ratio : -ratio; in gsAffineFunction()
36 m_trans -= m_mat * box1.col(0); in gsAffineFunction()
42 : m_mat(mat), m_trans(trans) in gsAffineFunction()
44 GISMO_ASSERT(m_mat.rows()==m_trans.rows(), in gsAffineFunction()
51 return m_mat.cols(); in domainDim()
57 return m_mat.rows(); in targetDim()
63 result = (m_mat*u).colwise()+m_trans; in eval_into()
79 result.resize(m_mat.rows()* m_mat.cols(), u.cols()); in deriv_into()
84 for (index_t col=0;col<m_mat.cols();++col) in deriv_into()
[all …]
/dports/emulators/mess/mame-mame0226/src/lib/netlist/plib/
H A Dgmres.h85 : m_mat(size)
101 while (m_mat.col_idx[k] < i && k < m_mat.row_idx[j+1])
103 if (m_mat.col_idx[k] == i && k < m_mat.row_idx[j+1])
125 for (std::size_t j = m_mat.row_idx[i]; j< m_mat.row_idx[i+1]; j++)
126 v += m_mat.A[j] * m_mat.A[j];
131 for (std::size_t j = m_mat.row_idx[i]; j< m_mat.row_idx[i+1]; j++)
132 v += m_mat.A[j] * m_mat.A[j];
133 m_diag[i] = m_mat.A[m_mat.diag[i]] / v;
144 v += m_mat.A[j] * m_mat.A[j];
146 m_diag[i] = m_mat.A[m_mat.diag[i]] / v;
[all …]
/dports/emulators/mame/mame-mame0226/src/lib/netlist/plib/
H A Dgmres.h85 : m_mat(size)
101 while (m_mat.col_idx[k] < i && k < m_mat.row_idx[j+1])
103 if (m_mat.col_idx[k] == i && k < m_mat.row_idx[j+1])
125 for (std::size_t j = m_mat.row_idx[i]; j< m_mat.row_idx[i+1]; j++)
126 v += m_mat.A[j] * m_mat.A[j];
131 for (std::size_t j = m_mat.row_idx[i]; j< m_mat.row_idx[i+1]; j++)
132 v += m_mat.A[j] * m_mat.A[j];
133 m_diag[i] = m_mat.A[m_mat.diag[i]] / v;
144 v += m_mat.A[j] * m_mat.A[j];
146 m_diag[i] = m_mat.A[m_mat.diag[i]] / v;
[all …]
/dports/math/gismo/gismo-21.12.0/src/gsSolver/
H A DgsIterativeSolver.h43 : m_mat(mat), in gsIterativeSolver()
51 …GISMO_ASSERT(m_mat->rows() == m_mat->cols(), "The matrix is not square." … in gsIterativeSolver()
53 if (!m_precond) m_precond = gsIdentityOp<T>::make(m_mat->rows()); in gsIterativeSolver()
73 : m_mat(makeMatrixOp(mat.derived())), in gsIterativeSolver()
81 …GISMO_ASSERT(m_mat->rows() == m_mat->cols(), "The matrix is not square." … in gsIterativeSolver()
83 if (!m_precond) m_precond = gsIdentityOp<T>::make(m_mat->rows()); in gsIterativeSolver()
176 GISMO_ASSERT( rhs.rows() == m_mat->rows(), in initIteration()
178 << rhs.rows() <<"!="<< m_mat->rows() ); in initIteration()
197 GISMO_ASSERT( x.rows() == m_mat->cols(), in initIteration()
199 << x.rows() <<"!="<< m_mat->cols() ); in initIteration()
[all …]
/dports/science/InsightToolkit/ITK-5.0.1/Modules/Numerics/FEM/include/
H A DitkFEMElement2DStrain.hxx30 ::Element2DStrain() : Superclass(), m_mat(nullptr) in Element2DStrain()
74 Me = Me * m_mat->GetDensityHeatProduct(); in GetMassMatrix()
85 Float fac = ( m_mat->GetThickness() * m_mat->GetYoungsModulus() ) in GetMaterialMatrix()
86 / ( ( 1 + m_mat->GetPoissonsRatio() ) * ( 1 - 2 * m_mat->GetPoissonsRatio() ) ); in GetMaterialMatrix()
87 D[0][0] = 1 - m_mat->GetPoissonsRatio(); in GetMaterialMatrix()
88 D[0][1] = m_mat->GetPoissonsRatio(); in GetMaterialMatrix()
97 D[2][2] = ( 1. - 2. * m_mat->GetPoissonsRatio() ) / 2.; in GetMaterialMatrix()
108 os << indent << "Materials: " << this->m_mat << std::endl; in PrintSelf()
H A DitkFEMElement2DStress.hxx30 ::Element2DStress() : Superclass(), m_mat(nullptr) in Element2DStress()
74 Me = Me * m_mat->GetDensityHeatProduct(); in GetMassMatrix()
85 Float disot = ( m_mat->GetThickness() * m_mat->GetYoungsModulus() ) in GetMaterialMatrix()
86 / ( 1.0 - ( m_mat->GetPoissonsRatio() * m_mat->GetPoissonsRatio() ) ); in GetMaterialMatrix()
89 D[0][1] = disot * ( m_mat->GetPoissonsRatio() ); in GetMaterialMatrix()
98 D[2][2] = disot * ( 1. - m_mat->GetPoissonsRatio() ) / 2.0; in GetMaterialMatrix()
107 os << indent << "Materials: " << this->m_mat << std::endl; in PrintSelf()
/dports/finance/kraft/kraft-0.97/src/
H A Dmaterialcalcpart.cpp40 m_mat(nullptr) in MaterialCalcPart()
43 if( m_mat ) { in MaterialCalcPart()
44 setName(m_mat->getText()); in MaterialCalcPart()
52 if( m_mat ) { in MaterialCalcPart()
53 setName(m_mat->getText()); in MaterialCalcPart()
72 m_mat = k->materialFromId(matID); in getMatFromID()
84 if( m_mat ) { in basisKosten()
85 g = m_mat->unitPrice() * m_calcAmount; in basisKosten()
92 return m_mat; in getMaterial()
/dports/math/spectra/spectra-1.0.0/include/Spectra/MatOp/
H A DDenseGenMatProd.h50 ConstGenericMatrix m_mat; variable
63 m_mat(mat) in DenseGenMatProd()
73 Index rows() const { return m_mat.rows(); } in rows()
77 Index cols() const { return m_mat.cols(); } in cols()
88 MapConstVec x(x_in, m_mat.cols()); in perform_op()
89 MapVec y(y_out, m_mat.rows()); in perform_op()
90 y.noalias() = m_mat * x; in perform_op()
98 return m_mat * mat_in;
106 return m_mat(i, j); in operator()

12345678910