/external/tensorflow/third_party/eigen3/unsupported/Eigen/CXX11/src/FixedPoint/ |
D | MatMatProduct.h | 77 template <typename Index, typename DataMapper, int mr, int nr, 79 struct gebp_kernel<QInt8, QInt8, Index, DataMapper, mr, nr, ConjugateLhs, 83 const QInt8* blockB, Index rows, Index depth, Index cols, 84 QInt32 alpha, Index strideA = -1, Index strideB = -1, 85 Index offsetA = 0, Index offsetB = 0); 88 template <typename Index, typename DataMapper, int mr, int nr, 90 EIGEN_DONT_INLINE void gebp_kernel<QInt8, QInt8, Index, DataMapper, mr, nr, 93 Index rows, Index depth, Index cols, QInt32 alpha, Index strideA, 94 Index strideB, Index offsetA, Index offsetB) { 110 for (Index j = 0; j < cols; ++j) { [all …]
|
/external/eigen/Eigen/src/SparseLU/ |
D | SparseLUImpl.h | 35 …Index expand(VectorType& vec, Index& length, Index nbElts, Index keep_prev, Index& num_expansions); 36 …Index memInit(Index m, Index n, Index annz, Index lwork, Index fillratio, Index panel_size, Globa… 38 …Index memXpand(VectorType& vec, Index& maxlen, Index nbElts, MemType memtype, Index& num_expansion… 39 …void heap_relax_snode (const Index n, IndexVector& et, const Index relax_columns, IndexVector& des… 40 …void relax_snode (const Index n, IndexVector& et, const Index relax_columns, IndexVector& descenda… 41 …Index snode_dfs(const Index jcol, const Index kcol,const MatrixType& mat, IndexVector& xprune, In… 42 Index snode_bmod (const Index jcol, const Index fsupc, ScalarVector& dense, GlobalLU_t& glu); 43 …Index pivotL(const Index jcol, const RealScalar& diagpivotthresh, IndexVector& perm_r, IndexVector… 46 Index& nseg, IndexVector& panel_lsub, IndexVector& segrep, 48 … IndexVector& xplore, GlobalLU_t& glu, Index& nextl_col, Index krow, Traits& traits); [all …]
|
D | SparseLU_Memory.h | 39 inline Index LUnumTempV(Index& m, Index& w, Index& t, Index& b) in LUnumTempV() 45 inline Index LUTempSpace(Index&m, Index& w) in LUTempSpace() 47 return (2*w + 4 + LUNoMarker) * m * sizeof(Index) + (w + 1) * m * sizeof(Scalar); in LUTempSpace() 63 Index SparseLUImpl<Scalar,StorageIndex>::expand(VectorType& vec, Index& length, Index nbElts, Inde… in expand() 67 Index new_len; // New size of the allocated memory in expand() 72 new_len = (std::max)(length+1,Index(alpha * length)); in expand() 105 Index tries = 0; // Number of attempts in expand() 109 new_len = (std::max)(length+1,Index(alpha * length)); in expand() 151 Index SparseLUImpl<Scalar,StorageIndex>::memInit(Index m, Index n, Index annz, Index lwork, Index f… in memInit() 153 Index& num_expansions = glu.num_expansions; //No memory expansions so far in memInit() [all …]
|
/external/tensorflow/tensorflow/core/kernels/ |
D | eigen_cuboid_convolution.h | 60 template <typename NewDimension, Index Planes, Index Rows, Index Cols, 61 typename ArgType, typename Device, typename Scalar_, typename Index, 65 Scalar_, Index, Side, 75 Scalar, Index, Side, 84 Scalar, Index, Side, 177 m_fastNumPatches = internal::TensorIntDivisor<Index>(m_num_patches); in TensorContractionInputMapper() 180 internal::TensorIntDivisor<Index>(m_patch_plane_stride); in TensorContractionInputMapper() 182 internal::TensorIntDivisor<Index>(m_patch_row_stride); in TensorContractionInputMapper() 184 internal::TensorIntDivisor<Index>(m_patch_col_stride); in TensorContractionInputMapper() 187 internal::TensorIntDivisor<Index>(m_patch_plane_inflate_strides); in TensorContractionInputMapper() [all …]
|
D | eigen_spatial_convolutions-inl.h | 57 template <typename NewDimension, Index Rows, Index Cols, typename ArgType, 58 typename Device, typename Scalar_, typename Index, 62 Scalar_, Index, Side, 73 Scalar, Index, Side, 83 Scalar, Index, Side, 107 Index patch_rows; in TensorContractionInputMapper() 108 Index patch_depth; in TensorContractionInputMapper() 156 internal::TensorIntDivisor<Index>(m_patch_row_stride); in TensorContractionInputMapper() 158 internal::TensorIntDivisor<Index>(m_patch_col_stride); in TensorContractionInputMapper() 160 internal::TensorIntDivisor<Index>(m_patch_row_inflate_strides); in TensorContractionInputMapper() [all …]
|
D | eigen_volume_patch.h | 30 typedef typename XprType::Index Index; typedef 34 typedef DSizes<Index, NumDims> Dimensions; 39 static constexpr Index PacketSize = 101 static_cast<Index>(op.padding_top_z() + op.padding_bottom_z()) - in CustomTensorEvaluator() 106 static_cast<Index>(op.padding_top() + op.padding_bottom()) - in CustomTensorEvaluator() 111 static_cast<Index>(op.padding_left() + op.padding_right()) - in CustomTensorEvaluator() 135 const Index dz = numext::maxi<DenseIndex>( in CustomTensorEvaluator() 138 const Index dy = numext::maxi<DenseIndex>( in CustomTensorEvaluator() 141 const Index dx = numext::maxi<DenseIndex>( in CustomTensorEvaluator() 216 m_fastOtherStride = internal::TensorIntDivisor<Index>(m_otherStride); in CustomTensorEvaluator() [all …]
|
D | scatter_functor.h | 130 template <typename Device, typename T, typename Index, scatter_op::UpdateOp op> 132 Index operator()(OpKernelContext* c, const Device& d, 135 typename TTypes<Index>::ConstFlat indices); 138 template <typename Device, typename T, typename Index, scatter_op::UpdateOp op> 140 Index ParallelExecute(OpKernelContext* c, const Device& d, 143 typename TTypes<Index>::ConstFlat indices) { 144 const Index N = static_cast<Index>(indices.size()); 145 const Index limit = static_cast<Index>(params.dimension(0)); 146 const Index kMaxLocks = 1024; 147 const Index entries_per_lock = (limit + kMaxLocks - 1) / kMaxLocks; [all …]
|
/external/eigen/unsupported/Eigen/CXX11/src/Tensor/ |
D | TensorDimensionList.h | 25 template <typename Index, std::size_t Rank> struct DimensionList { 27 const Index operator[] (const Index i) const { return i; } 32 template<typename Index, std::size_t Rank> struct array_size<DimensionList<Index, Rank> > { 35 template<typename Index, std::size_t Rank> struct array_size<const DimensionList<Index, Rank> > { 39 template<DenseIndex n, typename Index, std::size_t Rank> const Index array_get(DimensionList<Index,… 42 template<DenseIndex n, typename Index, std::size_t Rank> const Index array_get(const DimensionList<… 48 template <typename Index, std::size_t Rank> 49 struct index_known_statically_impl<DimensionList<Index, Rank> > { 54 template <typename Index, std::size_t Rank> 55 struct index_known_statically_impl<const DimensionList<Index, Rank> > { [all …]
|
D | TensorMap.h | 34 typedef typename internal::traits<PlainObjectType>::Index Index; typedef 49 static const Index NumIndices = PlainObjectType::NumIndices; 67 …EIGEN_STRONG_INLINE TensorMap(PointerArgType dataPtr, Index firstDimension, IndexTypes... otherDim… in TensorMap() 73 …EIGEN_STRONG_INLINE TensorMap(PointerArgType dataPtr, Index firstDimension) : m_data(dataPtr), m_d… in TensorMap() 78 …EIGEN_STRONG_INLINE TensorMap(PointerArgType dataPtr, Index dim1, Index dim2) : m_data(dataPtr), m… in TensorMap() 82 …EIGEN_STRONG_INLINE TensorMap(PointerArgType dataPtr, Index dim1, Index dim2, Index dim3) : m_data… in TensorMap() 86 …EIGEN_STRONG_INLINE TensorMap(PointerArgType dataPtr, Index dim1, Index dim2, Index dim3, Index di… in TensorMap() 90 …N_STRONG_INLINE TensorMap(PointerArgType dataPtr, Index dim1, Index dim2, Index dim3, Index dim4, … in TensorMap() 95 …EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE TensorMap(PointerArgType dataPtr, const array<Index, NumIndi… in TensorMap() argument 109 EIGEN_STRONG_INLINE Index rank() const { return m_dimensions.rank(); } in rank() [all …]
|
D | TensorContractionThreadPool.h | 21 template<typename LhsScalar, typename LhsMapper, typename Index> 25 const Index m_start; 26 const Index k_start; 27 const Index mc; 28 const Index kc; 31 …<typename LhsScalar, typename RhsScalar, typename RhsMapper, typename OutputMapper, typename Index> 37 const Index m; 38 const Index k; 39 const Index n; 40 const Index mc; [all …]
|
D | Tensor.h | 70 typedef typename internal::traits<Self>::Index Index; typedef 84 typedef DSizes<Index, NumIndices_> Dimensions; 92 … static const bool is_array = internal::is_base_of<array<Index, NumIndices>, CustomIndices>::value; 100 …EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE Index rank() const… in rank() 101 …EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE Index dimension(std::size_t n) const… in dimension() 103 …EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE Index size() const… in size() 115 …EIGEN_DEVICE_FUNC inline const Scalar& coeff(Index firstIndex, Index secondIndex, IndexTypes... ot… in coeff() 119 return coeff(array<Index, NumIndices>{{firstIndex, secondIndex, otherIndices...}}); in coeff() 124 …EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE const Scalar& coeff(const array<Index, NumIndices>& indices)… in coeff() argument 137 return coeff(internal::customIndices2Array<Index,NumIndices>(indices)); in coeff() [all …]
|
D | TensorExecutor.h | 30 typedef typename Expression::Index Index; typedef 38 const Index size = array_prod(evaluator.dimensions()); 39 for (Index i = 0; i < size; ++i) { 52 typedef typename Expression::Index Index; typedef 60 const Index size = array_prod(evaluator.dimensions()); 65 const Index UnrolledSize = (size / (4 * PacketSize)) * 4 * PacketSize; 66 for (Index i = 0; i < UnrolledSize; i += 4*PacketSize) { 67 for (Index j = 0; j < 4; j++) { 71 const Index VectorizedSize = (size / PacketSize) * PacketSize; 72 for (Index i = UnrolledSize; i < VectorizedSize; i += PacketSize) { [all …]
|
D | TensorVolumePatch.h | 31 typedef typename XprTraits::Index Index; 61 typedef typename Eigen::internal::traits<TensorVolumePatchOp>::Index Index; 169 typedef typename XprType::Index Index; 172 typedef DSizes<Index, NumDims> Dimensions; 251 … const Index dz = m_outputPlanes * m_plane_strides + m_patch_planes_eff - 1 - m_input_planes_eff; 252 const Index dy = m_outputRows * m_row_strides + m_patch_rows_eff - 1 - m_input_rows_eff; 253 const Index dx = m_outputCols * m_col_strides + m_patch_cols_eff - 1 - m_input_cols_eff; 324 m_fastOtherStride = internal::TensorIntDivisor<Index>(m_otherStride); 325 m_fastPatchStride = internal::TensorIntDivisor<Index>(m_patchStride); 326 m_fastColStride = internal::TensorIntDivisor<Index>(m_colStride); [all …]
|
/external/eigen/unsupported/Eigen/src/Skyline/ |
D | SkylineStorage.h | 24 typedef SparseIndex Index; typedef 61 memcpy(m_upperProfile, other.m_upperProfile, m_upperProfileSize * sizeof (Index)); 62 memcpy(m_lowerProfile, other.m_lowerProfile, m_lowerProfileSize * sizeof (Index)); 87 …void reserve(Index size, Index upperProfileSize, Index lowerProfileSize, Index upperSize, Index lo… in reserve() 88 Index newAllocatedSize = size + upperSize + lowerSize; in reserve() 98 …void resize(Index diagSize, Index upperProfileSize, Index lowerProfileSize, Index upperSize, Index… 100 … upperProfileSize, lowerProfileSize, upperSize + Index(reserveSizeFactor * upperSize), lowerSize +… 108 inline Index diagSize() const { in diagSize() 112 inline Index upperSize() const { in upperSize() 116 inline Index lowerSize() const { in lowerSize() [all …]
|
D | SkylineMatrix.h | 64 Index m_outerSize; 65 Index m_innerSize; 68 Index* m_colStartIndex; 69 Index* m_rowStartIndex; 74 inline Index rows() const { 78 inline Index cols() const { 82 inline Index innerSize() const { 86 inline Index outerSize() const { 90 inline Index upperNonZeros() const { 94 inline Index lowerNonZeros() const { [all …]
|
/external/eigen/Eigen/src/Core/products/ |
D | TriangularSolverMatrix.h | 18 template <typename Scalar, typename Index, int Side, int Mode, bool Conjugate, int TriStorageOrder> 19 struct triangular_solve_matrix<Scalar,Index,Side,Mode,Conjugate,TriStorageOrder,RowMajor> 22 Index size, Index cols, 23 const Scalar* tri, Index triStride, 24 Scalar* _other, Index otherStride, 28 Scalar, Index, Side==OnTheLeft?OnTheRight:OnTheLeft, 38 template <typename Scalar, typename Index, int Mode, bool Conjugate, int TriStorageOrder> 39 struct triangular_solve_matrix<Scalar,Index,OnTheLeft,Mode,Conjugate,TriStorageOrder,ColMajor> 42 Index size, Index otherSize, 43 const Scalar* _tri, Index triStride, [all …]
|
D | TriangularMatrixMatrix.h | 44 template <typename Scalar, typename Index, 51 template <typename Scalar, typename Index, 55 struct product_triangular_matrix_matrix<Scalar,Index,Mode,LhsIsTriangular, 60 Index rows, Index cols, Index depth, 61 const Scalar* lhs, Index lhsStride, 62 const Scalar* rhs, Index rhsStride, 63 Scalar* res, Index resStride, 66 product_triangular_matrix_matrix<Scalar, Index, 79 template <typename Scalar, typename Index, int Mode, 82 struct product_triangular_matrix_matrix<Scalar,Index,Mode,true, [all …]
|
D | SelfadjointMatrixMatrix.h | 18 template<typename Scalar, typename Index, int Pack1, int Pack2_dummy, int StorageOrder> 22 …alar* blockA, const const_blas_data_mapper<Scalar,Index,StorageOrder>& lhs, Index cols, Index i, I… in pack() 25 for(Index k=0; k<i; k++) in pack() 26 for(Index w=0; w<BlockRows; w++) in pack() 29 Index h = 0; in pack() 30 for(Index k=i; k<i+BlockRows; k++) in pack() 32 for(Index w=0; w<h; w++) in pack() 37 for(Index w=h+1; w<BlockRows; w++) in pack() 42 for(Index k=i+BlockRows; k<cols; k++) in pack() 43 for(Index w=0; w<BlockRows; w++) in pack() [all …]
|
/external/eigen/unsupported/Eigen/src/SparseExtra/ |
D | DynamicSparseMatrix.h | 77 Index m_innerSize; 82 inline Index rows() const { return IsRowMajor ? outerSize() : m_innerSize; } 83 inline Index cols() const { return IsRowMajor ? m_innerSize : outerSize(); } 84 inline Index innerSize() const { return m_innerSize; } 85 inline Index outerSize() const { return convert_index(m_data.size()); } 86 inline Index innerNonZeros(Index j) const { return m_data[j].size(); } 94 inline Scalar coeff(Index row, Index col) const 96 const Index outer = IsRowMajor ? row : col; 97 const Index inner = IsRowMajor ? col : row; 105 inline Scalar& coeffRef(Index row, Index col) [all …]
|
/external/llvm-project/lld/test/wasm/ |
D | many-functions.ll | 22 ; CHECK-NEXT: Index: 1 25 ; CHECK-NEXT: Index: 1 28 ; CHECK-NEXT: Index: 1 31 ; CHECK-NEXT: Index: 1 34 ; CHECK-NEXT: Index: 1 37 ; CHECK-NEXT: Index: 1 40 ; CHECK-NEXT: Index: 1 43 ; CHECK-NEXT: Index: 1 46 ; CHECK-NEXT: Index: 1 49 ; CHECK-NEXT: Index: 1 [all …]
|
D | locals-duplicate.test | 12 ; CHECK-NEXT: - Index: 0 21 ; CHECK-NEXT: - Index: 0 32 ; CHECK-NEXT: - Index: 0 38 ; CHECK-NEXT: - Index: 1 44 ; CHECK-NEXT: - Index: 2 54 ; CHECK-NEXT: Index: 0 57 ; CHECK-NEXT: Index: 1 60 ; CHECK-NEXT: Index: 3 63 ; CHECK-NEXT: Index: 4 66 ; CHECK-NEXT: Index: 1 [all …]
|
/external/llvm/lib/Option/ |
D | Option.cpp | 105 unsigned &Index, in accept() argument 111 Spelling = StringRef(Args.getArgString(Index), ArgSize); in accept() 119 if (ArgSize != strlen(Args.getArgString(Index))) in accept() 122 Arg *A = new Arg(UnaliasedOption, Spelling, Index++); in accept() 140 const char *Value = Args.getArgString(Index) + ArgSize; in accept() 141 return new Arg(UnaliasedOption, Spelling, Index++, Value); in accept() 145 const char *Str = Args.getArgString(Index) + ArgSize; in accept() 146 Arg *A = new Arg(UnaliasedOption, Spelling, Index++); in accept() 174 if (ArgSize != strlen(Args.getArgString(Index))) in accept() 177 Index += 2; in accept() [all …]
|
/external/swiftshader/third_party/llvm-10.0/llvm/lib/Option/ |
D | Option.cpp | 109 Arg *Option::acceptInternal(const ArgList &Args, unsigned &Index, in acceptInternal() argument 111 StringRef Spelling = StringRef(Args.getArgString(Index), ArgSize); in acceptInternal() 114 if (ArgSize != strlen(Args.getArgString(Index))) in acceptInternal() 116 return new Arg(*this, Spelling, Index++); in acceptInternal() 119 const char *Value = Args.getArgString(Index) + ArgSize; in acceptInternal() 120 return new Arg(*this, Spelling, Index++, Value); in acceptInternal() 124 const char *Str = Args.getArgString(Index) + ArgSize; in acceptInternal() 125 Arg *A = new Arg(*this, Spelling, Index++); in acceptInternal() 153 if (ArgSize != strlen(Args.getArgString(Index))) in acceptInternal() 156 Index += 2; in acceptInternal() [all …]
|
/external/llvm-project/llvm/lib/Option/ |
D | Option.cpp | 110 unsigned &Index) const { in acceptInternal() 114 if (ArgSize != strlen(Args.getArgString(Index))) in acceptInternal() 116 return new Arg(*this, Spelling, Index++); in acceptInternal() 119 const char *Value = Args.getArgString(Index) + ArgSize; in acceptInternal() 120 return new Arg(*this, Spelling, Index++, Value); in acceptInternal() 124 const char *Str = Args.getArgString(Index) + ArgSize; in acceptInternal() 125 Arg *A = new Arg(*this, Spelling, Index++); in acceptInternal() 153 if (ArgSize != strlen(Args.getArgString(Index))) in acceptInternal() 156 Index += 2; in acceptInternal() 157 if (Index > Args.getNumInputArgStrings() || in acceptInternal() [all …]
|
/external/eigen/Eigen/src/plugins/ |
D | BlockMethods.h | 64 inline BlockXpr block(Index startRow, Index startCol, Index blockRows, Index blockCols) in block() 71 inline const ConstBlockXpr block(Index startRow, Index startCol, Index blockRows, Index blockCols) … in block() 92 inline BlockXpr topRightCorner(Index cRows, Index cCols) in topRightCorner() 99 inline const ConstBlockXpr topRightCorner(Index cRows, Index cCols) const in topRightCorner() 151 inline typename FixedBlockXpr<CRows,CCols>::Type topRightCorner(Index cRows, Index cCols) in topRightCorner() 158 inline const typename ConstFixedBlockXpr<CRows,CCols>::Type topRightCorner(Index cRows, Index cCols… in topRightCorner() 178 inline BlockXpr topLeftCorner(Index cRows, Index cCols) in topLeftCorner() 185 inline const ConstBlockXpr topLeftCorner(Index cRows, Index cCols) const in topLeftCorner() 236 inline typename FixedBlockXpr<CRows,CCols>::Type topLeftCorner(Index cRows, Index cCols) in topLeftCorner() 243 inline const typename ConstFixedBlockXpr<CRows,CCols>::Type topLeftCorner(Index cRows, Index cCols)… in topLeftCorner() [all …]
|