Searched defs:MatrixType (Results 76 - 93 of 93) sorted by relevance

1234

/external/eigen/Eigen/src/SparseCore/
H A DSparseSelfAdjointView.h20 * \param MatrixType the type of the dense matrix storing the coefficients
37 template<typename MatrixType, unsigned int UpLo>
38 struct traits<SparseSelfAdjointView<MatrixType,UpLo> > : traits<MatrixType> {
41 template<int SrcUpLo,int DstUpLo,typename MatrixType,int DestOrder>
42 void permute_symm_to_symm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DestOrder,typename MatrixType::Index>& _dest, const typename MatrixType::Index* perm = 0);
44 template<int UpLo,typename MatrixType,in
314 permute_symm_to_fullsymm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DestOrder,typename MatrixType::Index>& _dest, const typename MatrixType::Index* perm) argument
401 permute_symm_to_symm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DstOrder,typename MatrixType::Index>& _dest, const typename MatrixType::Index* perm) argument
[all...]
H A DSparseMatrix.h63 typedef SparseMatrix<_Scalar, _Options, _Index> MatrixType; typedef in struct:Eigen::internal::traits
64 typedef typename nested<MatrixType>::type MatrixTypeNested;
/external/eigen/test/
H A Dgeo_transformations.cpp39 VERIFY_IS_APPROX(t0.matrix(), Transform3::MatrixType::Identity());
91 typedef typename Transform3::MatrixType MatrixType; typedef
152 VERIFY_IS_APPROX(t0.matrix(), Transform3::MatrixType::Identity());
155 VERIFY_IS_APPROX(t0.matrix(), Transform3::MatrixType::Identity());
200 VERIFY_IS_APPROX(t4.matrix(), MatrixType::Identity());
210 VERIFY_IS_APPROX(t4.matrix(), MatrixType::Identity());
219 VERIFY_IS_APPROX(t4.matrix(), MatrixType::Identity());
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DDGMRES.h26 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
111 typedef _MatrixType MatrixType; typedef in class:Eigen::DGMRES
112 typedef typename MatrixType::Scalar Scalar;
113 typedef typename MatrixType::Index Index;
114 typedef typename MatrixType::RealScalar RealScalar;
136 DGMRES(const MatrixType& A) : Base(A),m_restart(30),m_neig(0),m_r(0),m_maxNeig(5),m_isDeflAllocated(false),m_isDeflInitialized(false)
215 void dgmres(const MatrixType& mat,const Rhs& rhs, Dest& x, const Preconditioner& precond) const;
218 int dgmresCycle(const MatrixType& mat, const Preconditioner& precond, Dest& x, DenseVector& r0, RealScalar& beta, const RealScalar& normRhs, int& nbIts) const;
220 int dgmresComputeDeflationData(const MatrixType& mat, const Preconditioner& precond, const Index& it, Index& neig) const;
256 void DGMRES<_MatrixType, _Preconditioner>::dgmres(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...]
H A DBDCSVD.h33 * \param MatrixType the type of the matrix of which we are computing the SVD decomposition
46 typedef _MatrixType MatrixType; typedef in class:Eigen::BDCSVD
47 typedef typename MatrixType::Scalar Scalar;
48 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
49 typedef typename MatrixType::Index Index;
51 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
52 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
54 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
55 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime,
57 MatrixOptions = MatrixType
[all...]
/external/eigen/Eigen/src/Core/
H A DGeneralProduct.h188 // case, we could have a specialization for Block<MatrixType,1,1> with: operator=(Scalar x);
343 typedef typename internal::conditional<int(Side)==OnTheRight,_LhsNested,_RhsNested>::type MatrixType; typedef in class:Eigen::GeneralProduct
348 internal::gemv_selector<Side,(int(MatrixType::Flags)&RowMajorBit) ? RowMajor : ColMajor,
349 bool(internal::blas_traits<MatrixType>::HasUsableDirectAccess)>::run(*this, dst, alpha);
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/Eigenvalues/
H A DRealQZ.h40 * RealQZ(const MatrixType& B, const MatrixType& B, bool computeQZ)
60 typedef _MatrixType MatrixType; typedef in class:Eigen::RealQZ
62 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
63 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
64 Options = MatrixType::Options,
65 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
66 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
68 typedef typename MatrixType::Scalar Scalar;
70 typedef typename MatrixType
[all...]
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/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
504 typedef _MatrixType MatrixType; typedef in class:Eigen::JacobiSVD
[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/Eigen/src/SparseLU/
H A DSparseLU.h76 typedef _MatrixType MatrixType; typedef in class:Eigen::SparseLU
78 typedef typename MatrixType::Scalar Scalar;
79 typedef typename MatrixType::RealScalar RealScalar;
80 typedef typename MatrixType::Index Index;
93 SparseLU(const MatrixType& matrix):m_isInitialized(true),m_lastError(""),m_Ustore(0,0,0,0,0,0),m_symmetricmode(false),m_diagpivotthresh(1.0),m_detPermR(1)
104 void analyzePattern (const MatrixType& matrix);
105 void factorize (const MatrixType& matrix);
106 void simplicialfactorize(const MatrixType& matrix);
112 void compute (const MatrixType& matrix)
370 template <typename MatrixType, typenam
[all...]
/external/eigen/Eigen/src/SparseQR/
H A DSparseQR.h16 template<typename MatrixType, typename OrderingType> class SparseQR;
23 typedef typename SparseQRType::MatrixType ReturnType;
29 typedef typename SparseQRType::MatrixType ReturnType;
68 typedef _MatrixType MatrixType; typedef in class:Eigen::SparseQR
70 typedef typename MatrixType::Scalar Scalar;
71 typedef typename MatrixType::RealScalar RealScalar;
72 typedef typename MatrixType::Index Index;
87 SparseQR(const MatrixType& mat) : m_isInitialized(false), m_analysisIsok(false), m_lastError(""), m_useDefaultThreshold(true),m_isQSorted(false)
98 void compute(const MatrixType& mat)
103 void analyzePattern(const MatrixType
577 typedef typename SparseQRType::QRMatrixType MatrixType; typedef in struct:Eigen::SparseQR_QProduct
[all...]
/external/eigen/Eigen/src/UmfPackSupport/
H A DUmfPackSupport.h127 typedef _MatrixType MatrixType; typedef in class:Eigen::UmfPackLU
128 typedef typename MatrixType::Scalar Scalar;
129 typedef typename MatrixType::RealScalar RealScalar;
130 typedef typename MatrixType::Index Index;
132 typedef Matrix<int, 1, MatrixType::ColsAtCompileTime> IntRowVectorType;
133 typedef Matrix<int, MatrixType::RowsAtCompileTime, 1> IntColVectorType;
141 UmfPackLU(const MatrixType& matrix)
195 void compute(const MatrixType& matrix)
233 void analyzePattern(const MatrixType& matrix)
258 void factorize(const MatrixType
[all...]
/external/skia/src/gpu/gl/
H A DGrGLProgramEffects.cpp24 enum MatrixType { enum
74 MatrixType get_matrix_type(EffectKey transformKey, int transformIdx) {
75 return static_cast<MatrixType>(
/external/eigen/Eigen/src/Geometry/
H A DTransform.h32 typename MatrixType,
34 : int(MatrixType::RowsAtCompileTime) == int(transform_traits<TransformType>::HDim) ? 1
191 typedef typename internal::make_proper_matrix_type<Scalar,Rows,HDim,Options>::type MatrixType; typedef in class:Eigen::Transform
192 /** constified MatrixType */
193 typedef const MatrixType ConstMatrixType;
197 typedef Block<MatrixType,Dim,Dim,int(Mode)==(AffineCompact) && (Options&RowMajor)==0> LinearPart;
202 MatrixType&,
203 Block<MatrixType,Dim,HDim> >::type AffinePart;
206 const MatrixType&,
207 const Block<const MatrixType,Di
1160 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_take_affine_part
1171 typedef typename Transform<Scalar,Dim,AffineCompact,Options>::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_take_affine_part
1302 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_left_product_impl
1313 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_left_product_impl
1329 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_left_product_impl
1345 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_left_product_impl
1361 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_left_product_impl
[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...]

Completed in 4383 milliseconds

1234