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

1234

/external/eigen/Eigen/src/IterativeLinearSolvers/
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 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;
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...]
/external/eigen/Eigen/src/LU/
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...]
H A DPartialPivLU.h80 typedef _MatrixType MatrixType; typedef in class:Eigen::PartialPivLU
85 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
86 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
90 typedef typename MatrixType::PlainObject PlainObject;
96 * perform decompositions via PartialPivLU::compute(const MatrixType&).
141 inline const MatrixType& matrixLU() const
218 MatrixType reconstructedMatrix() const;
283 MatrixType m_lu;
291 template<typename MatrixType>
292 PartialPivLU<MatrixType>
351 typedef Block<MapLU, Dynamic, Dynamic> MatrixType; typedef in struct:Eigen::internal::partial_lu_impl
[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
110 typedef typename Traits::MatrixType MatrixType; typedef in class:Eigen::PardisoImpl
116 typedef Matrix<StorageIndex, 1, MatrixType::ColsAtCompileTime> IntRowVectorType;
117 typedef Matrix<StorageIndex, MatrixType::RowsAtCompileTime, 1> IntColVectorType;
166 Derived& analyzePattern(const MatrixType& matrix);
174 Derived& factorize(const MatrixType& matrix);
176 Derived& compute(const MatrixType
[all...]
/external/eigen/Eigen/src/QR/
H A DHouseholderQR.h48 typedef _MatrixType MatrixType; typedef in class:Eigen::HouseholderQR
50 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
51 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
52 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
53 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
55 typedef typename MatrixType::Scalar Scalar;
56 typedef typename MatrixType::RealScalar RealScalar;
58 typedef typename MatrixType::StorageIndex StorageIndex;
59 typedef Matrix<Scalar, RowsAtCompileTime, RowsAtCompileTime, (MatrixType::Flags&RowMajorBit) ? RowMajor : ColMajor, MaxRowsAtCompileTime, MaxRowsAtCompileTime> MatrixQType;
60 typedef typename internal::plain_diag_type<MatrixType>
[all...]
H A DColPivHouseholderQR.h52 typedef _MatrixType MatrixType; typedef in class:Eigen::ColPivHouseholderQR
54 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
55 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
56 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
57 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
59 typedef typename MatrixType::Scalar Scalar;
60 typedef typename MatrixType::RealScalar RealScalar;
62 typedef typename MatrixType::StorageIndex StorageIndex;
63 typedef typename internal::plain_diag_type<MatrixType>::type HCoeffsType;
65 typedef typename internal::plain_row_type<MatrixType, Inde
[all...]
H A DCompleteOrthogonalDecomposition.h30 * \param MatrixType the type of the matrix of which we are computing the COD.
50 typedef _MatrixType MatrixType; typedef in class:Eigen::CompleteOrthogonalDecomposition
52 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
53 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
54 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
55 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
57 typedef typename MatrixType::Scalar Scalar;
58 typedef typename MatrixType::RealScalar RealScalar;
59 typedef typename MatrixType::StorageIndex StorageIndex;
60 typedef typename internal::plain_diag_type<MatrixType>
[all...]
/external/eigen/Eigen/src/SVD/
H A DSVDBase.h52 typedef typename internal::traits<Derived>::MatrixType MatrixType; typedef in class:Eigen::SVDBase
53 typedef typename MatrixType::Scalar Scalar;
54 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
55 typedef typename MatrixType::StorageIndex StorageIndex;
58 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
59 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
61 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
62 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime,
64 MatrixOptions = MatrixType
[all...]
H A DUpperBidiagonalization.h24 typedef _MatrixType MatrixType; typedef in class:Eigen::internal::UpperBidiagonalization
26 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
27 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
30 typedef typename MatrixType::Scalar Scalar;
31 typedef typename MatrixType::RealScalar RealScalar;
39 const MatrixType,
40 const typename internal::remove_all<typename Diagonal<const MatrixType,0>::ConjugateReturnType>::type
43 const typename internal::remove_all<typename MatrixType::ConjugateReturnType>::type,
44 Diagonal<const MatrixType,1>,
52 * perform decompositions via Bidiagonalization::compute(const MatrixType
152 upperbidiagonalization_blocked_helper(MatrixType& A, typename MatrixType::RealScalar *diagonal, typename MatrixType::RealScalar *upper_diagonal, Index bs, Ref<Matrix<typename MatrixType::Scalar, Dynamic, Dynamic, traits<MatrixType>::Flags & RowMajorBit> > X, Ref<Matrix<typename MatrixType::Scalar, Dynamic, Dynamic, traits<MatrixType>::Flags & RowMajorBit> > Y) argument
[all...]
H A DJacobiSVD.h19 template<typename MatrixType, int QRPreconditioner,
20 bool IsComplex = NumTraits<typename MatrixType::Scalar>::IsComplex>
32 template<typename MatrixType, int QRPreconditioner, int Case>
35 enum { a = MatrixType::RowsAtCompileTime != Dynamic &&
36 MatrixType::ColsAtCompileTime != Dynamic &&
37 MatrixType::ColsAtCompileTime <= MatrixType::RowsAtCompileTime,
38 b = MatrixType::RowsAtCompileTime != Dynamic &&
39 MatrixType::ColsAtCompileTime != Dynamic &&
40 MatrixType
56 run(JacobiSVD<MatrixType, QRPreconditioner>&, const MatrixType&) argument
429 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
493 typedef _MatrixType MatrixType; typedef in class:Eigen::JacobiSVD
[all...]
/external/eigen/blas/
H A Dcommon.h95 typedef Map<Matrix<Scalar,Dynamic,Dynamic,ColMajor>, 0, OuterStride<> > MatrixType; typedef
/external/eigen/test/
H A Dgeo_hyperplane.cpp29 HyperplaneType::AmbientDimAtCompileTime> MatrixType; typedef
57 MatrixType rot = MatrixType::Random(dim,dim).householderQr().householderQ();
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DGMRES.h55 template<typename MatrixType, typename Rhs, typename Dest, typename Preconditioner>
56 bool gmres(const MatrixType & mat, const Rhs & rhs, Dest & x, const Preconditioner & precond,
219 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
274 typedef _MatrixType MatrixType; typedef in class:Eigen::GMRES
275 typedef typename MatrixType::Scalar Scalar;
276 typedef typename MatrixType::RealScalar RealScalar;
H A DMINRES.h29 template<typename MatrixType, typename Rhs, typename Dest, typename Preconditioner>
31 void minres(const MatrixType& mat, const Rhs& rhs, Dest& x,
154 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::traits
210 typedef _MatrixType MatrixType; typedef in class:Eigen::MINRES
211 typedef typename MatrixType::Scalar Scalar;
212 typedef typename MatrixType::RealScalar RealScalar;
247 && (!MatrixType::IsRowMajor)
/external/eigen/unsupported/Eigen/src/MatrixFunctions/
H A DMatrixExponential.h67 typedef typename MatA::PlainObject MatrixType; typedef
70 const MatrixType A2 = A * A;
71 const MatrixType tmp = b[3] * A2 + b[1] * MatrixType::Identity(A.rows(), A.cols());
73 V = b[2] * A2 + b[0] * MatrixType::Identity(A.rows(), A.cols());
84 typedef typename MatA::PlainObject MatrixType; typedef
85 typedef typename NumTraits<typename traits<MatrixType>::Scalar>::Real RealScalar;
87 const MatrixType A2 = A * A;
88 const MatrixType A4 = A2 * A2;
89 const MatrixType tm
102 typedef typename MatA::PlainObject MatrixType; typedef
123 typedef typename MatA::PlainObject MatrixType; typedef
145 typedef typename MatA::PlainObject MatrixType; typedef
173 typedef typename MatA::PlainObject MatrixType; typedef
354 typedef typename ArgType::PlainObject MatrixType; typedef
[all...]
/external/eigen/unsupported/Eigen/src/SparseExtra/
H A DMatrixMarketIterator.h47 typedef SparseMatrix<Scalar,ColMajor> MatrixType; typedef in class:Eigen::MatrixMarketIterator
74 inline MatrixType& matrix()
97 MatrixType tmp(m_mat);
103 MatrixType tmp(m_mat);
231 MatrixType m_mat; // Current matrix
/external/eigen/unsupported/Eigen/src/Splines/
H A DSplineFitting.h295 typedef Matrix<Scalar,Dynamic,Dynamic> MatrixType; typedef
301 MatrixType A = MatrixType::Zero(n,n);
312 HouseholderQR<MatrixType> qr(A);
315 ControlPointVectorType ctrls = qr.solve(MatrixType(pts.transpose())).transpose();
341 typedef Matrix<Scalar, Dynamic, Dynamic> MatrixType; typedef
350 MatrixType A = MatrixType::Zero(n, n);
353 MatrixType b(points.rows(), n);
408 FullPivLU<MatrixType> l
[all...]
/external/eigen/Eigen/src/Cholesky/
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 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...]
/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;
120 * \pre Either the constructor RealSchur(const MatrixType
[all...]
/external/eigen/Eigen/src/PaStiXSupport/
H A DPaStiXSupport.h43 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::pastix_traits
52 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::pastix_traits
61 typedef _MatrixType MatrixType; typedef in struct:Eigen::internal::pastix_traits
96 template <typename MatrixType>
97 void c_to_fortran_numbering (MatrixType& mat)
110 template <typename MatrixType>
111 void fortran_to_c_numbering (MatrixType& mat)
137 typedef typename internal::pastix_traits<Derived>::MatrixType _MatrixType;
138 typedef _MatrixType MatrixType; typedef in class:Eigen::PastixBase
139 typedef typename MatrixType
415 typedef _MatrixType MatrixType; typedef in class:Eigen::PastixLU
527 typedef _MatrixType MatrixType; typedef in class:Eigen::PastixLLT
611 typedef _MatrixType MatrixType; typedef in class:Eigen::PastixLDLT
[all...]
/external/eigen/Eigen/src/SPQRSupport/
H A DSuiteSparseQRSupport.h16 template<typename MatrixType> class SPQR;
23 typedef typename SPQRType::MatrixType ReturnType;
27 typedef typename SPQRType::MatrixType ReturnType;
69 typedef SparseMatrix<Scalar, ColMajor, StorageIndex> MatrixType; typedef in class:Eigen::SPQR
107 MatrixType mat(matrix);
179 const MatrixType matrixR() const
183 m_R = viewAsEigen<Scalar,ColMajor, typename MatrixType::StorageIndex>(*m_cR);
240 mutable MatrixType m_R; // The sparse matrix R in Eigen format

Completed in 1807 milliseconds

1234