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

12 3 4 5 6 7 8 91011>>

  /external/eigen/Eigen/src/Core/
Flagged.h 53 inline Index rows() const { return m_matrix.rows(); }
54 inline Index cols() const { return m_matrix.cols(); }
55 inline Index outerStride() const { return m_matrix.outerStride(); }
56 inline Index innerStride() const { return m_matrix.innerStride(); }
58 inline CoeffReturnType coeff(Index row, Index col) const
63 inline CoeffReturnType coeff(Index index) const
65 return m_matrix.coeff(index);
68 inline const Scalar& coeffRef(Index row, Index col) cons
    [all...]
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...]
  /external/eigen/Eigen/src/Core/products/
TriangularMatrixMatrix.h 44 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,
    [all...]
GeneralMatrixVector_MKL.h 49 template<typename Index, typename LhsScalar, int LhsStorageOrder, bool ConjugateLhs, typename RhsScalar, bool ConjugateRhs>
51 general_matrix_vector_product<Index,LhsScalar,LhsStorageOrder,ConjugateLhs,RhsScalar,ConjugateRhs,BuiltIn> {};
54 template<typename Index, bool ConjugateLhs, bool ConjugateRhs> \
55 struct general_matrix_vector_product<Index,Scalar,ColMajor,ConjugateLhs,Scalar,ConjugateRhs,Specialized> { \
57 Index rows, Index cols, \
58 const Scalar* lhs, Index lhsStride, \
59 const Scalar* rhs, Index rhsIncr, \
60 Scalar* res, Index resIncr, Scalar alpha) \
63 general_matrix_vector_product<Index,Scalar,ColMajor,ConjugateLhs,Scalar,ConjugateRhs,BuiltIn>::run(
    [all...]
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...]
  /external/eigen/Eigen/src/plugins/
BlockMethods.h 54 * \sa class Block, block(Index,Index)
56 inline Block<Derived> block(Index startRow, Index startCol, Index blockRows, Index blockCols)
61 /** This is the const version of block(Index,Index,Index,Index). *
    [all...]
  /external/eigen/Eigen/src/OrderingMethods/
Ordering.h 47 * \tparam Index The type of indices of the matrix
50 template <typename Index>
54 typedef PermutationMatrix<Dynamic, Dynamic, Index> PermutationType;
63 SparseMatrix<typename MatrixType::Scalar, ColMajor, Index> symm;
75 SparseMatrix<typename SrcType::Scalar, ColMajor, Index> C; C = mat;
91 * \tparam Index The type of indices of the matrix
93 template <typename Index>
97 typedef PermutationMatrix<Dynamic, Dynamic, Index> PermutationType;
114 template<typename Index>
118 typedef PermutationMatrix<Dynamic, Dynamic, Index> PermutationType;
    [all...]
  /external/pdfium/third_party/bigint/
NumberlikeArray.hh 31 // Type for the index of a block in the array
32 typedef unsigned int Index;
37 Index cap;
39 Index len;
44 NumberlikeArray(Index c) : cap(c), len(0) {
63 void allocate(Index c);
67 void allocateAndCopy(Index c);
76 NumberlikeArray(const Blk *b, Index blen);
79 Index getCapacity() const { return cap; }
80 Index getLength() const { return len;
    [all...]
  /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/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++);
139 const char *Value = Args.getArgString(Index) + ArgSize;
140 return new Arg(UnaliasedOption, Spelling, Index++, Value);
144 const char *Str = Args.getArgString(Index) + ArgSize;
145 Arg *A = new Arg(UnaliasedOption, Spelling, Index++);
173 if (ArgSize != strlen(Args.getArgString(Index)))
176 Index += 2
    [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...]
  /system/update_engine/payload_generator/
topological_sort.cc 31 set<Vertex::Index>* visited_nodes,
32 vector<Vertex::Index>* nodes,
33 Vertex::Index node) {
48 void TopologicalSort(const Graph& graph, vector<Vertex::Index>* out) {
49 set<Vertex::Index> visited_nodes;
51 for (Vertex::Index i = 0; i < graph.size(); i++) {
topological_sort.h 38 void TopologicalSort(const Graph& graph, std::vector<Vertex::Index>* out);
  /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'))
  /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/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...]

Completed in 4704 milliseconds

12 3 4 5 6 7 8 91011>>