Searched defs:Index (Results 201 - 225 of 515) sorted by relevance

1234567891011>>

/external/clang/lib/ASTMatchers/Dynamic/
H A DDiagnostics.cpp143 const unsigned Index = Next - '0'; local
144 if (Index < Args.size()) {
145 OS << Args[Index];
/external/clang/lib/Basic/
H A DTargetInfo.cpp482 unsigned &Index) const {
496 for (Index = 0; Index != NumOutputs; ++Index)
497 if (SymbolicName == OutputConstraints[Index].getName())
542 unsigned Index = 0; local
543 if (!resolveSymbolicName(Name, OutputConstraints, NumOutputs, Index))
548 if (Info.hasTiedOperand() && Info.getTiedOperand() != Index)
551 Info.setTiedOperand(Index, OutputConstraints[Index]);
[all...]
/external/clang/test/CodeGenCXX/
H A Dtemp-order.cpp13 unsigned Product, Index; member in struct:TempTracker
15 TempTracker() : Product(1), Index(0) {}
30 TT.Product *= pow(P, ++TT.Index);
/external/clang/unittests/Basic/
H A DVirtualFileSystemTest.cpp347 int Index = Name[Name.size()-1] - 'a'; local
348 ASSERT_TRUE(Index >= 0 && Index < 4);
349 Counts[Index]++;
/external/clang/unittests/libclang/
H A DLibclangTest.cpp10 #include "clang-c/Index.h"
346 CXIndex Index; member in class:LibclangReparseTest
356 Index = clang_createIndex(0, 0);
360 clang_disposeIndex(Index);
406 ClangTU = clang_parseTranslationUnit(Index, CppName.c_str(), nullptr, 0,
441 ClangTU = clang_parseTranslationUnit(Index, MName.c_str(), Args, NumArgs,
/external/clang/utils/TableGen/
H A DClangSACheckersEmitter.cpp77 unsigned Index; member in struct:__anon19561::GroupInfo
253 I->second.Index = index++;
266 OS << "static const short CheckerArray" << I->second.Index << "[] = { ";
281 OS << "static const short SubPackageArray" << I->second.Index << "[] = { ";
290 OS << recordGroupMap[I->second]->Index << ", ";
308 OS << "CheckerArray" << I->second.Index << ", ";
314 OS << "SubPackageArray" << I->second.Index << ", ";
/external/compiler-rt/lib/ubsan/
H A Dubsan_handlers.cc187 ValueHandle Index) {
192 Value IndexVal(Data->IndexType, Index);
197 ValueHandle Index) {
198 __ubsan_handle_out_of_bounds(Data, Index);
186 __ubsan_handle_out_of_bounds(OutOfBoundsData *Data, ValueHandle Index) argument
196 __ubsan_handle_out_of_bounds_abort(OutOfBoundsData *Data, ValueHandle Index) argument
/external/eigen/Eigen/src/Core/
H A DAssign.h134 template<typename Derived1, typename Derived2, int Index, int Stop>
138 outer = Index / Derived1::InnerSizeAtCompileTime,
139 inner = Index % Derived1::InnerSizeAtCompileTime
145 assign_DefaultTraversal_CompleteUnrolling<Derived1, Derived2, Index+1, Stop>::run(dst, src);
155 template<typename Derived1, typename Derived2, int Index, int Stop>
158 static EIGEN_STRONG_INLINE void run(Derived1 &dst, const Derived2 &src, typename Derived1::Index outer)
160 dst.copyCoeffByOuterInner(outer, Index, src);
161 assign_DefaultTraversal_InnerUnrolling<Derived1, Derived2, Index+1, Stop>::run(dst, src, outer);
168 static EIGEN_STRONG_INLINE void run(Derived1 &, const Derived2 &, typename Derived1::Index) {}
175 template<typename Derived1, typename Derived2, int Index, in
258 typedef typename Derived1::Index Index; typedef in struct:Eigen::internal::assign_impl
282 typedef typename Derived1::Index Index; typedef in struct:Eigen::internal::assign_impl
299 typedef typename Derived1::Index Index; typedef in struct:Eigen::internal::assign_impl
325 typedef typename Derived1::Index Index; typedef in struct:Eigen::internal::assign_impl
350 typedef typename Derived1::Index Index; typedef in struct:Eigen::internal::assign_impl
392 typedef typename Derived1::Index Index; typedef in struct:Eigen::internal::assign_impl
420 typedef typename Derived1::Index Index; typedef in struct:Eigen::internal::assign_impl
439 typedef typename Derived1::Index Index; typedef in struct:Eigen::internal::assign_impl
[all...]
H A DAssign_MKL.h87 typedef typename Derived1::Index Index; typedef in struct:Eigen::internal::vml_assign_impl
92 const Index innerSize = dst.innerSize();
93 const Index outerSize = dst.outerSize();
94 for(Index outer = 0; outer < outerSize; ++outer) {
H A DBandMatrix.h35 typedef typename DenseMatrixType::Index Index; typedef in class:Eigen::internal::BandMatrixBase
54 inline Index supers() const { return derived().supers(); }
57 inline Index subs() const { return derived().subs(); }
68 inline Block<CoefficientsType,Dynamic,1> col(Index i)
71 Index start = 0;
72 Index len = coeffs().rows();
76 len = (std::min)(rows(),std::max<Index>(0,coeffs().rows() - (supers()-i)));
79 len = std::max<Index>(0,coeffs().rows() - (i + 1 - rows() + subs()));
91 template<int Index> struc
182 typedef DenseIndex Index; typedef in struct:Eigen::internal::traits
204 typedef typename internal::traits<BandMatrix>::Index Index; typedef in class:Eigen::internal::BandMatrix
244 typedef typename _CoefficientsType::Index Index; typedef in struct:Eigen::internal::traits
267 typedef typename internal::traits<BandMatrixWrapper>::Index Index; typedef in class:Eigen::internal::BandMatrixWrapper
315 typedef typename Base::Index Index; typedef in class:Eigen::internal::TridiagonalMatrix
[all...]
H A DCwiseBinaryOp.h61 typedef typename promote_index_type<typename traits<Lhs>::Index,
62 typename traits<Rhs>::Index>::type Index; typedef in struct:Eigen::internal::traits
134 EIGEN_STRONG_INLINE Index rows() const {
141 EIGEN_STRONG_INLINE Index cols() const {
172 EIGEN_STRONG_INLINE const Scalar coeff(Index rowId, Index colId) const
179 EIGEN_STRONG_INLINE PacketScalar packet(Index rowId, Index colId) const
185 EIGEN_STRONG_INLINE const Scalar coeff(Index inde
[all...]
H A DCwiseNullaryOp.h57 CwiseNullaryOp(Index nbRows, Index nbCols, const NullaryOp& func = NullaryOp())
66 EIGEN_STRONG_INLINE Index rows() const { return m_rows.value(); }
67 EIGEN_STRONG_INLINE Index cols() const { return m_cols.value(); }
69 EIGEN_STRONG_INLINE const Scalar coeff(Index rowId, Index colId) const
75 EIGEN_STRONG_INLINE PacketScalar packet(Index rowId, Index colId) const
80 EIGEN_STRONG_INLINE const Scalar coeff(Index index) const
86 EIGEN_STRONG_INLINE PacketScalar packet(Index inde
752 typedef typename Derived::Index Index; typedef in struct:Eigen::internal::setIdentity_impl
[all...]
H A DDenseBase.h61 typedef typename internal::traits<Derived>::Index Index; typedef in class:Eigen::DenseBase
185 inline Index nonZeros() const { return size(); }
196 Index outerSize() const
207 Index innerSize() const
217 void resize(Index newSize)
227 void resize(Index nbRows, Index nbCols)
296 Constant(Index rows, Index col
[all...]
H A DDenseCoeffsBase.h38 typedef typename internal::traits<Derived>::Index Index; typedef in class:Eigen::DenseCoeffsBase
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) cons
281 typedef typename internal::traits<Derived>::Index Index; typedef in class:Eigen::DenseCoeffsBase
571 typedef typename internal::traits<Derived>::Index Index; typedef in class:Eigen::DenseCoeffsBase
642 typedef typename internal::traits<Derived>::Index Index; typedef in class:Eigen::DenseCoeffsBase
[all...]
H A DDiagonalMatrix.h25 typedef typename internal::traits<Derived>::Index Index; typedef in class:Eigen::DiagonalBase
56 inline Index rows() const { return diagonal().size(); }
57 inline Index cols() const { return diagonal().size(); }
128 typedef DenseIndex Index; typedef in struct:Eigen::internal::traits
144 typedef typename internal::traits<DiagonalMatrix>::Index Index; typedef in class:Eigen::DiagonalMatrix
162 inline DiagonalMatrix(Index dim) : m_diagonal(dim) {}
204 inline void resize(Index size) { m_diagonal.resize(size); }
208 inline void setZero(Index siz
235 typedef typename DiagonalVectorType::Index Index; typedef in struct:Eigen::internal::traits
[all...]
H A DIO.h163 typedef typename Derived::Index Index; typedef
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)
H A DMatrixBase.h55 typedef typename internal::traits<Derived>::Index Index; typedef in class:Eigen::MatrixBase
101 inline Index diagonalSize() const { return (std::min)(rows(),cols()); }
221 template<int Index> struct DiagonalIndexReturnType { typedef Diagonal<Derived,Index> Type; };
222 template<int Index> struct ConstDiagonalIndexReturnType { typedef const Diagonal<const Derived,Index> Type; };
224 template<int Index> typename DiagonalIndexReturnType<Index>::Type diagonal();
225 template<int Index> typenam
[all...]
H A DRedux.h172 typedef typename Derived::Index Index; typedef in struct:Eigen::internal::redux_impl
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; typedef in struct:Eigen::internal::redux_impl
201 const Index size = mat.size();
203 const Index packetSize = packet_traits<Scalar>::size;
204 const Index alignedStar
255 typedef typename Derived::Index Index; typedef in struct:Eigen::internal::redux_impl
[all...]
H A DSelfAdjointView.h65 typedef typename MatrixType::Index Index; typedef in class:Eigen::SelfAdjointView
75 inline Index rows() const { return m_matrix.rows(); }
76 inline Index cols() const { return m_matrix.cols(); }
77 inline Index outerStride() const { return m_matrix.outerStride(); }
78 inline Index innerStride() const { return m_matrix.innerStride(); }
83 inline Scalar coeff(Index row, Index col) const
92 inline Scalar& coeffRef(Index row, Index co
257 typedef typename Derived1::Index Index; typedef in struct:Eigen::internal::triangular_assignment_selector
277 typedef typename Derived1::Index Index; typedef
[all...]
H A DSolveTriangular.h19 template<typename LhsScalar, typename RhsScalar, typename Index, int Side, int Mode, bool Conjugate, int StorageOrder>
22 template <typename Scalar, typename Index, int Side, int Mode, bool Conjugate, int TriStorageOrder, int OtherStorageOrder>
71 triangular_solve_vector<LhsScalar, RhsScalar, typename Lhs::Index, Side, Mode, LhsProductTraits::NeedToConjugate,
85 typedef typename Rhs::Index Index; typedef in struct:Eigen::internal::triangular_solver_selector
93 const Index size = lhs.rows();
94 const Index othersize = Side==OnTheLeft? rhs.cols() : rhs.rows();
101 triangular_solve_matrix<Scalar,Index,Side,Mode,LhsProductTraits::NeedToConjugate,(int(Lhs::Flags) & RowMajorBit) ? RowMajor : ColMajor,
111 template<typename Lhs, typename Rhs, int Mode, int Index, int Size,
112 bool Stop = Index
235 typedef typename Base::Index Index; typedef in struct:Eigen::internal::triangular_solve_retval
[all...]
H A DTranspositions.h56 typedef typename IndicesType::Scalar Index; typedef in class:Eigen::TranspositionsBase
81 inline Index size() const { return indices().size(); }
84 inline const Index& coeff(Index i) const { return indices().coeff(i); }
86 inline Index& coeffRef(Index i) { return indices().coeffRef(i); }
88 inline const Index& operator()(Index i) const { return indices()(i); }
90 inline Index& operator()(Index
150 typedef IndexType Index; typedef in struct:Eigen::internal::traits
163 typedef typename IndicesType::Scalar Index; typedef in class:Eigen::Transpositions
221 typedef IndexType Index; typedef in struct:Eigen::internal::traits
235 typedef typename IndicesType::Scalar Index; typedef in class:Eigen::Map
278 typedef typename _IndicesType::Scalar Index; typedef in struct:Eigen::internal::traits
292 typedef typename IndicesType::Scalar Index; typedef in class:Eigen::TranspositionsWrapper
365 typedef typename TranspositionType::Index Index; typedef in struct:Eigen::internal::transposition_matrix_product_retval
[all...]
/external/eigen/Eigen/src/Core/products/
H A DCoeffBasedProduct.h46 typedef typename promote_index_type<typename traits<_LhsNested>::Index,
47 typename traits<_RhsNested>::Index>::type Index; typedef in struct:Eigen::internal::traits
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
173 EIGEN_STRONG_INLINE const Scalar coeff(Index index) const
176 const Index row = RowsAtCompileTime == 1 ? 0 : index;
177 const Index co
241 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_coeff_impl
252 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_coeff_impl
262 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_coeff_impl
279 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_coeff_vectorized_unroller
291 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_coeff_vectorized_unroller
302 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_coeff_impl
316 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_coeff_vectorized_dyn_selector
328 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_coeff_vectorized_dyn_selector
338 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_coeff_vectorized_dyn_selector
348 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_coeff_vectorized_dyn_selector
358 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_coeff_impl
372 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_packet_impl
383 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_packet_impl
394 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_packet_impl
404 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_packet_impl
414 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_packet_impl
427 typedef typename Lhs::Index Index; typedef in struct:Eigen::internal::product_packet_impl
[all...]
/external/eigen/Eigen/src/Eigenvalues/
H A DComplexSchur.h66 typedef typename MatrixType::Index Index; typedef in class:Eigen::ComplexSchur
94 ComplexSchur(Index size = RowsAtCompileTime==Dynamic ? 1 : RowsAtCompileTime)
187 * \sa compute(const MatrixType&, bool, Index)
226 ComplexSchur& setMaxIterations(Index maxIters)
233 Index getMaxIterations()
251 Index m_maxIters;
254 bool subdiagonalEntryIsNeglegible(Index i);
255 ComplexScalar computeShift(Index iu, Index ite
[all...]
H A DEigenSolver.h82 typedef typename MatrixType::Index Index; typedef in class:Eigen::EigenSolver
121 EigenSolver(Index size)
285 EigenSolver& setMaxIterations(Index maxIters)
292 Index getMaxIterations()
316 Index n = m_eivalues.rows();
318 for (Index i=0; i<n; ++i)
337 Index n = m_eivec.cols();
339 for (Index j=0; j<n; ++j)
350 for (Index
[all...]
H A DGeneralizedEigenSolver.h75 typedef typename MatrixType::Index Index; typedef in class:Eigen::GeneralizedEigenSolver
125 GeneralizedEigenSolver(Index size)
259 GeneralizedEigenSolver& setMaxIterations(Index maxIters)
283 // Index n = m_eivec.cols();
310 Index i = 0;

Completed in 448 milliseconds

1234567891011>>