HomeSort by relevance Sort by last modified time
    Searched refs:MatrixType (Results 76 - 100 of 241) sorted by null

1 2 34 5 6 7 8 910

  /external/eigen/test/
spqr_support.cpp 12 template<typename MatrixType,typename DenseMat>
13 int generate_sparse_rectangular_problem(MatrixType& A, DenseMat& dA, int maxRows = 300, int maxCols = 300)
16 typedef typename MatrixType::Scalar Scalar;
30 typedef SparseMatrix<Scalar,ColMajor> MatrixType;
31 MatrixType A;
35 SPQR<MatrixType> solver;
integer_types.cpp 19 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& m
    [all...]
jacobi.cpp 14 template<typename MatrixType, typename JacobiScalar>
15 void jacobi(const MatrixType& m = MatrixType())
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 b = a
    [all...]
array_reverse.cpp 16 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, BothDirections> m1_rb(m1)
    [all...]
cwiseop.cpp 33 template<typename MatrixType>
34 typename Eigen::internal::enable_if<!NumTraits<typename MatrixType::Scalar>::IsInteger,typename MatrixType::Scalar>::type
35 cwiseops_real_only(MatrixType& m1, MatrixType& m2, MatrixType& m3, MatrixType& mones)
37 typedef typename MatrixType::Scalar Scalar;
61 template<typename MatrixType>
62 typename Eigen::internal::enable_if<NumTraits<typename MatrixType::Scalar>::IsInteger,typename MatrixType::Scalar>::typ
    [all...]
  /external/eigen/unsupported/Eigen/src/Skyline/
SkylineInplaceLU.h 21 * \param MatrixType the type of the matrix of which we are computing the LU factorization
24 template<typename MatrixType>
27 typedef typename MatrixType::Scalar Scalar;
28 typedef typename MatrixType::Index Index;
30 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
36 SkylineInplaceLU(MatrixType& matrix, int flags = 0)
93 //inline const MatrixType& matrixL() const { return m_matrixL; }
96 //inline const MatrixType& matrixU() const { return m_matrixU; }
112 MatrixType& m_lu;
118 template<typename MatrixType>
    [all...]
  /external/eigen/Eigen/src/SparseCore/
SparseTriangularView.h 18 template<typename MatrixType, int Mode>
19 struct traits<SparseTriangularView<MatrixType,Mode> >
20 : public traits<MatrixType>
25 template<typename MatrixType, int Mode> class SparseTriangularView
26 : public SparseMatrixBase<SparseTriangularView<MatrixType,Mode> >
28 enum { SkipFirst = ((Mode&Lower) && !(MatrixType::Flags&RowMajorBit))
29 || ((Mode&Upper) && (MatrixType::Flags&RowMajorBit)),
45 typedef typename MatrixType::Nested MatrixTypeNested;
49 inline SparseTriangularView(const MatrixType& matrix) : m_matrix(matrix) {}
65 template<typename MatrixType, int Mode
    [all...]
SparseSelfAdjointView.h 20 * \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,int DestOrder
    [all...]
  /external/eigen/test/eigen2/
eigen2_basicstuff.cpp 12 template<typename MatrixType> void basicStuff(const MatrixType& m)
14 typedef typename MatrixType::Scalar Scalar;
15 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
22 MatrixType m1 = MatrixType::Random(rows, cols),
23 m2 = MatrixType::Random(rows, cols),
25 mzero = MatrixType::Zero(rows, cols),
26 square = Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime>::Random(rows, rows)
    [all...]
eigen2_cholesky.cpp 19 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::Random(rows,cols), matX(rows,cols)
    [all...]
eigen2_array.cpp 13 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> void comparisons(const MatrixType& m
    [all...]
eigen2_submatrices.cpp 18 typedef Matrix<Scalar, _Rows, _Cols> MatrixType;
19 CheckMinor(MatrixType& m1, int r1, int c1)
35 typedef Matrix<Scalar, 1, 1> MatrixType;
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::ColsAtCompileTime> RowVectorType
    [all...]
  /external/eigen/Eigen/src/QR/
HouseholderQR.h 24 * \param MatrixType the type of the matrix of which we are computing the QR decomposition
46 typedef _MatrixType MatrixType;
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::Index Index
    [all...]
ColPivHouseholderQR.h 22 * \param MatrixType the type of the matrix of which we are computing the QR decomposition
41 typedef _MatrixType MatrixType;
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::Index Index
    [all...]
  /external/eigen/Eigen/src/Core/
DiagonalProduct.h 17 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::Scalar, typename DiagonalType::Scalar>::value
    [all...]
Replicate.h 21 * \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::RowsAtCompileTime
    [all...]
  /external/eigen/Eigen/src/SVD/
UpperBidiagonalization.h 23 typedef _MatrixType MatrixType;
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,1>
    [all...]
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixFunction.h 21 * \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,1> and then converts the result back t
    [all...]
  /external/eigen/Eigen/src/Eigenvalues/
MatrixBaseEigenvalues.h 87 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
GeneralizedEigenSolver.h 46 * GeneralizedEigenSolver(const MatrixType&, const MatrixType&, bool) constructor which computes the
62 typedef _MatrixType MatrixType;
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::Scalar Scalar
    [all...]
  /external/eigen/bench/
bench_reverse.cpp 17 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/
BasicPreconditioners.h 41 typedef Matrix<Scalar,Dynamic,Dynamic> MatrixType;
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/
MetisSupport.h 28 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/
bench_svd.cpp 33 template<typename MatrixType>
34 void bench_svd(const MatrixType& a = MatrixType())
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/
SelfadjointProduct.h 47 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,OtherType,UpLo,false
    [all...]

Completed in 1399 milliseconds

1 2 34 5 6 7 8 910