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

1234

/external/eigen/test/
H A Dref.cpp33 template<typename MatrixType> void ref_matrix(const MatrixType& m)
35 typedef typename MatrixType::Index Index;
36 typedef typename MatrixType::Scalar Scalar;
37 typedef typename MatrixType::RealScalar RealScalar;
38 typedef Matrix<Scalar,Dynamic,Dynamic,MatrixType::Options> DynMatrixType;
39 typedef Matrix<RealScalar,Dynamic,Dynamic,MatrixType::Options> RealDynMatrixType;
41 typedef Ref<MatrixType> RefMat;
48 MatrixType m1 = MatrixType
87 typedef Matrix<Scalar,Dynamic,Dynamic,ColMajor> MatrixType; typedef
[all...]
H A Dgeo_transformations.cpp50 VERIFY_IS_APPROX(t0.matrix(), Transform3::MatrixType::Identity());
102 typedef typename Transform3::MatrixType MatrixType; typedef
178 VERIFY_IS_APPROX(t0.matrix(), Transform3::MatrixType::Identity());
181 VERIFY_IS_APPROX(t0.matrix(), Transform3::MatrixType::Identity());
226 VERIFY_IS_APPROX(t4.matrix(), MatrixType::Identity());
239 VERIFY_IS_APPROX(t4.matrix(), MatrixType::Identity());
248 VERIFY_IS_APPROX(t4.matrix(), MatrixType::Identity());
525 typedef Matrix<Scalar,Dim+1,Dim+1> MatrixType; typedef
542 MatrixType
[all...]
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DDGMRES.h26 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
113 typedef _MatrixType MatrixType; typedef in class:Eigen::DGMRES
114 typedef typename MatrixType::Scalar Scalar;
115 typedef typename MatrixType::Index Index;
116 typedef typename MatrixType::StorageIndex StorageIndex;
117 typedef typename MatrixType::RealScalar RealScalar;
202 void dgmres(const MatrixType& mat,const Rhs& rhs, Dest& x, const Preconditioner& precond) const;
205 int dgmresCycle(const MatrixType& mat, const Preconditioner& precond, Dest& x, DenseVector& r0, RealScalar& beta, const RealScalar& normRhs, int& nbIts) const;
207 int dgmresComputeDeflationData(const MatrixType& mat, const Preconditioner& precond, const Index& it, StorageIndex& neig) const;
243 void DGMRES<_MatrixType, _Preconditioner>::dgmres(const MatrixType
[all...]
/external/eigen/Eigen/src/Cholesky/
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/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;
104 RealQZ(const MatrixType
[all...]
H A DSelfAdjointEigenSolver.h23 template<typename MatrixType, typename DiagType, typename SubDiagType>
24 ComputationInfo computeFromTridiagonal_impl(DiagType& diag, SubDiagType& subdiag, const Index maxIterations, bool computeEigenvectors, MatrixType& eivec);
57 * SelfAdjointEigenSolver(const MatrixType&, int) constructor which computes
62 * The documentation for SelfAdjointEigenSolver(const MatrixType&, int)
74 typedef _MatrixType MatrixType; typedef in class:Eigen::SelfAdjointEigenSolver
76 Size = MatrixType::RowsAtCompileTime,
77 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
78 Options = MatrixType::Options,
79 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
83 typedef typename MatrixType
556 typedef typename SolverType::MatrixType MatrixType; typedef in struct:Eigen::internal::direct_selfadjoint_eigenvalues
714 typedef typename SolverType::MatrixType MatrixType; typedef in struct:Eigen::internal::direct_selfadjoint_eigenvalues
[all...]
/external/eigen/Eigen/src/LU/
H A DFullPivLU.h63 typedef _MatrixType MatrixType; typedef in class:Eigen::FullPivLU
69 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
70 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
72 typedef typename internal::plain_row_type<MatrixType, StorageIndex>::type IntRowVectorType;
73 typedef typename internal::plain_col_type<MatrixType, StorageIndex>::type IntColVectorType;
76 typedef typename MatrixType::PlainObject PlainObject;
82 * perform decompositions via LU::compute(const MatrixType&).
104 * This overloaded constructor is provided for \link InplaceDecomposition inplace decomposition \endlink when \c MatrixType is a Eigen::Ref.
131 inline const MatrixType& matrixLU() const
215 image(const MatrixType
[all...]
/external/eigen/Eigen/src/QR/
H A DFullPivHouseholderQR.h24 template<typename MatrixType> struct FullPivHouseholderQRMatrixQReturnType;
26 template<typename MatrixType>
27 struct traits<FullPivHouseholderQRMatrixQReturnType<MatrixType> >
29 typedef typename MatrixType::PlainObject ReturnType;
61 typedef _MatrixType MatrixType; typedef in class:Eigen::FullPivHouseholderQR
63 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
64 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
65 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
66 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
68 typedef typename MatrixType
[all...]
/external/eigen/Eigen/src/SVD/
H A DBDCSVD.h38 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
77 typedef _MatrixType MatrixType; typedef in class:Eigen::BDCSVD
78 typedef typename MatrixType::Scalar Scalar;
79 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
81 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
82 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
84 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
85 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime,
87 MatrixOptions = MatrixType::Options
105 * perform decompositions via BDCSVD::compute(const MatrixType
[all...]
/external/eigen/Eigen/src/SparseCholesky/
H A DSimplicialCholesky.h31 template<typename MatrixType>
32 struct simplicial_cholesky_grab_input<MatrixType,MatrixType> {
33 typedef MatrixType const * ConstMatrixPtr;
34 static void run(const MatrixType& input, ConstMatrixPtr &pmat, MatrixType &/*tmp*/)
61 typedef typename internal::traits<Derived>::MatrixType MatrixType; typedef in class:Eigen::SimplicialCholeskyBase
64 typedef typename MatrixType::Scalar Scalar;
65 typedef typename MatrixType
274 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
288 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
302 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
333 typedef _MatrixType MatrixType; typedef in class:Eigen::SimplicialLLT
424 typedef _MatrixType MatrixType; typedef in class:Eigen::SimplicialLDLT
506 typedef _MatrixType MatrixType; typedef in class:Eigen::SimplicialCholesky
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DSparseSelfAdjointView.h20 * \param MatrixType the type of the dense matrix storing the coefficients
31 template<typename MatrixType, unsigned int Mode>
32 struct traits<SparseSelfAdjointView<MatrixType,Mode> > : traits<MatrixType> {
35 template<int SrcMode,int DstMode,typename MatrixType,int DestOrder>
36 void permute_symm_to_symm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DestOrder,typename MatrixType::StorageIndex>& _dest, const typename MatrixType::StorageIndex* perm = 0);
38 template<int Mode,typename MatrixType,in
426 permute_symm_to_fullsymm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DestOrder,typename MatrixType::StorageIndex>& _dest, const typename MatrixType::StorageIndex* perm) argument
516 permute_symm_to_symm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DstOrder,typename MatrixType::StorageIndex>& _dest, const typename MatrixType::StorageIndex* perm) argument
[all...]
H A DSparseMatrix.h66 typedef SparseMatrix<_Scalar, _Options, _StorageIndex> MatrixType; typedef in struct:Eigen::internal::traits
67 typedef typename ref_selector<MatrixType>::type MatrixTypeNested;
/external/eigen/Eigen/src/SparseLU/
H A DSparseLU.h82 typedef _MatrixType MatrixType; typedef in class:Eigen::SparseLU
84 typedef typename MatrixType::Scalar Scalar;
85 typedef typename MatrixType::RealScalar RealScalar;
86 typedef typename MatrixType::StorageIndex StorageIndex;
95 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
96 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
104 explicit SparseLU(const MatrixType& matrix)
116 void analyzePattern (const MatrixType& matrix);
117 void factorize (const MatrixType& matrix);
118 void simplicialfactorize(const MatrixType
[all...]
/external/eigen/Eigen/src/SparseQR/
H A DSparseQR.h16 template<typename MatrixType, typename OrderingType> class SparseQR;
23 typedef typename SparseQRType::MatrixType ReturnType;
33 typedef typename SparseQRType::MatrixType ReturnType;
78 typedef _MatrixType MatrixType; typedef in class:Eigen::SparseQR
80 typedef typename MatrixType::Scalar Scalar;
81 typedef typename MatrixType::RealScalar RealScalar;
82 typedef typename MatrixType::StorageIndex StorageIndex;
89 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
90 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
103 explicit SparseQR(const MatrixType
602 typedef typename SparseQRType::QRMatrixType MatrixType; typedef in struct:Eigen::SparseQR_QProduct
702 typedef typename SparseQRType::MatrixType MatrixType; typedef in struct:Eigen::internal::evaluator_traits
[all...]
/external/eigen/Eigen/src/UmfPackSupport/
H A DUmfPackSupport.h141 typedef _MatrixType MatrixType; typedef in class:Eigen::UmfPackLU
142 typedef typename MatrixType::Scalar Scalar;
143 typedef typename MatrixType::RealScalar RealScalar;
144 typedef typename MatrixType::StorageIndex StorageIndex;
146 typedef Matrix<int, 1, MatrixType::ColsAtCompileTime> IntRowVectorType;
147 typedef Matrix<int, MatrixType::RowsAtCompileTime, 1> IntColVectorType;
152 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
153 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
386 template<typename MatrixType>
387 void UmfPackLU<MatrixType>
[all...]
/external/eigen/Eigen/src/Core/
H A DProductEvaluators.h367 typedef typename internal::remove_all<typename internal::conditional<int(Side)==OnTheRight,LhsNested,RhsNested>::type>::type MatrixType; typedef in struct:Eigen::internal::generic_product_impl
375 (int(MatrixType::Flags)&RowMajorBit) ? RowMajor : ColMajor,
376 bool(internal::blas_traits<MatrixType>::HasUsableDirectAccess)
705 triangular_product_impl<Lhs::Mode,true,typename Lhs::MatrixType,false,Rhs, Rhs::ColsAtCompileTime==1>
719 triangular_product_impl<Rhs::Mode,false,Lhs,Lhs::RowsAtCompileTime==1, typename Rhs::MatrixType, false>::run(dst, lhs, rhs.nestedExpression(), alpha);
740 selfadjoint_product_impl<typename Lhs::MatrixType,Lhs::Mode,false,Rhs,0,Rhs::IsVectorAtCompileTime>::run(dst, lhs.nestedExpression(), rhs, alpha);
753 selfadjoint_product_impl<Lhs,0,Lhs::IsVectorAtCompileTime,typename Rhs::MatrixType,Rhs::Mode,false>::run(dst, lhs, rhs.nestedExpression(), alpha);
762 template<typename MatrixType, typename DiagonalType, typename Derived, int ProductOrder>
766 typedef typename ScalarBinaryOpTraits<typename MatrixType::Scalar, typename DiagonalType::Scalar>::ReturnType Scalar;
769 CoeffReadCost = NumTraits<Scalar>::MulCost + evaluator<MatrixType>
923 typedef typename nested_eval<ExpressionType, 1>::type MatrixType; typedef in struct:Eigen::internal::permutation_matrix_product
1031 typedef typename nested_eval<ExpressionType, 1>::type MatrixType; typedef in struct:Eigen::internal::transposition_matrix_product
[all...]
H A DTriangularMatrix.h155 * \param MatrixType the type of the object in which we are taking the triangular part
168 template<typename MatrixType, unsigned int _Mode>
169 struct traits<TriangularView<MatrixType, _Mode> > : traits<MatrixType>
171 typedef typename ref_selector<MatrixType>::non_const_type MatrixTypeNested;
174 typedef typename MatrixType::PlainObject FullMatrixType;
175 typedef MatrixType ExpressionType;
178 FlagsLvalueBit = is_lvalue<MatrixType>::value ? LvalueBit : 0,
193 typedef _MatrixType MatrixType; typedef in class:Eigen::TriangularView
199 typedef typename internal::remove_all<typename MatrixType
342 typedef _MatrixType MatrixType; typedef in class:Eigen::TriangularViewImpl
[all...]
/external/eigen/Eigen/src/Geometry/
H A DTransform.h32 typename MatrixType,
34 : int(MatrixType::RowsAtCompileTime) == int(transform_traits<TransformType>::HDim) ? 1
36 int RhsCols = MatrixType::ColsAtCompileTime>
217 typedef typename internal::make_proper_matrix_type<Scalar,Rows,HDim,Options>::type MatrixType; typedef in class:Eigen::Transform
218 /** constified MatrixType */
219 typedef const MatrixType ConstMatrixType;
223 typedef Block<MatrixType,Dim,Dim,int(Mode)==(AffineCompact) && (Options&RowMajor)==0> LinearPart;
228 MatrixType&,
229 Block<MatrixType,Dim,HDim> >::type AffinePart;
232 const MatrixType
1238 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_take_affine_part
1249 typedef typename Transform<Scalar,Dim,AffineCompact,Options>::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_take_affine_part
1404 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_left_product_impl
1415 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_left_product_impl
1431 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_left_product_impl
1447 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_left_product_impl
1463 typedef typename TransformType::MatrixType MatrixType; typedef in struct:Eigen::internal::transform_left_product_impl
[all...]
/external/eigen/Eigen/src/SuperLUSupport/
H A DSuperLUSupport.h105 template<typename MatrixType>
174 template<typename MatrixType>
175 static SluMatrix Map(MatrixBase<MatrixType>& _mat)
177 MatrixType& mat(_mat.derived());
178 eigen_assert( ((MatrixType::Flags&RowMajorBit)!=RowMajorBit) && "row-major dense matrices are not supported by SuperLU");
181 res.setScalarType<typename MatrixType::Scalar>();
187 res.storage.lda = internal::convert_index<int>(MatrixType::IsVectorAtCompileTime ? mat.size() : mat.outerStride());
192 template<typename MatrixType>
193 static SluMatrix Map(SparseMatrixBase<MatrixType>& a_mat)
195 MatrixType
234 typedef Matrix<Scalar,Rows,Cols,Options,MRows,MCols> MatrixType; typedef in struct:Eigen::SluMatrixMapHelper
253 typedef Derived MatrixType; typedef in struct:Eigen::SluMatrixMapHelper
324 typedef _MatrixType MatrixType; typedef in class:Eigen::SuperLUBase
492 typedef _MatrixType MatrixType; typedef in class:Eigen::SuperLU
846 typedef _MatrixType MatrixType; typedef in class:Eigen::SuperILU
[all...]

Completed in 1591 milliseconds

1234