HomeSort by relevance Sort by last modified time
    Searched defs:rhs (Results 126 - 150 of 1146) sorted by null

1 2 3 4 56 7 8 91011>>

  /art/runtime/native/
java_lang_reflect_Executable.cc 300 const DexFile::TypeId& rhs = other_method->GetDexFile()->GetTypeId( local
307 rhs.descriptor_idx_, &rhs_len);
  /build/kati/
eval.cc 75 Var* rhs = NULL; local
84 rhs = sv;
89 rhs = new RecursiveVar(rhs_v, origin, orig_rhs);
94 rhs = new RecursiveVar(rhs_v, origin, orig_rhs);
100 rhs = prev;
108 rhs = new RecursiveVar(rhs_v, origin, orig_rhs);
110 rhs = prev;
121 rhs->SetDeprecated(prev->DeprecatedMessage());
126 LOG("Assign: %s=%s", lhs.c_str(), rhs->DebugString().c_str());
128 return rhs;
141 string rhs; local
154 Var* rhs = EvalRHS(lhs, stmt->rhs, stmt->orig_rhs, stmt->op, local
209 Value* rhs = stmt->after_term; local
291 const string&& rhs = stmt->rhs->Eval(this); local
371 StringPiece rhs; local
    [all...]
stmt.h 84 Value* rhs; member in struct:AssignStmt
116 Value* rhs; member in struct:IfStmt
  /cts/tests/openglperf2/jni/graphics/
Matrix.cpp 108 float const* const rhs = r.mData; local
118 const float e = rhs[i4 + j];
318 const float* rhs) {
320 const float x = rhs[0];
321 const float y = rhs[1];
322 const float z = rhs[2];
323 const float w = rhs[3];
  /cts/tests/tests/renderscript/src/android/renderscript/cts/
Matrix2fTest.java 141 // are the same. So lhs and rhs get reversed here.
143 Matrix2f rhs = new Matrix2f(rhsData); local
146 loadMul.loadMultiply(lhs, rhs);
149 lhs.multiply(rhs);
Matrix3fTest.java 200 // are the same. So lhs and rhs get reversed here.
202 Matrix3f rhs = new Matrix3f(rhsData); local
205 loadMul.loadMultiply(lhs, rhs);
208 lhs.multiply(rhs);
Matrix4fTest.java 207 // are the same. So lhs and rhs get reversed here.
209 Matrix4f rhs = new Matrix4f(rhsData); local
212 loadMul.loadMultiply(lhs, rhs);
215 lhs.multiply(rhs);
  /external/androidplot/AndroidPlot-Core/src/main/java/com/androidplot/util/
Configurator.java 206 String rhs = path.substring(separatorIndex + 1, path.length()); local
216 return getObjectContaining(o, rhs);
  /external/apache-commons-math/src/main/java/org/apache/commons/math/geometry/
Vector3D.java 421 final Vector3D rhs = (Vector3D)other; local
422 if (rhs.isNaN()) {
426 return (x == rhs.x) && (y == rhs.y) && (z == rhs.z);
  /external/apache-commons-math/src/main/java/org/apache/commons/math/linear/
ArrayFieldVector.java 823 FieldVector<T> rhs = (FieldVector<T>) other; local
824 if (data.length != rhs.getDimension()) {
829 if (!data[i].equals(rhs.getEntry(i))) {
  /external/clang/lib/StaticAnalyzer/Checkers/
MallocOverflowSecurityChecker.cpp 91 const Expr *rhs = binop->getRHS(); local
92 if (rhs->isEvaluatable(Context)) {
94 maxVal = rhs->EvaluateKnownConstInt(Context);
102 e = rhs;
183 const Expr *rhs = AssignEx->getRHS(); local
184 if (rhs->isEvaluatable(Context))
190 const Expr *rhse = rhs->IgnoreParenImpCasts();
228 const Expr * rhs = E->getRHS(); local
231 if (!isIntZeroExpr(lhs) && !isIntZeroExpr(rhs)) {
233 CheckExpr(rhs);
    [all...]
  /external/drm_hwcomposer/
drmdisplaycomposition.h 60 DrmCompositionPlane(DrmCompositionPlane &&rhs) = default; member in class:android::DrmCompositionPlane
  /external/eigen/Eigen/src/Core/
Product.h 15 template<typename Lhs, typename Rhs, int Option, typename StorageKind> class ProductImpl;
19 template<typename Lhs, typename Rhs, int Option>
20 struct traits<Product<Lhs, Rhs, Option> >
23 typedef typename remove_all<Rhs>::type RhsCleaned;
32 internal::product_type<Lhs,Rhs>::ret>::ret StorageKind;
79 typedef _Rhs Rhs;
82 Lhs, Rhs, Option,
84 typename internal::traits<Rhs>::StorageKind,
85 internal::product_type<Lhs,Rhs>::ret>::ret>::Base Base;
89 typedef typename internal::ref_selector<Rhs>::type RhsNested
104 EIGEN_DEVICE_FUNC const RhsNestedCleaned& rhs() const { return m_rhs; } function in class:Eigen::Product
    [all...]
  /external/eigen/Eigen/src/Core/products/
SelfadjointMatrixMatrix.h 91 const_blas_data_mapper<Scalar,Index,StorageOrder> rhs(_rhs,rhsStride);
100 blockB[count+0] = rhs(k,j2+0);
101 blockB[count+1] = rhs(k,j2+1);
104 blockB[count+2] = rhs(k,j2+2);
105 blockB[count+3] = rhs(k,j2+3);
109 blockB[count+4] = rhs(k,j2+4);
110 blockB[count+5] = rhs(k,j2+5);
111 blockB[count+6] = rhs(k,j2+6);
112 blockB[count+7] = rhs(k,j2+7);
128 blockB[count+0] = numext::conj(rhs(j2+0,k))
491 typename internal::add_const_on_value_type<ActualRhsType>::type rhs = RhsBlasTraits::extract(a_rhs); local
    [all...]
SelfadjointMatrixVector.h 33 const Scalar* rhs,
42 const Scalar* rhs,
76 Scalar t0 = cjAlpha * rhs[j];
78 Scalar t1 = cjAlpha * rhs[j+1];
96 t3 += cj1.pmul(A1[j], rhs[j]);
101 t2 += cj1.pmul(A0[j+1], rhs[j+1]);
107 t2 += cj1.pmul(A0[i], rhs[i]);
108 t3 += cj1.pmul(A1[i], rhs[i]);
114 const Scalar* EIGEN_RESTRICT rhsIt = rhs + alignedStart;
131 t2 += cj1.pmul(A0[i], rhs[i])
187 typename internal::add_const_on_value_type<ActualRhsType>::type rhs = RhsBlasTraits::extract(a_rhs); local
    [all...]
TriangularMatrixMatrix.h 62 const Scalar* rhs, Index rhsStride,
74 ::run(cols, rows, depth, rhs, rhsStride, lhs, lhsStride, res, resStride, alpha, blocking);
124 RhsMapper rhs(_rhs,rhsStride);
165 pack_rhs(blockB, rhs.getSubMapper(actual_k2,0), actual_kc, cols);
275 RhsMapper rhs(_rhs,rhsStride);
306 // align blocks with the end of the triangular part for trapezoidal rhs
321 pack_rhs(geb, rhs.getSubMapper(actual_k2,IsLower ? 0 : k2), actual_kc, rs);
323 // pack the triangular part of the rhs padding the unrolled blocks with zeros
334 rhs.getSubMapper(actual_k2+panelOffset, actual_j2),
342 triangularBuffer.coeffRef(j,j) = rhs(actual_j2+j,actual_j2+j)
406 typename internal::add_const_on_value_type<ActualRhsType>::type rhs = RhsBlasTraits::extract(a_rhs); local
    [all...]
  /external/eigen/Eigen/src/Eigenvalues/
GeneralizedEigenSolver.h 343 Matrix<Scalar, 2, 1> rhs = (alpha*mT.template block<2,Dynamic>(j-1,st,2,sz) - beta*mS.template block<2,Dynamic>(j-1,st,2,sz)) .lazyProduct( v.segment(st,sz) ); local
345 v.template segment<2>(j-1) = lhs.partialPivLu().solve(rhs);
394 Matrix<ComplexScalar, 2, 1> rhs = (alpha*mT.template block<2,Dynamic>(j-1,st,2,sz) - beta*mS.template block<2,Dynamic>(j-1,st,2,sz)) .lazyProduct( cv.segment(st,sz) ); local
396 cv.template segment<2>(j-1) = lhs.partialPivLu().solve(rhs);
RealSchur.h 477 const Scalar rhs = v.coeff(0) * (abs(m_matT.coeff(im-1,im-1)) + abs(Tmm) + abs(m_matT.coeff(im+1,im+1))); local
478 if (abs(lhs) < NumTraits<Scalar>::epsilon() * rhs)
  /external/eigen/Eigen/src/PaStiXSupport/
PaStiXSupport.h 161 template<typename Rhs,typename Dest>
162 bool _solve_impl(const MatrixBase<Rhs> &b, MatrixBase<Dest> &x) const;
366 template<typename Rhs,typename Dest>
367 bool PastixBase<Base>::_solve_impl(const MatrixBase<Rhs> &b, MatrixBase<Dest> &x) const
372 int rhs = 1; local
381 m_perm.data(), m_invp.data(), &x(0, i), rhs, m_iparm.data(), m_dparm.data());
  /external/eigen/test/
qr_colpivoting.cpp 52 MatrixType rhs = matrix * exact_solution; local
53 MatrixType cod_solution = cod.solve(rhs);
54 VERIFY_IS_APPROX(rhs, matrix * cod_solution);
58 MatrixType svd_solution = svd.solve(rhs);
62 VERIFY_IS_APPROX(cod_solution, pinv * rhs);
84 Matrix<Scalar, Rows, Cols2> rhs = matrix * exact_solution; local
85 Matrix<Scalar, Cols, Cols2> cod_solution = cod.solve(rhs);
86 VERIFY_IS_APPROX(rhs, matrix * cod_solution);
90 Matrix<Scalar, Cols, Cols2> svd_solution = svd.solve(rhs);
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixSquareRoot.h 47 Matrix<Scalar,1,2> rhs = T.template block<1,2>(i,j); local
49 rhs -= sqrtT.block(i, i+1, 1, j-i-1) * sqrtT.block(i+1, j, j-i-1, 2);
52 sqrtT.template block<1,2>(i,j).transpose() = A.fullPivLu().solve(rhs.transpose());
60 Matrix<Scalar,2,1> rhs = T.template block<2,1>(i,j); local
62 rhs -= sqrtT.block(i, i+2, 2, j-i-2) * sqrtT.block(i+2, j, j-i-2, 1);
65 sqrtT.template block<2,1>(i,j) = A.fullPivLu().solve(rhs);
87 Matrix<Scalar,4,1> rhs; local
88 rhs.coeffRef(0) = C.coeff(0,0);
89 rhs.coeffRef(1) = C.coeff(0,1);
90 rhs.coeffRef(2) = C.coeff(1,0)
    [all...]
  /external/eigen/unsupported/Eigen/src/Skyline/
SkylineProduct.h 15 template<typename Lhs, typename Rhs, int ProductMode>
17 typedef const typename internal::nested_eval<Lhs, Rhs::RowsAtCompileTime>::type LhsNested;
18 typedef const typename internal::nested_eval<Rhs, Lhs::RowsAtCompileTime>::type RhsNested;
75 template<typename Lhs, typename Rhs>
76 EIGEN_STRONG_INLINE SkylineProduct(const Lhs& lhs, const Rhs& rhs)
77 : m_lhs(lhs), m_rhs(rhs) {
78 eigen_assert(lhs.cols() == rhs.rows());
109 EIGEN_STRONG_INLINE const _RhsNested& rhs() const { function in class:Eigen::internal::SkylineProduct
121 template<typename Lhs, typename Rhs, typename Dest
    [all...]
  /external/eigen/unsupported/Eigen/src/SparseExtra/
MatrixMarketIterator.h 111 * If the rhs file is not provided, a random rhs is generated
113 inline VectorType& rhs() function in class:Eigen::MatrixMarketIterator
142 * where A and b are the matrix and the rhs.
143 * Note that when a rhs is provided, refX is not available
  /external/gemmlowp/test/
benchmark_all_sizes.cc 116 RhsType rhs; local
119 rhs.Resize(depth, cols);
122 MakeZero(&rhs);
139 &gemm_context, lhs.const_map(), rhs.const_map(), &result.map(), -128,
150 &gemm_context, lhs.const_map(), rhs.const_map(), &result.map(), -128,
168 RhsType rhs; local
171 rhs.Resize(depth, cols);
174 MakeZero(&rhs);
181 &gemm_context, lhs.const_map(), rhs.const_map(), &result.map(), -128,
192 &gemm_context, lhs.const_map(), rhs.const_map(), &result.map(), -128
    [all...]
benchmark_meta_gemm.cc 51 WorkingSet() : lhs(nullptr), rhs(nullptr), result(nullptr) {}
55 rhs = new std::uint8_t[k * m];
60 std::uint8_t* rhs; member in struct:WorkingSet
97 std::uint8_t* lhs, std::uint8_t* rhs, std::uint8_t* result) {
99 true, false, false, m, n, k, rhs, -100, k, lhs, -100, k, result, 10000,
108 shape.working_set().rhs, shape.working_set().result);
192 shape->working_set().rhs, shape->working_set().result);

Completed in 1078 milliseconds

1 2 3 4 56 7 8 91011>>