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

1 2 3 4 5 6 78 91011>>

  /external/eigen/Eigen/src/Core/
Redux.h 143 index = Start * packet_traits<typename Derived::Scalar>::size, enumerator in enum:Eigen::internal::redux_vec_unroller::__anon10253
144 outer = index / int(Derived::InnerSizeAtCompileTime),
145 inner = index % int(Derived::InnerSizeAtCompileTime),
172 typedef typename Derived::Index Index;
178 for(Index i = 1; i < mat.innerSize(); ++i)
180 for(Index i = 1; i < mat.outerSize(); ++i)
181 for(Index j = 0; j < mat.innerSize(); ++j)
197 typedef typename Derived::Index Index;
    [all...]
CwiseUnaryView.h 71 EIGEN_STRONG_INLINE Index rows() const { return m_matrix.rows(); }
72 EIGEN_STRONG_INLINE Index cols() const { return m_matrix.cols(); }
106 inline Index innerStride() const
111 inline Index outerStride() const
116 EIGEN_STRONG_INLINE CoeffReturnType coeff(Index row, Index col) const
121 EIGEN_STRONG_INLINE CoeffReturnType coeff(Index index) const
123 return derived().functor()(derived().nestedExpression().coeff(index));
126 EIGEN_STRONG_INLINE Scalar& coeffRef(Index row, Index col
    [all...]
PermutationMatrix.h 70 typedef typename Traits::Index Index;
73 typedef PermutationMatrix<IndicesType::SizeAtCompileTime,IndicesType::MaxSizeAtCompileTime,Index>
91 for(Index k=size()-1; k>=0; --k)
108 inline Index rows() const { return Index(indices().size()); }
111 inline Index cols() const { return Index(indices().size()); }
114 inline Index size() const { return Index(indices().size());
    [all...]
EigenBase.h 31 typedef typename internal::traits<Derived>::Index Index;
44 inline Index rows() const { return derived().rows(); }
46 inline Index cols() const { return derived().cols(); }
49 inline Index size() const { return rows() * cols(); }
DiagonalProduct.h 58 EIGEN_STRONG_INLINE Index rows() const { return m_matrix.rows(); }
59 EIGEN_STRONG_INLINE Index cols() const { return m_matrix.cols(); }
61 EIGEN_STRONG_INLINE const Scalar coeff(Index row, Index col) const
66 EIGEN_STRONG_INLINE const Scalar coeff(Index idx) const
75 EIGEN_STRONG_INLINE PacketScalar packet(Index row, Index col) const
80 const Index indexInDiagonalVector = ProductOrder == OnTheLeft ? row : col;
87 EIGEN_STRONG_INLINE PacketScalar packet(Index idx) const
97 EIGEN_STRONG_INLINE PacketScalar packet_impl(Index row, Index col, Index id, internal::true_type) cons
    [all...]
Transpose.h 69 inline Index rows() const { return m_matrix.cols(); }
70 inline Index cols() const { return m_matrix.rows(); }
109 inline Index innerStride() const { return derived().nestedExpression().innerStride(); }
110 inline Index outerStride() const { return derived().nestedExpression().outerStride(); }
121 inline ScalarWithConstIfNotLvalue& coeffRef(Index rowId, Index colId)
127 inline ScalarWithConstIfNotLvalue& coeffRef(Index index)
130 return derived().nestedExpression().const_cast_derived().coeffRef(index);
133 inline const Scalar& coeffRef(Index rowId, Index colId) cons
    [all...]
  /external/eigen/Eigen/src/Geometry/
EulerAngles.h 37 MatrixBase<Derived>::eulerAngles(Index a0, Index a1, Index a2) const
48 const Index odd = ((a0+1)%3 == a1) ? 0 : 1;
49 const Index i = a0;
50 const Index j = (a0 + 1 + odd)%3;
51 const Index k = (a0 + 2 - odd)%3;
  /external/eigen/Eigen/src/SparseCore/
SparseDenseProduct.h 49 typedef typename Lhs::Index Index;
105 EIGEN_STRONG_INLINE Index rows() const { return Tr ? m_rhs.rows() : m_lhs.rows(); }
106 EIGEN_STRONG_INLINE Index cols() const { return Tr ? m_lhs.cols() : m_rhs.cols(); }
120 typedef typename SparseDenseOuterProduct::Index Index;
122 EIGEN_STRONG_INLINE InnerIterator(const SparseDenseOuterProduct& prod, Index outer)
126 inline Index outer() const { return m_outer; }
127 inline Index row() const { return Transpose ? m_outer : Base::index(); }
    [all...]
SparseMatrixBase.h 33 typedef typename internal::traits<Derived>::Index Index;
108 typedef SparseMatrix<Scalar, Flags&RowMajorBit ? RowMajor : ColMajor, Index> PlainObject;
150 inline Index rows() const { return derived().rows(); }
152 inline Index cols() const { return derived().cols(); }
155 inline Index size() const { return rows() * cols(); }
158 inline Index nonZeros() const { return derived().nonZeros(); }
166 Index outerSize() const { return (int(Flags)&RowMajorBit) ? this->rows() : this->cols(); }
169 Index innerSize() const { return (int(Flags)&RowMajorBit) ? this->cols() : this->rows(); }
205 const Index outerSize = (int(OtherDerived::Flags) & RowMajorBit) ? other.rows() : other.cols()
    [all...]
  /external/eigen/test/
determinant.cpp 19 typedef typename MatrixType::Index Index;
20 Index size = m.rows();
30 Index i = internal::random<Index>(0, size-1);
31 Index j;
33 j = internal::random<Index>(0, size-1);
real_qz.cpp 20 typedef typename MatrixType::Index Index;
23 Index dim = m.cols();
30 Index k=internal::random<Index>(0, dim-1);
49 for (Index i=0; i<A.cols(); i++)
50 for (Index j=0; j<i; j++) {
sparse_basic.cpp 16 typedef typename SparseMatrixType::Index Index;
17 typedef Matrix<Index,2,1> Vector2;
19 const Index rows = ref.rows();
20 const Index cols = ref.cols();
140 for (Index j=0; j<cols; ++j)
142 for (Index k=0; k<rows/2; ++k)
144 Index i = internal::random<Index>(0,rows-1);
162 Index i = internal::random<Index>(0,rows-1)
    [all...]
jacobisvd.cpp 20 typedef typename MatrixType::Index Index;
21 Index rows = m.rows();
22 Index cols = m.cols();
48 typedef typename MatrixType::Index Index;
49 Index rows = m.rows();
50 Index cols = m.cols();
51 Index diagSize = (std::min)(rows, cols);
71 typedef typename MatrixType::Index Index
    [all...]
  /external/pdfium/third_party/bigint/
BigUnsignedInABase.cc 9 BigUnsignedInABase::BigUnsignedInABase(const Digit *d, Index l, Base base)
16 for (Index i = 0; i < l; i++)
52 Index digitNum = 0;
70 Index digitNum = len;
87 // `s.length()' is a `size_t', while `len' is a `NumberlikeArray::Index',
89 len = Index(s.length());
92 Index digitNum, symbolNumInString;
119 Index digitNum, symbolNumInString;
  /external/eigen/unsupported/Eigen/src/SVD/
SVDBase.h 53 typedef typename MatrixType::Index Index;
147 Index nonzeroSingularValues() const
160 inline Index rows() const { return m_rows; }
161 inline Index cols() const { return m_cols; }
166 bool allocate(Index rows, Index cols, unsigned int computationOptions) ;
175 Index m_nonzeroSingularValues, m_rows, m_cols, m_diagSize;
194 bool SVDBase<MatrixType>::allocate(Index rows, Index cols, unsigned int computationOptions
    [all...]
  /external/llvm/lib/Option/
Arg.cpp 21 Arg::Arg(const Option Opt, StringRef S, unsigned Index, const Arg *BaseArg)
22 : Opt(Opt), BaseArg(BaseArg), Spelling(S), Index(Index), Claimed(false),
25 Arg::Arg(const Option Opt, StringRef S, unsigned Index, const char *Value0,
27 : Opt(Opt), BaseArg(BaseArg), Spelling(S), Index(Index), Claimed(false),
32 Arg::Arg(const Option Opt, StringRef S, unsigned Index, const char *Value0,
34 : Opt(Opt), BaseArg(BaseArg), Spelling(S), Index(Index), Claimed(false),
53 O << " Index:" << Index
    [all...]
  /external/eigen/Eigen/src/Cholesky/
LLT_MKL.h 49 static inline typename MatrixType::Index potrf(MatrixType& m, char uplo) \
70 static typename MatrixType::Index blocked(MatrixType& m) \
75 static typename MatrixType::Index rankUpdate(MatrixType& mat, const VectorType& vec, const typename MatrixType::RealScalar& sigma) \
81 static typename MatrixType::Index blocked(MatrixType& m) \
86 static typename MatrixType::Index rankUpdate(MatrixType& mat, const VectorType& vec, const typename MatrixType::RealScalar& sigma) \
  /external/eigen/Eigen/src/SPQRSupport/
SuiteSparseQRSupport.h 50 * NOTE : The Index type of R is always UF_long. You can get it with SPQR::Index
62 typedef UF_long Index ;
63 typedef SparseMatrix<Scalar, ColMajor, Index> MatrixType;
116 Index col = matrix.cols();
133 inline Index rows() const {return m_cR->nrow; }
138 inline Index cols() const { return m_cR->ncol; }
164 Index rk = this->rank();
166 y.resize((std::max)(cols(),Index(y.rows())),y.cols());
172 for(Index i = 0; i < rk; ++i) dest.row(m_E[i]) = y.row(i)
    [all...]
  /external/eigen/unsupported/Eigen/src/AutoDiff/
AutoDiffJacobian.h 39 typedef typename JacobianType::Index Index;
63 for (Index j=0; j<jac.rows(); j++)
66 for (Index i=0; i<jac.cols(); i++)
71 for (Index i=0; i<jac.rows(); i++)
  /external/eigen/unsupported/Eigen/src/LevenbergMarquardt/
LevenbergMarquardt.h 72 typedef _Index Index;
75 typedef SparseMatrix<Scalar, ColMajor, Index> JacobianType;
118 typedef typename JacobianType::Index Index;
119 typedef typename QRSolver::Index PermIndex;
141 Index *nfev,
172 void setMaxfev(Index maxfev) {m_maxfev = maxfev; }
181 Index iterations() { return m_iter; }
184 Index nfev() { return m_nfev; }
187 Index njev() { return m_njev;
    [all...]
  /external/eigen/unsupported/Eigen/src/NonLinearOptimization/
chkder.h 23 typedef DenseIndex Index;
30 const Index m = fvec.size(), n = x.size();
35 for (Index j = 0; j < n; ++j) {
45 for (Index j = 0; j < n; ++j) {
51 for (Index i = 0; i < m; ++i) {
  /external/llvm/lib/Transforms/IPO/
FunctionImport.cpp 97 const FunctionInfoIndex &Index,
106 Twine(Index.getModuleId(F.getParent()->getModuleIdentifier()))).str();
152 // Helper function: given a worklist and an index, will process all the worklist
165 const FunctionInfoIndex &Index,
173 auto InfoList = Index.findFunctionInfoList(CalledFunctionName);
174 if (InfoList == Index.end()) {
254 findExternalCalls(DestModule, *F, Index, CalledFunctions, Worklist);
259 // index.
262 // summaries index.
274 findExternalCalls(DestModule, F, Index, CalledFunctions, Worklist)
    [all...]
  /external/eigen/Eigen/src/QR/
ColPivHouseholderQR.h 51 typedef typename MatrixType::Index Index;
55 typedef typename internal::plain_row_type<MatrixType, Index>::type IntRowVectorType;
62 typedef typename PermutationType::Index PermIndexType;
88 ColPivHouseholderQR(Index rows, Index cols)
221 inline Index rank() const
226 Index result = 0;
227 for(Index i = 0; i < m_nonzero_pivots; ++i)
238 inline Index dimensionOfKernel() cons
    [all...]
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixFunction.h 129 typedef typename MatrixType::Index Index;
135 typedef Matrix<Index, Traits::RowsAtCompileTime, 1> IntVectorType;
136 typedef Matrix<Index, Dynamic, 1> DynamicIntVectorType;
155 void swapEntriesInSchur(Index index);
157 Block<MatrixType> block(MatrixType& A, Index i, Index j);
169 DynamicIntVectorType m_blockStart; /**< \brief Row index at which block corresponding to i-th cluster starts */
239 const Index rows = m_T.rows()
    [all...]
MatrixFunctionAtomic.h 29 typedef typename MatrixType::Index Index;
52 bool taylorConverged(Index s, const MatrixType& F, const MatrixType& Fincr, const MatrixType& P);
58 Index m_Arows;
81 for (Index s = 1; s < 1.1 * m_Arows + 10; s++) { // upper limit is fairly arbitrary
105 bool MatrixFunctionAtomic<MatrixType>::taylorConverged(Index s, const MatrixType& F,
108 const Index n = F.rows();
114 for (Index r = 0; r < n; r++) {
116 for (Index i = 0; i < n; i++)

Completed in 3122 milliseconds

1 2 3 4 5 6 78 91011>>