Searched defs:MatrixType (Results 1 - 25 of 94) sorted by relevance

1234

/external/eigen/test/
H A Dsizeof.cpp12 template<typename MatrixType> void verifySizeOf(const MatrixType&) argument
14 typedef typename MatrixType::Scalar Scalar;
15 if (MatrixType::RowsAtCompileTime!=Dynamic && MatrixType::ColsAtCompileTime!=Dynamic)
16 VERIFY_IS_EQUAL(std::ptrdiff_t(sizeof(MatrixType)),std::ptrdiff_t(sizeof(Scalar))*std::ptrdiff_t(MatrixType::SizeAtCompileTime));
18 VERIFY_IS_EQUAL(sizeof(MatrixType),sizeof(Scalar*) + 2 * sizeof(typename MatrixType::Index));
H A Dconstructor.cpp15 template<typename MatrixType> struct Wrapper
17 MatrixType m_mat;
18 inline Wrapper(const MatrixType &x) : m_mat(x) {}
19 inline operator const MatrixType& () const { return m_mat; }
20 inline operator MatrixType& () { return m_mat; }
23 template<typename MatrixType> void ctor_init1(const MatrixType& m)
29 MatrixType m0 = MatrixType::Random(rows,cols);
31 VERIFY_EVALUATION_COUNT( MatrixType m
[all...]
H A Dconservative_resize.cpp19 typedef Matrix<Scalar, Eigen::Dynamic, Eigen::Dynamic, Storage> MatrixType; typedef
20 typedef typename MatrixType::Index Index;
22 MatrixType m, n;
25 m = n = MatrixType::Random(50,50);
29 m = n = MatrixType::Random(50,50);
33 m = n = MatrixType::Random(50,50);
42 m = n = MatrixType::Random(50,50);
52 m = n = MatrixType::Random(50,50);
53 m.conservativeResizeLike(MatrixType::Zero(rows,cols));
H A Dhessenberg.cpp16 typedef Matrix<Scalar,Size,Size> MatrixType; typedef
20 MatrixType m = MatrixType::Random(size,size);
21 HessenbergDecomposition<MatrixType> hess(m);
22 MatrixType Q = hess.matrixQ();
23 MatrixType H = hess.matrixH();
27 VERIFY(H(row,col) == (typename MatrixType::Scalar)0);
33 MatrixType A = MatrixType::Random(size, size);
34 HessenbergDecomposition<MatrixType> cs
[all...]
H A Djacobi.cpp14 template<typename MatrixType, typename JacobiScalar>
15 void jacobi(const MatrixType& m = MatrixType()) argument
17 typedef typename MatrixType::Index Index;
22 RowsAtCompileTime = MatrixType::RowsAtCompileTime,
23 ColsAtCompileTime = MatrixType::ColsAtCompileTime
28 const MatrixType a(MatrixType::Random(rows, cols));
41 MatrixType b = a;
54 MatrixType
[all...]
H A Dqtvector.cpp18 template<typename MatrixType>
19 void check_qtvector_matrix(const MatrixType& m)
21 typedef typename MatrixType::Index Index;
25 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
26 QVector<MatrixType> v(10, MatrixType(rows,cols)), w(20, y);
47 VERIFY((size_t)&(v[22]) == (size_t)&(v[21]) + sizeof(MatrixType));
51 MatrixType* re
63 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Dschur_complex.cpp14 template<typename MatrixType> void schur(int size = MatrixType::ColsAtCompileTime) argument
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
[all...]
H A Dschur_real.cpp14 template<typename MatrixType> void verifyIsQuasiTriangular(const MatrixType& T)
16 typedef typename MatrixType::Index Index;
19 typedef typename MatrixType::Scalar Scalar;
40 template<typename MatrixType> void schur(int size = MatrixType::ColsAtCompileTime) argument
44 MatrixType A = MatrixType::Random(size, size);
45 RealSchur<MatrixType> schurOfA(A);
47 MatrixType
[all...]
H A Dstddeque.cpp15 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,Eige
50 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Dstddeque_overload.cpp28 template<typename MatrixType>
29 void check_stddeque_matrix(const MatrixType& m)
31 typename MatrixType::Index rows = m.rows();
32 typename MatrixType::Index cols = m.cols();
33 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
34 std::deque<MatrixType> v(10, MatrixType(rows,cols)), w(20, y);
54 MatrixType* re
66 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Dstdlist.cpp15 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,Eige
50 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Dstdvector.cpp14 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(row
53 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Dstdvector_overload.cpp28 template<typename MatrixType>
29 void check_stdvector_matrix(const MatrixType& m)
31 typename MatrixType::Index rows = m.rows();
32 typename MatrixType::Index cols = m.cols();
33 MatrixType x = MatrixType::Random(rows,cols), y = MatrixType::Random(rows,cols);
34 std::vector<MatrixType> v(10, MatrixType(rows,cols)), w(20, y);
51 VERIFY((internal::UIntPtr)&(v[22]) == (internal::UIntPtr)&(v[21]) + sizeof(MatrixType));
67 typedef typename TransformType::MatrixType MatrixType; typedef
[all...]
H A Dbdcsvd.cpp28 template<typename MatrixType>
29 void bdcsvd(const MatrixType& a = MatrixType(), bool pickrandom = true) argument
31 MatrixType m = a;
35 CALL_SUBTEST(( svd_test_all_computation_options<BDCSVD<MatrixType> >(m, false) ));
38 template<typename MatrixType>
41 enum { Size = MatrixType::RowsAtCompileTime };
42 typedef typename MatrixType::RealScalar RealScalar;
44 MatrixType m = MatrixType
53 compare_bdc_jacobi(const MatrixType& a = MatrixType(), unsigned int computationOptions = 0) argument
[all...]
H A Dlinearstructure.cpp16 template<typename MatrixType> void linearStructure(const MatrixType& m)
22 typedef typename MatrixType::Index Index;
23 typedef typename MatrixType::Scalar Scalar;
24 typedef typename MatrixType::RealScalar RealScalar;
31 MatrixType m1 = MatrixType::Random(rows, cols),
32 m2 = MatrixType::Random(rows, cols),
77 template<typename MatrixType> void real_complex(DenseIndex rows = MatrixType argument
[all...]
H A Dproduct_large.cpp17 typedef Matrix<T,Dynamic,Dynamic> MatrixType; typedef
22 MatrixType A(rows,cols); A.setRandom();
/external/eigen/doc/snippets/
H A DTutorial_Map_using.cpp1 typedef Matrix<float,1,Dynamic> MatrixType; typedef
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/Eigen/src/Eigenvalues/
H A DGeneralizedSelfAdjointEigenSolver.h37 * GeneralizedSelfAdjointEigenSolver(const MatrixType&, const MatrixType&, int)
42 * The documentation for GeneralizedSelfAdjointEigenSolver(const MatrixType&, const MatrixType&, int)
53 typedef _MatrixType MatrixType; typedef in class:Eigen::GeneralizedSelfAdjointEigenSolver
89 * This constructor calls compute(const MatrixType&, const MatrixType&, int)
104 * \sa compute(const MatrixType&, const MatrixType&, int)
106 GeneralizedSelfAdjointEigenSolver(const MatrixType
[all...]
/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/doc/examples/
H A Dmake_circulant2.cpp29 ArgType::MaxSizeAtCompileTime> MatrixType; typedef in struct:circulant_helper
35 CwiseNullaryOp<circulant_functor<ArgType>, typename circulant_helper<ArgType>::MatrixType>
38 typedef typename circulant_helper<ArgType>::MatrixType MatrixType; typedef
39 return MatrixType::NullaryExpr(arg.size(), arg.size(), circulant_functor<ArgType>(arg.derived()));
H A Dnullary_indexing.cpp18 ColIndexType::MaxSizeAtCompileTime> MatrixType; typedef in class:indexing_functor
32 CwiseNullaryOp<indexing_functor<ArgType,RowIndexType,ColIndexType>, typename indexing_functor<ArgType,RowIndexType,ColIndexType>::MatrixType>
36 typedef typename Func::MatrixType MatrixType; typedef
37 return MatrixType::NullaryExpr(row_indices.size(), col_indices.size(), Func(arg.derived(), row_indices, col_indices));
/external/eigen/unsupported/bench/
H A Dbench_svd.cpp33 template<typename MatrixType>
34 void bench_svd(const MatrixType& a = MatrixType()) argument
36 MatrixType m = MatrixType::Random(a.rows(), a.cols());
48 BDCSVD<MatrixType> bdc_matrix(m);
55 JacobiSVD<MatrixType> jacobi_matrix(m);
79 BDCSVD<MatrixType> bdc_matrix(m, ComputeFullU|ComputeFullV);
86 JacobiSVD<MatrixType> jacobi_matrix(m, ComputeFullU|ComputeFullV);
/external/eigen/unsupported/test/
H A Dmatrix_functions.h14 template<typename MatrixType, int IsComplex = NumTraits<typename internal::traits<MatrixType>::Scalar>::IsComplex>
17 static void run(MatrixType&, MatrixType&, const MatrixType&) argument
22 template<typename MatrixType>
23 struct processTriangularMatrix<MatrixType,0>
25 static void run(MatrixType& m, MatrixType& T, const MatrixType
[all...]
/external/eigen/Eigen/src/misc/
H A DKernel.h23 typedef typename DecompositionType::MatrixType MatrixType; typedef in struct:Eigen::internal::traits
25 typename MatrixType::Scalar,
26 MatrixType::ColsAtCompileTime, // the number of rows in the "kernel matrix"
30 MatrixType::Options,
31 MatrixType::MaxColsAtCompileTime, // see explanation for 2nd template parameter
32 MatrixType::MaxColsAtCompileTime // the kernel is a subspace of the domain space,
67 typedef typename DecompositionType::MatrixType MatrixType; \
68 typedef typename MatrixType
[all...]
/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...]

Completed in 272 milliseconds

1234