Searched refs:MatrixType (Results 76 - 100 of 242) sorted by relevance

12345678910

/external/eigen/Eigen/src/Geometry/
H A DHomogeneous.h21 * \param MatrixType the type of the object in which we are making homogeneous
32 template<typename MatrixType,int Direction>
33 struct traits<Homogeneous<MatrixType,Direction> >
34 : traits<MatrixType>
36 typedef typename traits<MatrixType>::StorageKind StorageKind;
37 typedef typename nested<MatrixType>::type MatrixTypeNested;
40 RowsPlusOne = (MatrixType::RowsAtCompileTime != Dynamic) ?
41 int(MatrixType::RowsAtCompileTime) + 1 : Dynamic,
42 ColsPlusOne = (MatrixType::ColsAtCompileTime != Dynamic) ?
43 int(MatrixType
[all...]
/external/eigen/test/eigen2/
H A Deigen2_submatrices.cpp18 typedef Matrix<Scalar, _Rows, _Cols> MatrixType; typedef in struct:CheckMinor
19 CheckMinor(MatrixType& m1, int r1, int c1)
35 typedef Matrix<Scalar, 1, 1> MatrixType; typedef in struct:CheckMinor
36 CheckMinor(MatrixType&, int, int) {}
39 template<typename MatrixType> void submatrices(const MatrixType& m)
44 typedef typename MatrixType::Scalar Scalar;
45 typedef typename MatrixType::RealScalar RealScalar;
46 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
47 typedef Matrix<Scalar, 1, MatrixType
[all...]
H A Deigen2_cholesky.cpp19 template<typename MatrixType> void cholesky(const MatrixType& m)
27 typedef typename MatrixType::Scalar Scalar;
29 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType;
30 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
32 MatrixType a0 = MatrixType::Random(rows,cols);
34 MatrixType matB = MatrixType
[all...]
H A Deigen2_array.cpp13 template<typename MatrixType> void array(const MatrixType& m)
19 typedef typename MatrixType::Scalar Scalar;
21 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
26 MatrixType m1 = MatrixType::Random(rows, cols),
27 m2 = MatrixType::Random(rows, cols),
35 VERIFY_IS_APPROX(m1.cwise() + s1, MatrixType::Constant(rows,cols,s1) + m1);
36 VERIFY_IS_APPROX((m1*Scalar(2)).cwise() - s2, (m1+m1) - MatrixType::Constant(rows,cols,s2) );
52 template<typename MatrixType> voi
[all...]
/external/eigen/test/
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 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);
31 N1 = MatrixType::RowsAtCompileTime>2 ? 2 : 0,
32 N2 = MatrixType::RowsAtCompileTime>1 ? -1 : 0
36 if(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 Darray_reverse.cpp16 template<typename MatrixType> void reverse(const MatrixType& m)
18 typedef typename MatrixType::Index Index;
19 typedef typename MatrixType::Scalar Scalar;
20 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
27 MatrixType m1 = MatrixType::Random(rows, cols);
30 MatrixType m1_r = m1.reverse();
38 Reverse<MatrixType> m1_rd(m1);
46 Reverse<MatrixType, BothDirection
[all...]
H A Dcwiseop.cpp31 template<typename MatrixType>
32 typename Eigen::internal::enable_if<!NumTraits<typename MatrixType::Scalar>::IsInteger,typename MatrixType::Scalar>::type
33 cwiseops_real_only(MatrixType& m1, MatrixType& m2, MatrixType& m3, MatrixType& mones)
35 typedef typename MatrixType::Scalar Scalar;
59 template<typename MatrixType>
60 typename Eigen::internal::enable_if<NumTraits<typename MatrixType
[all...]
/external/eigen/Eigen/src/QR/
H A DHouseholderQR.h24 * \param MatrixType the type of the matrix of which we are computing the QR decomposition
46 typedef _MatrixType MatrixType; typedef in class:Eigen::HouseholderQR
48 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
49 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
50 Options = MatrixType::Options,
51 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
52 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
54 typedef typename MatrixType::Scalar Scalar;
55 typedef typename MatrixType::RealScalar RealScalar;
56 typedef typename MatrixType
[all...]
H A DColPivHouseholderQR.h22 * \param MatrixType the type of the matrix of which we are computing the QR decomposition
41 typedef _MatrixType MatrixType; typedef in class:Eigen::ColPivHouseholderQR
43 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
44 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
45 Options = MatrixType::Options,
46 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
47 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
49 typedef typename MatrixType::Scalar Scalar;
50 typedef typename MatrixType::RealScalar RealScalar;
51 typedef typename MatrixType
[all...]
H A DFullPivHouseholderQR.h18 template<typename MatrixType> struct FullPivHouseholderQRMatrixQReturnType;
20 template<typename MatrixType>
21 struct traits<FullPivHouseholderQRMatrixQReturnType<MatrixType> >
23 typedef typename MatrixType::PlainObject ReturnType;
34 * \param MatrixType the type of the matrix of which we are computing the QR decomposition
53 typedef _MatrixType MatrixType; typedef in class:Eigen::FullPivHouseholderQR
55 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
56 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
57 Options = MatrixType::Options,
58 MaxRowsAtCompileTime = MatrixType
[all...]
/external/eigen/Eigen/src/Core/
H A DDiagonalProduct.h17 template<typename MatrixType, typename DiagonalType, int ProductOrder>
18 struct traits<DiagonalProduct<MatrixType, DiagonalType, ProductOrder> >
19 : traits<MatrixType>
21 typedef typename scalar_product_traits<typename MatrixType::Scalar, typename DiagonalType::Scalar>::ReturnType Scalar;
23 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
24 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
25 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
26 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime,
28 _StorageOrder = MatrixType::Flags & RowMajorBit ? RowMajor : ColMajor,
31 _SameTypes = is_same<typename MatrixType
[all...]
H A DReplicate.h21 * \param MatrixType the type of the object we are replicating
31 template<typename MatrixType,int RowFactor,int ColFactor>
32 struct traits<Replicate<MatrixType,RowFactor,ColFactor> >
33 : traits<MatrixType>
35 typedef typename MatrixType::Scalar Scalar;
36 typedef typename traits<MatrixType>::StorageKind StorageKind;
37 typedef typename traits<MatrixType>::XprKind XprKind;
41 typedef typename nested<MatrixType,Factor>::type MatrixTypeNested;
44 RowsAtCompileTime = RowFactor==Dynamic || int(MatrixType::RowsAtCompileTime)==Dynamic
46 : RowFactor * MatrixType
[all...]
/external/eigen/Eigen/src/SVD/
H A DUpperBidiagonalization.h23 typedef _MatrixType MatrixType; typedef in class:Eigen::internal::UpperBidiagonalization
25 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
26 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
29 typedef typename MatrixType::Scalar Scalar;
30 typedef typename MatrixType::RealScalar RealScalar;
31 typedef typename MatrixType::Index Index;
38 const MatrixType,
39 CwiseUnaryOp<internal::scalar_conjugate_op<Scalar>, const Diagonal<const MatrixType,0> >
42 const typename internal::remove_all<typename MatrixType::ConjugateReturnType>::type,
43 Diagonal<const MatrixType,
[all...]
/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...]
/external/eigen/unsupported/Eigen/src/MatrixFunctions/
H A DMatrixFunction.h21 * \tparam MatrixType type of the argument of the matrix function,
34 template <typename MatrixType,
36 int IsComplex = NumTraits<typename internal::traits<MatrixType>::Scalar>::IsComplex>
49 MatrixFunction(const MatrixType& A, AtomicType& atomic);
67 template <typename MatrixType, typename AtomicType>
68 class MatrixFunction<MatrixType, AtomicType, 0>
72 typedef internal::traits<MatrixType> Traits;
76 static const int Options = MatrixType::Options;
90 MatrixFunction(const MatrixType& A, AtomicType& atomic) : m_A(A), m_atomic(atomic) { }
98 * uses MatrixFunction<MatrixType,
[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 DGeneralizedEigenSolver.h46 * GeneralizedEigenSolver(const MatrixType&, const MatrixType&, bool) constructor which computes the
62 typedef _MatrixType MatrixType; typedef in class:Eigen::GeneralizedEigenSolver
65 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
66 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
67 Options = MatrixType::Options,
68 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
69 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
72 /** \brief Scalar type for matrices of type #MatrixType. */
73 typedef typename MatrixType
[all...]
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;
63 typedef typename MatrixType::Index Index;
65 /** \brief Complex scalar type for #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)
/external/eigen/Eigen/src/IterativeLinearSolvers/
H A DBasicPreconditioners.h41 typedef Matrix<Scalar,Dynamic,Dynamic> MatrixType; typedef in class:Eigen::DiagonalPreconditioner
131 template<typename MatrixType>
132 IdentityPreconditioner(const MatrixType& ) {}
134 template<typename MatrixType>
135 IdentityPreconditioner& analyzePattern(const MatrixType& ) { return *this; }
137 template<typename MatrixType>
138 IdentityPreconditioner& factorize(const MatrixType& ) { return *this; }
140 template<typename MatrixType>
141 IdentityPreconditioner& compute(const MatrixType& ) { return *this; }
/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/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;
56 typedef typename MatrixType::Index Index;
65 StorageOrder = (internal::traits<MatrixType>::Flags&RowMajorBit) ? RowMajor : ColMajor,
83 template<typename MatrixType, typename OtherType, int UpLo>
84 struct selfadjoint_product_selector<MatrixType,OtherTyp
[all...]

Completed in 2215 milliseconds

12345678910