Home
last modified time | relevance | path

Searched refs:Index (Results 1 – 25 of 1113) sorted by relevance

12345678910>>...45

/external/eigen/Eigen/src/SparseLU/
DSparseLUImpl.h19 template <typename Scalar, typename Index>
24 typedef Matrix<Index,Dynamic,1> IndexVector;
27 typedef Ref<Matrix<Index,Dynamic,1> > BlockIndexVector;
29 typedef SparseMatrix<Scalar,ColMajor,Index> MatrixType;
33Index expand(VectorType& vec, Index& length, Index nbElts, Index keep_prev, Index& num_expansions);
34Index memInit(Index m, Index n, Index annz, Index lwork, Index fillratio, Index panel_size, Globa…
36Index memXpand(VectorType& vec, Index& maxlen, Index nbElts, MemType memtype, Index& num_expansion…
37 …void heap_relax_snode (const Index n, IndexVector& et, const Index relax_columns, IndexVector& des…
38 …void relax_snode (const Index n, IndexVector& et, const Index relax_columns, IndexVector& descenda…
39Index snode_dfs(const Index jcol, const Index kcol,const MatrixType& mat, IndexVector& xprune, In…
[all …]
DSparseLU_SupernodalMatrix.h37 typedef _Index Index; typedef
38 typedef Matrix<Index,Dynamic,1> IndexVector;
45 …MappedSuperNodalMatrix(Index m, Index n, ScalarVector& nzval, IndexVector& nzval_colptr, IndexVec… in MappedSuperNodalMatrix()
61 …void setInfos(Index m, Index n, ScalarVector& nzval, IndexVector& nzval_colptr, IndexVector& rowin… in setInfos()
78 Index rows() { return m_row; } in rows()
83 Index cols() { return m_col; } in cols()
99 Index* colIndexPtr() in colIndexPtr()
104 const Index* colIndexPtr() const in colIndexPtr()
112 Index* rowIndex() { return m_rowind; } in rowIndex()
114 const Index* rowIndex() const in rowIndex()
[all …]
DSparseLU_Memory.h39 template<typename Index>
40 inline Index LUnumTempV(Index& m, Index& w, Index& t, Index& b) in LUnumTempV()
45 template< typename Scalar, typename Index>
46 inline Index LUTempSpace(Index&m, Index& w) in LUTempSpace()
48 return (2*w + 4 + LUNoMarker) * m * sizeof(Index) + (w + 1) * m * sizeof(Scalar); in LUTempSpace()
62 template <typename Scalar, typename Index>
64 Index SparseLUImpl<Scalar,Index>::expand(VectorType& vec, Index& length, Index nbElts, Index keep_… in expand()
68 Index new_len; // New size of the allocated memory in expand()
73 new_len = (std::max)(length+1,Index(alpha * length)); in expand()
106 Index tries = 0; // Number of attempts in expand()
[all …]
DSparseLU_panel_dfs.h40 typedef typename IndexVector::Scalar Index; typedef
41 panel_dfs_traits(Index jcol, Index* marker) in panel_dfs_traits()
44 bool update_segrep(Index krep, Index jj) in update_segrep()
53 void mem_expand(IndexVector& /*glu.lsub*/, Index /*nextl*/, Index /*chmark*/) {} in mem_expand()
55 Index m_jcol;
56 Index* m_marker;
60 template <typename Scalar, typename Index>
62 void SparseLUImpl<Scalar,Index>::dfs_kernel(const Index jj, IndexVector& perm_r, in dfs_kernel()
63 Index& nseg, IndexVector& panel_lsub, IndexVector& segrep, in dfs_kernel()
66 Index& nextl_col, Index krow, Traits& traits in dfs_kernel()
[all …]
DSparseLU_kernel_bmod.h33 template <typename BlockScalarVector, typename ScalarVector, typename IndexVector, typename Index>
34 … BlockScalarVector& dense, ScalarVector& tempv, ScalarVector& lusup, Index& luptr, const Index lda,
35 … const Index nrow, IndexVector& lsub, const Index lptr, const Index no_zeros);
39 template <typename BlockScalarVector, typename ScalarVector, typename IndexVector, typename Index>
40 … BlockScalarVector& dense, ScalarVector& tempv, ScalarVector& lusup, Index& luptr, const Index lda, in run()
41 … const Index nrow, IndexVector& lsub, const Index lptr, const Index no_zeros) in run()
47 Index isub = lptr + no_zeros; in run()
49 Index irow; in run()
66 const Index PacketSize = internal::packet_traits<Scalar>::size; in run()
67 Index ldl = internal::first_multiple(nrow, PacketSize); in run()
[all …]
DSparseLU_column_dfs.h33 template <typename Scalar, typename Index> class SparseLUImpl;
42 typedef typename IndexVector::Scalar Index; typedef
43 …column_dfs_traits(Index jcol, Index& jsuper, typename SparseLUImpl<Scalar, Index>::GlobalLU_t& glu… in column_dfs_traits()
46 bool update_segrep(Index /*krep*/, Index /*jj*/) in update_segrep()
50 void mem_expand(IndexVector& lsub, Index& nextl, Index chmark) in mem_expand()
58 Index m_jcol;
59 Index& m_jsuper_ref;
60 typename SparseLUImpl<Scalar, Index>::GlobalLU_t& m_glu;
61 SparseLUImpl<Scalar, Index>& m_luImpl;
92 template <typename Scalar, typename Index>
[all …]
/external/eigen/Eigen/src/OrderingMethods/
DEigen_Colamd.h138 template <typename Index>
141 Index start ; /* index for A of first row in this column, or DEAD */
143 Index length ; /* number of rows in this column */
146 Index thickness ; /* number of original columns represented by this */
148 Index parent ; /* parent in parent tree super-column structure, if */
153 Index score ; /* the score used to maintain heap, if col is alive */
154 Index order ; /* pivot ordering of this column, if col is dead */
158 Index headhash ; /* head of a hash bucket, if col is at the head of */
160 Index hash ; /* hash value, if col is not in a degree list */
161 Index prev ; /* previous column in degree list, if col is in a */
[all …]
/external/eigen/unsupported/Eigen/src/Skyline/
DSkylineStorage.h24 typedef SparseIndex Index; typedef
61 memcpy(m_upperProfile, other.m_upperProfile, m_upperProfileSize * sizeof (Index));
62 memcpy(m_lowerProfile, other.m_lowerProfile, m_lowerProfileSize * sizeof (Index));
87 …void reserve(Index size, Index upperProfileSize, Index lowerProfileSize, Index upperSize, Index lo… in reserve()
88 Index newAllocatedSize = size + upperSize + lowerSize; in reserve()
98 …void resize(Index diagSize, Index upperProfileSize, Index lowerProfileSize, Index upperSize, Index
100 … upperProfileSize, lowerProfileSize, upperSize + Index(reserveSizeFactor * upperSize), lowerSize +…
108 inline Index diagSize() const { in diagSize()
112 inline Index upperSize() const { in upperSize()
116 inline Index lowerSize() const { in lowerSize()
[all …]
DSkylineMatrix.h64 Index m_outerSize;
65 Index m_innerSize;
68 Index* m_colStartIndex;
69 Index* m_rowStartIndex;
74 inline Index rows() const {
78 inline Index cols() const {
82 inline Index innerSize() const {
86 inline Index outerSize() const {
90 inline Index upperNonZeros() const {
94 inline Index lowerNonZeros() const {
[all …]
/external/eigen/Eigen/src/SparseCore/
DMappedSparseMatrix.h40 Index m_outerSize;
41 Index m_innerSize;
42 Index m_nnz;
43 Index* m_outerIndex;
44 Index* m_innerIndices;
49 inline Index rows() const { return IsRowMajor ? m_outerSize : m_innerSize; }
50 inline Index cols() const { return IsRowMajor ? m_innerSize : m_outerSize; }
51 inline Index innerSize() const { return m_innerSize; }
52 inline Index outerSize() const { return m_outerSize; }
61 inline const Index* innerIndexPtr() const { return m_innerIndices; }
[all …]
DSparseMatrix.h46 typedef _Index Index;
69 typedef _Index Index;
95 typedef internal::CompressedStorage<Scalar,Index> Storage;
104 Index m_outerSize;
105 Index m_innerSize;
106 Index* m_outerIndex;
107 Index* m_innerNonZeros; // optional, if null then the data is compressed
110 …Eigen::Map<Matrix<Index,Dynamic,1> > innerNonZeros() { return Eigen::Map<Matrix<Index,Dynamic,1> >…
111 …const Eigen::Map<const Matrix<Index,Dynamic,1> > innerNonZeros() const { return Eigen::Map<const …
119 inline Index rows() const { return IsRowMajor ? m_outerSize : m_innerSize; }
[all …]
DSparseVector.h33 typedef _Index Index;
75 typedef internal::CompressedStorage<Scalar,Index> Storage;
82 EIGEN_STRONG_INLINE Index rows() const { return IsColVector ? m_size : 1; }
83 EIGEN_STRONG_INLINE Index cols() const { return IsColVector ? 1 : m_size; }
84 EIGEN_STRONG_INLINE Index innerSize() const { return m_size; }
85 EIGEN_STRONG_INLINE Index outerSize() const { return 1; }
90 EIGEN_STRONG_INLINE const Index* innerIndexPtr() const { return &m_data.index(0); }
91 EIGEN_STRONG_INLINE Index* innerIndexPtr() { return &m_data.index(0); }
98 inline Scalar coeff(Index row, Index col) const
103 inline Scalar coeff(Index i) const
[all …]
DSparseBlock.h30 typedef typename BlockImpl::Index Index; in EIGEN_SPARSE_PUBLIC_INTERFACE() typedef
32 inline InnerIterator(const BlockType& xpr, Index outer) in EIGEN_SPARSE_PUBLIC_INTERFACE()
35 inline Index row() const { return IsRowMajor ? m_outer : this->index(); } in EIGEN_SPARSE_PUBLIC_INTERFACE()
36 inline Index col() const { return IsRowMajor ? this->index() : m_outer; } in EIGEN_SPARSE_PUBLIC_INTERFACE()
38 Index m_outer; in EIGEN_SPARSE_PUBLIC_INTERFACE()
42 typedef typename BlockImpl::Index Index; typedef
44 inline ReverseInnerIterator(const BlockType& xpr, Index outer) in ReverseInnerIterator()
47 inline Index row() const { return IsRowMajor ? m_outer : this->index(); } in row()
48 inline Index col() const { return IsRowMajor ? this->index() : m_outer; } in col()
50 Index m_outer;
[all …]
/external/eigen/Eigen/src/Core/products/
DSelfadjointMatrixMatrix.h18 template<typename Scalar, typename Index, int Pack1, int Pack2, int StorageOrder>
22 …alar* blockA, const const_blas_data_mapper<Scalar,Index,StorageOrder>& lhs, Index cols, Index i, I… in pack()
25 for(Index k=0; k<i; k++) in pack()
26 for(Index w=0; w<BlockRows; w++) in pack()
29 Index h = 0; in pack()
30 for(Index k=i; k<i+BlockRows; k++) in pack()
32 for(Index w=0; w<h; w++) in pack()
37 for(Index w=h+1; w<BlockRows; w++) in pack()
42 for(Index k=i+BlockRows; k<cols; k++) in pack()
43 for(Index w=0; w<BlockRows; w++) in pack()
[all …]
DTriangularSolverMatrix.h18 template <typename Scalar, typename Index, int Side, int Mode, bool Conjugate, int TriStorageOrder>
19 struct triangular_solve_matrix<Scalar,Index,Side,Mode,Conjugate,TriStorageOrder,RowMajor>
22 Index size, Index cols,
23 const Scalar* tri, Index triStride,
24 Scalar* _other, Index otherStride,
28 Scalar, Index, Side==OnTheLeft?OnTheRight:OnTheLeft,
38 template <typename Scalar, typename Index, int Mode, bool Conjugate, int TriStorageOrder>
39 struct triangular_solve_matrix<Scalar,Index,OnTheLeft,Mode,Conjugate,TriStorageOrder,ColMajor>
42 Index size, Index otherSize,
43 const Scalar* _tri, Index triStride,
[all …]
DTriangularMatrixMatrix.h44 template <typename Scalar, typename Index,
51 template <typename Scalar, typename Index,
55 struct product_triangular_matrix_matrix<Scalar,Index,Mode,LhsIsTriangular,
60 Index rows, Index cols, Index depth,
61 const Scalar* lhs, Index lhsStride,
62 const Scalar* rhs, Index rhsStride,
63 Scalar* res, Index resStride,
66 product_triangular_matrix_matrix<Scalar, Index,
79 template <typename Scalar, typename Index, int Mode,
82 struct product_triangular_matrix_matrix<Scalar,Index,Mode,true,
[all …]
DCoeffBasedProduct.h46 typedef typename promote_index_type<typename traits<_LhsNested>::Index,
47 typename traits<_RhsNested>::Index>::type Index;
161 EIGEN_STRONG_INLINE Index rows() const { return m_lhs.rows(); }
162 EIGEN_STRONG_INLINE Index cols() const { return m_rhs.cols(); }
164 EIGEN_STRONG_INLINE const Scalar coeff(Index row, Index col) const
174 EIGEN_STRONG_INLINE const Scalar coeff(Index index) const
177 const Index row = RowsAtCompileTime == 1 ? 0 : index;
178 const Index col = RowsAtCompileTime == 1 ? index : 0;
184 EIGEN_STRONG_INLINE const PacketScalar packet(Index row, Index col) const
211 const Diagonal<const LazyCoeffBasedProductType,Dynamic> diagonal(Index index) const
[all …]
DTriangularSolverVector.h17 template<typename LhsScalar, typename RhsScalar, typename Index, int Mode, bool Conjugate, int Stor…
18 struct triangular_solve_vector<LhsScalar, RhsScalar, Index, OnTheRight, Mode, Conjugate, StorageOrd…
20 static void run(Index size, const LhsScalar* _lhs, Index lhsStride, RhsScalar* rhs)
22 triangular_solve_vector<LhsScalar,RhsScalar,Index,OnTheLeft,
30 template<typename LhsScalar, typename RhsScalar, typename Index, int Mode, bool Conjugate>
31 struct triangular_solve_vector<LhsScalar, RhsScalar, Index, OnTheLeft, Mode, Conjugate, RowMajor>
36 static void run(Index size, const LhsScalar* _lhs, Index lhsStride, RhsScalar* rhs)
45 static const Index PanelWidth = EIGEN_TUNE_TRIANGULAR_PANEL_WIDTH;
46 for(Index pi=IsLower ? 0 : size;
50 Index actualPanelWidth = (std::min)(IsLower ? size - pi : pi, PanelWidth);
[all …]
/external/eigen/unsupported/Eigen/src/SparseExtra/
DDynamicSparseMatrix.h40 typedef _Index Index;
75 Index m_innerSize;
76 std::vector<internal::CompressedStorage<Scalar,Index> > m_data;
80 inline Index rows() const { return IsRowMajor ? outerSize() : m_innerSize; }
81 inline Index cols() const { return IsRowMajor ? m_innerSize : outerSize(); }
82 inline Index innerSize() const { return m_innerSize; }
83 inline Index outerSize() const { return static_cast<Index>(m_data.size()); }
84 inline Index innerNonZeros(Index j) const { return m_data[j].size(); }
86 std::vector<internal::CompressedStorage<Scalar,Index> >& _data() { return m_data; }
87 const std::vector<internal::CompressedStorage<Scalar,Index> >& _data() const { return m_data; }
[all …]
/external/eigen/Eigen/src/plugins/
DBlockMethods.h56 inline Block<Derived> block(Index startRow, Index startCol, Index blockRows, Index blockCols) in block()
62 inline const Block<const Derived> block(Index startRow, Index startCol, Index blockRows, Index bloc… in block()
80 inline Block<Derived> topRightCorner(Index cRows, Index cCols) in topRightCorner()
86 inline const Block<const Derived> topRightCorner(Index cRows, Index cCols) const in topRightCorner()
132 inline Block<Derived, CRows, CCols> topRightCorner(Index cRows, Index cCols) in topRightCorner()
139 inline const Block<const Derived, CRows, CCols> topRightCorner(Index cRows, Index cCols) const in topRightCorner()
156 inline Block<Derived> topLeftCorner(Index cRows, Index cCols) in topLeftCorner()
162 inline const Block<const Derived> topLeftCorner(Index cRows, Index cCols) const in topLeftCorner()
207 inline Block<Derived, CRows, CCols> topLeftCorner(Index cRows, Index cCols) in topLeftCorner()
214 inline const Block<const Derived, CRows, CCols> topLeftCorner(Index cRows, Index cCols) const in topLeftCorner()
[all …]
/external/llvm/lib/Option/
DOption.cpp101 unsigned &Index, in accept() argument
107 Spelling = StringRef(Args.getArgString(Index), ArgSize); in accept()
115 if (ArgSize != strlen(Args.getArgString(Index))) in accept()
118 Arg *A = new Arg(UnaliasedOption, Spelling, Index++); in accept()
131 const char *Value = Args.getArgString(Index) + ArgSize; in accept()
132 return new Arg(UnaliasedOption, Spelling, Index++, Value); in accept()
136 const char *Str = Args.getArgString(Index) + ArgSize; in accept()
137 Arg *A = new Arg(UnaliasedOption, Spelling, Index++); in accept()
165 if (ArgSize != strlen(Args.getArgString(Index))) in accept()
168 Index += 2; in accept()
[all …]
/external/eigen/Eigen/src/Core/
DArrayWrapper.h58 inline Index rows() const { return m_expression.rows(); }
59 inline Index cols() const { return m_expression.cols(); }
60 inline Index outerStride() const { return m_expression.outerStride(); }
61 inline Index innerStride() const { return m_expression.innerStride(); }
66 inline CoeffReturnType coeff(Index rowId, Index colId) const
71 inline Scalar& coeffRef(Index rowId, Index colId)
76 inline const Scalar& coeffRef(Index rowId, Index colId) const
81 inline CoeffReturnType coeff(Index index) const
86 inline Scalar& coeffRef(Index index)
91 inline const Scalar& coeffRef(Index index) const
[all …]
DDenseCoeffsBase.h38 typedef typename internal::traits<Derived>::Index Index; typedef
64 EIGEN_STRONG_INLINE Index rowIndexByOuterInner(Index outer, Index inner) const in rowIndexByOuterInner()
72 EIGEN_STRONG_INLINE Index colIndexByOuterInner(Index outer, Index inner) const in colIndexByOuterInner()
94 EIGEN_STRONG_INLINE CoeffReturnType coeff(Index row, Index col) const in coeff()
101 EIGEN_STRONG_INLINE CoeffReturnType coeffByOuterInner(Index outer, Index inner) const in coeffByOuterInner()
111 EIGEN_STRONG_INLINE CoeffReturnType operator()(Index row, Index col) const in operator()
134 coeff(Index index) const in coeff()
150 operator[](Index index) const
171 operator()(Index index) const in operator()
208 EIGEN_STRONG_INLINE PacketReturnType packet(Index row, Index col) const in packet()
[all …]
DBlock.h114 inline Block(XprType& xpr, Index i) : Impl(xpr,i)
123 inline Block(XprType& xpr, Index a_startRow, Index a_startCol)
134 Index a_startRow, Index a_startCol,
135 Index blockRows, Index blockCols)
152 typedef typename XprType::Index Index;
156 inline BlockImpl(XprType& xpr, Index i) : Impl(xpr,i) {}
157 …inline BlockImpl(XprType& xpr, Index a_startRow, Index a_startCol) : Impl(xpr, a_startRow, a_start…
158 …inline BlockImpl(XprType& xpr, Index a_startRow, Index a_startCol, Index blockRows, Index blockCol…
179 inline BlockImpl_dense(XprType& xpr, Index i)
193 inline BlockImpl_dense(XprType& xpr, Index a_startRow, Index a_startCol)
[all …]
/external/vboot_reference/utility/
Defidecompress.c212 UINT16 Index; in MakeTable() local
220 for (Index = 1; Index <= 16; Index++) { in MakeTable()
221 Count[Index] = 0; in MakeTable()
224 for (Index = 0; Index < NumOfChar; Index++) { in MakeTable()
225 Count[BitLen[Index]]++; in MakeTable()
230 for (Index = 1; Index <= 16; Index++) { in MakeTable()
231 Start[Index + 1] = (UINT16) (Start[Index] + (Count[Index] << (16 - Index))); in MakeTable()
241 for (Index = 1; Index <= TableBits; Index++) { in MakeTable()
242 Start[Index] >>= JuBits; in MakeTable()
243 Weight[Index] = (UINT16) (1U << (TableBits - Index)); in MakeTable()
[all …]

12345678910>>...45