Searched refs:MatrixType (Results 26 - 50 of 208) sorted by relevance

123456789

/external/eigen/Eigen/src/Eigenvalues/
H A DGeneralizedSelfAdjointEigenSolver.h37 * GeneralizedSelfAdjointEigenSolver(const MatrixType&, const MatrixType&, int)
42 * The documentation for GeneralizedSelfAdjointEigenSolver(const MatrixType&, const MatrixType&, int)
53 typedef _MatrixType MatrixType; typedef in class:Eigen::GeneralizedSelfAdjointEigenSolver
89 * This constructor calls compute(const MatrixType&, const MatrixType&, int)
104 * \sa compute(const MatrixType&, const MatrixType&, int)
106 GeneralizedSelfAdjointEigenSolver(const MatrixType
[all...]
H A DTridiagonalization.h18 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);
52 * given matrix. Alternatively, you can use the Tridiagonalization(const MatrixType&)
58 * The documentation of Tridiagonalization(const MatrixType&) contains an
68 typedef _MatrixType MatrixType; typedef in class:Eigen::Tridiagonalization
[all...]
H A DComplexSchur.h20 template<typename MatrixType, bool IsComplex> struct complex_schur_reduce_to_hessenberg;
42 * ComplexSchur(const MatrixType&, bool) constructor which computes
54 typedef _MatrixType MatrixType; typedef in class:Eigen::ComplexSchur
56 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
57 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
58 Options = MatrixType::Options,
59 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
60 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
64 typedef typename MatrixType::Scalar Scalar;
129 * ComplexSchur(const MatrixType
[all...]
/external/eigen/test/
H A Dprec_inverse_4x4.cpp14 template<typename MatrixType> void inverse_permutation_4x4()
16 typedef typename MatrixType::Scalar Scalar;
20 MatrixType m = PermutationMatrix<4>(indices);
21 MatrixType inv = m.inverse();
22 double error = double( (m*inv-MatrixType::Identity()).norm() / NumTraits<Scalar>::epsilon() );
29 template<typename MatrixType> void inverse_general_4x4(int repeat)
32 typedef typename MatrixType::Scalar Scalar;
33 typedef typename MatrixType::RealScalar RealScalar;
37 MatrixType m;
40 m = MatrixType
[all...]
H A Dinverse.cpp14 template<typename MatrixType> void inverse(const MatrixType& m)
17 typedef typename MatrixType::Index Index;
24 typedef typename MatrixType::Scalar Scalar;
26 MatrixType m1(rows, cols),
28 identity = MatrixType::Identity(rows, rows);
41 VERIFY_IS_APPROX(MatrixType(m1.transpose().inverse()), MatrixType(m1.inverse().transpose()));
45 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> VectorType;
65 MatrixType m
[all...]
H A Dschur_complex.cpp14 template<typename MatrixType> void schur(int size = MatrixType::ColsAtCompileTime) argument
16 typedef typename ComplexSchur<MatrixType>::ComplexScalar ComplexScalar;
17 typedef typename ComplexSchur<MatrixType>::ComplexMatrixType ComplexMatrixType;
21 MatrixType A = MatrixType::Random(size, size);
22 ComplexSchur<MatrixType> schurOfA(A);
28 VERIFY(T(row,col) == (typename MatrixType::Scalar)0);
35 ComplexSchur<MatrixType> csUninitialized;
41 MatrixType
[all...]
H A Dlu.cpp14 template<typename MatrixType>
15 typename MatrixType::RealScalar matrix_l1_norm(const MatrixType& m) {
19 template<typename MatrixType> void lu_non_invertible()
21 typedef typename MatrixType::Index Index;
22 typedef typename MatrixType::RealScalar RealScalar;
27 if(MatrixType::RowsAtCompileTime==Dynamic)
33 rows = MatrixType::RowsAtCompileTime;
35 if(MatrixType::ColsAtCompileTime==Dynamic)
42 cols2 = cols = MatrixType
[all...]
H A Deigensolver_complex.cpp16 template<typename MatrixType> bool find_pivot(typename MatrixType::Scalar tol, MatrixType &diffs, Index col=0)
72 template<typename MatrixType> void eigensolver(const MatrixType& m)
74 typedef typename MatrixType::Index Index;
81 typedef typename MatrixType::Scalar Scalar;
84 MatrixType a = MatrixType::Random(rows,cols);
85 MatrixType symm
[all...]
H A Dqr_fullpivoting.cpp14 template<typename MatrixType> void qr()
16 typedef typename MatrixType::Index Index;
25 typedef typename MatrixType::Scalar Scalar;
26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> MatrixQType;
27 MatrixType m1;
29 FullPivHouseholderQR<MatrixType> qr(m1);
36 MatrixType r = qr.matrixQR();
44 MatrixType c = qr.matrixQ() * r * qr.colsPermutation().inverse();
49 MatrixType tm
[all...]
H A Ddontalign.cpp19 template<typename MatrixType>
20 void dontalign(const MatrixType& m)
22 typedef typename MatrixType::Index Index;
23 typedef typename MatrixType::Scalar Scalar;
24 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
25 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType;
30 MatrixType a = MatrixType::Random(rows,cols);
H A Deigensolver_generic.cpp15 template<typename MatrixType> void eigensolver(const MatrixType& m)
17 typedef typename MatrixType::Index Index;
24 typedef typename MatrixType::Scalar Scalar;
26 typedef Matrix<RealScalar, MatrixType::RowsAtCompileTime, 1> RealVectorType;
27 typedef typename std::complex<typename NumTraits<typename MatrixType::Scalar>::Real> Complex;
29 MatrixType a = MatrixType::Random(rows,cols);
30 MatrixType a1 = MatrixType
[all...]
H A Dbdcsvd.cpp28 template<typename MatrixType>
29 void bdcsvd(const MatrixType& a = MatrixType(), bool pickrandom = true) argument
31 MatrixType m = a;
35 CALL_SUBTEST(( svd_test_all_computation_options<BDCSVD<MatrixType> >(m, false) ));
38 template<typename MatrixType>
41 enum { Size = MatrixType::RowsAtCompileTime };
42 typedef typename MatrixType::RealScalar RealScalar;
44 MatrixType m = MatrixType
53 compare_bdc_jacobi(const MatrixType& a = MatrixType(), unsigned int computationOptions = 0) argument
[all...]
H A Dqr.cpp13 template<typename MatrixType> void qr(const MatrixType& m)
15 typedef typename MatrixType::Index Index;
20 typedef typename MatrixType::Scalar Scalar;
21 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> MatrixQType;
23 MatrixType a = MatrixType::Random(rows,cols);
24 HouseholderQR<MatrixType> qrOfA(a);
29 MatrixType
[all...]
H A Dqr_colpivoting.cpp15 template <typename MatrixType>
17 typedef typename MatrixType::Index Index;
24 typedef typename MatrixType::Scalar Scalar;
25 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime,
26 MatrixType::RowsAtCompileTime>
28 MatrixType matrix;
30 CompleteOrthogonalDecomposition<MatrixType> cod(matrix);
40 MatrixType z = cod.matrixZ();
43 MatrixType t;
48 MatrixType
[all...]
/external/eigen/unsupported/Eigen/src/MatrixFunctions/
H A DMatrixExponential.h67 typedef typename MatA::PlainObject MatrixType; typedef
70 const MatrixType A2 = A * A;
71 const MatrixType tmp = b[3] * A2 + b[1] * MatrixType::Identity(A.rows(), A.cols());
73 V = b[2] * A2 + b[0] * MatrixType::Identity(A.rows(), A.cols());
84 typedef typename MatA::PlainObject MatrixType; typedef
85 typedef typename NumTraits<typename traits<MatrixType>::Scalar>::Real RealScalar;
87 const MatrixType A2 = A * A;
88 const MatrixType A4 = A2 * A2;
89 const MatrixType tm
102 typedef typename MatA::PlainObject MatrixType; typedef
123 typedef typename MatA::PlainObject MatrixType; typedef
145 typedef typename MatA::PlainObject MatrixType; typedef
173 typedef typename MatA::PlainObject MatrixType; typedef
354 typedef typename ArgType::PlainObject MatrixType; typedef
[all...]
/external/eigen/Eigen/src/IterativeLinearSolvers/
H A DIterativeSolverBase.h17 template<typename MatrixType>
36 static MatrixType ms_from;
37 enum { value = sizeof(test<MatrixType>(ms_from, 0))==sizeof(yes) };
40 template<typename MatrixType>
43 enum { value = is_ref_compatible_impl<typename remove_all<MatrixType>::type>::value };
46 template<typename MatrixType, bool MatrixFree = !internal::is_ref_compatible<MatrixType>::value>
50 template<typename MatrixType>
51 class generic_matrix_wrapper<MatrixType,false>
54 typedef Ref<const MatrixType> ActualMatrixTyp
150 typedef typename internal::traits<Derived>::MatrixType MatrixType; typedef in class:Eigen::IterativeSolverBase
[all...]
/external/eigen/Eigen/src/SVD/
H A DJacobiSVD.h19 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
56 run(JacobiSVD<MatrixType, QRPreconditioner>&, const MatrixType&) argument
429 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
493 typedef _MatrixType MatrixType; typedef in class:Eigen::JacobiSVD
[all...]
/external/eigen/Eigen/src/OrderingMethods/
H A DOrdering.h26 template<typename MatrixType>
27 void ordering_helper_at_plus_a(const MatrixType& A, MatrixType& symmat)
29 MatrixType C;
33 for (typename MatrixType::InnerIterator it(C, i); it; ++it)
60 template <typename MatrixType>
61 void operator()(const MatrixType& mat, PermutationType& perm)
64 SparseMatrix<typename MatrixType::Scalar, ColMajor, StorageIndex> symm;
101 template <typename MatrixType>
102 void operator()(const MatrixType
[all...]
/external/eigen/Eigen/src/Core/
H A DReplicate.h16 template<typename MatrixType,int RowFactor,int ColFactor>
17 struct traits<Replicate<MatrixType,RowFactor,ColFactor> >
18 : traits<MatrixType>
20 typedef typename MatrixType::Scalar Scalar;
21 typedef typename traits<MatrixType>::StorageKind StorageKind;
22 typedef typename traits<MatrixType>::XprKind XprKind;
23 typedef typename ref_selector<MatrixType>::type MatrixTypeNested;
26 RowsAtCompileTime = RowFactor==Dynamic || int(MatrixType::RowsAtCompileTime)==Dynamic
28 : RowFactor * MatrixType::RowsAtCompileTime,
29 ColsAtCompileTime = ColFactor==Dynamic || int(MatrixType
[all...]
H A DReverse.h19 template<typename MatrixType, int Direction>
20 struct traits<Reverse<MatrixType, Direction> >
21 : traits<MatrixType>
23 typedef typename MatrixType::Scalar Scalar;
24 typedef typename traits<MatrixType>::StorageKind StorageKind;
25 typedef typename traits<MatrixType>::XprKind XprKind;
26 typedef typename ref_selector<MatrixType>::type MatrixTypeNested;
29 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
30 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
31 MaxRowsAtCompileTime = MatrixType
[all...]
H A DDiagonal.h21 * \param MatrixType the type of the object in which we are taking a sub/main/super diagonal
36 template<typename MatrixType, int DiagIndex>
37 struct traits<Diagonal<MatrixType,DiagIndex> >
38 : traits<MatrixType>
40 typedef typename ref_selector<MatrixType>::type MatrixTypeNested;
42 typedef typename MatrixType::StorageKind StorageKind;
44 RowsAtCompileTime = (int(DiagIndex) == DynamicIndex || int(MatrixType::SizeAtCompileTime) == Dynamic) ? Dynamic
45 : (EIGEN_PLAIN_ENUM_MIN(MatrixType::RowsAtCompileTime - EIGEN_PLAIN_ENUM_MAX(-DiagIndex, 0),
46 MatrixType::ColsAtCompileTime - EIGEN_PLAIN_ENUM_MAX( DiagIndex, 0))),
48 MaxRowsAtCompileTime = int(MatrixType
[all...]
H A DSelfAdjointView.h21 * \param MatrixType the type of the dense matrix storing the coefficients
32 template<typename MatrixType, unsigned int UpLo>
33 struct traits<SelfAdjointView<MatrixType, UpLo> > : traits<MatrixType>
35 typedef typename ref_selector<MatrixType>::non_const_type MatrixTypeNested;
37 typedef MatrixType ExpressionType;
38 typedef typename MatrixType::PlainObject FullMatrixType;
41 FlagsLvalueBit = is_lvalue<MatrixType>::value ? LvalueBit : 0,
54 typedef _MatrixType MatrixType; typedef in class:Eigen::SelfAdjointView
62 typedef typename MatrixType
[all...]
/external/eigen/Eigen/src/Cholesky/
H A DLLT.h16 template<typename MatrixType, int UpLo> struct LLT_Traits;
55 typedef _MatrixType MatrixType; typedef in class:Eigen::LLT
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;
78 * perform decompositions via LLT::compute(const MatrixType
[all...]
H A DLDLT.h19 template<typename MatrixType, int UpLo> struct LDLT_Traits;
53 typedef _MatrixType MatrixType; typedef in class:Eigen::LDLT
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,UpL
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DSparseTranspose.h16 template<typename MatrixType,int CompressedAccess=int(MatrixType::Flags&CompressedAccessBit)>
18 : public SparseMatrixBase<Transpose<MatrixType> >
21 template<typename MatrixType>
22 class SparseTransposeImpl<MatrixType,CompressedAccessBit>
23 : public SparseCompressedBase<Transpose<MatrixType> >
25 typedef SparseCompressedBase<Transpose<MatrixType> > Base;
45 template<typename MatrixType> class TransposeImpl<MatrixType,Sparse>
46 : public internal::SparseTransposeImpl<MatrixType>
[all...]

Completed in 4226 milliseconds

123456789