Searched defs:coeff (Results 1 - 25 of 142) sorted by relevance

123456

/external/libvpx/libvpx/vp9/encoder/mips/msa/
H A Dvp9_error_msa.c19 v8i16 coeff, dq_coeff, coeff_r_h, coeff_l_h; \
24 coeff = LD_SH(coeff_ptr); \
26 UNPCK_SH_SW(coeff, coeff_r_w, coeff_l_w); \
27 ILVRL_H2_SH(coeff, dq_coeff, coeff_r_h, coeff_l_h); \
33 coeff = LD_SH(coeff_ptr + 8); \
35 UNPCK_SH_SW(coeff, coeff_r_w, coeff_l_w); \
36 ILVRL_H2_SH(coeff, dq_coeff, coeff_r_h, coeff_l_h); \
45 coeff = LD_SH(coeff_ptr); \
47 UNPCK_SH_SW(coeff, coeff_r_w, coeff_l_w); \
48 ILVRL_H2_SH(coeff, dq_coef
91 const int16_t *coeff = (const int16_t *)coeff_ptr; local
[all...]
/external/apache-commons-math/src/main/java/org/apache/commons/math/optimization/direct/
H A DMultiDirectional.java112 * @param coeff linear coefficient
119 final double coeff,
133 xTransformed[j] = xSmallest[j] + coeff * (xSmallest[j] - xOriginal[j]);
118 evaluateNewSimplex(final RealPointValuePair[] original, final double coeff, final Comparator<RealPointValuePair> comparator) argument
/external/libvpx/libvpx/vp9/encoder/arm/neon/
H A Dvp9_error_neon.c16 int64_t vp9_block_error_fp_neon(const int16_t *coeff, const int16_t *dqcoeff, argument
24 const int16x8_t c = vld1q_s16(coeff);
35 coeff += 8;
/external/python/cpython3/Modules/_decimal/tests/
H A Dbignum.py20 def xhash(coeff, exp):
22 if coeff < 0:
24 coeff = -coeff
29 hash_ = coeff * exp_hash % _PyHASH_MODULUS
35 coeff = int(x) variable
39 h1 = xhash(coeff, -849999999)
/external/libvpx/libvpx/test/
H A Didct8x8_test.cc62 tran_low_t coeff[64]; local
75 coeff[j] = static_cast<tran_low_t>(round(output_r[j]));
77 vpx_idct8x8_64_add_c(coeff, dst, 8);
H A Dvp9_block_error_test.cc33 typedef int64_t (*HBDBlockErrorFunc)(const tran_low_t *coeff,
41 typedef int64_t (*BlockErrorFunc)(const tran_low_t *coeff,
46 int64_t BlockError8BitWrapper(const tran_low_t *coeff, argument
50 return fn(coeff, dqcoeff, block_size, ssz);
72 DECLARE_ALIGNED(16, tran_low_t, coeff[4096]);
86 // coeff and dqcoeff will always have at least the same sign, and this
90 coeff[j] = rnd(1 << msb);
94 coeff[j] = -rnd(1 << msb);
99 ref_error_block_op_(coeff, dqcoeff, block_size, &ref_ssz, bit_depth_);
101 ret = error_block_op_(coeff, dqcoef
[all...]
/external/aac/libFDK/src/
H A DFDK_lpc.cpp118 const int inc, const FIXP_SGL *coeff,
147 const FIXP_SGL *pCoeff = coeff + order - 1;
170 const int inc, const FIXP_DBL *coeff,
186 const FIXP_DBL *pCoeff = coeff + order - 1;
222 FIXP_LPC_TNS coeff[2 * LPC_MAX_ORDER]; local
223 FDKmemcpy(&coeff[0], lpcCoeff_m, order * sizeof(FIXP_LPC_TNS));
224 FDKmemcpy(&coeff[order], lpcCoeff_m, order * sizeof(FIXP_LPC_TNS));
238 const FIXP_LPC_TNS *pCoeff = coeff + order - stateIndex;
265 FIXP_LPC coeff[2 * LPC_MAX_ORDER];
266 FDKmemcpy(&coeff[
116 CLpc_SynthesisLattice(FIXP_DBL *signal, const int signal_size, const int signal_e, const int signal_e_out, const int inc, const FIXP_SGL *coeff, const int order, FIXP_DBL *state) argument
168 CLpc_SynthesisLattice(FIXP_DBL *signal, const int signal_size, const int signal_e, const int signal_e_out, const int inc, const FIXP_DBL *coeff, const int order, FIXP_DBL *state) argument
[all...]
/external/eigen/Eigen/src/Core/
H A DForceAlignedAccess.h49 EIGEN_DEVICE_FUNC inline const CoeffReturnType coeff(Index row, Index col) const function in class:Eigen::ForceAlignedAccess
51 return m_expression.coeff(row, col);
59 EIGEN_DEVICE_FUNC inline const CoeffReturnType coeff(Index index) const function in class:Eigen::ForceAlignedAccess
61 return m_expression.coeff(index);
H A DNestByValue.h49 EIGEN_DEVICE_FUNC inline const CoeffReturnType coeff(Index row, Index col) const function in class:Eigen::NestByValue
51 return m_expression.coeff(row, col);
59 EIGEN_DEVICE_FUNC inline const CoeffReturnType coeff(Index index) const function in class:Eigen::NestByValue
61 return m_expression.coeff(index);
H A DReturnByValue.h31 /* The ReturnByValue object doesn't even have a coeff() method.
72 const Unusable& coeff(Index) const { return *reinterpret_cast<const Unusable*>(this); } function in class:Eigen::ReturnByValue
73 const Unusable& coeff(Index,Index) const { return *reinterpret_cast<const Unusable*>(this); } function in class:Eigen::ReturnByValue
H A DDiagonal.h124 inline CoeffReturnType coeff(Index row, Index) const function in class:Eigen::Diagonal
126 return m_matrix.coeff(row+rowOffset(), row+colOffset());
143 inline CoeffReturnType coeff(Index idx) const function in class:Eigen::Diagonal
145 return m_matrix.coeff(idx+rowOffset(), idx+colOffset());
H A DMapBase.h24 * This base class provides the const low-level accessors (e.g. coeff, coeffRef) of dense
73 using Base::coeff;
101 /** \copydoc PlainObjectBase::coeff(Index,Index) const */
103 inline const Scalar& coeff(Index rowId, Index colId) const function in class:Eigen::MapBase
108 /** \copydoc PlainObjectBase::coeff(Index) const */
110 inline const Scalar& coeff(Index index) const function in class:Eigen::MapBase
209 * This base class provides the non-const low-level accessors (e.g. coeff and coeffRef) of
232 using Base::coeff;
H A DSelect.h74 const Scalar coeff(Index i, Index j) const function in class:Eigen::Select
76 if (m_condition.coeff(i,j))
77 return m_then.coeff(i,j);
79 return m_else.coeff(i,j);
83 const Scalar coeff(Index i) const function in class:Eigen::Select
85 if (m_condition.coeff(i))
86 return m_then.coeff(i);
88 return m_else.coeff(i);
/external/eigen/test/
H A DsparseLM.cpp41 Scalar coeff; local
46 coeff = (x(j)-i)/v(i);
47 coeff *= coeff;
48 if (coeff < 1. && coeff > 0.)
49 y(j) += u(i)*std::pow((1-coeff), 2);
69 Scalar coeff; local
74 coeff = (m_x(j)-i)/v(i);
75 coeff *
93 Scalar coeff; local
[all...]
/external/libvpx/libvpx/vp9/encoder/x86/
H A Dvp9_highbd_block_error_intrin_sse2.c16 int64_t vp9_highbd_block_error_sse2(tran_low_t *coeff, tran_low_t *dqcoeff, argument
28 __m128i mm_coeff = _mm_load_si128((__m128i *)(coeff + i));
29 __m128i mm_coeff2 = _mm_load_si128((__m128i *)(coeff + i + 4));
59 const int64_t diff = coeff[i + j] - dqcoeff[i + j];
61 sqcoeff += (int64_t)coeff[i + j] * (int64_t)coeff[i + j];
H A Dvp9_error_avx2.c19 int64_t vp9_block_error_avx2(const tran_low_t *coeff, const tran_low_t *dqcoeff, argument
31 // Load 16 elements for coeff and dqcoeff.
32 coeff_256 = load_tran_low(coeff);
34 // dqcoeff - coeff
36 // madd (dqcoeff - coeff)
38 // madd coeff
57 // Load 32 elements for coeff and dqcoeff.
58 coeff_0 = load_tran_low(coeff + i);
60 coeff_1 = load_tran_low(coeff + i + 16);
62 // dqcoeff - coeff
109 vp9_block_error_fp_avx2(const tran_low_t *coeff, const tran_low_t *dqcoeff, int block_size) argument
[all...]
/external/skia/src/gpu/
H A DGrXferProcessor.cpp105 static const char* coeff_string(GrBlendCoeff coeff) { argument
106 switch (coeff) {
/external/skqp/src/gpu/
H A DGrXferProcessor.cpp105 static const char* coeff_string(GrBlendCoeff coeff) { argument
106 switch (coeff) {
/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/interpolation/
H A DBicubicSplineInterpolatingFunction.java414 * @param coeff Spline coefficients.
417 private double apply(double[] pX, double[] pY, double[][] coeff) { argument
421 result += coeff[i][j] * pX[i] * pY[j];
/external/eigen/demos/mix_eigen_and_c/
H A Dbinary_library.cpp107 void MatrixXd_set_coeff(C_MatrixXd *m, int i, int j, double coeff) argument
109 c_to_eigen(m)(i,j) = coeff;
162 void Map_MatrixXd_set_coeff(C_Map_MatrixXd *m, int i, int j, double coeff) argument
164 c_to_eigen(m)(i,j) = coeff;
/external/libvpx/libvpx/vp8/encoder/mips/msa/
H A Dencodeopt_msa.c18 v8i16 coeff, dq_coeff, coeff0, coeff1; local
24 coeff = LD_SH(coeff_ptr);
26 ILVRL_H2_SH(coeff, dq_coeff, coeff0, coeff1);
47 v8i16 coeff, coeff0, coeff1, coeff2, coeff3, coeff4; local
61 coeff_ptr = be->coeff;
63 coeff = LD_SH(coeff_ptr);
71 coeff_ptr = be->coeff;
79 ILVRL_H2_SH(coeff, dq_coeff, coeff0, coeff1);
113 v8i16 coeff, coeff0, coeff1, coeff2, coeff3, coeff4; local
121 coeff_ptr = be->coeff;
[all...]
/external/libvpx/libvpx/vpx_dsp/arm/
H A Dhadamard_neon.c51 tran_low_t *coeff) {
69 store_s16q_to_tran_low(coeff + 0, a0);
70 store_s16q_to_tran_low(coeff + 8, a1);
71 store_s16q_to_tran_low(coeff + 16, a2);
72 store_s16q_to_tran_low(coeff + 24, a3);
73 store_s16q_to_tran_low(coeff + 32, a4);
74 store_s16q_to_tran_low(coeff + 40, a5);
75 store_s16q_to_tran_low(coeff + 48, a6);
76 store_s16q_to_tran_low(coeff + 56, a7);
80 tran_low_t *coeff) {
50 vpx_hadamard_8x8_neon(const int16_t *src_diff, ptrdiff_t src_stride, tran_low_t *coeff) argument
79 vpx_hadamard_16x16_neon(const int16_t *src_diff, ptrdiff_t src_stride, tran_low_t *coeff) argument
[all...]
H A Dquantize_neon.c44 const int16x8_t coeff = load_tran_low_to_s16q(coeff_ptr); local
45 const int16x8_t coeff_sign = vshrq_n_s16(coeff, 15);
46 const int16x8_t coeff_abs = vabsq_s16(coeff);
96 const int16x8_t coeff = load_tran_low_to_s16q(coeff_ptr); local
97 const int16x8_t coeff_sign = vshrq_n_s16(coeff, 15);
98 const int16x8_t coeff_abs = vabsq_s16(coeff);
180 const int16x8_t coeff = load_tran_low_to_s16q(coeff_ptr); local
181 const int16x8_t coeff_sign = vshrq_n_s16(coeff, 15);
182 const int16x8_t coeff_abs = vabsq_s16(coeff);
240 const int16x8_t coeff local
[all...]
/external/libvpx/libvpx/vpx_dsp/ppc/
H A Dhadamard_vsx.c46 tran_low_t *coeff) {
64 store_tran_low(v[0], 0, coeff);
65 store_tran_low(v[1], 0, coeff + 8);
66 store_tran_low(v[2], 0, coeff + 16);
67 store_tran_low(v[3], 0, coeff + 24);
68 store_tran_low(v[4], 0, coeff + 32);
69 store_tran_low(v[5], 0, coeff + 40);
70 store_tran_low(v[6], 0, coeff + 48);
71 store_tran_low(v[7], 0, coeff + 56);
75 tran_low_t *coeff) {
45 vpx_hadamard_8x8_vsx(const int16_t *src_diff, ptrdiff_t src_stride, tran_low_t *coeff) argument
74 vpx_hadamard_16x16_vsx(const int16_t *src_diff, ptrdiff_t src_stride, tran_low_t *coeff) argument
[all...]
/external/libvpx/libvpx/vpx_dsp/
H A Dquantize.c22 const int coeff = coeff_ptr[rc]; local
23 const int coeff_sign = (coeff >> 31);
24 const int abs_coeff = (coeff ^ coeff_sign) - coeff_sign;
52 const int coeff = coeff_ptr[0]; local
53 const int coeff_sign = (coeff >> 31);
54 const int abs_coeff = (coeff ^ coeff_sign) - coeff_sign;
71 const int coeff = coeff_ptr[rc]; local
72 const int coeff_sign = (coeff >> 31);
73 const int abs_coeff = (coeff ^ coeff_sign) - coeff_sign;
104 const int coeff local
137 const int coeff = coeff_ptr[rc]; local
149 const int coeff = coeff_ptr[rc]; local
188 const int coeff = coeff_ptr[rc]; local
200 const int coeff = coeff_ptr[rc]; local
241 const int coeff = coeff_ptr[rc]; local
252 const int coeff = coeff_ptr[rc]; local
294 const int coeff = coeff_ptr[rc]; local
305 const int coeff = coeff_ptr[rc]; local
[all...]

Completed in 753 milliseconds

123456