/frameworks/av/media/libeffects/lvm/lib/Common/src/ |
DelayAllPass_Sat_32x16To32.c | 32 LVM_INT16 coeff, /* All pass filter coefficient */ 46 MUL32x16INTO32(delay[AllPassOffset], coeff, temp, 15) 67 MUL32x16INTO32(c, -coeff, temp, 15)
|
/frameworks/av/media/libstagefright/codecs/amrnb/enc/src/ |
qua_gain.cpp | 125 Word16 frac_coeff -- Word16 Array -- energy coeff. (5), fraction part, Q15 126 Word16 exp_coeff -- Word16 Array -- energy coeff. (5), exponent part, Q0 197 Word16 frac_coeff[], /* i : energy coeff. (5), fraction part, Q15 */ 198 Word16 exp_coeff[], /* i : energy coeff. (5), exponent part, Q0 */ 224 Word16 coeff[5]; local 317 L_Extract(L_tmp, &coeff[i], &coeff_lo[i], pOverflow); 351 L_tmp = Mpy_32_16(coeff[0], coeff_lo[0], g2_pitch, pOverflow); 352 L_tmp2 = Mpy_32_16(coeff[1], coeff_lo[1], g_pitch, pOverflow); 355 L_tmp2 = Mpy_32_16(coeff[2], coeff_lo[2], g2_code, pOverflow); 358 L_tmp2 = Mpy_32_16(coeff[3], coeff_lo[3], g_code, pOverflow) [all...] |
qgain795.cpp | 239 Word16 coeff[5]; local 298 L_Extract(L_tmp, &coeff[i], &coeff_lo[i], pOverflow); 325 L_tmp0 = Mpy_32_16(coeff[0], coeff_lo[0], g2_pitch, pOverflow); 326 L_tmp0 = Mac_32_16(L_tmp0, coeff[1], coeff_lo[1], g_pitch, pOverflow); 343 L_tmp = Mac_32(L_tmp0, coeff[2], coeff_lo[2], 345 L_tmp = Mac_32_16(L_tmp, coeff[3], coeff_lo[3], 347 L_tmp = Mac_32(L_tmp, coeff[4], coeff_lo[4], 508 Word16 coeff[5]; local 573 coeff[2] = mult(tmp, gain_pit, pOverflow); 579 coeff[3] = extract_h(L_shl(L_mult(alpha, frac_en[3], pOverflow), 1, pOverflow)) [all...] |
qgain475.cpp | 799 sf0_exp_coeff = energy coeff. (exponent part) (Word16) 800 sf0_frac_coeff = energy coeff. ((fraction part) (Word16) 806 sf1_exp_coeff = energy coeff. (exponent part) (Word16) 807 sf1_frac_coeff = energy coeff. (fraction part) (Word16) 1193 Word16 coeff[10]; local [all...] |
/frameworks/rs/cpu_ref/ |
rsCpuIntrinsicConvolve3x3.cpp | 74 const float* coeff) { 79 float4 px = convert_float4(py0[x1]) * coeff[0] + 80 convert_float4(py0[x]) * coeff[1] + 81 convert_float4(py0[x2]) * coeff[2] + 82 convert_float4(py1[x1]) * coeff[3] + 83 convert_float4(py1[x]) * coeff[4] + 84 convert_float4(py1[x2]) * coeff[5] + 85 convert_float4(py2[x1]) * coeff[6] + 86 convert_float4(py2[x]) * coeff[7] + 87 convert_float4(py2[x2]) * coeff[8] [all...] |
/external/libvpx/libvpx/vp8/encoder/x86/ |
vp8_enc_stubs_mmx.c | 31 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/ |
CwiseUnaryOp.h | 101 EIGEN_STRONG_INLINE const Scalar coeff(Index row, Index col) const function in class:Eigen::CwiseUnaryOpImpl 103 return derived().functor()(derived().nestedExpression().coeff(row, col)); 112 EIGEN_STRONG_INLINE const Scalar coeff(Index index) const function in class:Eigen::CwiseUnaryOpImpl 114 return derived().functor()(derived().nestedExpression().coeff(index));
|
Flagged.h | 58 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);
|
ForceAlignedAccess.h | 49 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);
|
ArrayWrapper.h | 61 inline CoeffReturnType coeff(Index row, Index col) const function in class:Eigen::ArrayWrapper 63 return m_expression.coeff(row, col); 76 inline CoeffReturnType coeff(Index index) const function in class:Eigen::ArrayWrapper 78 return m_expression.coeff(index); 174 inline CoeffReturnType coeff(Index row, Index col) const function in class:Eigen::MatrixWrapper 176 return m_expression.coeff(row, col); 189 inline CoeffReturnType coeff(Index index) const function in class:Eigen::MatrixWrapper 191 return m_expression.coeff(index);
|
ReturnByValue.h | 36 /* The ReturnByValue object doesn't even have a coeff() method. 71 const Unusable& coeff(Index) const { return *reinterpret_cast<const Unusable*>(this); } function in class:Eigen::ReturnByValue 72 const Unusable& coeff(Index,Index) const { return *reinterpret_cast<const Unusable*>(this); } function in class:Eigen::ReturnByValue
|
CwiseUnaryView.h | 112 EIGEN_STRONG_INLINE CoeffReturnType coeff(Index row, Index col) const function in class:Eigen::CwiseUnaryViewImpl 114 return derived().functor()(derived().nestedExpression().coeff(row, col)); 117 EIGEN_STRONG_INLINE CoeffReturnType coeff(Index index) const function in class:Eigen::CwiseUnaryViewImpl 119 return derived().functor()(derived().nestedExpression().coeff(index));
|
DiagonalProduct.h | 60 const Scalar coeff(Index row, Index col) const function in class:Eigen::DiagonalProduct 62 return m_diagonal.diagonal().coeff(ProductOrder == OnTheLeft ? row : col) * m_matrix.coeff(row, col); 83 internal::pset1<PacketScalar>(m_diagonal.diagonal().coeff(id)));
|
Swap.h | 78 Scalar tmp = m_expression.coeff(row, col); 79 m_expression.coeffRef(row, col) = _other.coeff(row, col); 88 Scalar tmp = m_expression.coeff(index); 89 m_expression.coeffRef(index) = _other.coeff(index);
|
/external/eigen/bench/ |
BenchUtil.h | 54 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/LU/ |
Inverse.h | 43 result.coeffRef(0,0) = Scalar(1) / matrix.coeff(0,0); 58 determinant = matrix.coeff(0,0); 73 result.coeffRef(0,0) = matrix.coeff(1,1) * invdet; 74 result.coeffRef(1,0) = -matrix.coeff(1,0) * invdet; 75 result.coeffRef(0,1) = -matrix.coeff(0,1) * invdet; 76 result.coeffRef(1,1) = matrix.coeff(0,0) * invdet; 123 return m.coeff(i1, j1) * m.coeff(i2, j2) 124 - m.coeff(i1, j2) * m.coeff(i2, j1) [all...] |
FullPivLU.h | 300 result += (internal::abs(m_lu.coeff(i,i)) > premultiplied_threshold); 481 m_lu.col(k).tail(rows-k-1) /= m_lu.coeff(k,k); 491 m_p.applyTranspositionOnTheRight(k, m_rowsTranspositions.coeff(k)); 495 m_q.applyTranspositionOnTheRight(k, m_colsTranspositions.coeff(k)); 580 if(abs(dec().matrixLU().coeff(i,i)) > premultiplied_threshold) 594 m.row(i).tail(cols-i) = dec().matrixLU().row(pivots.coeff(i)).tail(cols-i); 599 m.col(i).swap(m.col(pivots.coeff(i))); 611 m.col(i).swap(m.col(pivots.coeff(i))); 614 for(Index i = 0; i < rank(); ++i) dst.row(dec().permutationQ().indices().coeff(i)) = -m.row(i).tail(dimker); 615 for(Index i = rank(); i < cols; ++i) dst.row(dec().permutationQ().indices().coeff(i)).setZero() [all...] |
/external/aac/libSBRenc/src/ |
resampler.cpp | 375 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[B2]) [all...] |
/external/eigen/demos/mix_eigen_and_c/ |
binary_library.h | 37 int i, int j, double coeff); 58 int i, int j, double coeff);
|
binary_library.cpp | 107 void MatrixXd_set_coeff(C_MatrixXd *m, int i, int j, double coeff) 109 c_to_eigen(m)(i,j) = coeff; 162 void Map_MatrixXd_set_coeff(C_Map_MatrixXd *m, int i, int j, double coeff) 164 c_to_eigen(m)(i,j) = coeff;
|
/external/eigen/Eigen/src/Core/products/ |
CoeffBasedProduct.h | 26 * 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(row, 0) * rhs.coeff(0, col) [all...] |
SelfadjointRank2Update.h | 33 (conj(alpha) * conj(u.coeff(i))) * v.tail(size-i) 34 + (alpha * conj(v.coeff(i))) * u.tail(size-i); 47 (conj(alpha) * conj(u.coeff(i))) * v.head(i+1) 48 + (alpha * conj(v.coeff(i))) * u.head(i+1);
|
/external/eigen/Eigen/src/SVD/ |
JacobiSVD.h | 364 RealScalar n = sqrt(abs2(work_matrix.coeff(p,p)) + abs2(work_matrix.coeff(q,p))); 367 z = abs(work_matrix.coeff(p,q)) / work_matrix.coeff(p,q); 370 z = abs(work_matrix.coeff(q,q)) / work_matrix.coeff(q,q); 376 rot.c() = conj(work_matrix.coeff(p,p)) / n; 377 rot.s() = work_matrix.coeff(q,p) / n; 380 if(work_matrix.coeff(p,q) != Scalar(0)) 382 Scalar z = abs(work_matrix.coeff(p,q)) / work_matrix.coeff(p,q) [all...] |
/external/eigen/test/eigen2/ |
eigen2_sparse_vector.cpp | 38 // 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/eigen/Eigen/src/Eigenvalues/ |
ComplexEigenSolver.h | 275 m_matX.coeffRef(i,k) = -m_schur.matrixT().coeff(i,k); 278 ComplexScalar z = m_schur.matrixT().coeff(i,i) - m_schur.matrixT().coeff(k,k); 285 m_matX.coeffRef(i,k) = m_matX.coeff(i,k) / z;
|