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

1 2 3 45 6 7 8 910

  /external/eigen/Eigen/src/Eigenvalues/
ComplexEigenSolver.h 50 typedef _MatrixType MatrixType;
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...]
SelfAdjointEigenSolver.h 55 * SelfAdjointEigenSolver(const MatrixType&, int) constructor which computes
60 * The documentation for SelfAdjointEigenSolver(const MatrixType&, int)
72 typedef _MatrixType MatrixType;
74 Size = MatrixType::RowsAtCompileTime,
75 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
76 Options = MatrixType::Options,
77 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
81 typedef typename MatrixType::Scalar Scalar;
82 typedef typename MatrixType::Index Index;
99 typedef typename internal::plain_col_type<MatrixType, RealScalar>::type RealVectorType
    [all...]
  /external/eigen/unsupported/test/
matrix_power.cpp 12 template <typename MatrixType, int IsComplex = NumTraits<typename MatrixType::Scalar>::IsComplex>
16 template <typename MatrixType>
17 struct generateTriangularMatrix<MatrixType,0>
19 static void run(MatrixType& result, typename MatrixType::Index size)
22 result.template triangularView<Upper>() = MatrixType::Random(size, size);
23 for (typename MatrixType::Index i = 0; i < size; ++i)
29 template <typename MatrixType>
30 struct generateTriangularMatrix<MatrixType,1
    [all...]
  /external/eigen/Eigen/src/SparseCholesky/
SimplicialCholesky.h 39 typedef typename internal::traits<Derived>::MatrixType MatrixType;
42 typedef typename MatrixType::Scalar Scalar;
43 typedef typename MatrixType::RealScalar RealScalar;
44 typedef typename MatrixType::Index Index;
55 SimplicialCholeskyBase(const MatrixType& matrix)
185 void compute(const MatrixType& matrix)
196 void factorize(const MatrixType& a)
208 void analyzePattern(const MatrixType& a, bool doLDLT)
218 void ordering(const MatrixType& a, CholMatrixType& ap)
    [all...]
  /external/eigen/test/
nesting_ops.cpp 12 template <typename MatrixType> void run_nesting_ops(const MatrixType& _m)
14 typename MatrixType::Nested m(_m);
eigen2support.cpp 15 template<typename MatrixType> void eigen2support(const MatrixType& m)
17 typedef typename MatrixType::Index Index;
18 typedef typename MatrixType::Scalar Scalar;
23 MatrixType m1 = MatrixType::Random(rows, cols),
31 VERIFY_IS_APPROX(m1.cwise() + s1, MatrixType::Constant(rows,cols,s1) + m1);
32 VERIFY_IS_APPROX((m1*Scalar(2)).cwise() - s2, (m1+m1) - MatrixType::Constant(rows,cols,s2) );
stddeque.cpp 15 template<typename MatrixType>
16 void check_stddeque_matrix(const MatrixType& m)
18 typedef typename MatrixType::Index Index;
22 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
23 std::deque<MatrixType,Eigen::aligned_allocator<MatrixType> > v(10, MatrixType(rows,cols)), w(20, y);
29 typename std::deque<MatrixType,Eigen::aligned_allocator<MatrixType> >::iterator vi = v.begin()
    [all...]
stdlist.cpp 15 template<typename MatrixType>
16 void check_stdlist_matrix(const MatrixType& m)
18 typedef typename MatrixType::Index Index;
22 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
23 std::list<MatrixType,Eigen::aligned_allocator<MatrixType> > v(10, MatrixType(rows,cols)), w(20, y);
29 typename std::list<MatrixType,Eigen::aligned_allocator<MatrixType> >::iterator vi = v.begin()
    [all...]
array_for_matrix.cpp 12 template<typename MatrixType> void array_for_matrix(const MatrixType& m)
14 typedef typename MatrixType::Index Index;
15 typedef typename MatrixType::Scalar Scalar;
16 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> ColVectorType;
17 typedef Matrix<Scalar, 1, MatrixType::ColsAtCompileTime> RowVectorType;
22 MatrixType m1 = MatrixType::Random(rows, cols),
23 m2 = MatrixType::Random(rows, cols),
34 VERIFY_IS_APPROX((m1.array() + s1).matrix(), MatrixType::Constant(rows,cols,s1) + m1)
    [all...]
householder.cpp 13 template<typename MatrixType> void householder(const MatrixType& m)
15 typedef typename MatrixType::Index Index;
24 typedef typename MatrixType::Scalar Scalar;
26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
27 typedef Matrix<Scalar, internal::decrement_size<MatrixType::RowsAtCompileTime>::ret, 1> EssentialVectorType;
28 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType;
29 typedef Matrix<Scalar, Dynamic, MatrixType::ColsAtCompileTime> HBlockMatrixType;
32 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, MatrixType::RowsAtCompileTime> TMatrixType
    [all...]
mapped_matrix.cpp 47 template<typename MatrixType> void map_class_matrix(const MatrixType& m)
49 typedef typename MatrixType::Index Index;
50 typedef typename MatrixType::Scalar Scalar;
62 Map<MatrixType, Aligned>(array1, rows, cols) = MatrixType::Ones(rows,cols);
63 Map<MatrixType>(array2, rows, cols) = Map<MatrixType>(array1, rows, cols);
64 Map<MatrixType>(array3unaligned, rows, cols) = Map<MatrixType>(array1, rows, cols)
    [all...]
sizeoverflow.cpp 23 template<typename MatrixType>
26 VERIFY_THROWS_BADALLOC( MatrixType m(rows, cols) );
27 VERIFY_THROWS_BADALLOC( MatrixType m; m.resize(rows, cols) );
28 VERIFY_THROWS_BADALLOC( MatrixType m; m.conservativeResize(rows, cols) );
stdvector.cpp 14 template<typename MatrixType>
15 void check_stdvector_matrix(const MatrixType& m)
17 typename MatrixType::Index rows = m.rows();
18 typename MatrixType::Index cols = m.cols();
19 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
20 std::vector<MatrixType,Eigen::aligned_allocator<MatrixType> > v(10, MatrixType(rows,cols)), w(20, y)
    [all...]
sparseqr.cpp 12 template<typename MatrixType,typename DenseMat>
13 int generate_sparse_rectangular_problem(MatrixType& A, DenseMat& dA, int maxRows = 300)
15 typedef typename MatrixType::Scalar Scalar;
45 typedef SparseMatrix<Scalar,ColMajor> MatrixType;
48 MatrixType A;
51 SparseQR<MatrixType, COLAMDOrdering<int> > solver;
85 MatrixType Q, QtQ, idM;
diagonal.cpp 12 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::SizeAtCompileTime!=Dynamic
    [all...]
product_selfadjoint.cpp 12 template<typename MatrixType> void product_selfadjoint(const MatrixType& m)
14 typedef typename MatrixType::Index Index;
15 typedef typename MatrixType::Scalar Scalar;
16 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
17 typedef Matrix<Scalar, 1, MatrixType::RowsAtCompileTime> RowVectorType;
19 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, Dynamic, RowMajor> RhsMatrixType;
24 MatrixType m1 = MatrixType::Random(rows, cols),
25 m2 = MatrixType::Random(rows, cols)
    [all...]
  /external/eigen/Eigen/src/LU/
FullPivLU.h 21 * \param MatrixType the type of the matrix of which we are computing the LU decomposition
49 typedef _MatrixType MatrixType;
51 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
52 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
53 Options = MatrixType::Options,
54 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
55 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
57 typedef typename MatrixType::Scalar Scalar;
58 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
59 typedef typename internal::traits<MatrixType>::StorageKind StorageKind
    [all...]
  /external/eigen/Eigen/src/Householder/
BlockHouseholder.h 45 template<typename MatrixType,typename VectorsType,typename CoeffsType>
46 void apply_block_householder_on_the_left(MatrixType& mat, const VectorsType& vectors, const CoeffsType& hCoeffs)
48 typedef typename MatrixType::Index Index;
49 enum { TFactorSize = MatrixType::ColsAtCompileTime };
51 Matrix<typename MatrixType::Scalar, TFactorSize, TFactorSize, ColMajor> T(nbVecs,nbVecs);
57 Matrix<typename MatrixType::Scalar,VectorsType::ColsAtCompileTime,MatrixType::ColsAtCompileTime,0,
58 VectorsType::MaxColsAtCompileTime,MatrixType::MaxColsAtCompileTime> tmp = V.adjoint() * mat;
  /external/eigen/bench/
BenchUtil.h 21 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/Eigen/src/Core/util/
ForwardDeclarations.h 83 template<typename MatrixType, int Size=Dynamic> class VectorBlock;
84 template<typename MatrixType> class Transpose;
85 template<typename MatrixType> class Conjugate;
86 template<typename NullaryOp, typename MatrixType> class CwiseNullaryOp;
87 template<typename UnaryOp, typename MatrixType> class CwiseUnaryOp;
88 template<typename ViewOp, typename MatrixType> class CwiseUnaryView;
98 template<typename MatrixType, typename DiagonalType, int ProductOrder> class DiagonalProduct;
99 template<typename MatrixType, int Index = 0> class Diagonal;
111 template<typename MatrixType, int MapOptions=Unaligned, typename StrideType = Stride<0,0> > class Map;
114 template<typename MatrixType, unsigned int Mode> class TriangularView
    [all...]
  /external/eigen/Eigen/src/misc/
SparseSolve.h 23 typedef typename DecompositionType::MatrixType MatrixType;
72 typedef typename DecompositionType::MatrixType MatrixType; \
73 typedef typename MatrixType::Scalar Scalar; \
74 typedef typename MatrixType::RealScalar RealScalar; \
75 typedef typename MatrixType::Index Index; \
91 typedef typename DecompositionType::MatrixType MatrixType;
93 MatrixType::ColsAtCompileTime
    [all...]
  /external/eigen/Eigen/src/Core/
Reverse.h 22 * \param MatrixType the type of the object of which we are taking the reverse
33 template<typename MatrixType, int Direction>
34 struct traits<Reverse<MatrixType, Direction> >
35 : traits<MatrixType>
37 typedef typename MatrixType::Scalar Scalar;
38 typedef typename traits<MatrixType>::StorageKind StorageKind;
39 typedef typename traits<MatrixType>::XprKind XprKind;
40 typedef typename nested<MatrixType>::type MatrixTypeNested;
43 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
44 ColsAtCompileTime = MatrixType::ColsAtCompileTime
    [all...]
  /external/eigen/test/eigen2/
product.h 21 template<typename MatrixType> void product(const MatrixType& m)
27 typedef typename MatrixType::Scalar Scalar;
29 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> RowVectorType;
30 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> ColVectorType;
31 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> RowSquareMatrixType;
32 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, MatrixType::ColsAtCompileTime> ColSquareMatrixType;
33 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::ColsAtCompileTime
    [all...]
eigen2_sum.cpp 12 template<typename MatrixType> void matrixSum(const MatrixType& m)
14 typedef typename MatrixType::Scalar Scalar;
19 MatrixType m1 = MatrixType::Random(rows, cols);
21 VERIFY_IS_MUCH_SMALLER_THAN(MatrixType::Zero(rows, cols).sum(), Scalar(1));
22 VERIFY_IS_APPROX(MatrixType::Ones(rows, cols).sum(), Scalar(float(rows*cols))); // the float() here to shut up excessive MSVC warning about int->complex conversion being lossy
  /external/eigen/Eigen/src/IterativeLinearSolvers/
IterativeSolverBase.h 24 typedef typename internal::traits<Derived>::MatrixType MatrixType;
26 typedef typename MatrixType::Scalar Scalar;
27 typedef typename MatrixType::Index Index;
28 typedef typename MatrixType::RealScalar RealScalar;
52 IterativeSolverBase(const MatrixType& A)
65 Derived& analyzePattern(const MatrixType& A)
83 Derived& factorize(const MatrixType& A)
103 Derived& compute(const MatrixType& A)
223 const MatrixType* mp_matrix
    [all...]

Completed in 342 milliseconds

1 2 3 45 6 7 8 910