Searched refs:MatrixType (Results 51 - 75 of 208) sorted by relevance

123456789

/external/eigen/test/
H A Dspqr_support.cpp14 template<typename MatrixType,typename DenseMat>
15 int generate_sparse_rectangular_problem(MatrixType& A, DenseMat& dA, int maxRows = 300, int maxCols = 300)
18 typedef typename MatrixType::Scalar Scalar;
32 typedef SparseMatrix<Scalar,ColMajor> MatrixType; typedef
33 MatrixType A;
37 SPQR<MatrixType> solver;
H A Dinteger_types.cpp19 template<typename MatrixType> void signed_integer_type_tests(const MatrixType& m)
21 typedef typename MatrixType::Index Index;
22 typedef typename MatrixType::Scalar Scalar;
30 MatrixType m1(rows, cols),
31 m2 = MatrixType::Random(rows, cols),
32 mzero = MatrixType::Zero(rows, cols);
35 m1 = MatrixType::Random(rows, cols);
50 template<typename MatrixType> void integer_type_tests(const MatrixType
[all...]
H A Djacobi.cpp14 template<typename MatrixType, typename JacobiScalar>
15 void jacobi(const MatrixType& m = MatrixType()) argument
17 typedef typename MatrixType::Index Index;
22 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
23 ColsAtCompileTime = MatrixType::ColsAtCompileTime
28 const MatrixType a(MatrixType::Random(rows, cols));
41 MatrixType b = a;
54 MatrixType
[all...]
H A Dreal_qz.cpp15 template<typename MatrixType> void real_qz(const MatrixType& m)
21 typedef typename MatrixType::Index Index;
22 typedef typename MatrixType::Scalar Scalar;
26 MatrixType A = MatrixType::Random(dim,dim),
27 B = MatrixType::Random(dim,dim);
45 RealQZ<MatrixType> qz(dim);
75 VERIFY_IS_APPROX(qz.matrixQ()*qz.matrixQ().adjoint(), MatrixType::Identity(dim,dim));
76 VERIFY_IS_APPROX(qz.matrixZ()*qz.matrixZ().adjoint(), MatrixType
[all...]
H A Ddiagonal.cpp12 template<typename MatrixType> void diagonal(const MatrixType& m)
14 typedef typename MatrixType::Index Index;
15 typedef typename MatrixType::Scalar Scalar;
20 MatrixType m1 = MatrixType::Random(rows, cols),
21 m2 = MatrixType::Random(rows, cols);
33 N1 = MatrixType::RowsAtCompileTime>2 ? 2 : 0,
34 N2 = MatrixType::RowsAtCompileTime>1 ? -1 : 0
38 if(MatrixType
[all...]
H A Deigensolver_selfadjoint.cpp18 template<typename MatrixType> void selfadjointeigensolver_essential_check(const MatrixType& m)
20 typedef typename MatrixType::Scalar Scalar;
24 SelfAdjointEigenSolver<MatrixType> eiSymm(m);
43 SelfAdjointEigenSolver<MatrixType> eiDirect;
69 template<typename MatrixType> void selfadjointeigensolver(const MatrixType& m)
71 typedef typename MatrixType::Index Index;
78 typedef typename MatrixType::Scalar Scalar;
83 MatrixType
[all...]
H A Dinplace_decomposition.cpp17 template<typename DecType,typename MatrixType> void inplace(bool square = false, bool SPD = false)
19 typedef typename MatrixType::Scalar Scalar;
20 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> RhsType;
21 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> ResType;
23 Index rows = MatrixType::RowsAtCompileTime==Dynamic ? internal::random<Index>(2,EIGEN_TEST_MAX_SIZE/2) : Index(MatrixType::RowsAtCompileTime);
24 Index cols = MatrixType::ColsAtCompileTime==Dynamic ? (square?rows:internal::random<Index>(2,rows)) : Index(MatrixType::ColsAtCompileTime);
26 MatrixType A = MatrixType
[all...]
H A Darray_replicate.cpp12 template<typename MatrixType> void replicate(const MatrixType& m)
17 typedef typename MatrixType::Index Index;
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);
/external/eigen/Eigen/src/QR/
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...]
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 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...]
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...]
/external/eigen/Eigen/src/SVD/
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...]
/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/Eigenvalues/
H A DMatrixBaseEigenvalues.h87 template<typename MatrixType, unsigned int UpLo>
88 inline typename SelfAdjointView<MatrixType, UpLo>::EigenvaluesReturnType
89 SelfAdjointView<MatrixType, UpLo>::eigenvalues() const
91 typedef typename SelfAdjointView<MatrixType, UpLo>::PlainObject PlainObject;
151 template<typename MatrixType, unsigned int UpLo>
152 inline typename SelfAdjointView<MatrixType, UpLo>::RealScalar
153 SelfAdjointView<MatrixType, UpLo>::operatorNorm() const
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...]
/external/eigen/bench/
H A Dbench_reverse.cpp17 template <typename MatrixType>
18 __attribute__ ((noinline)) void bench_reverse(const MatrixType& m)
25 MatrixType a = MatrixType::Random(rows,cols);
26 MatrixType b = MatrixType::Random(rows,cols);
46 if (MatrixType::RowsAtCompileTime==Dynamic)
H A DBenchUtil.h21 template<typename MatrixType> void initMatrix_random(MatrixType& mat) __attribute__((noinline));
22 template<typename MatrixType> void initMatrix_random(MatrixType& mat)
24 mat.setRandom();// = MatrixType::random(mat.rows(), mat.cols());
27 template<typename MatrixType> void initMatrix_identity(MatrixType& mat) __attribute__((noinline));
28 template<typename MatrixType> void initMatrix_identity(MatrixType& mat)
/external/eigen/unsupported/test/
H A Dmatrix_power.cpp69 template<typename MatrixType>
70 void testGeneral(const MatrixType& m, const typename MatrixType::RealScalar& tol)
72 typedef typename MatrixType::RealScalar RealScalar;
73 MatrixType m1, m2, m3, m4, m5;
77 generateTestMatrix<MatrixType>::run(m1, m.rows());
78 MatrixPower<MatrixType> mpow(m1);
99 template<typename MatrixType>
100 void testSingular(const MatrixType& m_const, const typename MatrixType
[all...]
/external/eigen/Eigen/src/LU/
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/MetisSupport/
H A DMetisSupport.h28 template <typename MatrixType>
29 void get_symmetrized_graph(const MatrixType& A)
34 MatrixType At = A.transpose();
44 for (typename MatrixType::InnerIterator it(A, j); it; ++it)
54 for (typename MatrixType::InnerIterator it(At, j); it; ++it)
77 for (typename MatrixType::InnerIterator it(A,j); it; ++it)
88 for (typename MatrixType::InnerIterator it(At, j); it; ++it)
102 template <typename MatrixType>
103 void operator() (const MatrixType& A, PermutationType& matperm)
/external/eigen/unsupported/bench/
H A Dbench_svd.cpp33 template<typename MatrixType>
34 void bench_svd(const MatrixType& a = MatrixType()) argument
36 MatrixType m = MatrixType::Random(a.rows(), a.cols());
48 BDCSVD<MatrixType> bdc_matrix(m);
55 JacobiSVD<MatrixType> jacobi_matrix(m);
79 BDCSVD<MatrixType> bdc_matrix(m, ComputeFullU|ComputeFullV);
86 JacobiSVD<MatrixType> jacobi_matrix(m, ComputeFullU|ComputeFullV);
/external/eigen/doc/examples/
H A Dmake_circulant2.cpp29 ArgType::MaxSizeAtCompileTime> MatrixType; typedef in struct:circulant_helper
35 CwiseNullaryOp<circulant_functor<ArgType>, typename circulant_helper<ArgType>::MatrixType>
38 typedef typename circulant_helper<ArgType>::MatrixType MatrixType; typedef
39 return MatrixType::NullaryExpr(arg.size(), arg.size(), circulant_functor<ArgType>(arg.derived()));
/external/eigen/Eigen/src/Core/products/
H A DSelfadjointProduct.h47 template<typename MatrixType, typename OtherType, int UpLo, bool OtherIsVector = OtherType::IsVectorAtCompileTime>
50 template<typename MatrixType, typename OtherType, int UpLo>
51 struct selfadjoint_product_selector<MatrixType,OtherType,UpLo,true>
53 static void run(MatrixType& mat, const OtherType& other, const typename MatrixType::Scalar& alpha)
55 typedef typename MatrixType::Scalar Scalar;
64 StorageOrder = (internal::traits<MatrixType>::Flags&RowMajorBit) ? RowMajor : ColMajor,
82 template<typename MatrixType, typename OtherType, int UpLo>
83 struct selfadjoint_product_selector<MatrixType,OtherType,UpLo,false>
85 static void run(MatrixType
[all...]
/external/eigen/Eigen/src/Householder/
H A DBlockHouseholder.h78 template<typename MatrixType,typename VectorsType,typename CoeffsType>
79 void apply_block_householder_on_the_left(MatrixType& mat, const VectorsType& vectors, const CoeffsType& hCoeffs, bool forward)
81 enum { TFactorSize = MatrixType::ColsAtCompileTime };
83 Matrix<typename MatrixType::Scalar, TFactorSize, TFactorSize, RowMajor> T(nbVecs,nbVecs);
90 Matrix<typename MatrixType::Scalar,VectorsType::ColsAtCompileTime,MatrixType::ColsAtCompileTime,
91 (VectorsType::MaxColsAtCompileTime==1 && MatrixType::MaxColsAtCompileTime!=1)?RowMajor:ColMajor,
92 VectorsType::MaxColsAtCompileTime,MatrixType::MaxColsAtCompileTime> tmp = V.adjoint() * mat;

Completed in 280 milliseconds

123456789