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

1 2 34 5 6 7 8 9

  /external/eigen/test/
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...]
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;
17 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> ColVectorType;
18 typedef Matrix<Scalar, 1, MatrixType::ColsAtCompileTime> RowVectorType;
23 MatrixType m1 = MatrixType::Random(rows, cols),
24 m2 = MatrixType::Random(rows, cols),
35 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::ColsAtCompileTime> RightSquareMatrixType
    [all...]
diagonal.cpp 12 template<typename MatrixType> void diagonal(const MatrixType& m)
14 typedef typename MatrixType::Index Index;
15 typedef typename MatrixType::Scalar Scalar;
16 typedef typename MatrixType::RealScalar RealScalar;
17 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
18 typedef Matrix<Scalar, 1, MatrixType::ColsAtCompileTime> RowVectorType;
23 MatrixType m1 = MatrixType::Random(rows, cols),
24 m2 = MatrixType::Random(rows, cols)
    [all...]
array_replicate.cpp 12 template<typename MatrixType> void replicate(const MatrixType& m)
17 typedef typename MatrixType::Index Index;
18 typedef typename MatrixType::Scalar Scalar;
20 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
27 MatrixType m1 = MatrixType::Random(rows, cols),
28 m2 = MatrixType::Random(rows, cols);
eigen2support.cpp 14 template<typename MatrixType> void eigen2support(const MatrixType& m)
16 typedef typename MatrixType::Index Index;
17 typedef typename MatrixType::Scalar Scalar;
22 MatrixType m1 = MatrixType::Random(rows, cols),
30 VERIFY_IS_APPROX(m1.cwise() + s1, MatrixType::Constant(rows,cols,s1) + m1);
31 VERIFY_IS_APPROX((m1*Scalar(2)).cwise() - s2, (m1+m1) - MatrixType::Constant(rows,cols,s2) );
  /external/eigen/test/eigen2/
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_triangular.cpp 12 template<typename MatrixType> void triangular(const MatrixType& m)
14 typedef typename MatrixType::Scalar Scalar;
16 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
23 MatrixType m1 = MatrixType::Random(rows, cols),
24 m2 = MatrixType::Random(rows, cols),
29 mzero = MatrixType::Zero(rows, cols),
30 mones = MatrixType::Ones(rows, cols),
31 identity = Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime
    [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;
150 template<typename MatrixType, unsigned int UpLo>
151 inline typename SelfAdjointView<MatrixType, UpLo>::RealScalar
152 SelfAdjointView<MatrixType, UpLo>::operatorNorm() const
RealSchur.h 40 * 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;
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;
67 typedef typename MatrixType::Index Index
    [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/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)
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/SparseCore/
SparseTriangularView.h 17 template<typename MatrixType, int Mode>
18 struct traits<SparseTriangularView<MatrixType,Mode> >
19 : public traits<MatrixType>
24 template<typename MatrixType, int Mode> class SparseTriangularView
25 : public SparseMatrixBase<SparseTriangularView<MatrixType,Mode> >
27 enum { SkipFirst = ((Mode&Lower) && !(MatrixType::Flags&RowMajorBit))
28 || ((Mode&Upper) && (MatrixType::Flags&RowMajorBit)),
43 typedef typename MatrixType::Nested MatrixTypeNested;
47 inline SparseTriangularView(const MatrixType& matrix) : m_matrix(matrix) {}
63 template<typename MatrixType, int Mode
    [all...]
  /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/QR/
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...]
FullPivHouseholderQR.h 18 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;
55 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
56 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
57 Options = MatrixType::Options,
58 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime
    [all...]
  /external/eigen/Eigen/src/Core/
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/Core/products/
SelfadjointProduct.h 49 template<typename MatrixType, typename OtherType, int UpLo, bool OtherIsVector = OtherType::IsVectorAtCompileTime>
52 template<typename MatrixType, typename OtherType, int UpLo>
53 struct selfadjoint_product_selector<MatrixType,OtherType,UpLo,true>
55 static void run(MatrixType& mat, const OtherType& other, typename MatrixType::Scalar alpha)
57 typedef typename MatrixType::Scalar Scalar;
58 typedef typename MatrixType::Index Index;
67 StorageOrder = (internal::traits<MatrixType>::Flags&RowMajorBit) ? RowMajor : ColMajor,
85 template<typename MatrixType, typename OtherType, int UpLo>
86 struct selfadjoint_product_selector<MatrixType,OtherType,UpLo,false
    [all...]
  /external/eigen/Eigen/src/LU/
FullPivLU.h 21 * \param MatrixType the type of the matrix of which we are computing the LU decomposition
48 typedef _MatrixType MatrixType;
50 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
51 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
52 Options = MatrixType::Options,
53 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
54 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
56 typedef typename MatrixType::Scalar Scalar;
57 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
58 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> T(nbVecs,nbVecs);
57 Matrix<typename MatrixType::Scalar,VectorsType::ColsAtCompileTime,MatrixType::ColsAtCompileTime,0,
58 VectorsType::MaxColsAtCompileTime,MatrixType::MaxColsAtCompileTime> tmp = V.adjoint() * mat;
  /external/eigen/Eigen/src/Core/util/
ForwardDeclarations.h 84 template<typename MatrixType, int Size=Dynamic> class VectorBlock;
85 template<typename MatrixType> class Transpose;
86 template<typename MatrixType> class Conjugate;
87 template<typename NullaryOp, typename MatrixType> class CwiseNullaryOp;
88 template<typename UnaryOp, typename MatrixType> class CwiseUnaryOp;
89 template<typename ViewOp, typename MatrixType> class CwiseUnaryView;
99 template<typename MatrixType, typename DiagonalType, int ProductOrder> class DiagonalProduct;
100 template<typename MatrixType, int Index = 0> class Diagonal;
112 template<typename MatrixType, int MapOptions=Unaligned, typename StrideType = Stride<0,0> > class Map;
115 template<typename MatrixType, unsigned int Mode> class TriangularView
    [all...]
  /external/eigen/Eigen/src/misc/
SparseSolve.h 23 typedef typename DecompositionType::MatrixType MatrixType;
55 typedef typename DecompositionType::MatrixType MatrixType; \
56 typedef typename MatrixType::Scalar Scalar; \
57 typedef typename MatrixType::RealScalar RealScalar; \
58 typedef typename MatrixType::Index Index; \
74 typedef typename DecompositionType::MatrixType MatrixType;
76 MatrixType::ColsAtCompileTime
    [all...]

Completed in 332 milliseconds

1 2 34 5 6 7 8 9