Searched refs:coeff (Results 1 - 25 of 349) sorted by relevance

1234567891011>>

/external/eigen/unsupported/test/
H A Dcxx11_tensor_custom_index.cpp34 NormalIndex coeff(1,2,4,1);
36 VERIFY_IS_EQUAL(tensor.coeff(coeffC), tensor.coeff(coeff));
37 VERIFY_IS_EQUAL(tensor.coeffRef(coeffC), tensor.coeffRef(coeff));
52 NormalIndex coeff(1,2,4,1);
54 VERIFY_IS_EQUAL(tensor.coeff(coeffC), tensor.coeff(coeff));
55 VERIFY_IS_EQUAL(tensor.coeffRef(coeffC), tensor.coeffRef(coeff));
[all...]
H A Dkronecker_product.cpp32 VERIFY_IS_APPROX(ab.coeff(0,0), -0.4017367630386106);
33 VERIFY_IS_APPROX(ab.coeff(0,1), 0.1056863433932735);
34 VERIFY_IS_APPROX(ab.coeff(0,2), -0.7255206194554212);
35 VERIFY_IS_APPROX(ab.coeff(0,3), 0.1908653336744706);
36 VERIFY_IS_APPROX(ab.coeff(0,4), 0.350864567234111);
37 VERIFY_IS_APPROX(ab.coeff(0,5), -0.0923032108308013);
38 VERIFY_IS_APPROX(ab.coeff(1,0), 0.415417514804677);
39 VERIFY_IS_APPROX(ab.coeff(1,1), -0.2369227701722048);
40 VERIFY_IS_APPROX(ab.coeff(1,2), 0.7502275131458511);
41 VERIFY_IS_APPROX(ab.coeff(
[all...]
/external/eigen/Eigen/src/Geometry/
H A DEulerAngles.h55 res[0] = atan2(coeff(j,i), coeff(k,i));
64 Scalar s2 = Vector2(coeff(j,i), coeff(k,i)).norm();
65 res[1] = -atan2(s2, coeff(i,i));
69 Scalar s2 = Vector2(coeff(j,i), coeff(k,i)).norm();
70 res[1] = atan2(s2, coeff(i,i));
85 res[2] = atan2(c1*coeff(j,k)-s1*coeff(
[all...]
H A DOrthoMethods.h44 numext::conj(lhs.coeff(1) * rhs.coeff(2) - lhs.coeff(2) * rhs.coeff(1)),
45 numext::conj(lhs.coeff(2) * rhs.coeff(0) - lhs.coeff(0) * rhs.coeff(2)),
46 numext::conj(lhs.coeff(0) * rhs.coeff(
[all...]
H A DHyperplane.h167 EIGEN_DEVICE_FUNC inline const Scalar& offset() const { return m_coeffs.coeff(dim()); }
192 Scalar det = coeffs().coeff(0) * other.coeffs().coeff(1) - coeffs().coeff(1) * other.coeffs().coeff(0);
197 if(numext::abs(coeffs().coeff(1))>numext::abs(coeffs().coeff(0)))
198 return VectorType(coeffs().coeff(1), -coeffs().coeff(2)/coeffs().coeff(
[all...]
/external/skia/include/gpu/
H A DGrBlend.h76 static constexpr bool GrBlendCoeffRefsSrc(const GrBlendCoeff coeff) { argument
77 return kSC_GrBlendCoeff == coeff || kISC_GrBlendCoeff == coeff || kSA_GrBlendCoeff == coeff ||
78 kISA_GrBlendCoeff == coeff;
81 static constexpr bool GrBlendCoeffRefsDst(const GrBlendCoeff coeff) { argument
82 return kDC_GrBlendCoeff == coeff || kIDC_GrBlendCoeff == coeff || kDA_GrBlendCoeff == coeff ||
83 kIDA_GrBlendCoeff == coeff;
86 GrBlendCoeffRefsSrc2(const GrBlendCoeff coeff) argument
[all...]
/external/skqp/include/gpu/
H A DGrBlend.h76 static constexpr bool GrBlendCoeffRefsSrc(const GrBlendCoeff coeff) { argument
77 return kSC_GrBlendCoeff == coeff || kISC_GrBlendCoeff == coeff || kSA_GrBlendCoeff == coeff ||
78 kISA_GrBlendCoeff == coeff;
81 static constexpr bool GrBlendCoeffRefsDst(const GrBlendCoeff coeff) { argument
82 return kDC_GrBlendCoeff == coeff || kIDC_GrBlendCoeff == coeff || kDA_GrBlendCoeff == coeff ||
83 kIDA_GrBlendCoeff == coeff;
86 GrBlendCoeffRefsSrc2(const GrBlendCoeff coeff) argument
[all...]
/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/ImageMagick/MagickCore/
H A Ddistort.c90 static inline void CoefficientsToAffineArgs(double *coeff)
94 tmp[0]=coeff[3]; tmp[1]=coeff[1]; tmp[2]=coeff[4]; tmp[3]=coeff[2];
95 coeff[1]=tmp[0]; coeff[2]=tmp[1]; coeff[3]=tmp[2]; coeff[4]=tmp[3]; argument
97 static void InvertAffineCoefficients(const double *coeff,doubl
88 CoefficientsToAffineArgs(double *coeff) argument
109 InvertPerspectiveCoefficients(const double *coeff, double *inverse) argument
378 *coeff; local
1679 *coeff, local
2891 *coeff; local
[all...]
/external/eigen/Eigen/src/LU/
H A DDeterminant.h21 return matrix.coeff(0,a)
22 * (matrix.coeff(1,b) * matrix.coeff(2,c) - matrix.coeff(1,c) * matrix.coeff(2,b));
29 return (matrix.coeff(j,0) * matrix.coeff(k,1) - matrix.coeff(k,0) * matrix.coeff(j,1))
30 * (matrix.coeff(
[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/eigen/Eigen/src/misc/
H A DRealSvd2x2.h26 m << numext::real(matrix.coeff(p,p)), numext::real(matrix.coeff(p,q)),
27 numext::real(matrix.coeff(q,p)), numext::real(matrix.coeff(q,q));
29 RealScalar t = m.coeff(0,0) + m.coeff(1,1);
30 RealScalar d = m.coeff(1,0) - m.coeff(0,1);
/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/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/libvpx/libvpx/test/
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/libvpx/libvpx/vp8/encoder/x86/
H A Dvp8_enc_stubs_sse2.c18 short *coeff_ptr = mb->block[0].coeff;
25 short *s_ptr = &mb->coeff[256];
/external/libvpx/libvpx/vpx_dsp/
H A Davg.c38 int16_t *coeff) {
57 coeff[0] = c0 + c4;
58 coeff[7] = c1 + c5;
59 coeff[3] = c2 + c6;
60 coeff[4] = c3 + c7;
61 coeff[2] = c0 - c4;
62 coeff[6] = c1 - c5;
63 coeff[1] = c2 - c6;
64 coeff[5] = c3 - c7;
67 // The order of the output coeff o
37 hadamard_col8(const int16_t *src_diff, ptrdiff_t src_stride, int16_t *coeff) argument
69 vpx_hadamard_8x8_c(const int16_t *src_diff, ptrdiff_t src_stride, tran_low_t *coeff) argument
95 vpx_hadamard_16x16_c(const int16_t *src_diff, ptrdiff_t src_stride, tran_low_t *coeff) argument
128 vpx_satd_c(const tran_low_t *coeff, int length) argument
[all...]
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...]
/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...]
/external/eigen/Eigen/src/Eigenvalues/
H A DEigenSolver.h332 if (internal::isMuchSmallerThan(numext::imag(m_eivalues.coeff(i)), numext::real(m_eivalues.coeff(i)), precision))
333 matD.coeffRef(i,i) = numext::real(m_eivalues.coeff(i));
336 matD.template block<2,2>(i,i) << numext::real(m_eivalues.coeff(i)), numext::imag(m_eivalues.coeff(i)),
337 -numext::imag(m_eivalues.coeff(i)), numext::real(m_eivalues.coeff(i));
354 if (internal::isMuchSmallerThan(numext::imag(m_eivalues.coeff(j)), numext::real(m_eivalues.coeff(j)), precision) || j+1==n)
365 matV.coeffRef(i,j) = ComplexScalar(m_eivec.coeff(
[all...]
/external/eigen/unsupported/Eigen/src/MatrixFunctions/
H A DMatrixSquareRoot.h39 sqrtT.coeffRef(i,j) = (T.coeff(i,j) - tmp) / (sqrtT.coeff(i,i) + sqrtT.coeff(j,j));
50 Matrix<Scalar,2,2> A = sqrtT.coeff(i,i) * Matrix<Scalar,2,2>::Identity();
63 Matrix<Scalar,2,2> A = sqrtT.coeff(j,j) * Matrix<Scalar,2,2>::Identity();
74 coeffMatrix.coeffRef(0,0) = A.coeff(0,0) + B.coeff(0,0);
75 coeffMatrix.coeffRef(1,1) = A.coeff(0,0) + B.coeff(1,1);
76 coeffMatrix.coeffRef(2,2) = A.coeff(
[all...]
/external/skia/src/pathops/
H A DSkPathOpsConic.cpp16 double coeff[3]) {
20 coeff[0] = w * P20 - P20;
21 coeff[1] = P20 - 2 * wP10;
22 coeff[2] = wP10;
26 double coeff[3]; local
27 conic_deriv_coeff(coord, w, coeff);
28 return t * (t * coeff[0] + coeff[1]) + coeff[2];
32 double coeff[ local
14 conic_deriv_coeff(const double src[], SkScalar w, double coeff[3]) argument
[all...]
/external/skqp/src/pathops/
H A DSkPathOpsConic.cpp16 double coeff[3]) {
20 coeff[0] = w * P20 - P20;
21 coeff[1] = P20 - 2 * wP10;
22 coeff[2] = wP10;
26 double coeff[3]; local
27 conic_deriv_coeff(coord, w, coeff);
28 return t * (t * coeff[0] + coeff[1]) + coeff[2];
32 double coeff[ local
14 conic_deriv_coeff(const double src[], SkScalar w, double coeff[3]) argument
[all...]
/external/libvpx/libvpx/vpx_dsp/x86/
H A Davg_intrin_avx2.c95 int16_t *coeff) {
109 _mm256_storeu_si256((__m256i *)coeff,
111 coeff += 16;
112 _mm256_storeu_si256((__m256i *)coeff,
114 coeff += 16;
115 _mm256_storeu_si256((__m256i *)coeff,
117 coeff += 16;
118 _mm256_storeu_si256((__m256i *)coeff,
120 coeff += 16;
121 _mm256_storeu_si256((__m256i *)coeff,
94 hadamard_8x8x2_avx2(int16_t const *src_diff, ptrdiff_t src_stride, int16_t *coeff) argument
134 vpx_hadamard_16x16_avx2(int16_t const *src_diff, ptrdiff_t src_stride, tran_low_t *coeff) argument
165 store_tran_low(_mm256_add_epi16(b0, b2), coeff); local
166 store_tran_low(_mm256_add_epi16(b1, b3), coeff + 64); local
167 store_tran_low(_mm256_sub_epi16(b0, b2), coeff + 128); local
168 store_tran_low(_mm256_sub_epi16(b1, b3), coeff + 192); local
175 vpx_satd_avx2(const tran_low_t *coeff, int length) argument
[all...]
/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;

Completed in 702 milliseconds

1234567891011>>