/external/eigen/Eigen/src/OrderingMethods/ |
D | Ordering.h | 51 template <typename StorageIndex> 55 typedef PermutationMatrix<Dynamic, Dynamic, StorageIndex> PermutationType; 64 SparseMatrix<typename MatrixType::Scalar, ColMajor, StorageIndex> symm; in operator() 76 SparseMatrix<typename SrcType::Scalar, ColMajor, StorageIndex> C; C = mat; in operator() 94 template <typename StorageIndex> 98 typedef PermutationMatrix<Dynamic, Dynamic, StorageIndex> PermutationType; 117 template<typename StorageIndex> 121 typedef PermutationMatrix<Dynamic, Dynamic, StorageIndex> PermutationType; 122 typedef Matrix<StorageIndex, Dynamic, 1> IndexVector; 132 StorageIndex m = StorageIndex(mat.rows()); in operator() [all …]
|
D | Amd.h | 44 template<typename StorageIndex> 45 static StorageIndex cs_wclear (StorageIndex mark, StorageIndex lemax, StorageIndex *w, StorageIndex… in cs_wclear() 47 StorageIndex k; in cs_wclear() 59 template<typename StorageIndex> 60 StorageIndex cs_tdfs(StorageIndex j, StorageIndex k, StorageIndex *head, const StorageIndex *next, … in cs_tdfs() 62 StorageIndex i, p, top = 0; in cs_tdfs() 93 template<typename Scalar, typename StorageIndex> 94 …egree_ordering(SparseMatrix<Scalar,ColMajor,StorageIndex>& C, PermutationMatrix<Dynamic,Dynamic,St… in minimum_degree_ordering() 98 StorageIndex d, dk, dext, lemax = 0, e, elenk, eln, i, j, k, k1, in minimum_degree_ordering() 102 StorageIndex n = StorageIndex(C.cols()); in minimum_degree_ordering() [all …]
|
/external/eigen/Eigen/src/SparseLU/ |
D | SparseLU_panel_dfs.h | 40 typedef typename IndexVector::Scalar StorageIndex; typedef 41 panel_dfs_traits(Index jcol, StorageIndex* marker) in panel_dfs_traits() 44 bool update_segrep(Index krep, StorageIndex jj) in update_segrep() 56 StorageIndex* m_marker; 60 template <typename Scalar, typename StorageIndex> 62 void SparseLUImpl<Scalar,StorageIndex>::dfs_kernel(const StorageIndex jj, IndexVector& perm_r, in dfs_kernel() 70 StorageIndex kmark = marker(krow); in dfs_kernel() 74 StorageIndex kperm = perm_r(krow); in dfs_kernel() 77 panel_lsub(nextl_col++) = StorageIndex(krow); // krow is indexed into A in dfs_kernel() 86 StorageIndex krep = glu.xsup(glu.supno(kperm)+1) - 1; in dfs_kernel() [all …]
|
D | SparseLU_column_dfs.h | 33 template <typename Scalar, typename StorageIndex> class SparseLUImpl; 42 typedef typename IndexVector::Scalar StorageIndex; typedef 43 …ndex& jsuper, typename SparseLUImpl<Scalar, StorageIndex>::GlobalLU_t& glu, SparseLUImpl<Scalar, S… in column_dfs_traits() 60 typename SparseLUImpl<Scalar, StorageIndex>::GlobalLU_t& m_glu; 61 SparseLUImpl<Scalar, StorageIndex>& m_luImpl; 92 template <typename Scalar, typename StorageIndex> 93 Index SparseLUImpl<Scalar,StorageIndex>::column_dfs(const Index m, const Index jcol, IndexVector& p… in column_dfs() 115 dfs_kernel(StorageIndex(jcol), perm_r, nseg, glu.lsub, segrep, repfnz, xprune, marker2, parent, in column_dfs() 120 StorageIndex nsuper = glu.supno(jcol); in column_dfs() 121 StorageIndex jcolp1 = StorageIndex(jcol) + 1; in column_dfs() [all …]
|
D | SparseLU_SupernodalMatrix.h | 37 typedef _StorageIndex StorageIndex; typedef 38 typedef Matrix<StorageIndex,Dynamic,1> IndexVector; 99 StorageIndex* colIndexPtr() in colIndexPtr() 104 const StorageIndex* colIndexPtr() const in colIndexPtr() 112 StorageIndex* rowIndex() { return m_rowind; } in rowIndex() 114 const StorageIndex* rowIndex() const in rowIndex() 122 StorageIndex* rowIndexPtr() { return m_rowind_colptr; } in rowIndexPtr() 124 const StorageIndex* rowIndexPtr() const in rowIndexPtr() 132 StorageIndex* colToSup() { return m_col_to_sup; } in colToSup() 134 const StorageIndex* colToSup() const in colToSup() [all …]
|
D | SparseLU_heap_relax_snode.h | 45 template <typename Scalar, typename StorageIndex> 46 void SparseLUImpl<Scalar,StorageIndex>::heap_relax_snode (const Index n, IndexVector& et, const Ind… in heap_relax_snode() 51 internal::treePostorder(StorageIndex(n), et, post); // Post order etree in heap_relax_snode() 53 for (StorageIndex i = 0; i < n+1; ++i) inv_post(post(i)) = i; // inv_post = post.inverse()??? in heap_relax_snode() 77 StorageIndex k; in heap_relax_snode() 80 StorageIndex l; in heap_relax_snode() 92 k = StorageIndex(n); in heap_relax_snode()
|
D | SparseLU.h | 17 …ixType, typename _OrderingType = COLAMDOrdering<typename _MatrixType::StorageIndex> > class Sparse… 74 … >, public internal::SparseLUImpl<typename _MatrixType::Scalar, typename _MatrixType::StorageIndex> 86 typedef typename MatrixType::StorageIndex StorageIndex; typedef 87 typedef SparseMatrix<Scalar,ColMajor,StorageIndex> NCMatrix; 88 typedef internal::MappedSuperNodalMatrix<Scalar, StorageIndex> SCMatrix; 90 typedef Matrix<StorageIndex,Dynamic,1> IndexVector; 91 typedef PermutationMatrix<Dynamic, Dynamic, StorageIndex> PermutationType; 92 typedef internal::SparseLUImpl<Scalar, StorageIndex> Base; 156 …SparseLUMatrixUReturnType<SCMatrix,MappedSparseMatrix<Scalar,ColMajor,StorageIndex> > matrixU() co… in matrixU() 158 …return SparseLUMatrixUReturnType<SCMatrix, MappedSparseMatrix<Scalar,ColMajor,StorageIndex> >(m_Ls… in matrixU() [all …]
|
/external/eigen/Eigen/src/SparseCore/ |
D | SparseColEtree.h | 61 …ype& mat, IndexVector& parent, IndexVector& firstRowElt, typename MatrixType::StorageIndex *perm=0) 63 typedef typename MatrixType::StorageIndex StorageIndex; typedef 64 StorageIndex nc = convert_index<StorageIndex>(mat.cols()); // Number of columns 65 StorageIndex m = convert_index<StorageIndex>(mat.rows()); 66 StorageIndex diagSize = (std::min)(nc,m); 77 for (StorageIndex col = 0; col < nc; col++) 79 StorageIndex pcol = col; 91 StorageIndex rset, cset, rroot; 92 for (StorageIndex col = 0; col < nc; col++) 101 StorageIndex pcol = col; [all …]
|
D | SparseMap.h | 56 typedef typename Base::StorageIndex StorageIndex; 66 StorageIndex *, const StorageIndex *>::type IndexPointer; 70 Array<StorageIndex,2,1> m_zero_nnz; 97 inline const StorageIndex* innerIndexPtr() const { return m_innerIndices; } 99 inline const StorageIndex* outerIndexPtr() const { return m_outerIndex; } 101 inline const StorageIndex* innerNonZeroPtr() const { return m_innerNonZeros; } 119 const StorageIndex* r = std::lower_bound(&m_innerIndices[start],&m_innerIndices[end-1],inner); 126 …innerSize(IsRowMajor?cols:rows), m_zero_nnz(0,internal::convert_index<StorageIndex>(nnz)), m_outer… 132 …: m_outerSize(1), m_innerSize(size), m_zero_nnz(0,internal::convert_index<StorageIndex>(nnz)), m_o… 156 typedef typename Base::StorageIndex StorageIndex; [all …]
|
D | SparseMatrix.h | 50 typedef _StorageIndex StorageIndex; 72 typedef _StorageIndex StorageIndex; 117 typedef internal::CompressedStorage<Scalar,StorageIndex> Storage; 129 StorageIndex* m_outerIndex; 130 StorageIndex* m_innerNonZeros; // optional, if null then the data is compressed 157 inline const StorageIndex* innerIndexPtr() const { return m_data.indexPtr(); } 161 inline StorageIndex* innerIndexPtr() { return m_data.indexPtr(); } 166 inline const StorageIndex* outerIndexPtr() const { return m_outerIndex; } 170 inline StorageIndex* outerIndexPtr() { return m_outerIndex; } 175 inline const StorageIndex* innerNonZeroPtr() const { return m_innerNonZeros; } [all …]
|
D | SparseSelfAdjointView.h | 36 …ixType::Scalar,DestOrder,typename MatrixType::StorageIndex>& _dest, const typename MatrixType::Sto… 39 …ixType::Scalar,DestOrder,typename MatrixType::StorageIndex>& _dest, const typename MatrixType::Sto… 57 typedef typename MatrixType::StorageIndex StorageIndex; 58 typedef Matrix<StorageIndex,Dynamic,1> VectorI; 127 …MatrixTypeNested,Mode> twistedBy(const PermutationMatrix<Dynamic,Dynamic,StorageIndex>& perm) const 141 PermutationMatrix<Dynamic,Dynamic,StorageIndex> pnull; 148 PermutationMatrix<Dynamic,Dynamic,StorageIndex> pnull; 225 typedef typename DstXprType::StorageIndex StorageIndex; 229 …static void run(SparseMatrix<DestScalar,StorageOrder,StorageIndex> &dst, const SrcXprType &src, co… 236 …static void run(SparseMatrix<DestScalar,StorageOrder,StorageIndex> &dst, const SrcXprType &src, co… [all …]
|
D | AmbiVector.h | 27 typedef _StorageIndex StorageIndex; typedef 61 StorageIndex size() const { return m_size; } in size() 64 StorageIndex convert_index(Index idx) in convert_index() 66 return internal::convert_index<StorageIndex>(idx); in convert_index() 93 m_allocatedElements = (std::min)(StorageIndex(m_allocatedElements*1.5),m_size); in reallocateSparse() 106 StorageIndex next; 107 StorageIndex index; 114 StorageIndex m_size; 115 StorageIndex m_start; 116 StorageIndex m_end; [all …]
|
D | SparseTranspose.h | 29 typedef typename Base::StorageIndex StorageIndex; typedef 34 …inline const StorageIndex* innerIndexPtr() const { return derived().nestedExpression().innerIndexP… in innerIndexPtr() 35 …inline const StorageIndex* outerIndexPtr() const { return derived().nestedExpression().outerIndexP… in outerIndexPtr() 36 …inline const StorageIndex* innerNonZeroPtr() const { return derived().nestedExpression().innerNonZ… in innerNonZeroPtr() 39 inline StorageIndex* innerIndexPtr() { return derived().nestedExpression().innerIndexPtr(); } in innerIndexPtr() 40 inline StorageIndex* outerIndexPtr() { return derived().nestedExpression().outerIndexPtr(); } in outerIndexPtr() 41 … inline StorageIndex* innerNonZeroPtr() { return derived().nestedExpression().innerNonZeroPtr(); } in innerNonZeroPtr()
|
D | SparseUtil.h | 84 typedef typename traits<T>::StorageIndex _StorageIndex; 91 typedef typename traits<T>::StorageIndex _StorageIndex; 99 typedef typename traits<T>::StorageIndex _StorageIndex; 114 typedef typename traits<T>::StorageIndex _StorageIndex; 153 template<typename Scalar, typename StorageIndex=typename SparseMatrix<Scalar>::StorageIndex > 159 Triplet(const StorageIndex& i, const StorageIndex& j, const Scalar& v = Scalar(0)) 164 const StorageIndex& row() const { return m_row; } 167 const StorageIndex& col() const { return m_col; } 172 StorageIndex m_row, m_col;
|
D | CompressedStorage.h | 27 typedef _StorageIndex StorageIndex; typedef 93 …Index realloc_size = (std::min<Index>)(NumTraits<StorageIndex>::highest(), size + Index(reserveSi… 106 m_indices[id] = internal::convert_index<StorageIndex>(i); in append() 115 const StorageIndex* indexPtr() const { return m_indices; } in indexPtr() 116 StorageIndex* indexPtr() { return m_indices; } in indexPtr() 121 … inline StorageIndex& index(Index i) { eigen_internal_assert(m_indices!=0); return m_indices[i]; } in index() 122 …inline const StorageIndex& index(Index i) const { eigen_internal_assert(m_indices!=0); return m_in… in index() 183 internal::scoped_array<StorageIndex> newIndices(m_allocatedSize); 204 m_indices[id] = internal::convert_index<StorageIndex>(key); 235 internal::scoped_array<StorageIndex> newIndices(size); in reallocate() [all …]
|
/external/eigen/Eigen/src/IterativeLinearSolvers/ |
D | IncompleteLUT.h | 106 typedef _StorageIndex StorageIndex; typedef 109 typedef Matrix<StorageIndex,Dynamic,1> VectorI; 110 typedef SparseMatrix<Scalar,RowMajor,StorageIndex> FactorType; 197 PermutationMatrix<Dynamic,Dynamic,StorageIndex> m_P; // Fill-reducing permutation 198 PermutationMatrix<Dynamic,Dynamic,StorageIndex> m_Pinv; // Inverse permutation 205 template<typename Scalar, typename StorageIndex> 206 void IncompleteLUT<Scalar,StorageIndex>::setDroptol(const RealScalar& droptol) in setDroptol() 215 template<typename Scalar, typename StorageIndex> 216 void IncompleteLUT<Scalar,StorageIndex>::setFillfactor(int fillfactor) in setFillfactor() 221 template <typename Scalar, typename StorageIndex> [all …]
|
/external/eigen/Eigen/src/SparseCholesky/ |
D | SimplicialCholesky_impl.h | 53 const StorageIndex size = StorageIndex(ap.rows()); in analyzePattern_preordered() 58 ei_declare_aligned_stack_constructed_variable(StorageIndex, tags, size, 0); in analyzePattern_preordered() 60 for(StorageIndex k = 0; k < size; ++k) in analyzePattern_preordered() 68 StorageIndex i = it.index(); in analyzePattern_preordered() 85 StorageIndex* Lp = m_matrix.outerIndexPtr(); in analyzePattern_preordered() 87 for(StorageIndex k = 0; k < size; ++k) in analyzePattern_preordered() 110 const StorageIndex size = StorageIndex(ap.rows()); in factorize_preordered() 111 const StorageIndex* Lp = m_matrix.outerIndexPtr(); in factorize_preordered() 112 StorageIndex* Li = m_matrix.innerIndexPtr(); in factorize_preordered() 116 ei_declare_aligned_stack_constructed_variable(StorageIndex, pattern, size, 0); in factorize_preordered() [all …]
|
D | SimplicialCholesky.h | 66 typedef typename MatrixType::StorageIndex StorageIndex; 67 typedef SparseMatrix<Scalar,ColMajor,StorageIndex> CholMatrixType; 70 typedef Matrix<StorageIndex,Dynamic,1> VectorI; 115 const PermutationMatrix<Dynamic,Dynamic,StorageIndex>& permutationP() const 120 const PermutationMatrix<Dynamic,Dynamic,StorageIndex>& permutationPinv() const 259 PermutationMatrix<Dynamic,Dynamic,StorageIndex> m_P; // the permutation 260 PermutationMatrix<Dynamic,Dynamic,StorageIndex> m_Pinv; // the inverse permutation 266 …_UpLo = Lower, typename _Ordering = AMDOrdering<typename _MatrixType::StorageIndex> > class Simpli… 267 …_UpLo = Lower, typename _Ordering = AMDOrdering<typename _MatrixType::StorageIndex> > class Simpli… 268 …_UpLo = Lower, typename _Ordering = AMDOrdering<typename _MatrixType::StorageIndex> > class Simpli… [all …]
|
/external/eigen/Eigen/src/PardisoSupport/ |
D | PardisoSupport.h | 75 typedef typename _MatrixType::StorageIndex StorageIndex; 84 typedef typename _MatrixType::StorageIndex StorageIndex; 93 typedef typename _MatrixType::StorageIndex StorageIndex; 113 typedef typename Traits::StorageIndex StorageIndex; 114 typedef SparseMatrix<Scalar,RowMajor,StorageIndex> SparseMatrixType; 116 typedef Matrix<StorageIndex, 1, MatrixType::ColsAtCompileTime> IntRowVectorType; 117 typedef Matrix<StorageIndex, MatrixType::RowsAtCompileTime, 1> IntColVectorType; 118 typedef Array<StorageIndex,64,1,DontAlign> ParameterType; 127 …eigen_assert((sizeof(StorageIndex) >= sizeof(_INTEGER_t) && sizeof(StorageIndex) <= 8) && "Non-sup… 186 …internal::pardiso_run_selector<StorageIndex>::run(m_pt, 1, 1, m_type, -1, internal::convert_index<… [all …]
|
/external/eigen/unsupported/Eigen/src/SparseExtra/ |
D | BlockSparseMatrix.h | 289 typedef _StorageIndex StorageIndex; 306 …typedef BlockSparseMatrix<Scalar, BlockSize, IsColMajor ? ColMajor : RowMajor, StorageIndex> Plain… 415 for(StorageIndex bj = 0; bj < m_outerBSize; ++bj) 420 for(StorageIndex j = blockOuterIndex(bj); j < blockOuterIndex(bj+1); ++j) 425 StorageIndex bi = innerToBlock(it_spmat.index()); // Index of the current nonzero block 442 for(StorageIndex nz = 0; nz < m_nonzeros; ++nz) m_values[nz] = Scalar(0); 443 for(StorageIndex bj = 0; bj < m_outerBSize; ++bj) 446 for(StorageIndex j = blockOuterIndex(bj); j < blockOuterIndex(bj+1); ++j) 452 StorageIndex idx = 0; // Position of this block in the column block 453 StorageIndex bi = innerToBlock(it_spmat.index()); // Index of the current nonzero block [all …]
|
/external/eigen/Eigen/src/MetisSupport/ |
D | MetisSupport.h | 21 template <typename StorageIndex> 25 typedef PermutationMatrix<Dynamic,Dynamic,StorageIndex> PermutationType; 26 typedef Matrix<StorageIndex,Dynamic,1> IndexVector; 39 for (StorageIndex j = 0; j < m; j++) in get_symmetrized_graph() 70 StorageIndex CurNz = 0; in get_symmetrized_graph() 71 for (StorageIndex j = 0; j < m; j++) in get_symmetrized_graph() 79 …StorageIndex idx = it.index(); // Get the row index (for column major) or column index (for row ma… in get_symmetrized_graph() 90 StorageIndex idx = it.index(); in get_symmetrized_graph() 105 …StorageIndex m = internal::convert_index<StorageIndex>(A.cols()); // must be StorageIndex, because… in operator()
|
/external/eigen/Eigen/src/CholmodSupport/ |
D | CholmodSupport.h | 154 template<typename Scalar, int Flags, typename StorageIndex> 155 MappedSparseMatrix<Scalar,Flags,StorageIndex> viewAsEigen(cholmod_sparse& cm) 157 return MappedSparseMatrix<Scalar,Flags,StorageIndex> 158 (cm.nrow, cm.ncol, static_cast<StorageIndex*>(cm.p)[cm.ncol], 159 … static_cast<StorageIndex*>(cm.p), static_cast<StorageIndex*>(cm.i),static_cast<Scalar*>(cm.x) ); 185 typedef typename MatrixType::StorageIndex StorageIndex; 217 …inline StorageIndex cols() const { return internal::convert_index<StorageIndex, Index>(m_cholmodFa… 218 …inline StorageIndex rows() const { return internal::convert_index<StorageIndex, Index>(m_cholmodFa… 317 …Ref<SparseMatrix<typename RhsDerived::Scalar,ColMajor,typename RhsDerived::StorageIndex> > b_ref(b… 326 …d() = viewAsEigen<typename DestDerived::Scalar,ColMajor,typename DestDerived::StorageIndex>(*x_cs); [all …]
|
/external/eigen/Eigen/src/Core/ |
D | Transpositions.h | 23 typedef typename IndicesType::Scalar StorageIndex; typedef 56 inline const StorageIndex& coeff(Index i) const { return indices().coeff(i); } in coeff() 58 inline StorageIndex& coeffRef(Index i) { return indices().coeffRef(i); } in coeffRef() 60 inline const StorageIndex& operator()(Index i) const { return indices()(i); } in operator() 62 inline StorageIndex& operator()(Index i) { return indices()(i); } in operator() 64 inline const StorageIndex& operator[](Index i) const { return indices()(i); } 66 inline StorageIndex& operator[](Index i) { return indices()(i); } 82 for(StorageIndex i = 0; i < indices().size(); ++i) in setIdentity() 165 typedef typename IndicesType::Scalar StorageIndex; 225 typedef _StorageIndex StorageIndex; [all …]
|
D | PermutationMatrix.h | 61 typedef typename Traits::StorageIndex StorageIndex; typedef 62 …typedef Matrix<StorageIndex,RowsAtCompileTime,ColsAtCompileTime,0,MaxRowsAtCompileTime,MaxColsAtCo… 64 …ef PermutationMatrix<IndicesType::SizeAtCompileTime,IndicesType::MaxSizeAtCompileTime,StorageIndex> 144 StorageIndex n = StorageIndex(size()); in setIdentity() 145 for(StorageIndex i = 0; i < n; ++i) in setIdentity() 171 if(indices().coeff(k) == i) indices().coeffRef(k) = StorageIndex(j); in applyTranspositionOnTheLeft() 172 else if(indices().coeff(k) == j) indices().coeffRef(k) = StorageIndex(i); in applyTranspositionOnTheLeft() 289 typedef _StorageIndex StorageIndex; 318 typedef typename Traits::StorageIndex StorageIndex; 328 eigen_internal_assert(size <= NumTraits<StorageIndex>::highest()); [all …]
|
/external/eigen/Eigen/src/SparseQR/ |
D | SparseQR.h | 24 typedef typename ReturnType::StorageIndex StorageIndex; 82 typedef typename MatrixType::StorageIndex StorageIndex; 83 typedef SparseMatrix<Scalar,ColMajor,StorageIndex> QRMatrixType; 84 typedef Matrix<StorageIndex, Dynamic, 1> IndexVector; 86 typedef PermutationMatrix<Dynamic, Dynamic, StorageIndex> PermutationType; 322 m_perm_c.indices().setLinSpaced(n, 0,StorageIndex(n-1)); 353 StorageIndex m = StorageIndex(mat.rows()); 354 StorageIndex n = StorageIndex(mat.cols()); 355 StorageIndex diagSize = (std::min)(m,n); 380 const StorageIndex *originalOuterIndices = mat.outerIndexPtr(); [all …]
|