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

12 3 4 5 6 7 8 9

  /external/eigen/Eigen/src/Eigenvalues/
HessenbergDecomposition.h 18 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;
65 Size = MatrixType::RowsAtCompileTime,
67 Options = MatrixType::Options,
68 MaxSize = MatrixType::MaxRowsAtCompileTime,
72 /** \brief Scalar type for matrices of type #MatrixType. *
    [all...]
GeneralizedSelfAdjointEigenSolver.h 37 * GeneralizedSelfAdjointEigenSolver(const MatrixType&, const MatrixType&, int)
42 * The documentation for GeneralizedSelfAdjointEigenSolver(const MatrixType&, const MatrixType&, int)
54 typedef _MatrixType MatrixType;
90 * This constructor calls compute(const MatrixType&, const MatrixType&, int)
105 * \sa compute(const MatrixType&, const MatrixType&, int)
107 GeneralizedSelfAdjointEigenSolver(const MatrixType& matA, const MatrixType& matB
    [all...]
  /external/eigen/test/
eigensolver_complex.cpp 33 template<typename MatrixType> void eigensolver(const MatrixType& m)
35 typedef typename MatrixType::Index Index;
42 typedef typename MatrixType::Scalar Scalar;
44 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
45 typedef Matrix<RealScalar, MatrixType::RowsAtCompileTime, 1> RealVectorType;
46 typedef typename std::complex<typename NumTraits<typename MatrixType::Scalar>::Real> Complex;
48 MatrixType a = MatrixType::Random(rows,cols);
49 MatrixType symmA = a.adjoint() * a
    [all...]
eigensolver_generic.cpp 15 template<typename MatrixType> void eigensolver(const MatrixType& m)
17 typedef typename MatrixType::Index Index;
24 typedef typename MatrixType::Scalar Scalar;
26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
27 typedef Matrix<RealScalar, MatrixType::RowsAtCompileTime, 1> RealVectorType;
28 typedef typename std::complex<typename NumTraits<typename MatrixType::Scalar>::Real> Complex;
30 MatrixType a = MatrixType::Random(rows,cols);
31 MatrixType a1 = MatrixType::Random(rows,cols)
    [all...]
lu.cpp 14 template<typename MatrixType> void lu_non_invertible()
16 typedef typename MatrixType::Index Index;
17 typedef typename MatrixType::Scalar Scalar;
18 typedef typename MatrixType::RealScalar RealScalar;
23 if(MatrixType::RowsAtCompileTime==Dynamic)
29 rows = MatrixType::RowsAtCompileTime;
31 if(MatrixType::ColsAtCompileTime==Dynamic)
38 cols2 = cols = MatrixType::ColsAtCompileTime;
42 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
43 ColsAtCompileTime = MatrixType::ColsAtCompileTim
    [all...]
schur_complex.cpp 14 template<typename MatrixType> void schur(int size = MatrixType::ColsAtCompileTime)
16 typedef typename ComplexSchur<MatrixType>::ComplexScalar ComplexScalar;
17 typedef typename ComplexSchur<MatrixType>::ComplexMatrixType ComplexMatrixType;
21 MatrixType A = MatrixType::Random(size, size);
22 ComplexSchur<MatrixType> schurOfA(A);
28 VERIFY(T(row,col) == (typename MatrixType::Scalar)0);
35 ComplexSchur<MatrixType> csUninitialized;
41 MatrixType A = MatrixType::Random(size, size)
    [all...]
jacobisvd.cpp 17 template<typename MatrixType, int QRPreconditioner>
18 void jacobisvd_check_full(const MatrixType& m, const JacobiSVD<MatrixType, QRPreconditioner>& svd)
20 typedef typename MatrixType::Index Index;
25 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
26 ColsAtCompileTime = MatrixType::ColsAtCompileTime
29 typedef typename MatrixType::Scalar Scalar;
36 MatrixType sigma = MatrixType::Zero(rows,cols);
46 template<typename MatrixType, int QRPreconditioner
    [all...]
cholesky.cpp 29 template<typename MatrixType,template <typename,int> class CholType> void test_chol_update(const MatrixType& symm)
31 typedef typename MatrixType::Scalar Scalar;
32 typedef typename MatrixType::RealScalar RealScalar;
33 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
35 MatrixType symmLo = symm.template triangularView<Lower>();
36 MatrixType symmUp = symm.template triangularView<Upper>();
37 MatrixType symmCpy = symm;
39 CholType<MatrixType,Lower> chollo(symmLo);
40 CholType<MatrixType,Upper> cholup(symmUp)
    [all...]
swap.cpp 25 template<typename MatrixType> void swap(const MatrixType& m)
27 typedef typename other_matrix_type<MatrixType>::type OtherMatrixType;
28 typedef typename MatrixType::Scalar Scalar;
30 eigen_assert((!internal::is_same<MatrixType,OtherMatrixType>::value));
31 typename MatrixType::Index rows = m.rows();
32 typename MatrixType::Index cols = m.cols();
35 MatrixType m1 = MatrixType::Random(rows,cols);
36 MatrixType m2 = MatrixType::Random(rows,cols) + Scalar(100) * MatrixType::Identity(rows,cols)
    [all...]
eigensolver_selfadjoint.cpp 15 template<typename MatrixType> void selfadjointeigensolver(const MatrixType& m)
17 typedef typename MatrixType::Index Index;
24 typedef typename MatrixType::Scalar Scalar;
26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
27 typedef Matrix<RealScalar, MatrixType::RowsAtCompileTime, 1> RealVectorType;
28 typedef typename std::complex<typename NumTraits<typename MatrixType::Scalar>::Real> Complex;
32 MatrixType a = MatrixType::Random(rows,cols);
33 MatrixType a1 = MatrixType::Random(rows,cols)
    [all...]
qr_colpivoting.cpp 14 template<typename MatrixType> void qr()
16 typedef typename MatrixType::Index Index;
21 typedef typename MatrixType::Scalar Scalar;
22 typedef typename MatrixType::RealScalar RealScalar;
23 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> MatrixQType;
24 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> VectorType;
25 MatrixType m1;
27 ColPivHouseholderQR<MatrixType> qr(m1);
37 MatrixType r = qr.matrixQR().template triangularView<Upper>()
    [all...]
  /external/eigen/Eigen/src/Eigen2Support/
Minor.h 20 * \param MatrixType the type of the object in which we are taking a minor
30 template<typename MatrixType>
31 struct traits<Minor<MatrixType> >
32 : traits<MatrixType>
34 typedef typename nested<MatrixType>::type MatrixTypeNested;
36 typedef typename MatrixType::StorageKind StorageKind;
38 RowsAtCompileTime = (MatrixType::RowsAtCompileTime != Dynamic) ?
39 int(MatrixType::RowsAtCompileTime) - 1 : Dynamic,
40 ColsAtCompileTime = (MatrixType::ColsAtCompileTime != Dynamic) ?
41 int(MatrixType::ColsAtCompileTime) - 1 : Dynamic
    [all...]
  /external/eigen/Eigen/src/Core/
CwiseUnaryView.h 21 * \param MatrixType the type of the matrix we are applying the unary operator
30 template<typename ViewOp, typename MatrixType>
31 struct traits<CwiseUnaryView<ViewOp, MatrixType> >
32 : traits<MatrixType>
35 ViewOp(typename traits<MatrixType>::Scalar)
37 typedef typename MatrixType::Nested MatrixTypeNested;
42 MatrixTypeInnerStride = inner_stride_at_compile_time<MatrixType>::ret,
48 * int(sizeof(typename traits<MatrixType>::Scalar) / sizeof(Scalar)),
49 OuterStrideAtCompileTime = outer_stride_at_compile_time<MatrixType>::ret
54 template<typename ViewOp, typename MatrixType, typename StorageKind
    [all...]
Transpose.h 21 * \param MatrixType the type of the object of which we are taking the transpose
31 template<typename MatrixType>
32 struct traits<Transpose<MatrixType> > : traits<MatrixType>
34 typedef typename MatrixType::Scalar Scalar;
35 typedef typename nested<MatrixType>::type MatrixTypeNested;
37 typedef typename traits<MatrixType>::StorageKind StorageKind;
38 typedef typename traits<MatrixType>::XprKind XprKind;
40 RowsAtCompileTime = MatrixType::ColsAtCompileTime,
41 ColsAtCompileTime = MatrixType::RowsAtCompileTime
    [all...]
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...]
  /external/eigen/test/eigen2/
eigen2_eigensolver.cpp 17 template<typename MatrixType> void selfadjointeigensolver(const MatrixType& m)
25 typedef typename MatrixType::Scalar Scalar;
27 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
28 typedef Matrix<RealScalar, MatrixType::RowsAtCompileTime, 1> RealVectorType;
29 typedef typename std::complex<typename NumTraits<typename MatrixType::Scalar>::Real> Complex;
33 MatrixType a = MatrixType::Random(rows,cols);
34 MatrixType a1 = MatrixType::Random(rows,cols)
    [all...]
eigen2_nomalloc.cpp 22 template<typename MatrixType> void nomalloc(const MatrixType& m)
27 typedef typename MatrixType::Scalar Scalar;
28 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
33 MatrixType m1 = MatrixType::Random(rows, cols),
34 m2 = MatrixType::Random(rows, cols),
36 mzero = MatrixType::Zero(rows, cols),
37 identity = Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime
    [all...]
eigen2_inverse.cpp 14 template<typename MatrixType> void inverse(const MatrixType& m)
22 typedef typename MatrixType::Scalar Scalar;
24 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> VectorType;
26 MatrixType m1 = MatrixType::Random(rows, cols),
28 mzero = MatrixType::Zero(rows, cols),
29 identity = MatrixType::Identity(rows, rows);
33 m1 = MatrixType::Random(rows, cols);
eigen2_prec_inverse_4x4.cpp 29 template<typename MatrixType> void inverse_permutation_4x4()
31 typedef typename MatrixType::Scalar Scalar;
32 typedef typename MatrixType::RealScalar RealScalar;
36 MatrixType m = MatrixType::Zero();
41 MatrixType inv = m.inverse();
42 double error = double( (m*inv-MatrixType::Identity()).norm() / epsilon<Scalar>() );
48 template<typename MatrixType> void inverse_general_4x4(int repeat)
50 typedef typename MatrixType::Scalar Scalar;
51 typedef typename MatrixType::RealScalar RealScalar
    [all...]
eigen2_qr.cpp 13 template<typename MatrixType> void qr(const MatrixType& m)
21 typedef typename MatrixType::Scalar Scalar;
22 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, MatrixType::ColsAtCompileTime> SquareMatrixType;
23 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> VectorType;
25 MatrixType a = MatrixType::Random(rows,cols);
26 QR<MatrixType> qrOfA(a);
28 VERIFY_IS_NOT_APPROX(a+MatrixType::Identity(rows, cols), qrOfA.matrixQ() * qrOfA.matrixR())
    [all...]
  /external/eigen/doc/snippets/
Tutorial_Map_using.cpp 1 typedef Matrix<float,1,Dynamic> MatrixType;
2 typedef Map<MatrixType> MapType;
3 typedef Map<const MatrixType> MapTypeConst; // a read-only map
6 MatrixType m1(n_dims), m2(n_dims);
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixExponential.h 25 * \tparam MatrixType type of the argument of the exponential,
28 template <typename MatrixType>
40 MatrixExponential(const MatrixType &M);
62 void pade3(const MatrixType &A);
71 void pade5(const MatrixType &A);
80 void pade7(const MatrixType &A);
89 void pade9(const MatrixType &A);
98 void pade13(const MatrixType &A);
109 void pade17(const MatrixType &A);
138 typedef typename internal::traits<MatrixType>::Scalar Scalar
    [all...]
  /external/eigen/Eigen/src/Cholesky/
LLT.h 16 template<typename MatrixType, int UpLo> struct LLT_Traits;
25 * \param MatrixType the type of the matrix of which we are computing the LL^T Cholesky decomposition
53 typedef _MatrixType MatrixType;
55 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
56 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
57 Options = MatrixType::Options,
58 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
60 typedef typename MatrixType::Scalar Scalar;
61 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
62 typedef typename MatrixType::Index Index
    [all...]
  /external/eigen/Eigen/src/Geometry/
Homogeneous.h 21 * \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::ColsAtCompileTime) + 1 : Dynamic
    [all...]
  /external/eigen/Eigen/src/SparseCore/
SparseView.h 18 template<typename MatrixType>
19 struct traits<SparseView<MatrixType> > : traits<MatrixType>
24 Flags = int(traits<MatrixType>::Flags) & (RowMajorBit)
30 template<typename MatrixType>
31 class SparseView : public SparseMatrixBase<SparseView<MatrixType> >
33 typedef typename MatrixType::Nested MatrixTypeNested;
38 SparseView(const MatrixType& mat, const Scalar& m_reference = Scalar(0),
56 template<typename MatrixType>
57 class SparseView<MatrixType>::InnerIterator : public _MatrixTypeNested::InnerIterato
    [all...]

Completed in 757 milliseconds

12 3 4 5 6 7 8 9