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

12345678910

/external/eigen/test/
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 Deigensolver_complex.cpp33 template<typename MatrixType> void eigensolver(const MatrixType& m)
35 typedef typename MatrixType::Index Index;
42 typedef typename MatrixType::Scalar Scalar;
45 MatrixType a = MatrixType::Random(rows,cols);
46 MatrixType symmA = a.adjoint() * a;
48 ComplexEigenSolver<MatrixType> ei0(symmA);
52 ComplexEigenSolver<MatrixType> ei1(a);
55 // Note: If MatrixType i
[all...]
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 Dschur_real.cpp14 template<typename MatrixType> void verifyIsQuasiTriangular(const MatrixType& T)
16 typedef typename MatrixType::Index Index;
19 typedef typename MatrixType::Scalar Scalar;
40 template<typename MatrixType> void schur(int size = MatrixType::ColsAtCompileTime) argument
44 MatrixType A = MatrixType::Random(size, size);
45 RealSchur<MatrixType> schurOfA(A);
47 MatrixType
[all...]
H A Dlu.cpp14 template<typename MatrixType> void lu_non_invertible()
16 typedef typename MatrixType::Index Index;
17 typedef typename MatrixType::RealScalar RealScalar;
22 if(MatrixType::RowsAtCompileTime==Dynamic)
28 rows = MatrixType::RowsAtCompileTime;
30 if(MatrixType::ColsAtCompileTime==Dynamic)
37 cols2 = cols = MatrixType::ColsAtCompileTime;
41 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
42 ColsAtCompileTime = MatrixType::ColsAtCompileTime
44 typedef typename internal::kernel_retval_base<FullPivLU<MatrixType> >
[all...]
H A Dswap.cpp25 template<typename MatrixType> void swap(const MatrixType& m)
27 typedef typename other_matrix_type<MatrixType>::type OtherMatrixType;
28 typedef typename MatrixType::Scalar Scalar;
30 eigen_assert((!internal::is_same<MatrixType,OtherMatrixType>::value));
31 typename MatrixType::Index rows = m.rows();
32 typename MatrixType::Index cols = m.cols();
35 MatrixType m1 = MatrixType::Random(rows,cols);
36 MatrixType m
[all...]
/external/eigen/unsupported/test/
H A Dsvd_common.h26 template<typename MatrixType, typename SVD>
27 void svd_check_full(const MatrixType& m, const SVD& svd)
29 typedef typename MatrixType::Index Index;
33 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
34 ColsAtCompileTime = MatrixType::ColsAtCompileTime
37 typedef typename MatrixType::Scalar Scalar;
42 MatrixType sigma = MatrixType::Zero(rows, cols);
54 template<typename MatrixType, typename SVD>
55 void svd_compare_to_full(const MatrixType
[all...]
/external/eigen/unsupported/Eigen/src/MatrixFunctions/
H A DMatrixSquareRoot.h17 * \tparam MatrixType type of the argument of the matrix square root,
26 template <typename MatrixType>
39 MatrixSquareRootQuasiTriangular(const MatrixType& A)
56 typedef typename MatrixType::Index Index;
57 typedef typename MatrixType::Scalar Scalar;
59 void computeDiagonalPartOfSqrt(MatrixType& sqrtT, const MatrixType& T);
60 void computeOffDiagonalPartOfSqrt(MatrixType& sqrtT, const MatrixType& T);
61 void compute2x2diagonalBlock(MatrixType
[all...]
H A DMatrixExponential.h20 * \tparam MatrixType type of the argument of the exponential,
23 template <typename MatrixType>
35 MatrixExponential(const MatrixType &M);
57 void pade3(const MatrixType &A);
66 void pade5(const MatrixType &A);
75 void pade7(const MatrixType &A);
84 void pade9(const MatrixType &A);
93 void pade13(const MatrixType &A);
104 void pade17(const MatrixType &A);
133 typedef typename internal::traits<MatrixType>
[all...]
H A DMatrixPower.h15 template<typename MatrixType> class MatrixPower;
17 template<typename MatrixType>
18 class MatrixPowerRetval : public ReturnByValue< MatrixPowerRetval<MatrixType> >
21 typedef typename MatrixType::RealScalar RealScalar;
22 typedef typename MatrixType::Index Index;
24 MatrixPowerRetval(MatrixPower<MatrixType>& pow, RealScalar p) : m_pow(pow), m_p(p)
35 MatrixPower<MatrixType>& m_pow;
40 template<typename MatrixType>
45 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
46 MaxRowsAtCompileTime = MatrixType
[all...]
/external/eigen/Eigen/src/Eigen2Support/
H A DMinor.h20 * \param MatrixType the type of the object in which we are taking a minor
30 template<typename MatrixType>
31 struct traits<Minor<MatrixType> >
32 : traits<MatrixType>
34 typedef typename nested<MatrixType>::type MatrixTypeNested;
36 typedef typename MatrixType::StorageKind StorageKind;
38 RowsAtCompileTime = (MatrixType::RowsAtCompileTime != Dynamic) ?
39 int(MatrixType::RowsAtCompileTime) - 1 : Dynamic,
40 ColsAtCompileTime = (MatrixType::ColsAtCompileTime != Dynamic) ?
41 int(MatrixType
[all...]
H A DQR.h16 template<typename MatrixType>
17 class QR : public HouseholderQR<MatrixType>
21 typedef HouseholderQR<MatrixType> Base;
22 typedef Block<const MatrixType, MatrixType::ColsAtCompileTime, MatrixType::ColsAtCompileTime> MatrixRBlockType;
36 MatrixType matrixQ(void) const {
37 MatrixType ret = MatrixType::Identity(this->rows(), this->cols());
/external/eigen/test/eigen2/
H A Deigen2_eigensolver.cpp17 template<typename MatrixType> void selfadjointeigensolver(const MatrixType& m)
25 typedef typename MatrixType::Scalar Scalar;
27 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
28 typedef Matrix<RealScalar, MatrixType::RowsAtCompileTime, 1> RealVectorType;
29 typedef typename std::complex<typename NumTraits<typename MatrixType::Scalar>::Real> Complex;
33 MatrixType a = MatrixType::Random(rows,cols);
34 MatrixType a1 = MatrixType
[all...]
H A Deigen2_nomalloc.cpp22 template<typename MatrixType> void nomalloc(const MatrixType& m)
27 typedef typename MatrixType::Scalar Scalar;
28 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
33 MatrixType m1 = MatrixType::Random(rows, cols),
34 m2 = MatrixType::Random(rows, cols),
36 mzero = MatrixType::Zero(rows, cols),
37 identity = Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType
[all...]
H A Deigen2_swap.cpp25 template<typename MatrixType> void swap(const MatrixType& m)
27 typedef typename other_matrix_type<MatrixType>::type OtherMatrixType;
28 typedef typename MatrixType::Scalar Scalar;
30 ei_assert((!ei_is_same_type<MatrixType,OtherMatrixType>::ret));
35 MatrixType m1 = MatrixType::Random(rows,cols);
36 MatrixType m2 = MatrixType::Random(rows,cols) + Scalar(100) * MatrixType
[all...]
H A Deigen2_inverse.cpp14 template<typename MatrixType> void inverse(const MatrixType& m)
22 typedef typename MatrixType::Scalar Scalar;
24 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> VectorType;
26 MatrixType m1 = MatrixType::Random(rows, cols),
28 mzero = MatrixType::Zero(rows, cols),
29 identity = MatrixType::Identity(rows, rows);
33 m1 = MatrixType::Random(rows, cols);
H A Deigen2_prec_inverse_4x4.cpp29 template<typename MatrixType> void inverse_permutation_4x4()
31 typedef typename MatrixType::Scalar Scalar;
32 typedef typename MatrixType::RealScalar RealScalar;
36 MatrixType m = MatrixType::Zero();
41 MatrixType inv = m.inverse();
42 double error = double( (m*inv-MatrixType::Identity()).norm() / epsilon<Scalar>() );
48 template<typename MatrixType> void inverse_general_4x4(int repeat)
50 typedef typename MatrixType::Scalar Scalar;
51 typedef typename MatrixType
[all...]
H A Deigen2_qr.cpp13 template<typename MatrixType> void qr(const MatrixType& m)
21 typedef typename MatrixType::Scalar Scalar;
22 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, MatrixType::ColsAtCompileTime> SquareMatrixType;
23 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> VectorType;
25 MatrixType a = MatrixType::Random(rows,cols);
26 QR<MatrixType> qrOfA(a);
28 VERIFY_IS_NOT_APPROX(a+MatrixType
[all...]
/external/eigen/Eigen/src/Core/
H A DTranspose.h21 * \param MatrixType the type of the object of which we are taking the transpose
31 template<typename MatrixType>
32 struct traits<Transpose<MatrixType> > : traits<MatrixType>
34 typedef typename MatrixType::Scalar Scalar;
35 typedef typename nested<MatrixType>::type MatrixTypeNested;
37 typedef typename traits<MatrixType>::StorageKind StorageKind;
38 typedef typename traits<MatrixType>::XprKind XprKind;
40 RowsAtCompileTime = MatrixType::ColsAtCompileTime,
41 ColsAtCompileTime = MatrixType
[all...]
/external/eigen/Eigen/src/misc/
H A DKernel.h23 typedef typename DecompositionType::MatrixType MatrixType; typedef in struct:Eigen::internal::traits
25 typename MatrixType::Scalar,
26 MatrixType::ColsAtCompileTime, // the number of rows in the "kernel matrix"
30 MatrixType::Options,
31 MatrixType::MaxColsAtCompileTime, // see explanation for 2nd template parameter
32 MatrixType::MaxColsAtCompileTime // the kernel is a subspace of the domain space,
68 typedef typename DecompositionType::MatrixType MatrixType; \
69 typedef typename MatrixType
[all...]
/external/eigen/doc/snippets/
H A DTutorial_Map_using.cpp1 typedef Matrix<float,1,Dynamic> MatrixType; typedef
2 typedef Map<MatrixType> MapType;
3 typedef Map<const MatrixType> MapTypeConst; // a read-only map
6 MatrixType m1(n_dims), m2(n_dims);
/external/eigen/Eigen/src/Eigenvalues/
H A DTridiagonalization.h18 template<typename MatrixType> struct TridiagonalizationMatrixTReturnType;
19 template<typename MatrixType>
20 struct traits<TridiagonalizationMatrixTReturnType<MatrixType> >
22 typedef typename MatrixType::PlainObject ReturnType;
25 template<typename MatrixType, typename CoeffVectorType>
26 void tridiagonalization_inplace(MatrixType& matA, CoeffVectorType& hCoeffs);
50 * given matrix. Alternatively, you can use the Tridiagonalization(const MatrixType&)
56 * The documentation of Tridiagonalization(const MatrixType&) contains an
66 typedef _MatrixType MatrixType; typedef in class:Eigen::Tridiagonalization
68 typedef typename MatrixType
[all...]
H A DGeneralizedSelfAdjointEigenSolver.h37 * GeneralizedSelfAdjointEigenSolver(const MatrixType&, const MatrixType&, int)
42 * The documentation for GeneralizedSelfAdjointEigenSolver(const MatrixType&, const MatrixType&, int)
54 typedef _MatrixType MatrixType; typedef in class:Eigen::GeneralizedSelfAdjointEigenSolver
90 * This constructor calls compute(const MatrixType&, const MatrixType&, int)
105 * \sa compute(const MatrixType&, const MatrixType&, int)
107 GeneralizedSelfAdjointEigenSolver(const MatrixType
[all...]
/external/eigen/unsupported/Eigen/src/SVD/
H A DJacobiSVD.h18 template<typename MatrixType, int QRPreconditioner,
19 bool IsComplex = NumTraits<typename MatrixType::Scalar>::IsComplex>
31 template<typename MatrixType, int QRPreconditioner, int Case>
34 enum { a = MatrixType::RowsAtCompileTime != Dynamic &&
35 MatrixType::ColsAtCompileTime != Dynamic &&
36 MatrixType::ColsAtCompileTime <= MatrixType::RowsAtCompileTime,
37 b = MatrixType::RowsAtCompileTime != Dynamic &&
38 MatrixType::ColsAtCompileTime != Dynamic &&
39 MatrixType
56 run(JacobiSVD<MatrixType, QRPreconditioner>&, const MatrixType&) argument
497 typedef _MatrixType MatrixType; typedef in class:Eigen::JacobiSVD
[all...]
/external/eigen/Eigen/src/Cholesky/
H A DLLT.h16 template<typename MatrixType, int UpLo> struct LLT_Traits;
25 * \param MatrixType the type of the matrix of which we are computing the LL^T Cholesky decomposition
53 typedef _MatrixType MatrixType; typedef in class:Eigen::LLT
55 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
56 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
57 Options = MatrixType::Options,
58 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
60 typedef typename MatrixType::Scalar Scalar;
61 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
62 typedef typename MatrixType
[all...]

Completed in 328 milliseconds

12345678910