/system/update_engine/payload_generator/ |
graph_utils.h | 39 Vertex::Index dst, 42 Vertex::Index dst, 47 // For each node N in graph, drop all edges N->|index|. 48 void DropIncomingEdgesTo(Graph* graph, Vertex::Index index);
|
inplace_generator.h | 46 Vertex::Index new_vertex; 47 Vertex::Index old_src; 48 Vertex::Index old_dst; 65 Vertex::Index reader; 66 Vertex::Index writer; 104 // which the op is performed -> graph vertex index, and produces the 105 // reverse: a mapping from graph vertex index -> op_indexes index. 107 const std::vector<Vertex::Index>& op_indexes, 108 std::vector<std::vector<Vertex::Index>::size_type>* reverse_op_indexes) [all...] |
/external/eigen/Eigen/src/SparseLU/ |
SparseLU_panel_bmod.h | 55 template <typename Scalar, typename Index> 56 void SparseLUImpl<Scalar,Index>::panel_bmod(const Index m, const Index w, const Index jcol, 57 const Index nseg, ScalarVector& dense, ScalarVector& tempv, 61 Index ksub,jj,nextl_col; 62 Index fsupc, nsupc, nsupr, nrow; 63 Index krep, kfnz; 64 Index lptr; // points to the row subscripts of a supernode [all...] |
SparseLU_pruneL.h | 52 template <typename Scalar, typename Index> 53 void SparseLUImpl<Scalar,Index>::pruneL(const Index jcol, const IndexVector& perm_r, const Index pivrow, const Index nseg, const IndexVector& segrep, BlockIndexVector repfnz, IndexVector& xprune, GlobalLU_t& glu) 56 Index jsupno = glu.supno(jcol); 57 Index i,irep,irep1; 59 Index kmin = 0, kmax = 0, minloc, maxloc,krow;
|
/external/eigen/blas/ |
PackedTriangularSolverVector.h | 15 template<typename LhsScalar, typename RhsScalar, typename Index, int Side, int Mode, bool Conjugate, int StorageOrder> 19 template<typename LhsScalar, typename RhsScalar, typename Index, int Mode, bool Conjugate> 20 struct packed_triangular_solve_vector<LhsScalar, RhsScalar, Index, OnTheLeft, Mode, Conjugate, RowMajor> 25 static void run(Index size, const LhsScalar* lhs, RhsScalar* rhs) 32 for(Index pi=0; pi<size; ++pi) 34 Index i = IsLower ? pi : size-pi-1; 35 Index s = IsLower ? 0 : 1; 47 template<typename LhsScalar, typename RhsScalar, typename Index, int Mode, bool Conjugate> 48 struct packed_triangular_solve_vector<LhsScalar, RhsScalar, Index, OnTheLeft, Mode, Conjugate, ColMajor> 53 static void run(Index size, const LhsScalar* lhs, RhsScalar* rhs [all...] |
/external/eigen/Eigen/src/SparseCore/ |
SparseSelfAdjointView.h | 42 void permute_symm_to_symm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DestOrder,typename MatrixType::Index>& _dest, const typename MatrixType::Index* perm = 0); 45 void permute_symm_to_fullsymm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DestOrder,typename MatrixType::Index>& _dest, const typename MatrixType::Index* perm = 0); 55 typedef typename MatrixType::Index Index; 56 typedef Matrix<Index,Dynamic,1> VectorI; 65 inline Index rows() const { return m_matrix.rows(); } 66 inline Index cols() const { return m_matrix.cols(); } 124 template<typename DestScalar,int StorageOrder> void evalTo(SparseMatrix<DestScalar,StorageOrder,Index>& _dest) cons [all...] |
AmbiVector.h | 27 typedef _Index Index; 30 AmbiVector(Index size) 39 Index nonZeros() const; 42 void setBounds(Index start, Index end) { m_start = start; m_end = end; } 47 Scalar& coeffRef(Index i); 48 Scalar& coeff(Index i); 54 void resize(Index size) 61 Index size() const { return m_size; } 65 void reallocate(Index size 103 Index index; member in struct:Eigen::internal::AmbiVector::ListEl [all...] |
SparseDiagonalProduct.h | 35 typedef typename promote_index_type<typename traits<Lhs>::Index, 36 typename traits<Rhs>::Index>::type Index; 93 EIGEN_STRONG_INLINE Index rows() const { return m_lhs.rows(); } 94 EIGEN_STRONG_INLINE Index cols() const { return m_rhs.cols(); } 112 typedef typename Lhs::Index Index; 115 const SparseDiagonalProductType& expr, Index outer) 132 typedef typename Lhs::Index Index; [all...] |
SparseBlock.h | 30 typedef typename BlockImpl::Index Index; 32 inline InnerIterator(const BlockType& xpr, Index outer) 35 inline Index row() const { return IsRowMajor ? m_outer : this->index(); } 36 inline Index col() const { return IsRowMajor ? this->index() : m_outer; } 38 Index m_outer; 42 typedef typename BlockImpl::Index Index; 490 inline Index index() const { return Base::index() - (IsRowMajor ? m_block.m_startCol.value() : m_block.m_startRow.value()); } function in class:Eigen::BlockImpl::InnerIterator 513 inline Index index() const { return Base::index() - (IsRowMajor ? m_block.m_startCol.value() : m_block.m_startRow.value()); } function in class:Eigen::BlockImpl::ReverseInnerIterator [all...] |
/external/eigen/Eigen/src/Core/ |
Swap.h | 38 inline Index rows() const { return m_expression.rows(); } 39 inline Index cols() const { return m_expression.cols(); } 40 inline Index outerStride() const { return m_expression.outerStride(); } 41 inline Index innerStride() const { return m_expression.innerStride(); } 52 inline Scalar& coeffRef(Index rowId, Index colId) 57 inline Scalar& coeffRef(Index index) 59 return m_expression.const_cast_derived().coeffRef(index); 62 inline Scalar& coeffRef(Index rowId, Index colId) cons [all...] |
PlainObjectBase.h | 30 template<typename Index> 31 static EIGEN_ALWAYS_INLINE void run(Index, Index) 37 template<typename Index> 38 static EIGEN_ALWAYS_INLINE void run(Index rows, Index cols) 41 // we assume Index is signed 42 Index max_index = (size_t(1) << (8 * sizeof(Index) - 1)) - 1; // assume Index is signe [all...] |
Transpositions.h | 56 typedef typename IndicesType::Scalar Index; 81 inline Index size() const { return indices().size(); } 83 /** Direct access to the underlying index vector */ 84 inline const Index& coeff(Index i) const { return indices().coeff(i); } 85 /** Direct access to the underlying index vector */ 86 inline Index& coeffRef(Index i) { return indices().coeffRef(i); } 87 /** Direct access to the underlying index vector */ 88 inline const Index& operator()(Index i) const { return indices()(i); [all...] |
/external/eigen/Eigen/src/Core/products/ |
TriangularMatrixVector.h | 17 template<typename Index, int Mode, typename LhsScalar, bool ConjLhs, typename RhsScalar, bool ConjRhs, int StorageOrder, int Version=Specialized> 20 template<typename Index, int Mode, typename LhsScalar, bool ConjLhs, typename RhsScalar, bool ConjRhs, int Version> 21 struct triangular_matrix_vector_product<Index,Mode,LhsScalar,ConjLhs,RhsScalar,ConjRhs,ColMajor,Version> 29 static EIGEN_DONT_INLINE void run(Index _rows, Index _cols, const LhsScalar* _lhs, Index lhsStride, 30 const RhsScalar* _rhs, Index rhsIncr, ResScalar* _res, Index resIncr, const ResScalar& alpha); 33 template<typename Index, int Mode, typename LhsScalar, bool ConjLhs, typename RhsScalar, bool ConjRhs, int Version> 34 EIGEN_DONT_INLINE void triangular_matrix_vector_product<Index,Mode,LhsScalar,ConjLhs,RhsScalar,ConjRhs,ColMajor,Version [all...] |
CoeffBasedProduct.h | 46 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 171 /* Allow index-based non-packet access. It is impossible though to allow index-based packed access, 174 EIGEN_STRONG_INLINE const Scalar coeff(Index index) cons [all...] |
TriangularMatrixMatrix_MKL.h | 41 template <typename Scalar, typename Index, 47 product_triangular_matrix_matrix<Scalar,Index,Mode, 54 template <typename Index, int Mode, \ 57 struct product_triangular_matrix_matrix<Scalar,Index, Mode, LhsIsTriangular, \ 59 static inline void run(Index _rows, Index _cols, Index _depth, const Scalar* _lhs, Index lhsStride,\ 60 const Scalar* _rhs, Index rhsStride, Scalar* res, Index resStride, Scalar alpha, level3_blocking<Scalar,Scalar>& blocking) { [all...] |
GeneralMatrixVector.h | 30 template<typename Index, typename LhsScalar, bool ConjugateLhs, typename RhsScalar, bool ConjugateRhs, int Version> 31 struct general_matrix_vector_product<Index,LhsScalar,ColMajor,ConjugateLhs,RhsScalar,ConjugateRhs,Version> 52 Index rows, Index cols, 53 const LhsScalar* lhs, Index lhsStride, 54 const RhsScalar* rhs, Index rhsIncr, 55 ResScalar* res, Index resIncr, RhsScalar alpha); 58 template<typename Index, typename LhsScalar, bool ConjugateLhs, typename RhsScalar, bool ConjugateRhs, int Version> 59 EIGEN_DONT_INLINE void general_matrix_vector_product<Index,LhsScalar,ColMajor,ConjugateLhs,RhsScalar,ConjugateRhs,Version>::run( 60 Index rows, Index cols [all...] |
/external/eigen/Eigen/src/PardisoSupport/ |
PardisoSupport.h | 43 template<typename Index> 46 static Index run( _MKL_DSS_HANDLE_t pt, Index maxfct, Index mnum, Index type, Index phase, Index n, void *a, 47 Index *ia, Index *ja, Index *perm, Index nrhs, Index *iparm, Index msglvl, void *b, void *x [all...] |
/external/eigen/Eigen/src/MetisSupport/ |
MetisSupport.h | 21 template <typename Index> 25 typedef PermutationMatrix<Dynamic,Dynamic,Index> PermutationType; 26 typedef Matrix<Index,Dynamic,1> IndexVector; 31 Index m = A.cols(); 36 Index TotNz = 0; 46 Index idx = it.index(); // Get the row index (for column major) or column index (for row major) 56 Index idx = it.index(); [all...] |
/external/eigen/Eigen/src/misc/ |
Image.h | 41 typedef typename Base::Index Index; 49 inline Index rows() const { return m_dec.rows(); } 50 inline Index cols() const { return m_cols; } 51 inline Index rank() const { return m_rank; } 62 Index m_rank, m_cols; 72 typedef typename MatrixType::Index Index; \
|
/external/eigen/doc/examples/ |
Tutorial_ReductionsVisitorsBroadcasting_visitors.cpp | 15 MatrixXf::Index maxRow, maxCol; 19 MatrixXf::Index minRow, minCol;
|
/external/eigen/Eigen/src/IterativeLinearSolvers/ |
IncompleteLUT.h | 24 * \param ind The array of index for the elements in @p row 27 template <typename VectorV, typename VectorI, typename Index> 28 Index QuickSplit(VectorV &row, VectorI &ind, Index ncut) 33 Index mid; 34 Index n = row.size(); /* length of the vector */ 35 Index first, last ; 45 for (Index j = first + 1; j <= last; j++) { 103 typedef typename FactorType::Index Index; [all...] |
/external/eigen/Eigen/src/QR/ |
HouseholderQR.h | 56 typedef typename MatrixType::Index Index; 76 HouseholderQR(Index rows, Index cols) 182 inline Index rows() const { return m_qr.rows(); } 183 inline Index cols() const { return m_qr.cols(); } 227 typedef typename MatrixQR::Index Index; 230 Index rows = mat.rows(); 231 Index cols = mat.cols() [all...] |
/external/giflib/ |
quantize.c | 68 unsigned int Index, NumOfEntries; 91 Index = ((RedInput[i] >> (8 - BITS_PER_PRIM_COLOR)) << 96 ColorArrayEntries[Index].Count++; 158 /* Finally scan the input buffer again and put the mapped index in the 162 Index = ((RedInput[i] >> (8 - BITS_PER_PRIM_COLOR)) << 167 Index = ColorArrayEntries[Index].NewColorIndex; 168 OutputBuffer[i] = Index; 169 if (MaxRGBError[0] < ABS(OutputColorMap[Index].Red - RedInput[i])) 170 MaxRGBError[0] = ABS(OutputColorMap[Index].Red - RedInput[i]) [all...] |
/external/eigen/test/ |
visitor.cpp | 15 typedef typename MatrixType::Index Index; 17 Index rows = p.rows(); 18 Index cols = p.cols(); 23 for(Index i = 0; i < m.size(); i++) 24 for(Index i2 = 0; i2 < i; i2++) 29 Index minrow=0,mincol=0,maxrow=0,maxcol=0; 30 for(Index j = 0; j < cols; j++) 31 for(Index i = 0; i < rows; i++) 46 Index eigen_minrow, eigen_mincol, eigen_maxrow, eigen_maxcol [all...] |
/external/eigen/Eigen/src/LU/ |
PartialPivLU.h | 62 typedef typename MatrixType::Index Index; 81 PartialPivLU(Index size); 170 inline Index rows() const { return m_lu.rows(); } 171 inline Index cols() const { return m_lu.cols(); } 183 Index m_det_p; 198 PartialPivLU<MatrixType>::PartialPivLU(Index size) 233 typedef typename MatrixType::Index Index; 243 * \returns The index of the first pivot which is exactly zero if any, or a negative number otherwise [all...] |