HomeSort by relevance Sort by last modified time
    Searched refs:Index (Results 26 - 50 of 1029) sorted by null

12 3 4 5 6 7 8 91011>>

  /external/eigen/Eigen/src/SparseCore/
SparseMatrix.h 22 * Each colmun's (resp. row) non zeros are stored as a pair of value with associated row (resp. colmiun) index.
46 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> >(m_innerNonZeros, m_innerNonZeros?m_outerSize:0);
886 inline Index index() const { return m_indices[m_id]; } function in class:Eigen::SparseMatrix::InnerIterator
919 inline Index index() const { return m_indices[m_id-1]; } function in class:Eigen::SparseMatrix::ReverseInnerIterator
    [all...]
SparseVector.h 33 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);
367 inline Index index() const { return m_data.index(m_id); } function in class:Eigen::SparseVector::InnerIterator
399 inline Index index() const { return m_data.index(m_id-1); } function in class:Eigen::SparseVector::ReverseInnerIterator
    [all...]
SparseColEtree.h 39 template<typename Index, typename IndexVector>
40 Index etree_find (Index i, IndexVector& pp)
42 Index p = pp(i); // Parent
43 Index gp = pp(p); // Grand parent
57 * \param firstRowElt The column index of the first element in each row
61 int coletree(const MatrixType& mat, IndexVector& parent, IndexVector& firstRowElt, typename MatrixType::Index *perm=0)
63 typedef typename MatrixType::Index Index;
64 Index nc = mat.cols(); // Number of columns
    [all...]
  /external/eigen/Eigen/src/Core/products/
GeneralMatrixMatrixTriangular_MKL.h 40 template <typename Index, typename Scalar, int AStorageOrder, bool ConjugateA, int ResStorageOrder, int UpLo>
43 Index,Scalar,AStorageOrder,ConjugateA,Scalar,AStorageOrder,ConjugateA,ResStorageOrder,UpLo,BuiltIn> {};
48 template <typename Index, int LhsStorageOrder, bool ConjugateLhs, \
50 struct general_matrix_matrix_triangular_product<Index,Scalar,LhsStorageOrder,ConjugateLhs, \
52 static EIGEN_STRONG_INLINE void run(Index size, Index depth,const Scalar* lhs, Index lhsStride, \
53 const Scalar* rhs, Index rhsStride, Scalar* res, Index resStride, Scalar alpha) \
56 general_matrix_matrix_rankupdate<Index,Scalar,LhsStorageOrder,ConjugateLhs,ColMajor,UpLo>
    [all...]
TriangularSolverMatrix.h 18 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
    [all...]
TriangularSolverVector.h 17 template<typename LhsScalar, typename RhsScalar, typename Index, int Mode, bool Conjugate, int StorageOrder>
18 struct triangular_solve_vector<LhsScalar, RhsScalar, Index, OnTheRight, Mode, Conjugate, StorageOrder>
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
    [all...]
CoeffBasedProduct.h 46 typedef typename promote_index_type<typename traits<_LhsNested>::Index,
47 typename traits<_RhsNested>::Index>::type Index;
160 EIGEN_STRONG_INLINE Index rows() const { return m_lhs.rows(); }
161 EIGEN_STRONG_INLINE Index cols() const { return m_rhs.cols(); }
163 EIGEN_STRONG_INLINE const Scalar coeff(Index row, Index col) const
170 /* Allow index-based non-packet access. It is impossible though to allow index-based packed access,
173 EIGEN_STRONG_INLINE const Scalar coeff(Index index) cons
    [all...]
  /external/eigen/Eigen/src/Core/
DenseCoeffsBase.h 38 typedef typename internal::traits<Derived>::Index Index;
64 EIGEN_STRONG_INLINE Index rowIndexByOuterInner(Index outer, Index inner) const
72 EIGEN_STRONG_INLINE Index colIndexByOuterInner(Index outer, Index inner) const
81 * \link operator()(Index,Index) const \endlink instead
    [all...]
ForceAlignedAccess.h 44 inline Index rows() const { return m_expression.rows(); }
45 inline Index cols() const { return m_expression.cols(); }
46 inline Index outerStride() const { return m_expression.outerStride(); }
47 inline Index innerStride() const { return m_expression.innerStride(); }
49 inline const CoeffReturnType coeff(Index row, Index col) const
54 inline Scalar& coeffRef(Index row, Index col)
59 inline const CoeffReturnType coeff(Index index) cons
    [all...]
Random.h 19 template<typename Index>
20 inline const Scalar operator() (Index, Index = 0) const { return random<Scalar>(); }
45 * \sa MatrixBase::setRandom(), MatrixBase::Random(Index), MatrixBase::Random()
49 DenseBase<Derived>::Random(Index rows, Index cols)
72 * \sa MatrixBase::setRandom(), MatrixBase::Random(Index,Index), MatrixBase::Random()
76 DenseBase<Derived>::Random(Index size)
93 * \sa MatrixBase::setRandom(), MatrixBase::Random(Index,Index), MatrixBase::Random(Index
    [all...]
Block.h 26 * type of DenseBase::block(Index,Index,Index,Index) and DenseBase::block<int,int>(Index,Index) and
45 * \sa DenseBase::block(Index,Index,Index,Index), DenseBase::block(Index,Index), class VectorBloc
    [all...]
  /external/clang/lib/Sema/
TypeLocBuilder.cpp 50 unsigned NewIndex = Index + NewCapacity - Capacity;
52 &Buffer[Index],
53 Capacity - Index);
60 Index = NewIndex;
74 if (LocalSize > Index) {
75 size_t RequiredCapacity = Capacity + (LocalSize - Index);
100 memmove(&Buffer[Index - 4], &Buffer[Index], NumBytesAtAlign4);
101 Index -= 4;
111 memmove(&Buffer[Index + 4], &Buffer[Index], NumBytesAtAlign4)
    [all...]
  /external/eigen/Eigen/src/SparseLU/
SparseLU_relax_snode.h 46 template <typename Scalar, typename Index>
47 void SparseLUImpl<Scalar,Index>::relax_snode (const Index n, IndexVector& et, const Index relax_columns, IndexVector& descendants, IndexVector& relax_end)
51 Index j, parent;
61 Index snode_start; // beginning of a snode
SparseLU_panel_dfs.h 40 typedef typename IndexVector::Scalar Index;
41 panel_dfs_traits(Index jcol, Index* marker)
44 bool update_segrep(Index krep, Index jj)
53 void mem_expand(IndexVector& /*glu.lsub*/, Index /*nextl*/, Index /*chmark*/) {}
55 Index m_jcol;
56 Index* m_marker;
60 template <typename Scalar, typename Index>
    [all...]
SparseLU_copy_to_ucol.h 49 template <typename Scalar, typename Index>
50 Index SparseLUImpl<Scalar,Index>::copy_to_ucol(const Index jcol, const Index nseg, IndexVector& segrep, BlockIndexVector repfnz ,IndexVector& perm_r, BlockScalarVector dense, GlobalLU_t& glu)
52 Index ksub, krep, ksupno;
54 Index jsupno = glu.supno(jcol);
57 Index k = nseg - 1, i;
58 Index nextu = glu.xusub(jcol);
59 Index kfnz, isub, segsize;
    [all...]
SparseLU_kernel_bmod.h 33 template <typename BlockScalarVector, typename ScalarVector, typename IndexVector, typename Index>
34 static EIGEN_DONT_INLINE void run(const int segsize, 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 EIGEN_DONT_INLINE void LU_kernel_bmod<SegSizeAtCompileTime>::run(const int segsize, BlockScalarVector& dense, ScalarVector& tempv, ScalarVector& lusup, Index& luptr, const Index lda,
41 const Index nrow, IndexVector& lsub, const Index lptr, const Index no_zeros
    [all...]
SparseLU_pivotL.h 59 template <typename Scalar, typename Index>
60 Index SparseLUImpl<Scalar,Index>::pivotL(const Index jcol, const RealScalar& diagpivotthresh, IndexVector& perm_r, IndexVector& iperm_c, Index& pivrow, GlobalLU_t& glu)
63 Index fsupc = (glu.xsup)((glu.supno)(jcol)); // First column in the supernode containing the column jcol
64 Index nsupc = jcol - fsupc; // Number of columns in the supernode portion, excluding jcol; nsupc >=0
65 Index lptr = glu.xlsub(fsupc); // pointer to the starting location of the row subscripts for this supernode portion
66 Index nsupr = glu.xlsub(fsupc+1) - lptr; // Number of rows in the supernode
67 Index lda = glu.xlusup(fsupc+1) - glu.xlusup(fsupc); // leading dimensio
    [all...]
SparseLU_heap_relax_snode.h 45 template <typename Scalar, typename Index>
46 void SparseLUImpl<Scalar,Index>::heap_relax_snode (const Index n, IndexVector& et, const Index relax_columns, IndexVector& descendants, IndexVector& relax_end)
53 Index i;
68 Index j, parent;
77 Index snode_start; // beginning of a snode
78 Index k;
79 Index nsuper_et_post = 0; // Number of relaxed snodes in postordered etree
80 Index nsuper_et = 0; // Number of relaxed snodes in the original etree
    [all...]
  /external/clang/bindings/python/tests/cindex/
test_index.py 7 index = Index.create()
9 # FIXME: test Index.read
12 index = Index.create()
13 assert isinstance(index, Index)
14 tu = index.parse(os.path.join(kInputsDir, 'hello.cpp'))
test_file.py 1 from clang.cindex import Index, File
4 index = Index.create()
5 tu = index.parse('t.c', unsaved_files = [('t.c', "")])
  /external/eigen/unsupported/Eigen/src/Skyline/
SkylineMatrix.h 64 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/chromium_org/third_party/WebKit/public/platform/
WebIDBMetadata.h 42 struct Index;
63 WebVector<Index> indexes;
69 struct Index {
75 Index()
  /external/eigen/unsupported/Eigen/src/SparseExtra/
RandomSetter.h 157 typedef typename SparseMatrixType::Index Index;
184 const Index outerSize = SwapStorage ? target.innerSize() : target.outerSize();
185 const Index innerSize = SwapStorage ? target.outerSize() : target.innerSize();
191 Index aux = innerSize - 1;
199 for (Index k=0; k<m_outerPackets; ++k)
203 for (Index j=0; j<mp_target->outerSize(); ++j)
205 (*this)(TargetRowMajor?j:it.index(), TargetRowMajor?it.index():j) = it.value();
217 Index prevOuter = -1
    [all...]
BlockOfDynamicSparseMatrix.h 38 inline InnerIterator(const SparseInnerVectorSet& xpr, Index outer)
41 inline Index row() const { return IsRowMajor ? m_outer : this->index(); }
42 inline Index col() const { return IsRowMajor ? this->index() : m_outer; }
44 Index m_outer;
47 inline SparseInnerVectorSet(const MatrixType& matrix, Index outerStart, Index outerSize)
53 inline SparseInnerVectorSet(const MatrixType& matrix, Index outer)
72 for (Index j=0; j<m_outerSize.value(); ++j
    [all...]
  /external/llvm/lib/Option/
Option.cpp 104 unsigned &Index,
110 Spelling = StringRef(Args.getArgString(Index), ArgSize);
118 if (ArgSize != strlen(Args.getArgString(Index)))
121 Arg *A = new Arg(UnaliasedOption, Spelling, Index++);
134 const char *Value = Args.getArgString(Index) + ArgSize;
135 return new Arg(UnaliasedOption, Spelling, Index++, Value);
139 const char *Str = Args.getArgString(Index) + ArgSize;
140 Arg *A = new Arg(UnaliasedOption, Spelling, Index++);
168 if (ArgSize != strlen(Args.getArgString(Index)))
171 Index += 2
    [all...]

Completed in 2660 milliseconds

12 3 4 5 6 7 8 91011>>