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

12 3 4

  /external/eigen/Eigen/src/SparseCore/
SparsePermutation.h 22 typedef typename nested_eval<ExpressionType, 1>::type MatrixType;
23 typedef typename remove_all<MatrixType>::type MatrixTypeCleaned;
40 MatrixType mat(xpr);
  /external/eigen/test/
exceptions.cpp 95 typedef Eigen::Matrix<ScalarWithExceptions,Dynamic,Dynamic> MatrixType;
100 MatrixType m0(n,n), m1(n,n), m2(n,n);
geo_homogeneous.cpp 19 typedef Matrix<Scalar,Size,Size> MatrixType;
34 MatrixType m0 = MatrixType::Random();
mapped_matrix.cpp 52 template<typename MatrixType> void map_class_matrix(const MatrixType& m)
54 typedef typename MatrixType::Index Index;
55 typedef typename MatrixType::Scalar Scalar;
73 Map<MatrixType> map1(array1, rows, cols);
74 Map<MatrixType, AlignedMax> map2(array2, rows, cols);
75 Map<MatrixType> map3(array3unaligned, rows, cols);
76 Map<MatrixType> map4(array4, rows, cols);
78 VERIFY_IS_EQUAL(map1, MatrixType::Ones(rows,cols));
79 VERIFY_IS_EQUAL(map2, MatrixType::Ones(rows,cols))
    [all...]
sparseqr.cpp 12 template<typename MatrixType,typename DenseMat>
13 int generate_sparse_rectangular_problem(MatrixType& A, DenseMat& dA, int maxRows = 300, int maxCols = 150)
16 typedef typename MatrixType::Scalar Scalar;
46 typedef SparseMatrix<Scalar,ColMajor> MatrixType;
49 MatrixType A;
52 SparseQR<MatrixType, COLAMDOrdering<int> > solver;
86 MatrixType Q, QtQ, idM;
umeyama.cpp 25 typedef Eigen::Matrix<Scalar, Eigen::Dynamic, Eigen::Dynamic> MatrixType;
27 MatrixType Q;
35 Q = MatrixType::Random(size, size);
40 typename MatrixType::ColXpr colVec = Q.col(col);
43 typename MatrixType::ColXpr prevColVec = Q.col(prevCol);
53 typename MatrixType::RowXpr rowVec = Q.row(row);
56 typename MatrixType::RowXpr prevRowVec = Q.row(prevRow);
79 typedef Eigen::Matrix<Scalar, Eigen::Dynamic, Eigen::Dynamic> MatrixType;
82 MatrixType Q = randMatrixUnitary<Scalar>(size);
90 template <typename MatrixType>
    [all...]
permutationmatrices.cpp 15 template<typename MatrixType> void permutationmatrices(const MatrixType& m)
17 typedef typename MatrixType::Index Index;
18 typedef typename MatrixType::Scalar Scalar;
19 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime,
20 Options = MatrixType::Options };
31 MatrixType m_original = MatrixType::Random(rows,cols);
38 MatrixType m_permuted = MatrixType::Random(rows,cols)
    [all...]
  /external/eigen/unsupported/Eigen/src/LevenbergMarquardt/
LMpar.h 31 typedef typename QRSolver::MatrixType MatrixType;
46 MatrixType s;
  /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;
65 /** \brief Complex scalar type for #MatrixType.
76 * The length of the vector is the size of #MatrixType
    [all...]
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...]
ComplexSchur.h 20 template<typename MatrixType, bool IsComplex> struct complex_schur_reduce_to_hessenberg;
42 * ComplexSchur(const MatrixType&, bool) constructor which computes
54 typedef _MatrixType MatrixType;
56 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
57 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
58 Options = MatrixType::Options,
59 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
60 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
64 typedef typename MatrixType::Scalar Scalar;
129 * ComplexSchur(const MatrixType& matrix, bool computeU) or th
    [all...]
EigenSolver.h 48 * EigenSolver(const MatrixType&, bool) constructor which computes the
55 * The documentation for EigenSolver(const MatrixType&, bool) contains an
69 typedef _MatrixType MatrixType;
72 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
73 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
74 Options = MatrixType::Options,
75 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
76 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
79 /** \brief Scalar type for matrices of type #MatrixType. */
80 typedef typename MatrixType::Scalar Scalar
    [all...]
GeneralizedEigenSolver.h 47 * GeneralizedEigenSolver(const MatrixType&, const MatrixType&, bool) constructor which computes the
63 typedef _MatrixType MatrixType;
66 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
67 ColsAtCompileTime = MatrixType::ColsAtCompileTime,
68 Options = MatrixType::Options,
69 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
70 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
73 /** \brief Scalar type for matrices of type #MatrixType. */
74 typedef typename MatrixType::Scalar Scalar
    [all...]
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;
120 * \pre Either the constructor RealSchur(const MatrixType&, bool) or th
    [all...]
  /external/eigen/Eigen/src/IterativeLinearSolvers/
BiCGSTAB.h 28 template<typename MatrixType, typename Rhs, typename Dest, typename Preconditioner>
29 bool bicgstab(const MatrixType& mat, const Rhs& rhs, Dest& x,
120 typedef _MatrixType MatrixType;
167 typedef _MatrixType MatrixType;
168 typedef typename MatrixType::Scalar Scalar;
169 typedef typename MatrixType::RealScalar RealScalar;
ConjugateGradient.h 26 template<typename MatrixType, typename Rhs, typename Dest, typename Preconditioner>
28 void conjugate_gradient(const MatrixType& mat, const Rhs& rhs, Dest& x,
103 typedef _MatrixType MatrixType;
166 typedef _MatrixType MatrixType;
167 typedef typename MatrixType::Scalar Scalar;
168 typedef typename MatrixType::RealScalar RealScalar;
204 && (!MatrixType::IsRowMajor)
LeastSquareConjugateGradient.h 26 template<typename MatrixType, typename Rhs, typename Dest, typename Preconditioner>
28 void least_square_conjugate_gradient(const MatrixType& mat, const Rhs& rhs, Dest& x,
105 typedef _MatrixType MatrixType;
158 typedef _MatrixType MatrixType;
159 typedef typename MatrixType::Scalar Scalar;
160 typedef typename MatrixType::RealScalar RealScalar;
  /external/eigen/Eigen/src/LU/
InverseImpl.h 22 template<typename MatrixType, typename ResultType, int Size = MatrixType::RowsAtCompileTime>
26 static inline void run(const MatrixType& matrix, ResultType& result)
32 template<typename MatrixType, typename ResultType, int Size = MatrixType::RowsAtCompileTime>
39 template<typename MatrixType, typename ResultType>
40 struct compute_inverse<MatrixType, ResultType, 1>
43 static inline void run(const MatrixType& matrix, ResultType& result)
45 typedef typename MatrixType::Scalar Scalar;
46 internal::evaluator<MatrixType> matrixEval(matrix)
    [all...]
  /external/eigen/Eigen/src/PardisoSupport/
PardisoSupport.h 72 typedef _MatrixType MatrixType;
81 typedef _MatrixType MatrixType;
90 typedef _MatrixType MatrixType;
110 typedef typename Traits::MatrixType MatrixType;
116 typedef Matrix<StorageIndex, 1, MatrixType::ColsAtCompileTime> IntRowVectorType;
117 typedef Matrix<StorageIndex, MatrixType::RowsAtCompileTime, 1> IntColVectorType;
166 Derived& analyzePattern(const MatrixType& matrix);
174 Derived& factorize(const MatrixType& matrix);
176 Derived& compute(const MatrixType& matrix)
    [all...]
  /external/eigen/blas/
common.h 95 typedef Map<Matrix<Scalar,Dynamic,Dynamic,ColMajor>, 0, OuterStride<> > MatrixType;
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
GMRES.h 55 template<typename MatrixType, typename Rhs, typename Dest, typename Preconditioner>
56 bool gmres(const MatrixType & mat, const Rhs & rhs, Dest & x, const Preconditioner & precond,
219 typedef _MatrixType MatrixType;
274 typedef _MatrixType MatrixType;
275 typedef typename MatrixType::Scalar Scalar;
276 typedef typename MatrixType::RealScalar RealScalar;
MINRES.h 29 template<typename MatrixType, typename Rhs, typename Dest, typename Preconditioner>
31 void minres(const MatrixType& mat, const Rhs& rhs, Dest& x,
154 typedef _MatrixType MatrixType;
210 typedef _MatrixType MatrixType;
211 typedef typename MatrixType::Scalar Scalar;
212 typedef typename MatrixType::RealScalar RealScalar;
247 && (!MatrixType::IsRowMajor)
Scaling.h 51 typedef _MatrixType MatrixType;
52 typedef typename MatrixType::Scalar Scalar;
53 typedef typename MatrixType::Index Index;
58 IterScaling(const MatrixType& matrix)
73 void compute (const MatrixType& mat)
95 for (typename MatrixType::InnerIterator it(m_matrix, k); it; ++it)
119 for (typename MatrixType::InnerIterator it(m_matrix, k); it; ++it)
143 void computeRef (MatrixType& mat)
178 MatrixType m_matrix;
  /external/eigen/unsupported/Eigen/src/Splines/
SplineFitting.h 295 typedef Matrix<Scalar,Dynamic,Dynamic> MatrixType;
301 MatrixType A = MatrixType::Zero(n,n);
312 HouseholderQR<MatrixType> qr(A);
315 ControlPointVectorType ctrls = qr.solve(MatrixType(pts.transpose())).transpose();
341 typedef Matrix<Scalar, Dynamic, Dynamic> MatrixType;
350 MatrixType A = MatrixType::Zero(n, n);
353 MatrixType b(points.rows(), n);
408 FullPivLU<MatrixType> lu(A)
    [all...]
  /external/eigen/Eigen/src/Core/
SelfAdjointView.h 21 * \param MatrixType the type of the dense matrix storing the coefficients
32 template<typename MatrixType, unsigned int UpLo>
33 struct traits<SelfAdjointView<MatrixType, UpLo> > : traits<MatrixType>
35 typedef typename ref_selector<MatrixType>::non_const_type MatrixTypeNested;
37 typedef MatrixType ExpressionType;
38 typedef typename MatrixType::PlainObject FullMatrixType;
41 FlagsLvalueBit = is_lvalue<MatrixType>::value ? LvalueBit : 0,
54 typedef _MatrixType MatrixType;
62 typedef typename MatrixType::StorageIndex StorageIndex
    [all...]

Completed in 325 milliseconds

12 3 4