Searched refs:coeff (Results 26 - 50 of 302) sorted by relevance

1234567891011>>

/external/chromium_org/third_party/libvpx/source/libvpx/vp8/encoder/x86/
H A Dvp8_enc_stubs_mmx.c31 short *coeff_ptr = b->coeff;
55 short *coeff_ptr = mb->block[0].coeff;
63 short *s_ptr = &mb->coeff[256];
/external/libvpx/libvpx/vp8/encoder/x86/
H A Dvp8_enc_stubs_mmx.c31 short *coeff_ptr = b->coeff;
55 short *coeff_ptr = mb->block[0].coeff;
63 short *s_ptr = &mb->coeff[256];
/external/eigen/Eigen/src/Core/
H A DBooleanRedux.h27 return all_unroller<Derived, UnrollCount-1>::run(mat) && mat.coeff(row, col);
53 return any_unroller<Derived, UnrollCount-1>::run(mat) || mat.coeff(row, col);
93 if (!coeff(i, j)) return false;
117 if (coeff(i, j)) return true;
H A DFlagged.h58 inline CoeffReturnType coeff(Index row, Index col) const function in class:Eigen::Flagged
60 return m_matrix.coeff(row, col);
63 inline CoeffReturnType coeff(Index index) const function in class:Eigen::Flagged
65 return m_matrix.coeff(index);
H A DForceAlignedAccess.h49 inline const CoeffReturnType coeff(Index row, Index col) const function in class:Eigen::ForceAlignedAccess
51 return m_expression.coeff(row, col);
59 inline const CoeffReturnType coeff(Index index) const function in class:Eigen::ForceAlignedAccess
61 return m_expression.coeff(index);
H A DArrayWrapper.h61 inline CoeffReturnType coeff(Index rowId, Index colId) const function in class:Eigen::ArrayWrapper
63 return m_expression.coeff(rowId, colId);
76 inline CoeffReturnType coeff(Index index) const function in class:Eigen::ArrayWrapper
78 return m_expression.coeff(index);
181 inline CoeffReturnType coeff(Index rowId, Index colId) const function in class:Eigen::MatrixWrapper
183 return m_expression.coeff(rowId, colId);
196 inline CoeffReturnType coeff(Index index) const function in class:Eigen::MatrixWrapper
198 return m_expression.coeff(index);
H A DCoreIterators.h40 return (IsRowMajor) ? m_expression.coeff(m_outer, m_inner)
41 : m_expression.coeff(m_inner, m_outer);
H A DCwiseUnaryView.h104 inline const Scalar* data() const { return &coeff(0); }
116 EIGEN_STRONG_INLINE CoeffReturnType coeff(Index row, Index col) const function in class:Eigen::CwiseUnaryViewImpl
118 return derived().functor()(derived().nestedExpression().coeff(row, col));
121 EIGEN_STRONG_INLINE CoeffReturnType coeff(Index index) const function in class:Eigen::CwiseUnaryViewImpl
123 return derived().functor()(derived().nestedExpression().coeff(index));
H A DCwiseUnaryOp.h101 EIGEN_STRONG_INLINE const Scalar coeff(Index rowId, Index colId) const function in class:Eigen::CwiseUnaryOpImpl
103 return derived().functor()(derived().nestedExpression().coeff(rowId, colId));
112 EIGEN_STRONG_INLINE const Scalar coeff(Index index) const function in class:Eigen::CwiseUnaryOpImpl
114 return derived().functor()(derived().nestedExpression().coeff(index));
/external/eigen/bench/
H A DBenchUtil.h54 dst(i,j) = src.coeff(i,j);
68 gsl_matrix_set(*dst, i, j, src.coeff(i,j));
81 dst(i,j) = src.coeff(i,j);
88 dst[j] = src.coeff(j);
/external/eigen/Eigen/src/Eigen2Support/Geometry/
H A DQuaternion.h69 inline Scalar x() const { return m_coeffs.coeff(0); }
71 inline Scalar y() const { return m_coeffs.coeff(1); }
73 inline Scalar z() const { return m_coeffs.coeff(2); }
75 inline Scalar w() const { return m_coeffs.coeff(3); }
460 q.x() = (mat.coeff(2,1) - mat.coeff(1,2)) * t;
461 q.y() = (mat.coeff(0,2) - mat.coeff(2,0)) * t;
462 q.z() = (mat.coeff(1,0) - mat.coeff(
[all...]
/external/chromium_org/third_party/libvpx/source/libvpx/vp9/encoder/
H A Dvp9_encodemb.c110 const tran_low_t *const coeff = BLOCK_OFFSET(mb->plane[plane].coeff, block); local
173 dx = mul * (dqcoeff[rc] - coeff[rc]);
186 if ((abs(x) * dequant_ptr[rc != 0] > abs(coeff[rc]) * mul) &&
187 (abs(x) * dequant_ptr[rc != 0] < abs(coeff[rc]) * mul +
321 tran_low_t *const coeff = BLOCK_OFFSET(p->coeff, block); local
333 fdct32x32(x->use_lp32x32fdct, src_diff, coeff, diff_stride);
334 vp9_quantize_fp_32x32(coeff, 1024, x->skip_block, p->zbin, p->round_fp,
340 vp9_fdct16x16(src_diff, coeff, diff_strid
371 tran_low_t *const coeff = BLOCK_OFFSET(p->coeff, block); local
419 tran_low_t *const coeff = BLOCK_OFFSET(p->coeff, block); local
606 tran_low_t *coeff = BLOCK_OFFSET(p->coeff, block); local
[all...]
/external/eigen/Eigen/src/LU/
H A DInverse.h43 result.coeffRef(0,0) = Scalar(1) / matrix.coeff(0,0);
59 determinant = matrix.coeff(0,0);
74 result.coeffRef(0,0) = matrix.coeff(1,1) * invdet;
75 result.coeffRef(1,0) = -matrix.coeff(1,0) * invdet;
76 result.coeffRef(0,1) = -matrix.coeff(0,1) * invdet;
77 result.coeffRef(1,1) = matrix.coeff(0,0) * invdet;
125 return m.coeff(i1, j1) * m.coeff(i2, j2)
126 - m.coeff(i1, j2) * m.coeff(i
[all...]
/external/aac/libSBRenc/src/
H A Dresampler.cpp375 const FIXP_SGL *coeff = downFilter->coeffa; local
405 state0 = input + fMult(state1, coeff[B1]) + fMult(state2, coeff[B2]);
406 y = state0 - fMult(state1b, coeff[A1]) - fMult(state2b, coeff[A2]);
421 coeff += BIQUAD_COEFSTEP;
440 state0 = input - fMult(state1, coeff[A1]) - fMult(state2, coeff[A2]);
441 y = state0 + fMult(state1, coeff[B1]) + fMult(state2, coeff[B
[all...]
/external/eigen/demos/mix_eigen_and_c/
H A Dbinary_library.h37 int i, int j, double coeff);
58 int i, int j, double coeff);
/external/chromium_org/third_party/skia/src/opts/
H A DSkBitmapFilter_opts_SSE2.cpp145 __m128i coeff, coeff16; local
147 coeff = _mm_loadl_epi64(reinterpret_cast<const __m128i*>(filter_values));
149 coeff16 = _mm_shufflelo_epi16(coeff, _MM_SHUFFLE(1, 1, 0, 0));
172 coeff16 = _mm_shufflelo_epi16(coeff, _MM_SHUFFLE(3, 3, 2, 2));
198 __m128i coeff, coeff16; local
199 coeff = _mm_loadl_epi64(reinterpret_cast<const __m128i*>(filter_values));
201 coeff = _mm_and_si128(coeff, mask[r]);
202 coeff16 = _mm_shufflelo_epi16(coeff, _MM_SHUFFLE(1, 1, 0, 0));
217 coeff16 = _mm_shufflelo_epi16(coeff, _MM_SHUFFL
271 __m128i coeff, coeff16lo, coeff16hi; local
314 __m128i coeff; local
[all...]
/external/eigen/Eigen/src/SVD/
H A DJacobiSVD.h377 RealScalar n = sqrt(numext::abs2(work_matrix.coeff(p,p)) + numext::abs2(work_matrix.coeff(q,p)));
381 z = abs(work_matrix.coeff(p,q)) / work_matrix.coeff(p,q);
384 if(work_matrix.coeff(q,q)!=Scalar(0))
386 z = abs(work_matrix.coeff(q,q)) / work_matrix.coeff(q,q);
394 rot.c() = conj(work_matrix.coeff(p,p)) / n;
395 rot.s() = work_matrix.coeff(q,p) / n;
398 if(work_matrix.coeff(
[all...]
/external/libvpx/libvpx/vp9/encoder/
H A Dvp9_quantize.c43 const int coeff = coeff_ptr[rc]; local
45 if (coeff < zbins[rc != 0] && coeff > nzbins[rc != 0])
55 const int coeff = coeff_ptr[rc]; local
56 const int coeff_sign = (coeff >> 31);
57 const int abs_coeff = (coeff ^ coeff_sign) - coeff_sign;
98 const int coeff = coeff_ptr[rc]; local
102 if (coeff >= zbins[rc != 0] || coeff <= nzbins[rc != 0])
110 const int coeff local
[all...]
H A Dvp9_encodemb.c117 const int16_t *coeff = BLOCK_OFFSET(mb->plane[plane].coeff, block); local
186 dx = mul * (dqcoeff[rc] - coeff[rc]);
199 if ((abs(x)*dequant_ptr[rc != 0] > abs(coeff[rc]) * mul) &&
200 (abs(x)*dequant_ptr[rc != 0] < abs(coeff[rc]) * mul +
323 int16_t *const coeff = BLOCK_OFFSET(p->coeff, block); local
335 fdct32x32(x->use_lp32x32fdct, src_diff, coeff, diff_stride);
336 vp9_quantize_b_32x32(coeff, 1024, x->skip_block, p->zbin, p->round,
342 vp9_fdct16x16(src_diff, coeff, diff_strid
483 int16_t *coeff = BLOCK_OFFSET(p->coeff, block); local
[all...]
/external/eigen/Eigen/src/Core/products/
H A DCoeffBasedProduct.h26 * on the generic Assign mechanism to evaluate the product per coeff (or packet).
157 && "if you wanted a coeff-wise or a dot product use the respective explicit functions");
163 EIGEN_STRONG_INLINE const Scalar coeff(Index row, Index col) const function in class:Eigen::CoeffBasedProduct
173 EIGEN_STRONG_INLINE const Scalar coeff(Index index) const function in class:Eigen::CoeffBasedProduct
231 * Normal product .coeff() implementation (with meta-unrolling)
245 res += lhs.coeff(row, UnrollingIndex) * rhs.coeff(UnrollingIndex, col);
255 res = lhs.coeff(row, 0) * rhs.coeff(0, col);
266 res = lhs.coeff(ro
[all...]
/external/eigen/unsupported/Eigen/src/SVD/
H A DJacobiSVD.h377 RealScalar n = sqrt(numext::abs2(work_matrix.coeff(p,p)) + numext::abs2(work_matrix.coeff(q,p)));
380 z = abs(work_matrix.coeff(p,q)) / work_matrix.coeff(p,q);
383 z = abs(work_matrix.coeff(q,q)) / work_matrix.coeff(q,q);
389 rot.c() = conj(work_matrix.coeff(p,p)) / n;
390 rot.s() = work_matrix.coeff(q,p) / n;
393 if(work_matrix.coeff(p,q) != Scalar(0))
395 Scalar z = abs(work_matrix.coeff(
[all...]
/external/chromium_org/third_party/skia/src/gpu/
H A DGrBlend.cpp11 static inline GrBlendCoeff swap_coeff_src_dst(GrBlendCoeff coeff) { argument
12 switch (coeff) {
30 return coeff;
65 // We could pick out the coeff r,g,b,a values here and use them to compute the blend term color,
140 // We call the same function to simplify the dst blend coeff. We trick it out by swapping the
/external/eigen/test/eigen2/
H A Deigen2_sparse_vector.cpp38 // test coeff and coeffRef
41 VERIFY_IS_MUCH_SMALLER_THAN( v1.coeff(zerocoords[i]), eps );
50 VERIFY(it.value()==v1.coeff(it.index()));
51 VERIFY(it.value()==refV1.coeff(it.index()));
/external/skia/src/gpu/
H A DGrBlend.cpp11 static inline GrBlendCoeff swap_coeff_src_dst(GrBlendCoeff coeff) { argument
12 switch (coeff) {
30 return coeff;
65 // We could pick out the coeff r,g,b,a values here and use them to compute the blend term color,
140 // We call the same function to simplify the dst blend coeff. We trick it out by swapping the
/external/eigen/unsupported/Eigen/src/MatrixFunctions/
H A DMatrixPower.h114 res.coeffRef(0,0) = pow(m_A.coeff(0,0), p);
117 res.coeffRef(i,i) = pow(m_A.coeff(i,i), p);
118 if (m_A.coeff(i-1,i-1) == m_A.coeff(i,i))
119 res.coeffRef(i-1,i) = p * pow(m_A.coeff(i,i), p-1);
120 else if (2*abs(m_A.coeff(i-1,i-1)) < abs(m_A.coeff(i,i)) || 2*abs(m_A.coeff(i,i)) < abs(m_A.coeff(i-1,i-1)))
121 res.coeffRef(i-1,i) = (res.coeff(
[all...]

Completed in 373 milliseconds

1234567891011>>