HomeSort by relevance Sort by last modified time
    Searched refs:Index (Results 276 - 300 of 983) sorted by null

<<11121314151617181920>>

  /external/clang/lib/Serialization/
ModuleManager.cpp 79 New->Index = Chain.size();
200 void ModuleManager::setGlobalIndex(GlobalModuleIndex *Index) {
201 GlobalIndex = Index;
207 // Notify the global module index about all of the modules we've already
275 unsigned &NumUnusedEdges = UnusedIncomingEdges[(*M)->Index];
291 // module index, mark every module file in common with the global module
292 // index that is *not* in that set as 'visited'.
298 State->VisitNumber[M->Index] = VisitNumber;
305 if (State->VisitNumber[CurrentModule->Index] == VisitNumber)
309 assert(State->VisitNumber[CurrentModule->Index] == VisitNumber - 1)
    [all...]
  /external/eigen/Eigen/src/Core/
ProductBase.h 30 typedef typename promote_index_type<typename traits<Lhs>::Index,
31 typename traits<Rhs>::Index>::type Index;
98 inline Index rows() const { return m_lhs.rows(); }
99 inline Index cols() const { return m_rhs.cols(); }
127 template<int Index>
128 const Diagonal<FullyLazyCoeffBaseProductType,Index> diagonal() const
131 const Diagonal<FullyLazyCoeffBaseProductType,Dynamic> diagonal(Index index) const
132 { return FullyLazyCoeffBaseProductType(m_lhs, m_rhs).diagonal(index); }
    [all...]
Select.h 72 Index rows() const { return m_condition.rows(); }
73 Index cols() const { return m_condition.cols(); }
75 const Scalar coeff(Index i, Index j) const
83 const Scalar coeff(Index i) const
StableNorm.h 47 const Index blockSize = 4096;
54 Index n = size();
55 Index bi = internal::first_aligned(derived());
79 static Index nmax = -1;
93 nbig = (std::numeric_limits<Index>::max)(); // largest integer
117 Index n = size();
122 for(Index j=0; j<n; ++j)
  /external/clang/include/clang/Sema/
Designator.h 51 Expr *Index;
91 return ArrayInfo.Index;
136 static Designator getArray(Expr *Index,
140 D.ArrayInfo.Index = Index;
Template.h 64 /// \brief Retrieve the template argument at a given depth and index.
65 const TemplateArgument &operator()(unsigned Depth, unsigned Index) const {
67 assert(Index < TemplateArgumentLists[getNumLevels() - Depth - 1].size());
68 return TemplateArgumentLists[getNumLevels() - Depth - 1][Index];
72 /// given depth and index.
75 bool hasTemplateArgument(unsigned Depth, unsigned Index) const {
78 if (Index >= TemplateArgumentLists[getNumLevels() - Depth - 1].size())
81 return !(*this)(Depth, Index).isNull();
85 void setArgument(unsigned Depth, unsigned Index,
88 assert(Index < TemplateArgumentLists[getNumLevels() - Depth - 1].size())
    [all...]
  /external/llvm/lib/Object/
MachOUniversal.cpp 59 const MachOUniversalBinary *Parent, uint32_t Index)
60 : Parent(Parent), Index(Index) {
61 if (Parent == 0 || Index > Parent->getNumberOfObjects()) {
67 Index * macho::FatArchHeaderSize;
  /external/chromium_org/third_party/mesa/src/src/gallium/auxiliary/gallivm/
lp_bld_tgsi_info.c 69 if (src->Index < Elements(ctx->temp)) {
70 *chan_info = ctx->temp[src->Index][swizzle];
75 assert(src->Index < Elements(ctx->imm));
76 if (src->Index < Elements(ctx->imm)) {
77 chan_info->u.value = ctx->imm[src->Index][swizzle];
80 chan_info->u.index = src->Index;
142 tex_info->unit = inst->Src[3].Register.Index;
149 tex_info->unit = inst->Src[1].Register.Index;
186 unsigned index; local
337 unsigned index; local
404 unsigned index; local
    [all...]
  /external/chromium_org/third_party/mesa/src/src/gallium/drivers/r300/compiler/
radeon_pair_translate.c 198 pair->RGB.Src[i].Index =
199 inst->PreSub.SrcReg[i].Index;
205 pair->Alpha.Src[i].Index =
206 inst->PreSub.SrcReg[i].Index;
235 inst->SrcReg[i].File, inst->SrcReg[i].Index);
262 inst->SrcReg[i].File, inst->SrcReg[i].Index);
285 if (inst->DstReg.Index == c->OutputDepth) {
289 if (inst->DstReg.Index == c->OutputColor[i]) {
302 pair->RGB.DestIndex = inst->DstReg.Index;
309 pair->Alpha.DestIndex = inst->DstReg.Index;
    [all...]
  /external/clang/lib/Basic/
TargetInfo.cpp 384 unsigned &Index) const {
398 for (Index = 0; Index != NumOutputs; ++Index)
399 if (SymbolicName == OutputConstraints[Index].getName())
441 unsigned Index = 0;
442 if (!resolveSymbolicName(Name, OutputConstraints, NumOutputs, Index))
447 if (Info.hasTiedOperand() && Info.getTiedOperand() != Index)
450 Info.setTiedOperand(Index, OutputConstraints[Index]);
    [all...]
  /external/mesa3d/src/gallium/auxiliary/gallivm/
lp_bld_tgsi_info.c 69 if (src->Index < Elements(ctx->temp)) {
70 *chan_info = ctx->temp[src->Index][swizzle];
75 assert(src->Index < Elements(ctx->imm));
76 if (src->Index < Elements(ctx->imm)) {
77 chan_info->u.value = ctx->imm[src->Index][swizzle];
80 chan_info->u.index = src->Index;
142 tex_info->unit = inst->Src[3].Register.Index;
149 tex_info->unit = inst->Src[1].Register.Index;
186 unsigned index; local
337 unsigned index; local
404 unsigned index; local
    [all...]
  /external/mesa3d/src/gallium/drivers/r300/compiler/
radeon_pair_translate.c 198 pair->RGB.Src[i].Index =
199 inst->PreSub.SrcReg[i].Index;
205 pair->Alpha.Src[i].Index =
206 inst->PreSub.SrcReg[i].Index;
235 inst->SrcReg[i].File, inst->SrcReg[i].Index);
262 inst->SrcReg[i].File, inst->SrcReg[i].Index);
285 if (inst->DstReg.Index == c->OutputDepth) {
289 if (inst->DstReg.Index == c->OutputColor[i]) {
302 pair->RGB.DestIndex = inst->DstReg.Index;
309 pair->Alpha.DestIndex = inst->DstReg.Index;
    [all...]
  /external/chromium_org/third_party/mesa/src/src/mesa/program/
prog_optimize.c 229 GLuint index = inst->SrcReg[j].Index; local
230 ASSERT(map[index] >= 0);
231 inst->SrcReg[j].Index = map[index];
235 const GLuint index = inst->DstReg.Index; local
236 ASSERT(map[index] >= 0);
237 inst->DstReg.Index = map[index];
275 const GLuint index = inst->SrcReg[j].Index; local
299 const GLuint index = inst->DstReg.Index; local
327 GLint chan, index = inst->DstReg.Index; local
612 const GLuint index = inst->DstReg.Index; local
1022 const GLuint index = inst->SrcReg[j].Index; local
1030 const GLuint index = inst->DstReg.Index; local
    [all...]
  /external/mesa3d/src/mesa/program/
prog_optimize.c 229 GLuint index = inst->SrcReg[j].Index; local
230 ASSERT(map[index] >= 0);
231 inst->SrcReg[j].Index = map[index];
235 const GLuint index = inst->DstReg.Index; local
236 ASSERT(map[index] >= 0);
237 inst->DstReg.Index = map[index];
275 const GLuint index = inst->SrcReg[j].Index; local
299 const GLuint index = inst->DstReg.Index; local
327 GLint chan, index = inst->DstReg.Index; local
612 const GLuint index = inst->DstReg.Index; local
1022 const GLuint index = inst->SrcReg[j].Index; local
1030 const GLuint index = inst->DstReg.Index; local
    [all...]
  /external/eigen/Eigen/src/Eigenvalues/
EigenSolver.h 82 typedef typename MatrixType::Index Index;
121 EigenSolver(Index size)
303 Index n = m_eivalues.rows();
305 for (Index i=0; i<n; ++i)
324 Index n = m_eivec.cols();
326 for (Index j=0; j<n; ++j)
337 for (Index i=0; i<n; ++i)
365 Index i = 0;
417 const Index size = m_eivec.cols()
    [all...]
SelfAdjointEigenSolver.h 82 typedef typename MatrixType::Index Index;
107 * SelfAdjointEigenSolver(Index) for dynamic-size matrices.
131 SelfAdjointEigenSolver(Index size)
379 template<int StorageOrder,typename RealScalar, typename Scalar, typename Index>
380 static void tridiagonal_qr_step(RealScalar* diag, RealScalar* subdiag, Index start, Index end, Scalar* matrixQ, Index n);
392 Index n = matrix.cols();
417 Index end = n-1
    [all...]
  /external/eigen/Eigen/src/Core/products/
SelfadjointMatrixVector.h 23 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool ConjugateRhs, int Version=Specialized>
26 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool ConjugateRhs, int Version>
31 Index size,
32 const Scalar* lhs, Index lhsStride,
33 const Scalar* _rhs, Index rhsIncr,
39 const Index PacketSize = sizeof(Packet)/sizeof(Scalar);
63 for (Index i=0; i<size; ++i, it+=rhsIncr)
67 Index bound = (std::max)(Index(0),size-8) & 0xfffffffe;
71 for (Index j=FirstTriangular ? bound : 0
    [all...]
GeneralBlockPanelKernel.h 513 template<typename LhsScalar, typename RhsScalar, typename Index, int mr, int nr, bool ConjugateLhs, bool ConjugateRhs>
531 void operator()(ResScalar* res, Index resStride, const LhsScalar* blockA, const RhsScalar* blockB, Index rows, Index depth, Index cols, ResScalar alpha,
532 Index strideA=-1, Index strideB=-1, Index offsetA=0, Index offsetB=0, RhsScalar* unpackedB = 0)
540 Index packet_cols = (cols/nr) * nr
    [all...]
  /external/eigen/Eigen/src/IterativeLinearSolvers/
IncompleteLUT.h 51 typedef typename FactorType::Index Index;
70 Index rows() const { return m_lu.rows(); }
72 Index cols() const { return m_lu.cols(); }
135 inline bool operator() (const Index& row, const Index& col, const Scalar&) const
150 PermutationMatrix<Dynamic,Dynamic,Index> m_P; // Fill-reducing permutation
151 PermutationMatrix<Dynamic,Dynamic,Index> m_Pinv; // Inverse permutation
181 * \param ind The array of index for the elements in @p row
224 SparseMatrix<Scalar,ColMajor, Index> mat1 = amat
    [all...]
  /external/eigen/test/
adjoint.cpp 19 typedef typename MatrixType::Index Index;
25 Index rows = m.rows();
26 Index cols = m.cols();
74 Index r = internal::random<Index>(0, rows-1),
75 c = internal::random<Index>(0, cols-1);
product_notemporary.cpp 33 typedef typename MatrixType::Index Index;
41 Index rows = m.rows();
42 Index cols = m.cols();
55 Index c0 = internal::random<Index>(4,cols-8),
56 c1 = internal::random<Index>(8,cols-c0),
57 r0 = internal::random<Index>(4,cols-8),
58 r1 = internal::random<Index>(8,rows-r0);
  /external/eigen/Eigen/src/Geometry/
AlignedBox.h 35 typedef DenseIndex Index;
63 inline explicit AlignedBox(Index _dim) : m_min(_dim), m_max(_dim)
82 inline Index dim() const { return AmbientDimAtCompileTime==Dynamic ? m_min.size()-1 : Index(AmbientDimAtCompileTime); }
148 Index mult = 1;
149 for(Index d=0; d<dim(); ++d)
163 for(Index d=0; d<dim(); ++d)
302 for (Index k=0; k<dim(); ++k)
323 for (Index k=0; k<dim(); ++k)
  /external/chromium_org/third_party/WebKit/Source/web/
WebIDBMetadata.cpp 54 webObjectStore.indexes = WebVector<Index>(static_cast<size_t>(objectStore.indexes.size()));
59 const IDBIndexMetadata& index = indexIterator->value; local
60 Index webIndex;
61 webIndex.id = index.id;
62 webIndex.name = index.name;
63 webIndex.keyPath = index.keyPath;
64 webIndex.unique = index.unique;
65 webIndex.multiEntry = index.multiEntry;
80 const Index webIndex = webObjectStore.indexes[j];
81 IDBIndexMetadata index(webIndex.name, webIndex.id, webIndex.keyPath, webIndex.unique, webIndex.multiEntry)
    [all...]
  /external/clang/include/clang/Serialization/
ModuleManager.h 48 /// \brief The list of module files that both we and the global module index
51 /// Either the global index or the module manager may have modules that the
52 /// other does not know about, because the global index can be out-of-date
55 /// known to the global index.
58 /// \brief The global module index, if one is attached.
60 /// The global module index will actually be owned by the ASTReader; this is
133 /// \brief Returns the module associated with the given index
134 ModuleFile &operator[](unsigned Index) const { return *Chain[Index]; }
202 /// \brief Set the global module index
    [all...]
  /external/eigen/Eigen/src/CholmodSupport/
CholmodSupport.h 82 eigen_assert(false && "Index type different than int is not supported yet");
136 template<typename Scalar, int Flags, typename Index>
137 MappedSparseMatrix<Scalar,Flags,Index> viewAsEigen(cholmod_sparse& cm)
139 return MappedSparseMatrix<Scalar,Flags,Index>
140 (cm.nrow, cm.ncol, reinterpret_cast<Index*>(cm.p)[cm.ncol],
141 reinterpret_cast<Index*>(cm.p), reinterpret_cast<Index*>(cm.i),reinterpret_cast<Scalar*>(cm.x) );
163 typedef typename MatrixType::Index Index;
187 inline Index cols() const { return m_cholmodFactor->n;
    [all...]

Completed in 695 milliseconds

<<11121314151617181920>>