Searched defs:MatrixType (Results 1 - 25 of 94) sorted by path

1234

/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...]
H A DLLT.h16 template<typename MatrixType, int UpLo> struct LLT_Traits;
55 typedef _MatrixType MatrixType; typedef in class:Eigen::LLT
57 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
58 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
59 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
61 typedef typename MatrixType::Scalar Scalar;
62 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
64 typedef typename MatrixType::StorageIndex StorageIndex;
72 typedef internal::LLT_Traits<MatrixType,UpLo> Traits;
78 * perform decompositions via LLT::compute(const MatrixType
[all...]
/external/eigen/Eigen/src/CholmodSupport/
H A DCholmodSupport.h180 typedef _MatrixType MatrixType; typedef in class:Eigen::CholmodBase
182 typedef typename MatrixType::Scalar Scalar;
183 typedef typename MatrixType::RealScalar RealScalar;
184 typedef MatrixType CholMatrixType;
185 typedef typename MatrixType::StorageIndex StorageIndex;
187 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
188 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
201 explicit CholmodBase(const MatrixType& matrix)
232 Derived& compute(const MatrixType& matrix)
245 void analyzePattern(const MatrixType
441 typedef _MatrixType MatrixType; typedef in class:Eigen::CholmodSimplicialLLT
492 typedef _MatrixType MatrixType; typedef in class:Eigen::CholmodSimplicialLDLT
541 typedef _MatrixType MatrixType; typedef in class:Eigen::CholmodSupernodalLLT
592 typedef _MatrixType MatrixType; typedef in class:Eigen::CholmodDecomposition
[all...]
/external/eigen/Eigen/src/Core/
H A DConditionEstimator.h58 typedef typename Decomposition::MatrixType MatrixType; typedef
61 typedef typename internal::plain_col_type<MatrixType>::type Vector;
62 typedef typename internal::plain_col_type<MatrixType, RealScalar>::type RealVector;
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 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 ref_selector<MatrixType>::non_const_type MatrixTypeNested;
37 typedef MatrixType ExpressionType;
38 typedef typename MatrixType::PlainObject FullMatrixType;
41 FlagsLvalueBit = is_lvalue<MatrixType>::value ? LvalueBit : 0,
54 typedef _MatrixType MatrixType; typedef in class:Eigen::SelfAdjointView
62 typedef typename MatrixType
[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/Eigenvalues/
H A DComplexEigenSolver.h50 typedef _MatrixType MatrixType; typedef in class:Eigen::ComplexEigenSolver
53 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
54 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
55 Options = MatrixType::Options,
56 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
57 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
60 /** \brief Scalar type for matrices of type #MatrixType. */
61 typedef typename MatrixType::Scalar Scalar;
65 /** \brief Complex scalar type for #MatrixType.
76 * The length of the vector is the size of #MatrixType
[all...]
H A DComplexSchur.h20 template<typename MatrixType, bool IsComplex> struct complex_schur_reduce_to_hessenberg;
42 * ComplexSchur(const MatrixType&, bool) constructor which computes
54 typedef _MatrixType MatrixType; typedef in class:Eigen::ComplexSchur
56 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
57 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
58 Options = MatrixType::Options,
59 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
60 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
64 typedef typename MatrixType::Scalar Scalar;
129 * ComplexSchur(const MatrixType
[all...]
H A DEigenSolver.h48 * EigenSolver(const MatrixType&, bool) constructor which computes the
55 * The documentation for EigenSolver(const MatrixType&, bool) contains an
69 typedef _MatrixType MatrixType; typedef in class:Eigen::EigenSolver
72 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
73 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
74 Options = MatrixType::Options,
75 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
76 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
79 /** \brief Scalar type for matrices of type #MatrixType. */
80 typedef typename MatrixType
[all...]
H A DGeneralizedEigenSolver.h47 * GeneralizedEigenSolver(const MatrixType&, const MatrixType&, bool) constructor which computes the
63 typedef _MatrixType MatrixType; typedef in class:Eigen::GeneralizedEigenSolver
66 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
67 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
68 Options = MatrixType::Options,
69 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
70 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
73 /** \brief Scalar type for matrices of type #MatrixType. */
74 typedef typename MatrixType
[all...]
H A DGeneralizedSelfAdjointEigenSolver.h37 * GeneralizedSelfAdjointEigenSolver(const MatrixType&, const MatrixType&, int)
42 * The documentation for GeneralizedSelfAdjointEigenSolver(const MatrixType&, const MatrixType&, int)
53 typedef _MatrixType MatrixType; typedef in class:Eigen::GeneralizedSelfAdjointEigenSolver
89 * This constructor calls compute(const MatrixType&, const MatrixType&, int)
104 * \sa compute(const MatrixType&, const MatrixType&, int)
106 GeneralizedSelfAdjointEigenSolver(const MatrixType
[all...]
H A DHessenbergDecomposition.h18 template<typename MatrixType> struct HessenbergDecompositionMatrixHReturnType;
19 template<typename MatrixType>
20 struct traits<HessenbergDecompositionMatrixHReturnType<MatrixType> >
22 typedef MatrixType ReturnType;
47 * HessenbergDecomposition(const MatrixType&) constructor which computes the
62 typedef _MatrixType MatrixType; typedef in class:Eigen::HessenbergDecomposition
65 Size = MatrixType::RowsAtCompileTime,
67 Options = MatrixType::Options,
68 MaxSize = MatrixType::MaxRowsAtCompileTime,
72 /** \brief Scalar type for matrices of type #MatrixType
[all...]
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 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;
120 * \pre Either the constructor RealSchur(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...]
H A DTridiagonalization.h18 template<typename MatrixType> struct TridiagonalizationMatrixTReturnType;
19 template<typename MatrixType>
20 struct traits<TridiagonalizationMatrixTReturnType<MatrixType> >
21 : public traits<typename MatrixType::PlainObject>
23 typedef typename MatrixType::PlainObject ReturnType; // FIXME shall it be a BandMatrix?
27 template<typename MatrixType, typename CoeffVectorType>
28 void tridiagonalization_inplace(MatrixType& matA, CoeffVectorType& hCoeffs);
52 * given matrix. Alternatively, you can use the Tridiagonalization(const MatrixType&)
58 * The documentation of Tridiagonalization(const MatrixType&) contains an
68 typedef _MatrixType MatrixType; typedef in class:Eigen::Tridiagonalization
[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...]
H A DUmeyama.h31 template<typename MatrixType, typename OtherMatrixType>
35 MinRowsAtCompileTime = EIGEN_SIZE_MIN_PREFER_DYNAMIC(MatrixType::RowsAtCompileTime, OtherMatrixType::RowsAtCompileTime),
42 typedef Matrix<typename traits<MatrixType>::Scalar,
45 AutoAlign | (traits<MatrixType>::Flags & RowMajorBit ? RowMajor : ColMajor),
108 typedef Matrix<Scalar, Dimension, Dimension> MatrixType; typedef
129 const MatrixType sigma = one_over_n * dst_demean * src_demean.transpose();
131 JacobiSVD<MatrixType> svd(sigma, ComputeFullU | ComputeFullV);
/external/eigen/Eigen/src/IterativeLinearSolvers/
H A DBiCGSTAB.h28 template<typename MatrixType, typename Rhs, typename Dest, typename Preconditioner>
29 bool bicgstab(const MatrixType& mat, const Rhs& rhs, Dest& x,
120 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
167 typedef _MatrixType MatrixType; typedef in class:Eigen::BiCGSTAB
168 typedef typename MatrixType::Scalar Scalar;
169 typedef typename MatrixType::RealScalar RealScalar;
H A DConjugateGradient.h26 template<typename MatrixType, typename Rhs, typename Dest, typename Preconditioner>
28 void conjugate_gradient(const MatrixType& mat, const Rhs& rhs, Dest& x,
103 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
166 typedef _MatrixType MatrixType; typedef in class:Eigen::ConjugateGradient
167 typedef typename MatrixType::Scalar Scalar;
168 typedef typename MatrixType::RealScalar RealScalar;
204 && (!MatrixType::IsRowMajor)
H A DIterativeSolverBase.h17 template<typename MatrixType>
36 static MatrixType ms_from;
37 enum { value = sizeof(test<MatrixType>(ms_from, 0))==sizeof(yes) };
40 template<typename MatrixType>
43 enum { value = is_ref_compatible_impl<typename remove_all<MatrixType>::type>::value };
46 template<typename MatrixType, bool MatrixFree = !internal::is_ref_compatible<MatrixType>::value>
50 template<typename MatrixType>
51 class generic_matrix_wrapper<MatrixType,false>
54 typedef Ref<const MatrixType> ActualMatrixTyp
150 typedef typename internal::traits<Derived>::MatrixType MatrixType; typedef in class:Eigen::IterativeSolverBase
[all...]
H A DLeastSquareConjugateGradient.h26 template<typename MatrixType, typename Rhs, typename Dest, typename Preconditioner>
28 void least_square_conjugate_gradient(const MatrixType& mat, const Rhs& rhs, Dest& x,
105 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
158 typedef _MatrixType MatrixType; typedef in class:Eigen::LeastSquaresConjugateGradient
159 typedef typename MatrixType::Scalar Scalar;
160 typedef typename MatrixType::RealScalar RealScalar;
/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...]
H A DInverseImpl.h22 template<typename MatrixType, typename ResultType, int Size = MatrixType::RowsAtCompileTime>
26 static inline void run(const MatrixType& matrix, ResultType& result)
32 template<typename MatrixType, typename ResultType, int Size = MatrixType::RowsAtCompileTime>
39 template<typename MatrixType, typename ResultType>
40 struct compute_inverse<MatrixType, ResultType, 1>
43 static inline void run(const MatrixType& matrix, ResultType& result)
45 typedef typename MatrixType::Scalar Scalar;
46 internal::evaluator<MatrixType> matrixEva
377 >::type MatrixType; typedef
[all...]

Completed in 341 milliseconds

1234