Searched defs:lhs (Results 276 - 300 of 505) sorted by relevance

<<11121314151617181920>>

/external/clang/lib/ARCMigrate/
H A DTransProperties.cpp292 Expr *lhs = E->getLHS()->IgnoreParenImpCasts(); local
293 if (ObjCIvarRefExpr *RE = dyn_cast<ObjCIvarRefExpr>(lhs)) {
/external/clang/lib/StaticAnalyzer/Core/
H A DSymbolManager.cpp253 const SymIntExpr *SymbolManager::getSymIntExpr(const SymExpr *lhs, argument
258 SymIntExpr::Profile(ID, lhs, op, v, t);
264 new (data) SymIntExpr(lhs, op, v, t);
271 const IntSymExpr *SymbolManager::getIntSymExpr(const llvm::APSInt& lhs, argument
276 IntSymExpr::Profile(ID, lhs, op, rhs, t);
282 new (data) IntSymExpr(lhs, op, rhs, t);
289 const SymSymExpr *SymbolManager::getSymSymExpr(const SymExpr *lhs, argument
294 SymSymExpr::Profile(ID, lhs, op, rhs, t);
300 new (data) SymSymExpr(lhs, op, rhs, t);
/external/eigen/Eigen/src/Core/
H A DGeneralProduct.h187 static void run(const Lhs &lhs, const Rhs &rhs, Dest& dest, const typename Dest::Scalar& alpha) argument
192 ::run(rhs.transpose(), lhs.transpose(), destT, alpha);
199 static inline void run(const Lhs &lhs, const Rhs &rhs, Dest& dest, const typename Dest::Scalar& alpha) argument
213 ActualLhsType actualLhs = LhsBlasTraits::extract(lhs);
216 ResScalar actualAlpha = alpha * LhsBlasTraits::extractScalarFactor(lhs)
293 static void run(const Lhs &lhs, const Rhs &rhs, Dest& dest, const typename Dest::Scalar& alpha) argument
305 typename add_const<ActualLhsType>::type actualLhs = LhsBlasTraits::extract(lhs);
308 ResScalar actualAlpha = alpha * LhsBlasTraits::extractScalarFactor(lhs)
346 static void run(const Lhs &lhs, const Rhs &rhs, Dest& dest, const typename Dest::Scalar& alpha) argument
353 dest += (alpha*actual_rhs.coeff(k)) * lhs
360 run(const Lhs &lhs, const Rhs &rhs, Dest& dest, const typename Dest::Scalar& alpha) argument
[all...]
H A DPermutationMatrix.h216 void assignProduct(const Lhs& lhs, const Rhs& rhs) argument
218 eigen_assert(lhs.cols() == rhs.rows());
219 for (Index i=0; i<rows();++i) indices().coeffRef(i) = lhs.indices().coeff(rhs.indices().coeff(i));
406 PermutationMatrix(internal::PermPermProduct_t, const Lhs& lhs, const Rhs& rhs) argument
407 : m_indices(lhs.indices().size())
409 Base::assignProduct(lhs,rhs);
H A DSelfAdjointView.h128 operator*(const MatrixBase<OtherDerived>& lhs, const SelfAdjointView& rhs) argument
130 return Product<OtherDerived,SelfAdjointView>(lhs.derived(),rhs);
257 // operator*(const MatrixBase<OtherDerived>& lhs, const SelfAdjointView<MatrixType,UpLo>& rhs)
259 // return internal::matrix_selfadjoint_product_returntype<OtherDerived,SelfAdjointView<MatrixType,UpLo> >(lhs.derived(),rhs);
/external/eigen/Eigen/src/Core/products/
H A DGeneralMatrixMatrixTriangular.h44 static EIGEN_STRONG_INLINE void run(Index size, Index depth,const LhsScalar* lhs, Index lhsStride, argument
52 ::run(size,depth,rhs,rhsStride,lhs,lhsStride,res,resStride,alpha,blocking);
70 LhsMapper lhs(_lhs,lhsStride);
103 pack_lhs(blockA, lhs.getSubMapper(i2, k2), actual_kc, actual_mc);
210 typename internal::add_const_on_value_type<ActualLhs>::type actualLhs = LhsBlasTraits::extract(prod.lhs());
218 Scalar actualAlpha = alpha * LhsBlasTraits::extractScalarFactor(prod.lhs().derived()) * RhsBlasTraits::extractScalarFactor(prod.rhs().derived());
256 typename internal::add_const_on_value_type<ActualLhs>::type actualLhs = LhsBlasTraits::extract(prod.lhs());
264 typename ProductType::Scalar actualAlpha = alpha * LhsBlasTraits::extractScalarFactor(prod.lhs().derived()) * RhsBlasTraits::extractScalarFactor(prod.rhs().derived());
H A DGeneralMatrixVector.h81 const LhsMapper& lhs,
90 const LhsMapper& lhs,
124 const Index lhsStride = lhs.stride();
138 const Index lhsAlignmentOffset = lhs.firstAligned(size);
198 const LhsScalars lhs0 = lhs.getVectorMapper(0, i+0), lhs1 = lhs.getVectorMapper(0, i+offset1),
199 lhs2 = lhs.getVectorMapper(0, i+2), lhs3 = lhs.getVectorMapper(0, i+offset3);
291 const LhsScalars lhs0 = lhs.getVectorMapper(0, k);
357 const LhsMapper& lhs,
88 run( Index rows, Index cols, const LhsMapper& lhs, const RhsMapper& rhs, ResScalar* res, Index resIncr, RhsScalar alpha) argument
364 run( Index rows, Index cols, const LhsMapper& lhs, const RhsMapper& rhs, ResScalar* res, Index resIncr, ResScalar alpha) argument
[all...]
H A DSelfadjointMatrixMatrix.h22 void pack(Scalar* blockA, const const_blas_data_mapper<Scalar,Index,StorageOrder>& lhs, Index cols, Index i, Index& count) argument
27 blockA[count++] = lhs(i+w,k); // normal
33 blockA[count++] = numext::conj(lhs(k, i+w)); // transposed
35 blockA[count++] = numext::real(lhs(k,k)); // real (diagonal)
38 blockA[count++] = lhs(i+w, k); // normal
44 blockA[count++] = numext::conj(lhs(k, i+w)); // transposed
49 const_blas_data_mapper<Scalar,Index,StorageOrder> lhs(_lhs,lhsStride);
59 pack<3*PacketSize>(blockA, lhs, cols, i, count);
63 pack<2*PacketSize>(blockA, lhs, cols, i, count);
67 pack<1*PacketSize>(blockA, lhs, col
289 run( Index rows, Index cols, const Scalar* lhs, Index lhsStride, const Scalar* rhs, Index rhsStride, Scalar* res, Index resStride, const Scalar& alpha, level3_blocking<Scalar,Scalar>& blocking) argument
490 typename internal::add_const_on_value_type<ActualLhsType>::type lhs = LhsBlasTraits::extract(a_lhs); local
[all...]
H A DSelfadjointMatrixVector.h32 const Scalar* lhs, Index lhsStride,
41 const Scalar* lhs, Index lhsStride,
73 const Scalar* EIGEN_RESTRICT A0 = lhs + j*lhsStride;
74 const Scalar* EIGEN_RESTRICT A1 = lhs + (j+1)*lhsStride;
140 const Scalar* EIGEN_RESTRICT A0 = lhs + j*lhsStride;
186 typename internal::add_const_on_value_type<ActualLhsType>::type lhs = LhsBlasTraits::extract(a_lhs); local
228 lhs.rows(), // size
229 &lhs.coeffRef(0,0), lhs.outerStride(), // lhs inf
39 run( Index size, const Scalar* lhs, Index lhsStride, const Scalar* rhs, Scalar* res, Scalar alpha) argument
[all...]
H A DTriangularMatrixMatrix.h24 // const_blas_data_mapper<Scalar, StorageOrder> lhs(_lhs,lhsStride);
31 // blockA[count++] = cj(lhs(i+w, k));
36 // blockA[count++] = cj(lhs(i, k));
61 const Scalar* lhs, Index lhsStride,
74 ::run(cols, rows, depth, rhs, rhsStride, lhs, lhsStride, res, resStride, alpha, blocking);
123 LhsMapper lhs(_lhs,lhsStride);
158 // align blocks with the end of the triangular part for trapezoidal lhs
167 // the selected lhs's panel has to be split in three different parts:
175 // for each small vertical panels of lhs
189 triangularBuffer.coeffRef(k,k) = lhs(startBloc
59 run( Index rows, Index cols, Index depth, const Scalar* lhs, Index lhsStride, const Scalar* rhs, Index rhsStride, Scalar* res, Index resStride, const Scalar& alpha, level3_blocking<Scalar,Scalar>& blocking) argument
405 typename internal::add_const_on_value_type<ActualLhsType>::type lhs = LhsBlasTraits::extract(a_lhs); local
[all...]
/external/eigen/Eigen/src/Eigenvalues/
H A DRealSchur.h476 const Scalar lhs = m_matT.coeff(im,im-1) * (abs(v.coeff(1)) + abs(v.coeff(2))); local
478 if (abs(lhs) < NumTraits<Scalar>::epsilon() * rhs)
/external/eigen/Eigen/src/Geometry/
H A DHomogeneous.h90 operator* (const MatrixBase<Lhs>& lhs, const Homogeneous& rhs) argument
93 return Product<Lhs,Homogeneous>(lhs.derived(),rhs);
98 operator* (const Transform<Scalar,Dim,Mode,Options>& lhs, const Homogeneous& rhs) argument
101 return Product<Transform<Scalar,Dim,Mode,Options>, Homogeneous>(lhs,rhs);
260 EIGEN_DEVICE_FUNC homogeneous_left_product_impl(const Lhs& lhs, const MatrixType& rhs) argument
261 : m_lhs(take_matrix_for_product<Lhs>::run(lhs)),
299 EIGEN_DEVICE_FUNC homogeneous_right_product_impl(const MatrixType& lhs, const Rhs& rhs) argument
300 : m_lhs(lhs), m_rhs(rhs)
387 EIGEN_DEVICE_FUNC static void evalTo(Dest& dst, const Homogeneous<LhsArg,Horizontal>& lhs, const Rhs& rhs) argument
389 homogeneous_right_product_impl<Homogeneous<LhsArg,Horizontal>, Rhs>(lhs
428 evalTo(Dest& dst, const Lhs& lhs, const Homogeneous<RhsArg,Vertical>& rhs) argument
440 evalTo(Dest& dst, const Lhs& lhs, const Homogeneous<RhsArg,Vertical>& rhs) argument
482 evalTo(Dest& dst, const TransformType& lhs, const Homogeneous<RhsArg,Vertical>& rhs) argument
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DSparseMatrixBase.h303 operator*(const DiagonalBase<OtherDerived> &lhs, const SparseMatrixBase& rhs) argument
304 { return Product<OtherDerived,Derived>(lhs.derived(), rhs.derived()); }
320 operator*(const MatrixBase<OtherDerived> &lhs, const SparseMatrixBase& rhs) argument
321 { return Product<OtherDerived,Derived>(lhs.derived(), rhs.derived()); }
/external/eigen/blas/
H A Dlevel2_impl.h15 static void run(Index rows, Index cols,const Scalar *lhs, Index lhsStride, const Scalar *rhs, Index rhsIncr, Scalar* res, Index resIncr, Scalar alpha) argument
22 rows, cols, LhsMapper(lhs, lhsStride), RhsMapper(rhs, rhsIncr), res, resIncr, alpha);
/external/eigen/test/
H A Devaluators.cpp8 prod(const Lhs& lhs, const Rhs& rhs) argument
10 return Product<Lhs,Rhs>(lhs,rhs);
15 lazyprod(const Lhs& lhs, const Rhs& rhs) argument
17 return Product<Lhs,Rhs,LazyProduct>(lhs,rhs);
/external/eigen/unsupported/Eigen/CXX11/src/Tensor/
H A DTensorConcatenation.h26 // Type promotion to handle the case where the types of the lhs and the rhs are different.
69 EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE TensorConcatenationOp(const LhsXprType& lhs, const RhsXprType& rhs, Axis axis) argument
70 : m_lhs_xpr(lhs), m_rhs_xpr(rhs), m_axis(axis) {}
H A DTensorExpr.h27 * operator (e.g. addition) is applied to a lhs and a rhs expression.
144 // Type promotion to handle the case where the types of the lhs and the rhs
199 EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE TensorCwiseBinaryOp(const LhsXprType& lhs, const RhsXprType& rhs, const BinaryOp& func = BinaryOp()) argument
200 : m_lhs_xpr(lhs), m_rhs_xpr(rhs), m_functor(func) {}
/external/gemmlowp/eight_bit_int_gemm/
H A Deight_bit_int_gemm.cc82 MatrixMap<const std::uint8_t, LhsOrder> lhs(a, m, k, lda);
90 context, lhs, rhs, &result, lhs_offset, rhs_offset, result_offset, \
117 MatrixMap<const std::uint8_t, LhsOrder> lhs(a, m, k, lda);
127 context, lhs, rhs, &result, lhs_offset, rhs_offset, empty_pipeline); \
237 void MetaGemmQuantized8Bit(GemmContext* context, const std::uint8_t* lhs, argument
250 lhs, rhs, m, n, k, lhs_offset, rhs_offset, sum_offset,
257 rhs, lhs, n, m, k, rhs_offset, lhs_offset, sum_offset,
264 void MetaGemmFloat(GemmContext* context, const std::uint8_t* lhs, argument
275 lhs, rhs, m, n, k, lhs_offset, rhs_offset, result_offset, result);
281 rhs, lhs,
[all...]
/external/google-breakpad/src/testing/test/
H A Dgmock-generated-matchers_test.cc262 virtual bool MatchAndExplain(int lhs, argument
264 const int diff = lhs - rhs_;
273 return lhs > rhs_;
/external/libchrome/sandbox/linux/bpf_dsl/
H A Dbpf_dsl.cc162 AndBoolExprImpl(BoolExpr lhs, BoolExpr rhs) argument
163 : lhs_(std::move(lhs)), rhs_(std::move(rhs)) {}
182 OrBoolExprImpl(BoolExpr lhs, BoolExpr rhs) argument
183 : lhs_(std::move(lhs)), rhs_(std::move(rhs)) {}
276 BoolExpr AllOf(BoolExpr lhs, BoolExpr rhs) { argument
277 return std::make_shared<AndBoolExprImpl>(std::move(lhs), std::move(rhs));
284 BoolExpr AnyOf(BoolExpr lhs, BoolExpr rhs) { argument
285 return std::make_shared<OrBoolExprImpl>(std::move(lhs), std::move(rhs));
/external/libcxx/test/support/
H A Dcontainer_test_types.h129 inline bool operator!=(TypeInfo<L> const& lhs, TypeInfo<R> const& rhs) argument
130 { return !(lhs == rhs); }
/external/llvm/include/llvm/Support/
H A DScopedPrinter.h331 static bool flagName(const EnumEntry<T> &lhs, const EnumEntry<T> &rhs) { argument
332 return lhs.Name < rhs.Name;
/external/mesa3d/src/glsl/
H A Dlower_variable_index_to_cond_assign.cpp413 ir_dereference *lhs = new(mem_ctx) ir_dereference_variable(var); local
414 ir_assignment *assign = new(mem_ctx) ir_assignment(lhs,
432 ir_dereference *lhs = new(mem_ctx) ir_dereference_variable(index); local
434 new(mem_ctx) ir_assignment(lhs, orig_deref->array_index, NULL);
437 orig_deref->array_index = lhs->clone(mem_ctx, NULL);
499 ir->lhs->accept(&f);
502 convert_dereference_array(f.deref, ir, ir->lhs);
/external/skia/tools/skdiff/
H A Dskdiff.h162 const DiffRecord* lhs = *reinterpret_cast<DiffRecord* const *>(untyped_lhs); local
167 if (lhs->fResult != rhs->fResult) {
168 return (lhs->fResult < rhs->fResult) ? 1 : -1;
172 int result = T::comparePixels(lhs, rhs);
179 return strcmp(lhs->fBase.fFilename.c_str(), rhs->fBase.fFilename.c_str());
186 static int comparePixels(const DiffRecord* lhs, const DiffRecord* rhs) { argument
187 if (lhs->fFractionDifference < rhs->fFractionDifference) {
190 if (rhs->fFractionDifference < lhs->fFractionDifference) {
199 static int comparePixels(const DiffRecord* lhs, const DiffRecord* rhs) { argument
200 if (lhs
214 comparePixels(const DiffRecord* lhs, const DiffRecord* rhs) argument
235 comparePixels(const DiffRecord* lhs, const DiffRecord* rhs) argument
[all...]
/external/swiftshader/third_party/LLVM/examples/Kaleidoscope/Chapter2/
H A Dtoy.cpp103 BinaryExprAST(char op, ExprAST *lhs, ExprAST *rhs) argument
104 : Op(op), LHS(lhs), RHS(rhs) {}

Completed in 589 milliseconds

<<11121314151617181920>>