HomeSort by relevance Sort by last modified time
    Searched refs:StorageIndex (Results 1 - 25 of 97) sorted by null

1 2 3 4

  /external/eigen/Eigen/src/OrderingMethods/
Ordering.h 48 * \tparam StorageIndex The type of indices of the matrix
51 template <typename StorageIndex>
55 typedef PermutationMatrix<Dynamic, Dynamic, StorageIndex> PermutationType;
64 SparseMatrix<typename MatrixType::Scalar, ColMajor, StorageIndex> symm;
76 SparseMatrix<typename SrcType::Scalar, ColMajor, StorageIndex> C; C = mat;
92 * \tparam StorageIndex The type of indices of the matrix
94 template <typename StorageIndex>
98 typedef PermutationMatrix<Dynamic, Dynamic, StorageIndex> PermutationType;
112 * \tparam StorageIndex The type of indices of the matrix
117 template<typename StorageIndex>
    [all...]
Amd.h 44 template<typename StorageIndex>
45 static StorageIndex cs_wclear (StorageIndex mark, StorageIndex lemax, StorageIndex *w, StorageIndex n)
47 StorageIndex k;
59 template<typename StorageIndex>
60 StorageIndex cs_tdfs(StorageIndex j, StorageIndex k, StorageIndex *head, const StorageIndex *next, StorageIndex *post, StorageIndex (…)
    [all...]
  /external/eigen/Eigen/src/SparseCore/
SparseColEtree.h 61 int coletree(const MatrixType& mat, IndexVector& parent, IndexVector& firstRowElt, typename MatrixType::StorageIndex *perm=0)
63 typedef typename MatrixType::StorageIndex StorageIndex;
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
    [all...]
SparseTranspose.h 29 typedef typename Base::StorageIndex StorageIndex;
34 inline const StorageIndex* innerIndexPtr() const { return derived().nestedExpression().innerIndexPtr(); }
35 inline const StorageIndex* outerIndexPtr() const { return derived().nestedExpression().outerIndexPtr(); }
36 inline const StorageIndex* innerNonZeroPtr() const { return derived().nestedExpression().innerNonZeroPtr(); }
39 inline StorageIndex* innerIndexPtr() { return derived().nestedExpression().innerIndexPtr(); }
40 inline StorageIndex* outerIndexPtr() { return derived().nestedExpression().outerIndexPtr(); }
41 inline StorageIndex* innerNonZeroPtr() { return derived().nestedExpression().innerNonZeroPtr(); }
MappedSparseMatrix.h 39 typedef typename Base::StorageIndex StorageIndex;
42 inline MappedSparseMatrix(Index rows, Index cols, Index nnz, StorageIndex* outerIndexPtr, StorageIndex* innerIndexPtr, Scalar* valuePtr, StorageIndex* innerNonZeroPtr = 0)
AmbiVector.h 27 typedef _StorageIndex StorageIndex;
61 StorageIndex size() const { return m_size; }
64 StorageIndex convert_index(Index idx)
66 return internal::convert_index<StorageIndex>(idx);
93 m_allocatedElements = (std::min)(StorageIndex(m_allocatedElements*1.5),m_size);
106 StorageIndex next;
107 StorageIndex index;
114 StorageIndex m_size;
115 StorageIndex m_start;
116 StorageIndex m_end
    [all...]
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 : m_outerSize(IsRowMajor?rows:cols), m_innerSize(IsRowMajor?cols:rows), m_zero_nnz(0,internal::convert_index<StorageIndex>(nnz)), m_outerIndex(outerIndexPtr)
    [all...]
SparseMatrix.h 39 * Codes making use of \c SparseMatrix::Index, might thus likely have to be changed to use \c SparseMatrix::StorageIndex instead.
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;
    [all...]
SparseSelfAdjointView.h 36 void permute_symm_to_symm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DestOrder,typename MatrixType::StorageIndex>& _dest, const typename MatrixType::StorageIndex* perm = 0);
39 void permute_symm_to_fullsymm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DestOrder,typename MatrixType::StorageIndex>& _dest, const typename MatrixType::StorageIndex* perm = 0);
57 typedef typename MatrixType::StorageIndex StorageIndex;
58 typedef Matrix<StorageIndex,Dynamic,1> VectorI;
127 SparseSymmetricPermutationProduct<_MatrixTypeNested,Mode> twistedBy(const PermutationMatrix<Dynamic,Dynamic,StorageIndex>& perm) const
141 PermutationMatrix<Dynamic,Dynamic,StorageIndex> pnull;
148 PermutationMatrix<Dynamic,Dynamic,StorageIndex> pnull
    [all...]
CompressedStorage.h 27 typedef _StorageIndex StorageIndex;
93 Index realloc_size = (std::min<Index>)(NumTraits<StorageIndex>::highest(), size + Index(reserveSizeFactor*double(size)));
106 m_indices[id] = internal::convert_index<StorageIndex>(i);
115 const StorageIndex* indexPtr() const { return m_indices; }
116 StorageIndex* indexPtr() { return m_indices; }
121 inline StorageIndex& index(Index i) { eigen_internal_assert(m_indices!=0); return m_indices[i]; }
122 inline const StorageIndex& index(Index i) const { eigen_internal_assert(m_indices!=0); return m_indices[i]; }
183 internal::scoped_array<StorageIndex> newIndices(m_allocatedSize);
204 m_indices[id] = internal::convert_index<StorageIndex>(key);
235 internal::scoped_array<StorageIndex> newIndices(size)
    [all...]
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;
    [all...]
  /external/eigen/Eigen/src/SparseLU/
SparseLU_column_dfs.h 33 template <typename Scalar, typename StorageIndex> class SparseLUImpl;
42 typedef typename IndexVector::Scalar StorageIndex;
43 column_dfs_traits(Index jcol, Index& jsuper, typename SparseLUImpl<Scalar, StorageIndex>::GlobalLU_t& glu, SparseLUImpl<Scalar, StorageIndex>& luImpl)
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& perm_r, Index maxsuper, Index& nseg,
115 dfs_kernel(StorageIndex(jcol), perm_r, nseg, glu.lsub, segrep, repfnz, xprune, marker2, parent,
120 StorageIndex nsuper = glu.supno(jcol)
    [all...]
SparseLU_panel_dfs.h 40 typedef typename IndexVector::Scalar StorageIndex;
41 panel_dfs_traits(Index jcol, StorageIndex* marker)
44 bool update_segrep(Index krep, StorageIndex jj)
56 StorageIndex* m_marker;
60 template <typename Scalar, typename StorageIndex>
62 void SparseLUImpl<Scalar,StorageIndex>::dfs_kernel(const StorageIndex jj, IndexVector& perm_r,
70 StorageIndex kmark = marker(krow);
74 StorageIndex kperm = perm_r(krow);
77 panel_lsub(nextl_col++) = StorageIndex(krow); // krow is indexed into
    [all...]
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 Index relax_columns, IndexVector& descendants, IndexVector& relax_end)
51 internal::treePostorder(StorageIndex(n), et, post); // Post order etree
53 for (StorageIndex i = 0; i < n+1; ++i) inv_post(post(i)) = i; // inv_post = post.inverse()???
77 StorageIndex k;
80 StorageIndex l;
92 k = StorageIndex(n);
SparseLU_SupernodalMatrix.h 37 typedef _StorageIndex StorageIndex;
38 typedef Matrix<StorageIndex,Dynamic,1> IndexVector;
99 StorageIndex* colIndexPtr()
104 const StorageIndex* colIndexPtr() const
112 StorageIndex* rowIndex() { return m_rowind; }
114 const StorageIndex* rowIndex() const
122 StorageIndex* rowIndexPtr() { return m_rowind_colptr; }
124 const StorageIndex* rowIndexPtr() const
132 StorageIndex* colToSup() { return m_col_to_sup; }
134 const StorageIndex* colToSup() cons
    [all...]
SparseLU_relax_snode.h 46 template <typename Scalar, typename StorageIndex>
47 void SparseLUImpl<Scalar,StorageIndex>::relax_snode (const Index n, IndexVector& et, const Index relax_columns, IndexVector& descendants, IndexVector& relax_end)
72 relax_end(snode_start) = StorageIndex(j); // Record last column
SparseLU_Utils.h 20 template <typename Scalar, typename StorageIndex>
21 void SparseLUImpl<Scalar,StorageIndex>::countnz(const Index n, Index& nnzL, Index& nnzU, GlobalLU_t& glu)
51 template <typename Scalar, typename StorageIndex>
52 void SparseLUImpl<Scalar,StorageIndex>::fixupL(const Index n, const IndexVector& perm_r, GlobalLU_t& glu)
56 StorageIndex nextl = 0;
SparseLU_pivotL.h 59 template <typename Scalar, typename StorageIndex>
60 Index SparseLUImpl<Scalar,StorageIndex>::pivotL(const Index jcol, const RealScalar& diagpivotthresh, IndexVector& perm_r, IndexVector& iperm_c, Index& pivrow, GlobalLU_t& glu)
70 StorageIndex* lsub_ptr = &(glu.lsub.data()[lptr]); // Start of row indices of the supernode
93 perm_r(pivrow) = StorageIndex(jcol);
114 perm_r(pivrow) = StorageIndex(jcol);
  /external/eigen/Eigen/src/SparseCholesky/
SimplicialCholesky_impl.h 53 const StorageIndex size = StorageIndex(ap.rows());
58 ei_declare_aligned_stack_constructed_variable(StorageIndex, tags, size, 0);
60 for(StorageIndex k = 0; k < size; ++k)
68 StorageIndex i = it.index();
85 StorageIndex* Lp = m_matrix.outerIndexPtr();
87 for(StorageIndex k = 0; k < size; ++k)
110 const StorageIndex size = StorageIndex(ap.rows());
111 const StorageIndex* Lp = m_matrix.outerIndexPtr()
    [all...]
  /external/eigen/Eigen/src/MetisSupport/
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++)
70 StorageIndex CurNz = 0;
71 for (StorageIndex j = 0; j < m; j++)
79 StorageIndex idx = it.index(); // Get the row index (for column major) or column index (for row major)
90 StorageIndex idx = it.index();
105 StorageIndex m = internal::convert_index<StorageIndex>(A.cols()); // must be StorageIndex, because it is passed by address to METI
    [all...]
  /external/eigen/Eigen/src/PardisoSupport/
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
    [all...]
  /external/eigen/Eigen/src/IterativeLinearSolvers/
IncompleteLUT.h 106 typedef _StorageIndex StorageIndex;
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)
215 template<typename Scalar, typename StorageIndex>
216 void IncompleteLUT<Scalar,StorageIndex>::setFillfactor(int fillfactor)
221 template <typename Scalar, typename StorageIndex>
    [all...]
  /external/eigen/Eigen/src/CholmodSupport/
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_cholmodFactor->n);
    [all...]
  /external/eigen/unsupported/Eigen/src/SparseExtra/
BlockSparseMatrix.h 289 typedef _StorageIndex StorageIndex;
306 typedef BlockSparseMatrix<Scalar, BlockSize, IsColMajor ? ColMajor : RowMajor, StorageIndex> PlainObject;
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 bloc
    [all...]
  /external/eigen/Eigen/src/Core/
Transpositions.h 23 typedef typename IndicesType::Scalar StorageIndex;
56 inline const StorageIndex& coeff(Index i) const { return indices().coeff(i); }
58 inline StorageIndex& coeffRef(Index i) { return indices().coeffRef(i); }
60 inline const StorageIndex& operator()(Index i) const { return indices()(i); }
62 inline StorageIndex& operator()(Index i) { return indices()(i); }
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)
165 typedef typename IndicesType::Scalar StorageIndex;
225 typedef _StorageIndex StorageIndex;
    [all...]

Completed in 131 milliseconds

1 2 3 4