Home
last modified time | relevance | path

Searched refs:Mat3d (Results 1 – 25 of 92) sorted by relevance

1234

/dports/audio/faust/faust-2.37.3/tools/physicalModeling/mesh2faust/vega/libraries/minivector/
H A Dmat3d.h185 inline Mat3d::Mat3d(const double mat[9]) in Mat3d() function
192 inline Mat3d::Mat3d(const Vec3d rows[3]) in Mat3d() function
206 inline Mat3d::Mat3d(double diag) in Mat3d() function
237 inline Mat3d & Mat3d::operator=(const Mat3d & source)
246 inline Mat3d Mat3d::operator+ (const Mat3d & mat2) const
256 inline Mat3d & Mat3d::operator+= (const Mat3d & mat2)
264 inline Mat3d Mat3d::operator- (const Mat3d & mat2) const
274 inline Mat3d & Mat3d::operator-= (const Mat3d & mat2)
384 inline const Mat3d Mat3d::operator* (const Mat3d & mat2) const
400 inline Mat3d inv(const Mat3d & mat) in inv()
[all …]
H A Dmat3d.cpp35 const Mat3d Mat3d::Identity(1.0);
36 const Mat3d Mat3d::Zero(0.0);
48 void eigen_sym(Mat3d & a, Vec3d & eig_val, Vec3d eig_vec[3]) in eigen_sym()
79 int SVD(Mat3d & F, Mat3d & U, Vec3d & Sigma, Mat3d & V, double singularValue_eps, int modifiedSVD) in SVD()
97 Mat3d normalEq = trans(F) * F; in SVD()
271 bool eigen_sym_NR(Mat3d & M, Vec3d & eig_val, Vec3d eig_vec[3], int maxIterations, double epsilon) in eigen_sym_NR()
/dports/audio/faust/faust-2.37.3/tools/physicalModeling/mesh2faust/vega/libraries/include/
H A Dmat3d.h185 inline Mat3d::Mat3d(const double mat[9]) in Mat3d() function
192 inline Mat3d::Mat3d(const Vec3d rows[3]) in Mat3d() function
206 inline Mat3d::Mat3d(double diag) in Mat3d() function
237 inline Mat3d & Mat3d::operator=(const Mat3d & source)
246 inline Mat3d Mat3d::operator+ (const Mat3d & mat2) const
256 inline Mat3d & Mat3d::operator+= (const Mat3d & mat2)
264 inline Mat3d Mat3d::operator- (const Mat3d & mat2) const
274 inline Mat3d & Mat3d::operator-= (const Mat3d & mat2)
384 inline const Mat3d Mat3d::operator* (const Mat3d & mat2) const
400 inline Mat3d inv(const Mat3d & mat) in inv()
[all …]
H A DStVKTetHighMemoryABCD.h51 …inline virtual Mat3d A(void * elementIterator, int i, int j) { return A_[*(int*)elementIterator][i… in A()
59 Mat3d (*A_) [4][4];
64 …void StVKSingleTetABCD(Vec3d vertices[4], Mat3d A[4][4], double B[4][4], Vec3d C[4][4][4], double …
H A DStVKCubeABCD.h46 inline virtual Mat3d A(void * elementIterator, int i, int j) { return A_[i][j]; } in A()
54 Mat3d A_[8][8];
H A DStVKStiffnessMatrix.h90 …inline void AddMatrix3x3Block(int c, int a, int element, Mat3d & matrix, SparseMatrix * sparseMatr…
93 inline void StVKStiffnessMatrix::AddMatrix3x3Block(int c, int a, int element, Mat3d & matrix, Spars… in AddMatrix3x3Block()
H A DStVKElementABCD.h44 virtual Mat3d A(void * elementIterator, int i, int j) = 0;
H A DStVKTetABCD.h48 virtual Mat3d A(void * elementIterator, int i, int j);
/dports/audio/faust/faust-2.37.3/tools/physicalModeling/mesh2faust/vega/libraries/stvk/
H A DStVKTetHighMemoryABCD.cpp38 int totalCoefficientSize = (sizeof(Mat3d [4][4]) + in StVKTetHighMemoryABCD()
45 A_ = (Mat3d (*) [4][4]) &block[0]; in StVKTetHighMemoryABCD()
46 B_ = (double (*) [4][4]) &block[sizeof(Mat3d [4][4]) * numElements]; in StVKTetHighMemoryABCD()
47 C_ = (Vec3d (*) [4][4][4]) &block[(sizeof(Mat3d [4][4]) + sizeof(double [4][4])) * numElements]; in StVKTetHighMemoryABCD()
48 …D_ = (double (*) [4][4][4][4]) &block[(sizeof(Mat3d [4][4]) + sizeof(double [4][4]) + sizeof(Vec3d… in StVKTetHighMemoryABCD()
50 A_ = (Mat3d (*) [4][4]) malloc (sizeof(Mat3d [4][4]) * numElements); in StVKTetHighMemoryABCD()
80 void StVKTetHighMemoryABCD::StVKSingleTetABCD(Vec3d vtx[4], Mat3d A[4][4], double B[4][4], Vec3d C[… in StVKSingleTetABCD()
H A DStVKTetHighMemoryABCD.h51 …inline virtual Mat3d A(void * elementIterator, int i, int j) { return A_[*(int*)elementIterator][i… in A()
59 Mat3d (*A_) [4][4];
64 …void StVKSingleTetABCD(Vec3d vertices[4], Mat3d A[4][4], double B[4][4], Vec3d C[4][4][4], double …
H A DStVKCubeABCD.h46 inline virtual Mat3d A(void * elementIterator, int i, int j) { return A_[i][j]; } in A()
54 Mat3d A_[8][8];
H A DStVKStiffnessMatrix.h90 …inline void AddMatrix3x3Block(int c, int a, int element, Mat3d & matrix, SparseMatrix * sparseMatr…
93 inline void StVKStiffnessMatrix::AddMatrix3x3Block(int c, int a, int element, Mat3d & matrix, Spars… in AddMatrix3x3Block()
H A DStVKElementABCD.h44 virtual Mat3d A(void * elementIterator, int i, int j) = 0;
H A DStVKTetABCD.h48 virtual Mat3d A(void * elementIterator, int i, int j);
/dports/misc/openvdb/openvdb-9.0.0/openvdb/openvdb/math/
H A DMaps.cc99 createSymmetricMap(const Mat3d& m) in createSymmetricMap()
107 Mat3d Umatrix; in createSymmetricMap()
124 createPolarDecomposedMap(const Mat3d& m) in createPolarDecomposedMap()
129 Mat3d unitary, symmetric, mat3 = m.transpose(); in createPolarDecomposedMap()
201 const Mat3d mat3 = mat4d.getMat3(); in approxInverse()
202 const Mat3d mat3T = mat3.transpose(); in approxInverse()
231 Mat3d eigenVectors; in approxInverse()
236 Mat3d d = Mat3d::identity(); in approxInverse()
246 Mat3d pseudoInv = eigenVectors * d * eigenVectors.transpose(); in approxInverse()
H A DMaps.h171 virtual Mat3d applyIJC(const Mat3d& m) const = 0;
461 Mat3d applyIJC(const Mat3d& m) const override {
787 Mat3d applyIJC(const Mat3d& in) const OPENVDB_MAP_FUNC_SPECIFIER
789 Mat3d tmp;
1065 Mat3d applyIJC(const Mat3d& mat) const override {return mat;}
1329 Mat3d tmp;
2241 Mat3d gradE(Mat3d::zero());
2286 Mat3d matE0(Mat3d::zero());
2287 Mat3d matE1(Mat3d::zero()); // matE2 = 0
2302 Mat3d gradE(Mat3d::zero());
[all …]
/dports/audio/faust/faust-2.37.3/tools/physicalModeling/mesh2faust/vega/libraries/volumetricMesh/
H A DvolumetricMeshDeformationGradient.cpp22 Mat3d F(F_); in ComputePrincipalStretches()
23 Mat3d U; in ComputePrincipalStretches()
24 Mat3d V; in ComputePrincipalStretches()
H A DtetMesh.cpp225 void TetMesh::getElementInertiaTensor(int el, Mat3d & inertiaTensor) const in getElementInertiaTensor()
256 inertiaTensor = Mat3d(A, -Bp, -Cp, -Bp, B, -Ap, -Cp, -Ap, C); in getElementInertiaTensor()
355 Mat3d M(vtx[1] - vtx[0], vtx[2] - vtx[0], vtx[3] - vtx[0]); in computeGradient()
356 Mat3d MInv = inv(M); in computeGradient()
374 Mat3d rhs(rows); in computeGradient()
378 Mat3d gradM = trans(MInv * rhs); in computeGradient()
H A DgenerateGradientMatrix.cpp45 Mat3d M(vtx[1] - vtx[0], vtx[2] - vtx[0], vtx[3] - vtx[0]); in GenerateElementMatrixEntries()
46 Mat3d MInvT = trans(inv(M)); in GenerateElementMatrixEntries()
/dports/astro/celestia-gtk/celestia-1.6.1/src/celengine/
H A Dcustomorbit.cpp1369 Mat3d Rorbit = (Mat3d::yrotation(node) * in computePosition()
1376 Mat3d RLaplacian = (Mat3d::yrotation( N) * in computePosition()
1383 Mat3d RMars_eq = (Mat3d::yrotation( N) * in computePosition()
1438 Mat3d Rorbit = (Mat3d::yrotation(node) * in computePosition()
1445 Mat3d RLaplacian = (Mat3d::yrotation( N) * in computePosition()
1452 Mat3d RMars_eq = (Mat3d::yrotation( N) * in computePosition()
1499 Mat3d Rorbit = (Mat3d::yrotation(theta) *
1503 Mat3d RLaplacian = (Mat3d::yrotation( N) *
1511 Mat3d RMars_eq = (Mat3d::yrotation( Nm) *
2630 Mat3d R = (Mat3d::yrotation(theta) * in computePosition()
[all …]
H A Dspicerotation.cpp173 Mat3d m(Vec3d(xform[0][0], xform[0][1], xform[0][2]), in computeSpin()
177 Mat3d m(Vec3d(xform[0][0], xform[1][0], xform[2][0]), in computeSpin()
/dports/astro/celestia/celestia-1.6.1/src/celengine/
H A Dcustomorbit.cpp1369 Mat3d Rorbit = (Mat3d::yrotation(node) * in computePosition()
1376 Mat3d RLaplacian = (Mat3d::yrotation( N) * in computePosition()
1383 Mat3d RMars_eq = (Mat3d::yrotation( N) * in computePosition()
1438 Mat3d Rorbit = (Mat3d::yrotation(node) * in computePosition()
1445 Mat3d RLaplacian = (Mat3d::yrotation( N) * in computePosition()
1452 Mat3d RMars_eq = (Mat3d::yrotation( N) * in computePosition()
1499 Mat3d Rorbit = (Mat3d::yrotation(theta) *
1503 Mat3d RLaplacian = (Mat3d::yrotation( N) *
1511 Mat3d RMars_eq = (Mat3d::yrotation( Nm) *
2630 Mat3d R = (Mat3d::yrotation(theta) * in computePosition()
[all …]
H A Dspicerotation.cpp173 Mat3d m(Vec3d(xform[0][0], xform[0][1], xform[0][2]), in computeSpin()
177 Mat3d m(Vec3d(xform[0][0], xform[1][0], xform[2][0]), in computeSpin()
/dports/astro/stellarium/stellarium-0.21.3/src/tests/
H A DtestPrecession.cpp87Mat3d RP(EQX[0], EQX[1], EQX[2], V[0], V[1], V[2], PEQR[0], PEQR[1], PEQR[2]); // result from pape… in testPrecessionAnglesVondrak()
101 Mat3d matDiff3x3=(RRot-RP4).upper3x3(); in testPrecessionAnglesVondrak()
H A DtestVecMath.cpp473 Mat3d md; in testMatrix3Math()
486 md = md + Mat3d(1.,1.,1.,1.,1.,1.,1.,1.,1.); in testMatrix3Math()
488 md = md - Mat3d(2.,2.,2.,2.,2.,2.,2.,2.,2.); in testMatrix3Math()
490 md = Mat3d(1.,1.,1.,1.,1.,1.,1.,1.,1.)*Mat3d(5.,5.,5.,5.,5.,5.,5.,5.,5.); in testMatrix3Math()

1234