/external/eigen/unsupported/test/ |
D | matrix_function.cpp | 25 template<typename MatrixType> 26 MatrixType randomMatrixWithRealEivals(const typename MatrixType::Index size) in randomMatrixWithRealEivals() 28 typedef typename MatrixType::Index Index; in randomMatrixWithRealEivals() 29 typedef typename MatrixType::Scalar Scalar; in randomMatrixWithRealEivals() 30 typedef typename MatrixType::RealScalar RealScalar; in randomMatrixWithRealEivals() 31 MatrixType diag = MatrixType::Zero(size, size); in randomMatrixWithRealEivals() 36 MatrixType A = MatrixType::Random(size, size); in randomMatrixWithRealEivals() 37 HouseholderQR<MatrixType> QRofA(A); in randomMatrixWithRealEivals() 41 template <typename MatrixType, int IsComplex = NumTraits<typename internal::traits<MatrixType>::Sca… 45 static MatrixType run(const typename MatrixType::Index size); [all …]
|
D | matrix_functions.h | 14 template<typename MatrixType, int IsComplex = NumTraits<typename internal::traits<MatrixType>::Scal… 17 static void run(MatrixType&, MatrixType&, const MatrixType&) in run() 22 template<typename MatrixType> 23 struct processTriangularMatrix<MatrixType,0> 25 static void run(MatrixType& m, MatrixType& T, const MatrixType& U) 39 template <typename MatrixType, int IsComplex = NumTraits<typename internal::traits<MatrixType>::Sca… 42 template <typename MatrixType> 43 struct generateTestMatrix<MatrixType,0> 45 static void run(MatrixType& result, typename MatrixType::Index size) 47 result = MatrixType::Random(size, size); [all …]
|
/external/eigen/Eigen/src/LU/ |
D | InverseImpl.h | 22 template<typename MatrixType, typename ResultType, int Size = MatrixType::RowsAtCompileTime> 26 static inline void run(const MatrixType& matrix, ResultType& result) in run() 32 template<typename MatrixType, typename ResultType, int Size = MatrixType::RowsAtCompileTime> 39 template<typename MatrixType, typename ResultType> 40 struct compute_inverse<MatrixType, ResultType, 1> 43 static inline void run(const MatrixType& matrix, ResultType& result) 45 typedef typename MatrixType::Scalar Scalar; 46 internal::evaluator<MatrixType> matrixEval(matrix); 51 template<typename MatrixType, typename ResultType> 52 struct compute_inverse_and_det_with_check<MatrixType, ResultType, 1> [all …]
|
/external/eigen/unsupported/Eigen/src/MatrixFunctions/ |
D | MatrixExponential.h | 67 typedef typename MatA::PlainObject MatrixType; in matrix_exp_pade3() typedef 70 const MatrixType A2 = A * A; in matrix_exp_pade3() 71 const MatrixType tmp = b[3] * A2 + b[1] * MatrixType::Identity(A.rows(), A.cols()); in matrix_exp_pade3() 73 V = b[2] * A2 + b[0] * MatrixType::Identity(A.rows(), A.cols()); in matrix_exp_pade3() 84 typedef typename MatA::PlainObject MatrixType; in matrix_exp_pade5() typedef 85 typedef typename NumTraits<typename traits<MatrixType>::Scalar>::Real RealScalar; in matrix_exp_pade5() 87 const MatrixType A2 = A * A; in matrix_exp_pade5() 88 const MatrixType A4 = A2 * A2; in matrix_exp_pade5() 89 const MatrixType tmp = b[5] * A4 + b[3] * A2 + b[1] * MatrixType::Identity(A.rows(), A.cols()); in matrix_exp_pade5() 91 V = b[4] * A4 + b[2] * A2 + b[0] * MatrixType::Identity(A.rows(), A.cols()); in matrix_exp_pade5() [all …]
|
D | MatrixSquareRoot.h | 19 template <typename MatrixType, typename ResultType> 20 void matrix_sqrt_quasi_triangular_2x2_diagonal_block(const MatrixType& T, typename MatrixType::Inde… in matrix_sqrt_quasi_triangular_2x2_diagonal_block() 24 typedef typename traits<MatrixType>::Scalar Scalar; in matrix_sqrt_quasi_triangular_2x2_diagonal_block() 34 template <typename MatrixType, typename ResultType> 35 …asi_triangular_1x1_off_diagonal_block(const MatrixType& T, typename MatrixType::Index i, typename … in matrix_sqrt_quasi_triangular_1x1_off_diagonal_block() 37 typedef typename traits<MatrixType>::Scalar Scalar; in matrix_sqrt_quasi_triangular_1x1_off_diagonal_block() 43 template <typename MatrixType, typename ResultType> 44 …asi_triangular_1x2_off_diagonal_block(const MatrixType& T, typename MatrixType::Index i, typename … in matrix_sqrt_quasi_triangular_1x2_off_diagonal_block() 46 typedef typename traits<MatrixType>::Scalar Scalar; in matrix_sqrt_quasi_triangular_1x2_off_diagonal_block() 56 template <typename MatrixType, typename ResultType> [all …]
|
D | MatrixPower.h | 15 template<typename MatrixType> class MatrixPower; 38 template<typename MatrixType> 39 …PowerParenthesesReturnValue : public ReturnByValue< MatrixPowerParenthesesReturnValue<MatrixType> > 42 typedef typename MatrixType::RealScalar RealScalar; 43 typedef typename MatrixType::Index Index; 51 … MatrixPowerParenthesesReturnValue(MatrixPower<MatrixType>& pow, RealScalar p) : m_pow(pow), m_p(p) in MatrixPowerParenthesesReturnValue() 67 MatrixPower<MatrixType>& m_pow; 86 template<typename MatrixType> 91 RowsAtCompileTime = MatrixType::RowsAtCompileTime, 92 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime [all …]
|
/external/eigen/test/ |
D | cholesky.cpp | 20 template<typename MatrixType, int UpLo> 21 typename MatrixType::RealScalar matrix_l1_norm(const MatrixType& m) { in matrix_l1_norm() 22 MatrixType symm = m.template selfadjointView<UpLo>(); in matrix_l1_norm() 26 template<typename MatrixType,template <typename,int> class CholType> void test_chol_update(const Ma… in test_chol_update() 28 typedef typename MatrixType::Scalar Scalar; in test_chol_update() 29 typedef typename MatrixType::RealScalar RealScalar; in test_chol_update() 30 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType; in test_chol_update() 32 MatrixType symmLo = symm.template triangularView<Lower>(); in test_chol_update() 33 MatrixType symmUp = symm.template triangularView<Upper>(); in test_chol_update() 34 MatrixType symmCpy = symm; in test_chol_update() [all …]
|
D | lu.cpp | 14 template<typename MatrixType> 15 typename MatrixType::RealScalar matrix_l1_norm(const MatrixType& m) { in matrix_l1_norm() 19 template<typename MatrixType> void lu_non_invertible() in lu_non_invertible() 21 typedef typename MatrixType::Index Index; in lu_non_invertible() 22 typedef typename MatrixType::RealScalar RealScalar; in lu_non_invertible() 27 if(MatrixType::RowsAtCompileTime==Dynamic) in lu_non_invertible() 33 rows = MatrixType::RowsAtCompileTime; in lu_non_invertible() 35 if(MatrixType::ColsAtCompileTime==Dynamic) in lu_non_invertible() 42 cols2 = cols = MatrixType::ColsAtCompileTime; in lu_non_invertible() 46 RowsAtCompileTime = MatrixType::RowsAtCompileTime, in lu_non_invertible() [all …]
|
D | qr_colpivoting.cpp | 15 template <typename MatrixType> 17 typedef typename MatrixType::Index Index; in cod() 24 typedef typename MatrixType::Scalar Scalar; in cod() 25 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, in cod() 26 MatrixType::RowsAtCompileTime> in cod() 28 MatrixType matrix; in cod() 30 CompleteOrthogonalDecomposition<MatrixType> cod(matrix); in cod() 40 MatrixType z = cod.matrixZ(); in cod() 43 MatrixType t; in cod() 48 MatrixType c = q * t * z * cod.colsPermutation().inverse(); in cod() [all …]
|
D | zerosized.cpp | 13 template<typename MatrixType> void zeroReduction(const MatrixType& m) { in zeroReduction() 25 template<typename MatrixType> void zeroSizedMatrix() in zeroSizedMatrix() 27 MatrixType t1; in zeroSizedMatrix() 28 typedef typename MatrixType::Scalar Scalar; in zeroSizedMatrix() 30 if (MatrixType::SizeAtCompileTime == Dynamic || MatrixType::SizeAtCompileTime == 0) in zeroSizedMatrix() 33 if (MatrixType::RowsAtCompileTime == Dynamic) in zeroSizedMatrix() 35 if (MatrixType::ColsAtCompileTime == Dynamic) in zeroSizedMatrix() 38 if (MatrixType::RowsAtCompileTime == Dynamic && MatrixType::ColsAtCompileTime == Dynamic) in zeroSizedMatrix() 41 MatrixType t2(0, 0), t3(t1); in zeroSizedMatrix() 50 if(MatrixType::MaxColsAtCompileTime!=0 && MatrixType::MaxRowsAtCompileTime!=0) in zeroSizedMatrix() [all …]
|
D | eigensolver_generalized_real.cpp | 16 template<typename MatrixType> void generalized_eigensolver_real(const MatrixType& m) in generalized_eigensolver_real() 18 typedef typename MatrixType::Index Index; in generalized_eigensolver_real() 25 typedef typename MatrixType::Scalar Scalar; in generalized_eigensolver_real() 27 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType; in generalized_eigensolver_real() 29 MatrixType a = MatrixType::Random(rows,cols); in generalized_eigensolver_real() 30 MatrixType b = MatrixType::Random(rows,cols); in generalized_eigensolver_real() 31 MatrixType a1 = MatrixType::Random(rows,cols); in generalized_eigensolver_real() 32 MatrixType b1 = MatrixType::Random(rows,cols); in generalized_eigensolver_real() 33 MatrixType spdA = a.adjoint() * a + a1.adjoint() * a1; in generalized_eigensolver_real() 34 MatrixType spdB = b.adjoint() * b + b1.adjoint() * b1; in generalized_eigensolver_real() [all …]
|
D | schur_real.cpp | 14 template<typename MatrixType> void verifyIsQuasiTriangular(const MatrixType& T) in verifyIsQuasiTriangular() 16 typedef typename MatrixType::Index Index; in verifyIsQuasiTriangular() 19 typedef typename MatrixType::Scalar Scalar; in verifyIsQuasiTriangular() 40 template<typename MatrixType> void schur(int size = MatrixType::ColsAtCompileTime) in schur() 44 MatrixType A = MatrixType::Random(size, size); in schur() 45 RealSchur<MatrixType> schurOfA(A); in schur() 47 MatrixType U = schurOfA.matrixU(); in schur() 48 MatrixType T = schurOfA.matrixT(); in schur() 54 RealSchur<MatrixType> rsUninitialized; in schur() 60 MatrixType A = MatrixType::Random(size, size); in schur() [all …]
|
D | qr_fullpivoting.cpp | 14 template<typename MatrixType> void qr() in qr() 16 typedef typename MatrixType::Index Index; in qr() 25 typedef typename MatrixType::Scalar Scalar; in qr() 26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> MatrixQType; in qr() 27 MatrixType m1; in qr() 29 FullPivHouseholderQR<MatrixType> qr(m1); in qr() 36 MatrixType r = qr.matrixQR(); in qr() 44 MatrixType c = qr.matrixQ() * r * qr.colsPermutation().inverse(); in qr() 49 MatrixType tmp; in qr() 52 MatrixType m2 = MatrixType::Random(cols,cols2); in qr() [all …]
|
D | qr.cpp | 13 template<typename MatrixType> void qr(const MatrixType& m) in qr() 15 typedef typename MatrixType::Index Index; in qr() 20 typedef typename MatrixType::Scalar Scalar; in qr() 21 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> MatrixQType; in qr() 23 MatrixType a = MatrixType::Random(rows,cols); in qr() 24 HouseholderQR<MatrixType> qrOfA(a); in qr() 29 MatrixType r = qrOfA.matrixQR().template triangularView<Upper>(); in qr() 33 template<typename MatrixType, int Cols2> void qr_fixedsize() in qr_fixedsize() 35 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime }; in qr_fixedsize() 36 typedef typename MatrixType::Scalar Scalar; in qr_fixedsize() [all …]
|
D | eigensolver_complex.cpp | 16 template<typename MatrixType> bool find_pivot(typename MatrixType::Scalar tol, MatrixType &diffs, I… in find_pivot() 72 template<typename MatrixType> void eigensolver(const MatrixType& m) in eigensolver() 74 typedef typename MatrixType::Index Index; in eigensolver() 81 typedef typename MatrixType::Scalar Scalar; in eigensolver() 84 MatrixType a = MatrixType::Random(rows,cols); in eigensolver() 85 MatrixType symmA = a.adjoint() * a; in eigensolver() 87 ComplexEigenSolver<MatrixType> ei0(symmA); in eigensolver() 91 ComplexEigenSolver<MatrixType> ei1(a); in eigensolver() 98 ComplexEigenSolver<MatrixType> ei2; in eigensolver() 99 ei2.setMaxIterations(ComplexSchur<MatrixType>::m_maxIterationsPerRow * rows).compute(a); in eigensolver() [all …]
|
D | eigensolver_selfadjoint.cpp | 18 template<typename MatrixType> void selfadjointeigensolver_essential_check(const MatrixType& m) in selfadjointeigensolver_essential_check() 20 typedef typename MatrixType::Scalar Scalar; in selfadjointeigensolver_essential_check() 24 SelfAdjointEigenSolver<MatrixType> eiSymm(m); in selfadjointeigensolver_essential_check() 43 SelfAdjointEigenSolver<MatrixType> eiDirect; in selfadjointeigensolver_essential_check() 69 template<typename MatrixType> void selfadjointeigensolver(const MatrixType& m) in selfadjointeigensolver() 71 typedef typename MatrixType::Index Index; in selfadjointeigensolver() 78 typedef typename MatrixType::Scalar Scalar; in selfadjointeigensolver() 83 MatrixType a = MatrixType::Random(rows,cols); in selfadjointeigensolver() 84 MatrixType a1 = MatrixType::Random(rows,cols); in selfadjointeigensolver() 85 MatrixType symmA = a.adjoint() * a + a1.adjoint() * a1; in selfadjointeigensolver() [all …]
|
/external/eigen/Eigen/src/Core/ |
D | Transpose.h | 17 template<typename MatrixType> 18 struct traits<Transpose<MatrixType> > : public traits<MatrixType> 20 typedef typename ref_selector<MatrixType>::type MatrixTypeNested; 23 RowsAtCompileTime = MatrixType::ColsAtCompileTime, 24 ColsAtCompileTime = MatrixType::RowsAtCompileTime, 25 MaxRowsAtCompileTime = MatrixType::MaxColsAtCompileTime, 26 MaxColsAtCompileTime = MatrixType::MaxRowsAtCompileTime, 27 FlagsLvalueBit = is_lvalue<MatrixType>::value ? LvalueBit : 0, 31 InnerStrideAtCompileTime = inner_stride_at_compile_time<MatrixType>::ret, 32 OuterStrideAtCompileTime = outer_stride_at_compile_time<MatrixType>::ret [all …]
|
D | CwiseUnaryView.h | 16 template<typename ViewOp, typename MatrixType> 17 struct traits<CwiseUnaryView<ViewOp, MatrixType> > 18 : traits<MatrixType> 21 ViewOp(const typename traits<MatrixType>::Scalar&) 23 typedef typename MatrixType::Nested MatrixTypeNested; 26 FlagsLvalueBit = is_lvalue<MatrixType>::value ? LvalueBit : 0, 28 MatrixTypeInnerStride = inner_stride_at_compile_time<MatrixType>::ret, 33 … : int(MatrixTypeInnerStride) * int(sizeof(typename traits<MatrixType>::Scalar) / sizeof(Scalar)), 34 OuterStrideAtCompileTime = outer_stride_at_compile_time<MatrixType>::ret == Dynamic 36 …: outer_stride_at_compile_time<MatrixType>::ret * int(sizeof(typename traits<MatrixType>::Scalar) … [all …]
|
/external/eigen/Eigen/src/SVD/ |
D | JacobiSVD.h | 19 template<typename MatrixType, int QRPreconditioner, 20 bool IsComplex = NumTraits<typename MatrixType::Scalar>::IsComplex> 32 template<typename MatrixType, int QRPreconditioner, int Case> 35 enum { a = MatrixType::RowsAtCompileTime != Dynamic && 36 MatrixType::ColsAtCompileTime != Dynamic && 37 MatrixType::ColsAtCompileTime <= MatrixType::RowsAtCompileTime, 38 b = MatrixType::RowsAtCompileTime != Dynamic && 39 MatrixType::ColsAtCompileTime != Dynamic && 40 MatrixType::RowsAtCompileTime <= MatrixType::ColsAtCompileTime, 47 template<typename MatrixType, int QRPreconditioner, int Case, [all …]
|
/external/eigen/Eigen/src/Eigenvalues/ |
D | Tridiagonalization.h | 18 template<typename MatrixType> struct TridiagonalizationMatrixTReturnType; 19 template<typename MatrixType> 20 struct traits<TridiagonalizationMatrixTReturnType<MatrixType> > 21 : public traits<typename MatrixType::PlainObject> 23 typedef typename MatrixType::PlainObject ReturnType; // FIXME shall it be a BandMatrix? 27 template<typename MatrixType, typename CoeffVectorType> 28 void tridiagonalization_inplace(MatrixType& matA, CoeffVectorType& hCoeffs); 68 typedef _MatrixType MatrixType; 70 typedef typename MatrixType::Scalar Scalar; 75 Size = MatrixType::RowsAtCompileTime, [all …]
|
/external/eigen/Eigen/src/Cholesky/ |
D | LLT.h | 16 template<typename MatrixType, int UpLo> struct LLT_Traits; 55 typedef _MatrixType MatrixType; typedef 57 RowsAtCompileTime = MatrixType::RowsAtCompileTime, 58 ColsAtCompileTime = MatrixType::ColsAtCompileTime, 59 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime 61 typedef typename MatrixType::Scalar Scalar; 62 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar; 64 typedef typename MatrixType::StorageIndex StorageIndex; 72 typedef internal::LLT_Traits<MatrixType,UpLo> Traits; 168 inline const MatrixType& matrixLLT() const in matrixLLT() [all …]
|
D | LDLT.h | 19 template<typename MatrixType, int UpLo> struct LDLT_Traits; 53 typedef _MatrixType MatrixType; typedef 55 RowsAtCompileTime = MatrixType::RowsAtCompileTime, 56 ColsAtCompileTime = MatrixType::ColsAtCompileTime, 57 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime, 58 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime, 61 typedef typename MatrixType::Scalar Scalar; 62 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar; 64 typedef typename MatrixType::StorageIndex StorageIndex; 70 typedef internal::LDLT_Traits<MatrixType,UpLo> Traits; [all …]
|
/external/eigen/Eigen/src/SparseCholesky/ |
D | SimplicialCholesky.h | 31 template<typename MatrixType> 32 struct simplicial_cholesky_grab_input<MatrixType,MatrixType> { 33 typedef MatrixType const * ConstMatrixPtr; 34 static void run(const MatrixType& input, ConstMatrixPtr &pmat, MatrixType &/*tmp*/) 61 typedef typename internal::traits<Derived>::MatrixType MatrixType; 64 typedef typename MatrixType::Scalar Scalar; 65 typedef typename MatrixType::RealScalar RealScalar; 66 typedef typename MatrixType::StorageIndex StorageIndex; 73 ColsAtCompileTime = MatrixType::ColsAtCompileTime, 74 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime [all …]
|
/external/eigen/Eigen/src/QR/ |
D | CompleteOrthogonalDecomposition.h | 50 typedef _MatrixType MatrixType; 52 RowsAtCompileTime = MatrixType::RowsAtCompileTime, 53 ColsAtCompileTime = MatrixType::ColsAtCompileTime, 54 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime, 55 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime 57 typedef typename MatrixType::Scalar Scalar; 58 typedef typename MatrixType::RealScalar RealScalar; 59 typedef typename MatrixType::StorageIndex StorageIndex; 60 typedef typename internal::plain_diag_type<MatrixType>::type HCoeffsType; 63 typedef typename internal::plain_row_type<MatrixType, Index>::type [all …]
|
/external/eigen/Eigen/src/misc/ |
D | Image.h | 23 typedef typename DecompositionType::MatrixType MatrixType; 25 typename MatrixType::Scalar, 26 MatrixType::RowsAtCompileTime, // the image is a subspace of the destination space, whose 29 MatrixType::Options, 30 …MatrixType::MaxRowsAtCompileTime, // the image matrix will consist of columns from the original ma… 31 …MatrixType::MaxColsAtCompileTime // so it has the same number of rows and at most as many columns. 39 typedef typename DecompositionType::MatrixType MatrixType; 42 image_retval_base(const DecompositionType& dec, const MatrixType& originalMatrix) 52 inline const MatrixType& originalMatrix() const { return m_originalMatrix; } 62 const MatrixType& m_originalMatrix; [all …]
|