Searched refs:MatrixType (Results 126 - 150 of 242) sorted by relevance

12345678910

/external/eigen/test/
H A Dproduct_selfadjoint.cpp12 template<typename MatrixType> void product_selfadjoint(const MatrixType& m)
14 typedef typename MatrixType::Index Index;
15 typedef typename MatrixType::Scalar Scalar;
16 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
17 typedef Matrix<Scalar, 1, MatrixType::RowsAtCompileTime> RowVectorType;
19 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, Dynamic, RowMajor> RhsMatrixType;
24 MatrixType m1 = MatrixType::Random(rows, cols),
25 m2 = MatrixType
[all...]
H A Dstdvector_overload.cpp28 template<typename MatrixType>
29 void check_stdvector_matrix(const MatrixType& m)
31 typename MatrixType::Index rows = m.rows();
32 typename MatrixType::Index cols = m.cols();
33 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
34 std::vector<MatrixType> v(10, MatrixType(rows,cols)), w(20, y);
51 VERIFY((size_t)&(v[22]) == (size_t)&(v[21]) + sizeof(MatrixType));
67 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Dconservative_resize.cpp19 typedef Matrix<Scalar, Eigen::Dynamic, Eigen::Dynamic, Storage> MatrixType; typedef
20 typedef typename MatrixType::Index Index;
22 MatrixType m, n;
25 m = n = MatrixType::Random(50,50);
29 m = n = MatrixType::Random(50,50);
33 m = n = MatrixType::Random(50,50);
42 m = n = MatrixType::Random(50,50);
52 m = n = MatrixType::Random(50,50);
53 m.conservativeResizeLike(MatrixType::Zero(rows,cols));
H A Dnullary.cpp12 template<typename MatrixType>
13 bool equalsIdentity(const MatrixType& A)
15 typedef typename MatrixType::Index Index;
16 typedef typename MatrixType::Scalar Scalar;
102 template<typename MatrixType>
103 void testMatrixType(const MatrixType& m)
105 typedef typename MatrixType::Index Index;
109 MatrixType A;
112 VERIFY(equalsIdentity(MatrixType::Identity(rows, cols)));
H A Dqtvector.cpp18 template<typename MatrixType>
19 void check_qtvector_matrix(const MatrixType& m)
21 typedef typename MatrixType::Index Index;
25 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
26 QVector<MatrixType> v(10, MatrixType(rows,cols)), w(20, y);
47 VERIFY((size_t)&(v[22]) == (size_t)&(v[21]) + sizeof(MatrixType));
51 MatrixType* re
63 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Ddeterminant.cpp14 template<typename MatrixType> void determinant(const MatrixType& m)
19 typedef typename MatrixType::Index Index;
22 MatrixType m1(size, size), m2(size, size);
25 typedef typename MatrixType::Scalar Scalar;
27 VERIFY_IS_APPROX(MatrixType::Identity(size, size).determinant(), Scalar(1));
H A Dtriangular.cpp14 template<typename MatrixType> void triangular_square(const MatrixType& m)
16 typedef typename MatrixType::Scalar Scalar;
18 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
22 typename MatrixType::Index rows = m.rows();
23 typename MatrixType::Index cols = m.cols();
25 MatrixType m1 = MatrixType::Random(rows, cols),
26 m2 = MatrixType::Random(rows, cols),
33 MatrixType m1u
[all...]
/external/eigen/test/eigen2/
H A Deigen2_determinant.cpp14 template<typename MatrixType> void determinant(const MatrixType& m)
21 MatrixType m1(size, size), m2(size, size);
24 typedef typename MatrixType::Scalar Scalar;
26 VERIFY_IS_APPROX(MatrixType::Identity(size, size).determinant(), Scalar(1));
H A Deigen2_map.cpp38 template<typename MatrixType> void map_class_matrix(const MatrixType& m)
40 typedef typename MatrixType::Scalar Scalar;
52 Map<MatrixType, Aligned>(array1, rows, cols) = MatrixType::Ones(rows,cols);
53 Map<MatrixType>(array2, rows, cols) = Map<MatrixType>((const Scalar*)array1, rows, cols); // test non-const-correctness support in eigen2
54 Map<MatrixType>(array3unaligned, rows, cols) = Map<MatrixType>(array1, rows, cols);
55 MatrixType ma
[all...]
H A Deigen2_newstdvector.cpp15 template<typename MatrixType>
16 void check_stdvector_matrix(const MatrixType& m)
20 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
21 std::vector<MatrixType,Eigen::aligned_allocator<MatrixType> > v(10, MatrixType(rows,cols)), w(20, y);
38 VERIFY((std::size_t)&(v[22]) == (std::size_t)&(v[21]) + sizeof(MatrixType));
42 MatrixType* re
54 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Deigen2_stdvector.cpp14 template<typename MatrixType>
15 void check_stdvector_matrix(const MatrixType& m)
19 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
20 std::vector<MatrixType, aligned_allocator<MatrixType> > v(10, MatrixType(rows,cols)), w(20, y);
37 VERIFY((std::size_t)&(v[22]) == (std::size_t)&(v[21]) + sizeof(MatrixType));
41 MatrixType* re
53 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Deigen2_qtvector.cpp20 template<typename MatrixType>
21 void check_qtvector_matrix(const MatrixType& m)
25 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
26 QVector<MatrixType> v(10, MatrixType(rows,cols)), w(20, y);
47 VERIFY((size_t)&(v[22]) == (size_t)&(v[21]) + sizeof(MatrixType));
51 MatrixType* ref = &w[0];
63 typedef typename TransformType::MatrixType MatrixTyp typedef
[all...]
H A Deigen2_linearstructure.cpp12 template<typename MatrixType> void linearStructure(const MatrixType& m)
18 typedef typename MatrixType::Scalar Scalar;
19 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
26 MatrixType m1 = MatrixType::Random(rows, cols),
27 m2 = MatrixType::Random(rows, cols),
29 mzero = MatrixType::Zero(rows, cols);
/external/eigen/Eigen/src/SparseCore/
H A DSparseTriangularView.h18 template<typename MatrixType, int Mode>
19 struct traits<SparseTriangularView<MatrixType,Mode> >
20 : public traits<MatrixType>
25 template<typename MatrixType, int Mode> class SparseTriangularView
26 : public SparseMatrixBase<SparseTriangularView<MatrixType,Mode> >
28 enum { SkipFirst = ((Mode&Lower) && !(MatrixType::Flags&RowMajorBit))
29 || ((Mode&Upper) && (MatrixType::Flags&RowMajorBit)),
45 typedef typename MatrixType::Nested MatrixTypeNested;
49 inline SparseTriangularView(const MatrixType& matrix) : m_matrix(matrix) {}
65 template<typename MatrixType, in
[all...]
/external/eigen/Eigen/src/SuperLUSupport/
H A DSuperLUSupport.h80 template<typename MatrixType>
149 template<typename MatrixType>
150 static SluMatrix Map(MatrixBase<MatrixType>& _mat)
152 MatrixType& mat(_mat.derived());
153 eigen_assert( ((MatrixType::Flags&RowMajorBit)!=RowMajorBit) && "row-major dense matrices are not supported by SuperLU");
156 res.setScalarType<typename MatrixType::Scalar>();
162 res.storage.lda = MatrixType::IsVectorAtCompileTime ? mat.size() : mat.outerStride();
167 template<typename MatrixType>
168 static SluMatrix Map(SparseMatrixBase<MatrixType>& mat)
171 if ((MatrixType
208 typedef Matrix<Scalar,Rows,Cols,Options,MRows,MCols> MatrixType; typedef in struct:Eigen::SluMatrixMapHelper
227 typedef Derived MatrixType; typedef in struct:Eigen::SluMatrixMapHelper
294 typedef _MatrixType MatrixType; typedef in class:Eigen::SuperLUBase
483 typedef _MatrixType MatrixType; typedef in class:Eigen::SuperLU
825 typedef _MatrixType MatrixType; typedef in class:Eigen::SuperILU
[all...]
/external/eigen/Eigen/src/Eigenvalues/
H A DRealSchur.h40 * given matrix. Alternatively, you can use the RealSchur(const MatrixType&, bool)
45 * The documentation of RealSchur(const MatrixType&, bool) contains an example
57 typedef _MatrixType MatrixType; typedef in class:Eigen::RealSchur
59 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
60 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
61 Options = MatrixType::Options,
62 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
63 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
65 typedef typename MatrixType::Scalar Scalar;
67 typedef typename MatrixType
[all...]
/external/eigen/bench/
H A DbenchCholesky.cpp28 template <typename MatrixType>
29 __attribute__ ((noinline)) void benchLLT(const MatrixType& m)
43 typedef typename MatrixType::Scalar Scalar;
44 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType;
46 MatrixType a = MatrixType::Random(rows,cols);
76 if (MatrixType::RowsAtCompileTime==Dynamic)
88 if (MatrixType::RowsAtCompileTime==Dynamic)
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DScaling.h50 typedef _MatrixType MatrixType; typedef in class:Eigen::IterScaling
51 typedef typename MatrixType::Scalar Scalar;
52 typedef typename MatrixType::Index Index;
57 IterScaling(const MatrixType& matrix)
72 void compute (const MatrixType& mat)
93 for (typename MatrixType::InnerIterator it(m_matrix, k); it; ++it)
117 for (typename MatrixType::InnerIterator it(m_matrix, k); it; ++it)
141 void computeRef (MatrixType& mat)
176 MatrixType m_matrix;
/external/eigen/unsupported/Eigen/src/SparseExtra/
H A DBlockOfDynamicSparseMatrix.h29 typedef DynamicSparseMatrix<_Scalar, _Options, _Index> MatrixType;
35 class InnerIterator: public MatrixType::InnerIterator
39 : MatrixType::InnerIterator(xpr.m_matrix, xpr.m_outerStart + outer), m_outer(outer)
47 inline SparseInnerVectorSet(const MatrixType& matrix, Index outerStart, Index outerSize)
53 inline SparseInnerVectorSet(const MatrixType& matrix, Index outer)
112 const typename MatrixType::Nested m_matrix;
/external/eigen/Eigen/src/PaStiXSupport/
H A DPaStiXSupport.h35 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::pastix_traits
44 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::pastix_traits
53 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::pastix_traits
88 template <typename MatrixType>
89 void c_to_fortran_numbering (MatrixType& mat)
102 template <typename MatrixType>
103 void fortran_to_c_numbering (MatrixType& mat)
123 typedef typename internal::pastix_traits<Derived>::MatrixType _MatrixType;
124 typedef _MatrixType MatrixType; typedef in class:Eigen::PastixBase
125 typedef typename MatrixType
434 typedef _MatrixType MatrixType; typedef in class:Eigen::PastixLU
544 typedef _MatrixType MatrixType; typedef in class:Eigen::PastixLLT
625 typedef _MatrixType MatrixType; typedef in class:Eigen::PastixLDLT
[all...]
/external/eigen/unsupported/Eigen/src/Eigenvalues/
H A DArpackSelfAdjointEigenSolver.h34 template<typename MatrixSolver, typename MatrixType, typename Scalar, bool BisSPD> struct OP;
39 template<typename MatrixType, typename MatrixSolver=SimplicialLLT<MatrixType>, bool BisSPD=false>
43 //typedef typename MatrixSolver::MatrixType MatrixType;
45 /** \brief Scalar type for matrices of type \p MatrixType. */
46 typedef typename MatrixType::Scalar Scalar;
47 typedef typename MatrixType::Index Index;
49 /** \brief Real scalar type for \p MatrixType.
62 typedef typename internal::plain_col_type<MatrixType, RealScala
[all...]
/external/eigen/Eigen/src/Core/
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 nested<MatrixType>::type MatrixTypeNested;
37 typedef MatrixType ExpressionType;
38 typedef typename MatrixType::PlainObject DenseMatrixType;
53 template<typename MatrixType, unsigned int UpLo> class SelfAdjointView
54 : public TriangularBase<SelfAdjointView<MatrixType, UpLo> >
65 typedef typename MatrixType
[all...]
H A DTriangularMatrix.h124 * \param MatrixType the type of the object in which we are taking the triangular part
137 template<typename MatrixType, unsigned int _Mode>
138 struct traits<TriangularView<MatrixType, _Mode> > : traits<MatrixType>
140 typedef typename nested<MatrixType>::type MatrixTypeNested;
143 typedef MatrixType ExpressionType;
144 typedef typename MatrixType::PlainObject DenseMatrixType;
166 typedef _MatrixType MatrixType; typedef in class:Eigen::TriangularView
175 typedef typename internal::remove_all<typename MatrixType::ConjugateReturnType>::type MatrixConjugateReturnType;
192 inline TriangularView(const MatrixType
[all...]
/external/eigen/Eigen/src/Core/util/
H A DForwardDeclarations.h83 template<typename MatrixType, int Size=Dynamic> class VectorBlock;
84 template<typename MatrixType> class Transpose;
85 template<typename MatrixType> class Conjugate;
86 template<typename NullaryOp, typename MatrixType> class CwiseNullaryOp;
87 template<typename UnaryOp, typename MatrixType> class CwiseUnaryOp;
88 template<typename ViewOp, typename MatrixType> class CwiseUnaryView;
98 template<typename MatrixType, typename DiagonalType, int ProductOrder> class DiagonalProduct;
99 template<typename MatrixType, int Index = 0> class Diagonal;
111 template<typename MatrixType, int MapOptions=Unaligned, typename StrideType = Stride<0,0> > class Map;
114 template<typename MatrixType, unsigne
[all...]
/external/eigen/Eigen/src/PardisoSupport/
H A DPardisoSupport.h72 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::pardiso_traits
81 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::pardiso_traits
90 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::pardiso_traits
103 typedef typename Traits::MatrixType MatrixType; typedef in class:Eigen::PardisoImpl
109 typedef Matrix<Index, 1, MatrixType::ColsAtCompileTime> IntRowVectorType;
110 typedef Matrix<Index, MatrixType::RowsAtCompileTime, 1> IntColVectorType;
157 Derived& analyzePattern(const MatrixType& matrix);
165 Derived& factorize(const MatrixType& matrix);
167 Derived& compute(const MatrixType
[all...]

Completed in 890 milliseconds

12345678910