Searched refs:MatrixType (Results 176 - 200 of 208) sorted by relevance

123456789

/external/eigen/bench/
H A Dbenchmark-blocking-sizes.cpp52 typedef MatrixXf MatrixType; typedef
53 typedef MatrixType::Scalar Scalar;
187 MatrixType *lhs = new MatrixType[matrix_pool_size];
188 MatrixType *rhs = new MatrixType[matrix_pool_size];
189 MatrixType *dst = new MatrixType[matrix_pool_size];
192 lhs[i] = MatrixType::Zero(productsizes.m, productsizes.k);
193 rhs[i] = MatrixType
[all...]
H A Ddense_solvers.cpp14 template<typename Solver,typename MatrixType>
16 void compute_norm_equation(Solver &solver, const MatrixType &A) {
23 template<typename Solver,typename MatrixType>
25 void compute(Solver &solver, const MatrixType &A) {
/external/eigen/test/
H A Dnullary.cpp13 template<typename MatrixType>
14 bool equalsIdentity(const MatrixType& A)
16 typedef typename MatrixType::Scalar Scalar;
196 template<typename MatrixType>
197 void testMatrixType(const MatrixType& m)
202 typedef typename MatrixType::Scalar Scalar;
203 typedef typename MatrixType::RealScalar RealScalar;
210 MatrixType A;
213 VERIFY(equalsIdentity(MatrixType::Identity(rows, cols)));
216 A = MatrixType
[all...]
H A Dexceptions.cpp95 typedef Eigen::Matrix<ScalarWithExceptions,Dynamic,Dynamic> MatrixType; typedef
100 MatrixType m0(n,n), m1(n,n), m2(n,n);
H A Dproduct_notemporary.cpp14 template<typename MatrixType> void product_notemporary(const MatrixType& m)
18 typedef typename MatrixType::Index Index;
19 typedef typename MatrixType::Scalar Scalar;
20 typedef typename MatrixType::RealScalar RealScalar;
29 ColMajorMatrixType m1 = MatrixType::Random(rows, cols),
30 m2 = MatrixType::Random(rows, cols),
H A Dgeo_homogeneous.cpp19 typedef Matrix<Scalar,Size,Size> MatrixType; typedef
34 MatrixType m0 = MatrixType::Random();
H A Dmain.h394 typename T1::Scalar test_relative_error(const T1 &a, const T2 &b, const typename T1::MatrixType* = 0)
543 template<typename MatrixType>
544 void createRandomPIMatrixOfRank(Index desired_rank, Index rows, Index cols, MatrixType& m);
545 template<typename MatrixType>
546 void createRandomPIMatrixOfRank(Index desired_rank, Index rows, Index cols, MatrixType& m)
548 typedef typename internal::traits<MatrixType>::Scalar Scalar;
549 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime };
569 MatrixType d = MatrixType
[all...]
H A Dgeo_hyperplane.cpp29 HyperplaneType::AmbientDimAtCompileTime> MatrixType; typedef
57 MatrixType rot = MatrixType::Random(dim,dim).householderQr().householderQ();
/external/eigen/unsupported/Eigen/src/LevenbergMarquardt/
H A DLMpar.h31 typedef typename QRSolver::MatrixType MatrixType; typedef
46 MatrixType s;
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DGMRES.h55 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; typedef in struct:Eigen::internal::traits
274 typedef _MatrixType MatrixType; typedef in class:Eigen::GMRES
275 typedef typename MatrixType::Scalar Scalar;
276 typedef typename MatrixType::RealScalar RealScalar;
/external/eigen/unsupported/test/
H A Dkronecker_product.cpp18 template<typename MatrixType>
19 void check_dimension(const MatrixType& ab, const int rows, const int cols)
26 template<typename MatrixType>
27 void check_kronecker_product(const MatrixType& ab)
71 template<typename MatrixType>
72 void check_sparse_kronecker_product(const MatrixType& ab)
/external/eigen/Eigen/src/Eigenvalues/
H A DComplexSchur_LAPACKE.h45 typedef Matrix<EIGTYPE, Dynamic, Dynamic, EIGCOLROW> MatrixType; \
46 typedef MatrixType::RealScalar RealScalar; \
/external/eigen/Eigen/src/IterativeLinearSolvers/
H A DIncompleteCholesky.h77 * \sa IncompleteCholesky(const MatrixType&)
83 template<typename MatrixType>
84 IncompleteCholesky(const MatrixType& matrix) : m_initialShift(1e-3),m_factorizationIsOk(false)
116 template<typename MatrixType>
117 void analyzePattern(const MatrixType& mat)
137 template<typename MatrixType>
138 void factorize(const MatrixType& mat);
146 template<typename MatrixType>
147 void compute(const MatrixType& mat)
H A DIncompleteLUT.h124 template<typename MatrixType>
125 explicit IncompleteLUT(const MatrixType& mat, const RealScalar& droptol=NumTraits<Scalar>::dummy_precision(), int fillfactor = 10)
148 template<typename MatrixType>
149 void analyzePattern(const MatrixType& amat);
151 template<typename MatrixType>
152 void factorize(const MatrixType& amat);
159 template<typename MatrixType>
160 IncompleteLUT& compute(const MatrixType& amat)
/external/eigen/Eigen/src/QR/
H A DColPivHouseholderQR_LAPACKE.h49 typedef Matrix<EIGTYPE, Dynamic, Dynamic, EIGCOLROW, Dynamic, Dynamic> MatrixType; \
50 typedef MatrixType::RealScalar RealScalar; \
/external/eigen/lapack/
H A Dlu.cpp62 MatrixType lu(a,*n,*n,*lda);
63 MatrixType B(b,*n,*nrhs,*ldb);
/external/eigen/Eigen/src/Core/
H A DProductEvaluators.h367 typedef typename internal::remove_all<typename internal::conditional<int(Side)==OnTheRight,LhsNested,RhsNested>::type>::type MatrixType; typedef in struct:Eigen::internal::generic_product_impl
375 (int(MatrixType::Flags)&RowMajorBit) ? RowMajor : ColMajor,
376 bool(internal::blas_traits<MatrixType>::HasUsableDirectAccess)
705 triangular_product_impl<Lhs::Mode,true,typename Lhs::MatrixType,false,Rhs, Rhs::ColsAtCompileTime==1>
719 triangular_product_impl<Rhs::Mode,false,Lhs,Lhs::RowsAtCompileTime==1, typename Rhs::MatrixType, false>::run(dst, lhs, rhs.nestedExpression(), alpha);
740 selfadjoint_product_impl<typename Lhs::MatrixType,Lhs::Mode,false,Rhs,0,Rhs::IsVectorAtCompileTime>::run(dst, lhs.nestedExpression(), rhs, alpha);
753 selfadjoint_product_impl<Lhs,0,Lhs::IsVectorAtCompileTime,typename Rhs::MatrixType,Rhs::Mode,false>::run(dst, lhs, rhs.nestedExpression(), alpha);
762 template<typename MatrixType, typename DiagonalType, typename Derived, int ProductOrder>
766 typedef typename ScalarBinaryOpTraits<typename MatrixType::Scalar, typename DiagonalType::Scalar>::ReturnType Scalar;
769 CoeffReadCost = NumTraits<Scalar>::MulCost + evaluator<MatrixType>
923 typedef typename nested_eval<ExpressionType, 1>::type MatrixType; typedef in struct:Eigen::internal::permutation_matrix_product
1031 typedef typename nested_eval<ExpressionType, 1>::type MatrixType; typedef in struct:Eigen::internal::transposition_matrix_product
[all...]
H A DSolveTriangular.h165 template<typename MatrixType, unsigned int Mode>
167 void TriangularViewImpl<MatrixType,Mode,Dense>::solveInPlace(const MatrixBase<OtherDerived>& _other) const
178 internal::triangular_solver_selector<MatrixType, typename internal::remove_reference<OtherCopy>::type,
/external/eigen/Eigen/src/Householder/
H A DHouseholderSequence.h109 template<typename OtherScalarType, typename MatrixType> struct matrix_type_times_scalar_type
111 typedef typename ScalarBinaryOpTraits<OtherScalarType, typename MatrixType::Scalar>::ReturnType
113 typedef Matrix<ResultScalar, MatrixType::RowsAtCompileTime, MatrixType::ColsAtCompileTime,
114 0, MatrixType::MaxRowsAtCompileTime, MatrixType::MaxColsAtCompileTime> Type;
/external/clang/test/SemaTemplate/
H A Ddefault-expr-arguments.cpp308 template < typename MatrixType, int =
309 A < MatrixType >::Flags ? : A < MatrixType >::Flags & a > class B;
/external/eigen/Eigen/src/Core/products/
H A DGeneralMatrixMatrixTriangular_BLAS.h107 typedef Matrix<EIGTYPE, Dynamic, Dynamic, AStorageOrder> MatrixType; \
117 MatrixType a; \
119 Map<const MatrixType, 0, OuterStride<> > mapA(lhs,n,k,OuterStride<>(lhsStride)); \
/external/eigen/Eigen/src/SparseCore/
H A DSparsePermutation.h22 typedef typename nested_eval<ExpressionType, 1>::type MatrixType; typedef in struct:Eigen::internal::permutation_matrix_product
23 typedef typename remove_all<MatrixType>::type MatrixTypeCleaned;
40 MatrixType mat(xpr);
H A DSparseUtil.h57 template<typename MatrixType, unsigned int UpLo> class SparseSelfAdjointView;
59 template<typename MatrixType> class SparseView;
72 template<typename MatrixType,int UpLo> class SparseSymmetricPermutationProduct;
/external/eigen/Eigen/src/SparseLU/
H A DSparseLUImpl.h31 typedef SparseMatrix<Scalar,ColMajor,StorageIndex> MatrixType; typedef in class:Eigen::internal::SparseLUImpl
41 Index snode_dfs(const Index jcol, const Index kcol,const MatrixType& mat, IndexVector& xprune, IndexVector& marker, GlobalLU_t& glu);
49 void panel_dfs(const Index m, const Index w, const Index jcol, MatrixType& A, IndexVector& perm_r, Index& nseg, ScalarVector& dense, IndexVector& panel_lsub, IndexVector& segrep, IndexVector& repfnz, IndexVector& xprune, IndexVector& marker, IndexVector& parent, IndexVector& xplore, GlobalLU_t& glu);
/external/eigen/unsupported/Eigen/src/SparseExtra/
H A DBlockSparseMatrix.h388 template<typename MatrixType>
389 inline BlockSparseMatrix(const MatrixType& spmat) : m_blockSize(BlockSize)
404 template<typename MatrixType>
405 inline BlockSparseMatrix& operator=(const MatrixType& spmat)
409 eigen_assert(((MatrixType::Options&RowMajorBit) != IsColMajor) && "Wrong storage order");
410 typedef SparseMatrix<bool,MatrixType::Options,typename MatrixType::Index> MatrixPatternType;
422 typename MatrixType::InnerIterator it_spmat(spmat, j);
449 typename MatrixType::InnerIterator it_spmat(spmat, j);
497 template<typename MatrixType>
[all...]

Completed in 618 milliseconds

123456789