/external/eigen/test/ |
mapped_matrix.cpp | 18 typedef typename VectorType::Index Index; 21 Index size = m.size(); 49 typedef typename MatrixType::Index Index; 52 Index rows = m.rows(), cols = m.cols(), size = rows*cols; 78 typedef typename VectorType::Index Index; 81 Index size = m.size(); 121 typedef typename MatrixType::Index Index [all...] |
eigen2support.cpp | 17 typedef typename MatrixType::Index Index; 20 Index rows = m.rows(); 21 Index cols = m.cols();
|
inverse.cpp | 17 typedef typename MatrixType::Index Index; 21 Index rows = m.rows(); 22 Index cols = m.cols();
|
product_extra.cpp | 14 typedef typename MatrixType::Index Index; 21 Index rows = m.rows(); 22 Index cols = m.cols(); 88 Index i = internal::random<Index>(0,m1.rows()-2); 89 Index j = internal::random<Index>(0,m1.cols()-2); 90 Index r = internal::random<Index>(1,m1.rows()-i) [all...] |
sparse_product.cpp | 16 typedef typename SparseMatrixType::Index Index; 17 Index c = internal::random<Index>(0,m2.cols()-1); 18 Index c1 = internal::random<Index>(0,m2.cols()-1); 26 typedef typename SparseMatrixType::Index Index; 27 Index r = internal::random<Index>(0,m2.rows()-1) [all...] |
redux.cpp | 14 typedef typename MatrixType::Index Index; 18 Index rows = m.rows(); 19 Index cols = m.cols(); 47 Index r0 = internal::random<Index>(0,rows-1); 48 Index c0 = internal::random<Index>(0,cols-1); 49 Index r1 = internal::random<Index>(r0+1,rows)-r0 [all...] |
/external/mesa3d/src/gallium/drivers/r300/compiler/tests/ |
rc_test_helpers.c | 30 static int match_length(regmatch_t * matches, int index) 32 return matches[index].rm_eo - matches[index].rm_so; 73 struct match_info Index; 78 * Initialize the source register at index src_index for the instruction based 112 tokens.Index.String = src_str + matches[4].rm_so; 113 tokens.Index.Length = match_length(matches, 4); 138 /* Index */ 140 src_reg->Index = strtol(tokens.Index.String, NULL, 10) [all...] |
/external/eigen/Eigen/src/Core/ |
IO.h | 163 typedef typename Derived::Index Index; 165 Index width = 0; 195 for(Index j = 0; j < m.cols(); ++j) 196 for(Index i = 0; i < m.rows(); ++i) 201 width = std::max<Index>(width, Index(sstr.str().length())); 205 for(Index i = 0; i < m.rows(); ++i) 212 for(Index j = 1; j < m.cols(); ++j)
|
/external/eigen/Eigen/src/Eigen2Support/ |
Block.h | 30 * \sa class Block, block(Index,Index,Index,Index) 34 ::corner(CornerType type, Index cRows, Index cCols) 51 /** This is the const version of corner(CornerType, Index, Index).*/ 54 DenseBase<Derived>::corner(CornerType type, Index cRows, Index cCols) cons [all...] |
/external/eigen/Eigen/src/IterativeLinearSolvers/ |
BasicPreconditioners.h | 37 typedef typename Vector::Index Index; 51 Index rows() const { return m_invdiag.size(); } 52 Index cols() const { return m_invdiag.size(); } 67 while(it && it.index()!=j) ++it; 68 if(it && it.index()==j)
|
/external/eigen/Eigen/src/SparseCore/ |
SparseProduct.h | 19 typedef typename internal::traits<Lhs>::Index Index; 28 SparseMatrix<Scalar,0,Index>, 32 SparseMatrix<Scalar,0,Index>, 47 typedef typename promote_index_type<typename traits<_LhsNested>::Index, 48 typename traits<_RhsNested>::Index>::type Index; 124 EIGEN_STRONG_INLINE Index rows() const { return m_lhs.rows(); } 125 EIGEN_STRONG_INLINE Index cols() const { return m_rhs.cols(); }
|
/external/eigen/test/eigen2/ |
eigen2_sizeof.cpp | 18 VERIFY(sizeof(MatrixType)==sizeof(Scalar*) + 2 * sizeof(typename MatrixType::Index));
|
/external/eigen/unsupported/Eigen/src/AutoDiff/ |
AutoDiffVector.h | 41 typedef typename JacobianType::Index Index; 52 CoeffType operator[] (Index i) { return CoeffType(m_values[i], m_jacobian.col(i)); } 53 const CoeffType operator[] (Index i) const { return CoeffType(m_values[i], m_jacobian.col(i)); } 55 CoeffType operator() (Index i) { return CoeffType(m_values[i], m_jacobian.col(i)); } 56 const CoeffType operator() (Index i) const { return CoeffType(m_values[i], m_jacobian.col(i)); } 58 CoeffType coeffRef(Index i) { return CoeffType(m_values[i], m_jacobian.col(i)); } 59 const CoeffType coeffRef(Index i) const { return CoeffType(m_values[i], m_jacobian.col(i)); } 61 Index size() const { return m_values.size(); }
|
/external/eigen/unsupported/Eigen/src/IterativeSolvers/ |
IncompleteLU.h | 20 typedef typename Vector::Index Index; 34 Index rows() const { return m_lu.rows(); } 35 Index cols() const { return m_lu.cols(); } 46 for(; k_it && k_it.index()<i; ++k_it) 48 int k = k_it.index(); 53 while(kj_it && kj_it.index()<=k) ++kj_it; 56 if(kj_it.index()==j_it.index()) 62 else if(kj_it.index()<j_it.index()) ++kj_it [all...] |
/external/eigen/unsupported/Eigen/src/NonLinearOptimization/ |
qrsolv.h | 17 typedef DenseIndex Index; 20 Index i, j, k, l; 22 Index n = s.cols(); 75 Index nsing;
|
r1updt.h | 15 typedef DenseIndex Index; 19 const Index m = s.rows(); 20 const Index n = s.cols(); 21 Index i, j=1;
|
lmpar.h | 17 typedef DenseIndex Index; 20 Index i, j, l; 23 Index iter; 31 const Index n = r.cols(); 40 Index nsing = n-1; 175 typedef DenseIndex Index; 178 Index j; 181 Index iter; 189 const Index n = qr.matrixQR().cols(); 198 // const Index rank = qr.nonzeroPivots(); // exactly double(0. [all...] |
/external/mesa3d/src/gallium/drivers/r300/compiler/ |
radeon_emulate_loops.c | 51 int Index; 89 rc_register_file file, unsigned int index, unsigned int mask) 93 value->Src->Index != index || 100 inst->U.I.SrcReg[0].Index)){ 106 inst->U.I.SrcReg[0].Index, 114 rc_register_file file, unsigned int index, unsigned int mask) 122 count_inst->Index != index || 134 /* Find the index of the counter register. * [all...] |
/external/opencv3/modules/flann/include/opencv2/flann/ |
miniflann.hpp | 128 class CV_EXPORTS_W Index 131 CV_WRAP Index(); 132 CV_WRAP Index(InputArray features, const IndexParams& params, cvflann::flann_distance_t distType=cvflann::FLANN_DIST_L2); 133 virtual ~Index(); 153 void* index; member in class:cv::flann::Index
|
/external/eigen/Eigen/src/Eigenvalues/ |
SelfAdjointEigenSolver.h | 82 typedef typename MatrixType::Index Index; 107 * SelfAdjointEigenSolver(Index) for dynamic-size matrices. 131 SelfAdjointEigenSolver(Index size) 384 template<int StorageOrder,typename RealScalar, typename Scalar, typename Index> 385 static void tridiagonal_qr_step(RealScalar* diag, RealScalar* subdiag, Index start, Index end, Scalar* matrixQ, Index n); 400 Index n = matrix.cols(); 426 Index end = n-1 [all...] |
/system/update_engine/payload_generator/ |
inplace_generator.cc | 83 // their destination extents given the index of the operations in the graph. 238 const vector<vector<Vertex::Index>::size_type>& table) 244 const vector<vector<Vertex::Index>::size_type>& table_; 250 const vector<Vertex::Index>& op_indexes, 251 vector<vector<Vertex::Index>::size_type>* reverse_op_indexes) { 252 vector<vector<Vertex::Index>::size_type> table(op_indexes.size()); 253 for (vector<Vertex::Index>::size_type i = 0, e = op_indexes.size(); 255 Vertex::Index node = op_indexes[i]; 265 const vector<Vertex::Index>& op_indexes, 268 vector<vector<Vertex::Index>::size_type> table [all...] |
/external/jdiff/src/jdiff/ |
HTMLIndexes.java | 23 /** Emit all the bottom left frame index files. */ 35 // are any removals etc for the allDiffs index. 59 * the given program element type in an alphabetical index. 61 * @param indexBaseName The base name of the index file. 76 title = programElementType + " Removals Index"; 79 title = programElementType + " Additions Index"; 82 title = programElementType + " Changes Index"; 85 title = programElementType + " Differences Index"; 125 * with a link to the top of the index. 141 Index entry = (Index)(iter.next()) [all...] |
/external/eigen/Eigen/src/Cholesky/ |
LDLT.h | 62 typedef typename MatrixType::Index Index; 88 LDLT(Index size) 99 * \sa LDLT(Index size) 223 inline Index rows() const { return m_matrix.rows(); } 224 inline Index cols() const { return m_matrix.cols(); } 269 typedef typename MatrixType::Index Index; 271 const Index size = mat.rows(); 282 for (Index k = 0; k < size; ++k [all...] |
/external/eigen/Eigen/src/Jacobi/ |
Jacobi.h | 65 bool makeJacobi(const MatrixBase<Derived>&, typename Derived::Index p, typename Derived::Index q); 80 * \sa MatrixBase::makeJacobi(const MatrixBase<Derived>&, Index, Index), MatrixBase::applyOnTheLeft(), MatrixBase::applyOnTheRight() 126 inline bool JacobiRotation<Scalar>::makeJacobi(const MatrixBase<Derived>& m, typename Derived::Index p, typename Derived::Index q) 277 inline void MatrixBase<Derived>::applyOnTheLeft(Index p, Index q, const JacobiRotation<OtherScalar>& j) 292 inline void MatrixBase<Derived>::applyOnTheRight(Index p, Index q, const JacobiRotation<OtherScalar>& j [all...] |
/external/eigen/Eigen/src/Core/util/ |
BlasUtil.h | 21 template<typename LhsScalar, typename RhsScalar, typename Index, int mr, int nr, bool ConjugateLhs=false, bool ConjugateRhs=false> 24 template<typename Scalar, typename Index, int nr, int StorageOrder, bool Conjugate = false, bool PanelMode=false> 27 template<typename Scalar, typename Index, int Pack1, int Pack2, int StorageOrder, bool Conjugate = false, bool PanelMode = false> 31 typename Index, 37 template<typename Index, typename LhsScalar, int LhsStorageOrder, bool ConjugateLhs, typename RhsScalar, bool ConjugateRhs, int Version=Specialized> 122 template<typename Scalar, typename Index, int StorageOrder> 126 blas_data_mapper(Scalar* data, Index stride) : m_data(data), m_stride(stride) {} 127 EIGEN_STRONG_INLINE Scalar& operator()(Index i, Index j) 131 Index m_stride [all...] |