Searched refs:MatrixType (Results 101 - 125 of 242) sorted by relevance

12345678910

/external/eigen/unsupported/test/
H A Dmatrix_power.cpp12 template <typename MatrixType, int IsComplex = NumTraits<typename MatrixType::Scalar>::IsComplex>
16 template <typename MatrixType>
17 struct generateTriangularMatrix<MatrixType,0>
19 static void run(MatrixType& result, typename MatrixType::Index size)
22 result.template triangularView<Upper>() = MatrixType::Random(size, size);
23 for (typename MatrixType::Index i = 0; i < size; ++i)
29 template <typename MatrixType>
30 struct generateTriangularMatrix<MatrixType,
[all...]
/external/eigen/Eigen/src/SparseCholesky/
H A DSimplicialCholesky.h39 typedef typename internal::traits<Derived>::MatrixType MatrixType; typedef in class:Eigen::SimplicialCholeskyBase
42 typedef typename MatrixType::Scalar Scalar;
43 typedef typename MatrixType::RealScalar RealScalar;
44 typedef typename MatrixType::Index Index;
55 SimplicialCholeskyBase(const MatrixType& matrix)
185 void compute(const MatrixType& matrix)
196 void factorize(const MatrixType& a)
208 void analyzePattern(const MatrixType& a, bool doLDLT)
218 void ordering(const MatrixType
252 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
266 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
280 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
309 typedef _MatrixType MatrixType; typedef in class:Eigen::SimplicialLLT
398 typedef _MatrixType MatrixType; typedef in class:Eigen::SimplicialLDLT
480 typedef _MatrixType MatrixType; typedef in class:Eigen::SimplicialCholesky
[all...]
/external/eigen/test/
H A Dnesting_ops.cpp12 template <typename MatrixType> void run_nesting_ops(const MatrixType& _m)
14 typename MatrixType::Nested m(_m);
H A Deigen2support.cpp14 template<typename MatrixType> void eigen2support(const MatrixType& m)
16 typedef typename MatrixType::Index Index;
17 typedef typename MatrixType::Scalar Scalar;
22 MatrixType m1 = MatrixType::Random(rows, cols),
30 VERIFY_IS_APPROX(m1.cwise() + s1, MatrixType::Constant(rows,cols,s1) + m1);
31 VERIFY_IS_APPROX((m1*Scalar(2)).cwise() - s2, (m1+m1) - MatrixType::Constant(rows,cols,s2) );
H A Dproduct.h20 template<typename MatrixType> void product(const MatrixType& m)
25 typedef typename MatrixType::Index Index;
26 typedef typename MatrixType::Scalar Scalar;
27 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> RowVectorType;
28 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> ColVectorType;
29 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> RowSquareMatrixType;
30 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, MatrixType
[all...]
H A Dstddeque.cpp15 template<typename MatrixType>
16 void check_stddeque_matrix(const MatrixType& m)
18 typedef typename MatrixType::Index Index;
22 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
23 std::deque<MatrixType,Eigen::aligned_allocator<MatrixType> > v(10, MatrixType(rows,cols)), w(20, y);
29 typename std::deque<MatrixType,Eige
50 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Dstdlist.cpp15 template<typename MatrixType>
16 void check_stdlist_matrix(const MatrixType& m)
18 typedef typename MatrixType::Index Index;
22 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
23 std::list<MatrixType,Eigen::aligned_allocator<MatrixType> > v(10, MatrixType(rows,cols)), w(20, y);
29 typename std::list<MatrixType,Eige
50 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Darray_for_matrix.cpp12 template<typename MatrixType> void array_for_matrix(const MatrixType& m)
14 typedef typename MatrixType::Index Index;
15 typedef typename MatrixType::Scalar Scalar;
16 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> ColVectorType;
17 typedef Matrix<Scalar, 1, MatrixType::ColsAtCompileTime> RowVectorType;
22 MatrixType m1 = MatrixType::Random(rows, cols),
23 m2 = MatrixType::Random(rows, cols),
34 VERIFY_IS_APPROX((m1.array() + s1).matrix(), MatrixType
187 typedef Matrix<Scalar,Dynamic,Dynamic> MatrixType; typedef
[all...]
H A Dhouseholder.cpp13 template<typename MatrixType> void householder(const MatrixType& m)
15 typedef typename MatrixType::Index Index;
24 typedef typename MatrixType::Scalar Scalar;
26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
27 typedef Matrix<Scalar, internal::decrement_size<MatrixType::RowsAtCompileTime>::ret, 1> EssentialVectorType;
28 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType;
29 typedef Matrix<Scalar, Dynamic, MatrixType::ColsAtCompileTime> HBlockMatrixType;
32 typedef Matrix<Scalar, MatrixType
[all...]
H A Dmapped_matrix.cpp47 template<typename MatrixType> void map_class_matrix(const MatrixType& m)
49 typedef typename MatrixType::Index Index;
50 typedef typename MatrixType::Scalar Scalar;
62 Map<MatrixType, Aligned>(array1, rows, cols) = MatrixType::Ones(rows,cols);
63 Map<MatrixType>(array2, rows, cols) = Map<MatrixType>(array1, rows, cols);
64 Map<MatrixType>(array3unaligned, rows, cols) = Map<MatrixType>(array
[all...]
H A Dsizeoverflow.cpp23 template<typename MatrixType>
26 VERIFY_THROWS_BADALLOC( MatrixType m(rows, cols) );
27 VERIFY_THROWS_BADALLOC( MatrixType m; m.resize(rows, cols) );
28 VERIFY_THROWS_BADALLOC( MatrixType m; m.conservativeResize(rows, cols) );
H A Dstdvector.cpp14 template<typename MatrixType>
15 void check_stdvector_matrix(const MatrixType& m)
17 typename MatrixType::Index rows = m.rows();
18 typename MatrixType::Index cols = m.cols();
19 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
20 std::vector<MatrixType,Eigen::aligned_allocator<MatrixType> > v(10, MatrixType(row
53 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Dsparseqr.cpp12 template<typename MatrixType,typename DenseMat>
13 int generate_sparse_rectangular_problem(MatrixType& A, DenseMat& dA, int maxRows = 300, int maxCols = 150)
16 typedef typename MatrixType::Scalar Scalar;
46 typedef SparseMatrix<Scalar,ColMajor> MatrixType; typedef
49 MatrixType A;
52 SparseQR<MatrixType, COLAMDOrdering<int> > solver;
84 MatrixType Q, QtQ, idM;
/external/eigen/Eigen/src/Eigenvalues/
H A DSelfAdjointEigenSolver.h55 * SelfAdjointEigenSolver(const MatrixType&, int) constructor which computes
60 * The documentation for SelfAdjointEigenSolver(const MatrixType&, int)
72 typedef _MatrixType MatrixType; typedef in class:Eigen::SelfAdjointEigenSolver
74 Size = MatrixType::RowsAtCompileTime,
75 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
76 Options = MatrixType::Options,
77 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
81 typedef typename MatrixType::Scalar Scalar;
82 typedef typename MatrixType::Index Index;
99 typedef typename internal::plain_col_type<MatrixType, RealScala
490 typedef typename SolverType::MatrixType MatrixType; typedef in struct:Eigen::internal::direct_selfadjoint_eigenvalues
665 typedef typename SolverType::MatrixType MatrixType; typedef in struct:Eigen::internal::direct_selfadjoint_eigenvalues
[all...]
/external/eigen/Eigen/src/LU/
H A DFullPivLU.h21 * \param MatrixType the type of the matrix of which we are computing the LU decomposition
49 typedef _MatrixType MatrixType; typedef in class:Eigen::FullPivLU
51 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
52 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
53 Options = MatrixType::Options,
54 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
55 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
57 typedef typename MatrixType::Scalar Scalar;
58 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
59 typedef typename internal::traits<MatrixType>
[all...]
/external/eigen/Eigen/src/Householder/
H A DBlockHouseholder.h45 template<typename MatrixType,typename VectorsType,typename CoeffsType>
46 void apply_block_householder_on_the_left(MatrixType& mat, const VectorsType& vectors, const CoeffsType& hCoeffs)
48 typedef typename MatrixType::Index Index;
49 enum { TFactorSize = MatrixType::ColsAtCompileTime };
51 Matrix<typename MatrixType::Scalar, TFactorSize, TFactorSize, ColMajor> T(nbVecs,nbVecs);
57 Matrix<typename MatrixType::Scalar,VectorsType::ColsAtCompileTime,MatrixType::ColsAtCompileTime,0,
58 VectorsType::MaxColsAtCompileTime,MatrixType::MaxColsAtCompileTime> tmp = V.adjoint() * mat;
/external/eigen/bench/
H A DBenchUtil.h21 template<typename MatrixType> void initMatrix_random(MatrixType& mat) __attribute__((noinline));
22 template<typename MatrixType> void initMatrix_random(MatrixType& mat)
24 mat.setRandom();// = MatrixType::random(mat.rows(), mat.cols());
27 template<typename MatrixType> void initMatrix_identity(MatrixType& mat) __attribute__((noinline));
28 template<typename MatrixType> void initMatrix_identity(MatrixType& mat)
/external/eigen/unsupported/Eigen/src/Skyline/
H A DSkylineInplaceLU.h21 * \param MatrixType the type of the matrix of which we are computing the LU factorization
24 template<typename MatrixType>
27 typedef typename MatrixType::Scalar Scalar;
28 typedef typename MatrixType::Index Index;
30 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
36 SkylineInplaceLU(MatrixType& matrix, int flags = 0)
93 //inline const MatrixType& matrixL() const { return m_matrixL; }
96 //inline const MatrixType& matrixU() const { return m_matrixU; }
112 MatrixType& m_lu;
118 template<typename MatrixType>
[all...]
/external/eigen/Eigen/src/misc/
H A DSparseSolve.h23 typedef typename DecompositionType::MatrixType MatrixType; typedef in struct:Eigen::internal::traits
72 typedef typename DecompositionType::MatrixType MatrixType; \
73 typedef typename MatrixType::Scalar Scalar; \
74 typedef typename MatrixType::RealScalar RealScalar; \
75 typedef typename MatrixType::Index Index; \
91 typedef typename DecompositionType::MatrixType MatrixType; typedef in struct:Eigen::internal::traits
93 MatrixType
[all...]
/external/eigen/test/eigen2/
H A Deigen2_triangular.cpp12 template<typename MatrixType> void triangular(const MatrixType& m)
14 typedef typename MatrixType::Scalar Scalar;
16 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
23 MatrixType m1 = MatrixType::Random(rows, cols),
24 m2 = MatrixType::Random(rows, cols),
29 mzero = MatrixType::Zero(rows, cols),
30 mones = MatrixType::Ones(rows, cols),
31 identity = Matrix<Scalar, MatrixType
[all...]
H A Dproduct.h21 template<typename MatrixType> void product(const MatrixType& m)
27 typedef typename MatrixType::Scalar Scalar;
29 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> RowVectorType;
30 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> ColVectorType;
31 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> RowSquareMatrixType;
32 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, MatrixType::ColsAtCompileTime> ColSquareMatrixType;
33 typedef Matrix<Scalar, MatrixType
[all...]
H A Deigen2_sum.cpp12 template<typename MatrixType> void matrixSum(const MatrixType& m)
14 typedef typename MatrixType::Scalar Scalar;
19 MatrixType m1 = MatrixType::Random(rows, cols);
21 VERIFY_IS_MUCH_SMALLER_THAN(MatrixType::Zero(rows, cols).sum(), Scalar(1));
22 VERIFY_IS_APPROX(MatrixType::Ones(rows, cols).sum(), Scalar(float(rows*cols))); // the float() here to shut up excessive MSVC warning about int->complex conversion being lossy
H A Deigen2_adjoint.cpp12 template<typename MatrixType> void adjoint(const MatrixType& m)
18 typedef typename MatrixType::Scalar Scalar;
20 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
21 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType;
29 MatrixType m1 = MatrixType::Random(rows, cols),
30 m2 = MatrixType::Random(rows, cols),
32 mzero = MatrixType
[all...]
/external/eigen/Eigen/src/Core/
H A DReverse.h22 * \param MatrixType the type of the object of which we are taking the reverse
33 template<typename MatrixType, int Direction>
34 struct traits<Reverse<MatrixType, Direction> >
35 : traits<MatrixType>
37 typedef typename MatrixType::Scalar Scalar;
38 typedef typename traits<MatrixType>::StorageKind StorageKind;
39 typedef typename traits<MatrixType>::XprKind XprKind;
40 typedef typename nested<MatrixType>::type MatrixTypeNested;
43 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
44 ColsAtCompileTime = MatrixType
[all...]
/external/eigen/Eigen/src/IterativeLinearSolvers/
H A DIterativeSolverBase.h24 typedef typename internal::traits<Derived>::MatrixType MatrixType; typedef in class:Eigen::IterativeSolverBase
26 typedef typename MatrixType::Scalar Scalar;
27 typedef typename MatrixType::Index Index;
28 typedef typename MatrixType::RealScalar RealScalar;
52 IterativeSolverBase(const MatrixType& A)
65 Derived& analyzePattern(const MatrixType& A)
83 Derived& factorize(const MatrixType& A)
103 Derived& compute(const MatrixType& A)
223 const MatrixType* mp_matri
[all...]

Completed in 203 milliseconds

12345678910