/third_party/boost/boost/math/special_functions/detail/ |
D | lanczos_sse2.hpp | 26 static const ALIGN16 double coeff[26] = { in lanczos_sum() local 60 …coeff[24] * z + coeff[22]) * z + coeff[20]) * z + coeff[18]) * z + coeff[16]) * z + coeff[14]) * z… in lanczos_sum() 64 __m128d sum_even = _mm_load_pd(coeff); in lanczos_sum() 65 __m128d sum_odd = _mm_load_pd(coeff+2); in lanczos_sum() 70 nc_even = _mm_load_pd(coeff + 4); in lanczos_sum() 72 nc_odd = _mm_load_pd(coeff + 6); in lanczos_sum() 77 nc_even = _mm_load_pd(coeff + 8); in lanczos_sum() 79 nc_odd = _mm_load_pd(coeff + 10); in lanczos_sum() 84 nc_even = _mm_load_pd(coeff + 12); in lanczos_sum() 86 nc_odd = _mm_load_pd(coeff + 14); in lanczos_sum() [all …]
|
/third_party/ffmpeg/tests/checkasm/ |
D | vf_colorspace.c | 58 int w, int h, const int16_t coeff[3][3][8], in check_yuv2yuv() 76 int16_t (*coeff)[3][8] = (int16_t(*)[3][8]) coeff_buf; in check_yuv2yuv() local 82 coeff[0][0][n] = (1 << 14) + (1 << 7) + 1; in check_yuv2yuv() 83 coeff[0][1][n] = (1 << 7) - 1; in check_yuv2yuv() 84 coeff[0][2][n] = -(1 << 8); in check_yuv2yuv() 85 coeff[1][0][n] = coeff[2][0][n] = 0; in check_yuv2yuv() 86 coeff[1][1][n] = (1 << 14) + (1 << 7); in check_yuv2yuv() 87 coeff[1][2][n] = -(1 << 7); in check_yuv2yuv() 88 coeff[2][2][n] = (1 << 14) - (1 << 6); in check_yuv2yuv() 89 coeff[2][1][n] = 1 << 6; in check_yuv2yuv() [all …]
|
/third_party/skia/src/gpu/ |
D | GrBlend.h | 77 static constexpr bool GrBlendCoeffRefsSrc(const GrBlendCoeff coeff) { in GrBlendCoeffRefsSrc() argument 78 return kSC_GrBlendCoeff == coeff || kISC_GrBlendCoeff == coeff || kSA_GrBlendCoeff == coeff || in GrBlendCoeffRefsSrc() 79 kISA_GrBlendCoeff == coeff; in GrBlendCoeffRefsSrc() 82 static constexpr bool GrBlendCoeffRefsDst(const GrBlendCoeff coeff) { in GrBlendCoeffRefsDst() argument 83 return kDC_GrBlendCoeff == coeff || kIDC_GrBlendCoeff == coeff || kDA_GrBlendCoeff == coeff || in GrBlendCoeffRefsDst() 84 kIDA_GrBlendCoeff == coeff; in GrBlendCoeffRefsDst() 87 static constexpr bool GrBlendCoeffRefsSrc2(const GrBlendCoeff coeff) { in GrBlendCoeffRefsSrc2() argument 88 return kS2C_GrBlendCoeff == coeff || kIS2C_GrBlendCoeff == coeff || in GrBlendCoeffRefsSrc2() 89 kS2A_GrBlendCoeff == coeff || kIS2A_GrBlendCoeff == coeff; in GrBlendCoeffRefsSrc2() 113 static constexpr bool GrBlendCoeffRefsConstant(const GrBlendCoeff coeff) { in GrBlendCoeffRefsConstant() argument [all …]
|
/third_party/flutter/skia/src/gpu/ |
D | GrBlend.h | 79 static constexpr bool GrBlendCoeffRefsSrc(const GrBlendCoeff coeff) { in GrBlendCoeffRefsSrc() argument 80 return kSC_GrBlendCoeff == coeff || kISC_GrBlendCoeff == coeff || kSA_GrBlendCoeff == coeff || in GrBlendCoeffRefsSrc() 81 kISA_GrBlendCoeff == coeff; in GrBlendCoeffRefsSrc() 84 static constexpr bool GrBlendCoeffRefsDst(const GrBlendCoeff coeff) { in GrBlendCoeffRefsDst() argument 85 return kDC_GrBlendCoeff == coeff || kIDC_GrBlendCoeff == coeff || kDA_GrBlendCoeff == coeff || in GrBlendCoeffRefsDst() 86 kIDA_GrBlendCoeff == coeff; in GrBlendCoeffRefsDst() 89 static constexpr bool GrBlendCoeffRefsSrc2(const GrBlendCoeff coeff) { in GrBlendCoeffRefsSrc2() argument 90 return kS2C_GrBlendCoeff == coeff || kIS2C_GrBlendCoeff == coeff || in GrBlendCoeffRefsSrc2() 91 kS2A_GrBlendCoeff == coeff || kIS2A_GrBlendCoeff == coeff; in GrBlendCoeffRefsSrc2()
|
/third_party/cmsis/CMSIS/DSP/Source/FilteringFunctions/ |
D | arm_fir_sparse_f32.c | 128 float32_t coeff = *pCoeffs++; /* Read the first coefficient value */ in arm_fir_sparse_f32() local 166 *pOut++ = *px++ * coeff; in arm_fir_sparse_f32() 168 *pOut++ = *px++ * coeff; in arm_fir_sparse_f32() 170 *pOut++ = *px++ * coeff; in arm_fir_sparse_f32() 172 *pOut++ = *px++ * coeff; in arm_fir_sparse_f32() 191 *pOut++ = *px++ * coeff; in arm_fir_sparse_f32() 199 coeff = *pCoeffs++; in arm_fir_sparse_f32() 237 *pOut++ += *px++ * coeff; in arm_fir_sparse_f32() 239 *pOut++ += *px++ * coeff; in arm_fir_sparse_f32() 241 *pOut++ += *px++ * coeff; in arm_fir_sparse_f32() [all …]
|
D | arm_fir_sparse_q31.c | 75 q31_t coeff = *pCoeffs++; /* Read the first coefficient value */ in arm_fir_sparse_q31() local 116 *pOut++ = (q31_t) (((q63_t) *px++ * coeff) >> 32); in arm_fir_sparse_q31() 118 *pOut++ = (q31_t) (((q63_t) *px++ * coeff) >> 32); in arm_fir_sparse_q31() 120 *pOut++ = (q31_t) (((q63_t) *px++ * coeff) >> 32); in arm_fir_sparse_q31() 122 *pOut++ = (q31_t) (((q63_t) *px++ * coeff) >> 32); in arm_fir_sparse_q31() 141 *pOut++ = (q31_t) (((q63_t) *px++ * coeff) >> 32); in arm_fir_sparse_q31() 149 coeff = *pCoeffs++; in arm_fir_sparse_q31() 188 out += ((q63_t) *px++ * coeff) >> 32; in arm_fir_sparse_q31() 192 out += ((q63_t) *px++ * coeff) >> 32; in arm_fir_sparse_q31() 196 out += ((q63_t) *px++ * coeff) >> 32; in arm_fir_sparse_q31() [all …]
|
D | arm_fir_sparse_q7.c | 80 q7_t coeff = *pCoeffs++; /* Read the coefficient value */ in arm_fir_sparse_q7() local 124 *pScratchOut++ = ((q31_t) *px++ * coeff); in arm_fir_sparse_q7() 125 *pScratchOut++ = ((q31_t) *px++ * coeff); in arm_fir_sparse_q7() 126 *pScratchOut++ = ((q31_t) *px++ * coeff); in arm_fir_sparse_q7() 127 *pScratchOut++ = ((q31_t) *px++ * coeff); in arm_fir_sparse_q7() 146 *pScratchOut++ = ((q31_t) *px++ * coeff); in arm_fir_sparse_q7() 154 coeff = *pCoeffs++; in arm_fir_sparse_q7() 192 in = *pScratchOut + ((q31_t) * px++ * coeff); in arm_fir_sparse_q7() 194 in = *pScratchOut + ((q31_t) * px++ * coeff); in arm_fir_sparse_q7() 196 in = *pScratchOut + ((q31_t) * px++ * coeff); in arm_fir_sparse_q7() [all …]
|
D | arm_fir_sparse_q15.c | 79 q15_t coeff = *pCoeffs++; /* Read the first coefficient value */ in arm_fir_sparse_q15() local 123 *pScratchOut++ = ((q31_t) *px++ * coeff); in arm_fir_sparse_q15() 124 *pScratchOut++ = ((q31_t) *px++ * coeff); in arm_fir_sparse_q15() 125 *pScratchOut++ = ((q31_t) *px++ * coeff); in arm_fir_sparse_q15() 126 *pScratchOut++ = ((q31_t) *px++ * coeff); in arm_fir_sparse_q15() 145 *pScratchOut++ = ((q31_t) *px++ * coeff); in arm_fir_sparse_q15() 153 coeff = *pCoeffs++; in arm_fir_sparse_q15() 191 *pScratchOut++ += (q31_t) *px++ * coeff; in arm_fir_sparse_q15() 192 *pScratchOut++ += (q31_t) *px++ * coeff; in arm_fir_sparse_q15() 193 *pScratchOut++ += (q31_t) *px++ * coeff; in arm_fir_sparse_q15() [all …]
|
/third_party/mindspore/mindspore/lite/test/ut/src/runtime/kernel/arm/fp32/ |
D | reduce_fp32_tests.cc | 43 float coeff); 72 bool reduce_to_end, float coeff) { in Prepare() argument 85 param_.coeff = coeff; in Prepare() 116 float coeff = 1.0f; in TEST_F() local 119 …Prepare(in_shape, out_shape, in, out, ReduceMode_ReduceMean, axes, axis_num, reduce_to_end, coeff); in TEST_F() 143 float coeff = 2.0f; in TEST_F() local 146 …Prepare(in_shape, out_shape, in, out, ReduceMode_ReduceMean, axes, axis_num, reduce_to_end, coeff); in TEST_F() 171 float coeff = 2.0f; in TEST_F() local 174 …Prepare(in_shape, out_shape, in, out, ReduceMode_ReduceMean, axes, axis_num, reduce_to_end, coeff); in TEST_F() 197 float coeff = 0.0f; in TEST_F() local [all …]
|
/third_party/boost/boost/numeric/odeint/stepper/ |
D | controlled_adams_bashforth_moulton.hpp | 179 coeff_type &coeff = m_stepper.coeff(); in initialize_controlled() local 195 coeff.predict(t-dt, dt); in initialize_controlled() 196 coeff.do_step(m_dxdt.m_v); in initialize_controlled() 197 coeff.confirm(); in initialize_controlled() 199 if(coeff.m_eo < order_value) in initialize_controlled() 201 ++coeff.m_eo; in initialize_controlled() 229 coeff_type &coeff = m_stepper.coeff(); in try_step() local 232 dt = m_step_adjuster.adjust_stepsize(coeff.m_eo, dt, m_xerr[2].m_v, out, m_stepper.dxdt() ); in try_step() 238 coeff.do_step(m_dxdt.m_v); in try_step() 239 coeff.confirm(); in try_step() [all …]
|
/third_party/cmsis/CMSIS/DSP/Source/TransformFunctions/ |
D | arm_cfft_radix2_q15.c | 99 q31_t coeff, out1, out2; in arm_radix2_butterfly_q15() local 111 coeff = read_q15x2 ((q15_t *)pCoef + (ia * 2U)); in arm_radix2_butterfly_q15() 130 out1 = __SMUAD(coeff, R) >> 16; in arm_radix2_butterfly_q15() 131 out2 = __SMUSDX(coeff, R); in arm_radix2_butterfly_q15() 133 out1 = __SMUSDX(R, coeff) >> 16U; in arm_radix2_butterfly_q15() 134 out2 = __SMUAD(coeff, R); in arm_radix2_butterfly_q15() 139 coeff = read_q15x2 ((q15_t *)pCoef + (ia * 2U)); in arm_radix2_butterfly_q15() 160 out1 = __SMUAD(coeff, R) >> 16; in arm_radix2_butterfly_q15() 161 out2 = __SMUSDX(coeff, R); in arm_radix2_butterfly_q15() 164 out1 = __SMUSDX(R, coeff) >> 16U; in arm_radix2_butterfly_q15() [all …]
|
/third_party/boost/libs/numeric/odeint/test/ |
D | adaptive_adams_coefficients.cpp | 41 aac_type coeff; in BOOST_AUTO_TEST_CASE_TEMPLATE() local 44 coeff.predict(t, dt); in BOOST_AUTO_TEST_CASE_TEMPLATE() 45 coeff.do_step(deriv); in BOOST_AUTO_TEST_CASE_TEMPLATE() 46 coeff.confirm(); in BOOST_AUTO_TEST_CASE_TEMPLATE() 50 if(coeff.m_eo < steps) in BOOST_AUTO_TEST_CASE_TEMPLATE() 51 coeff.m_eo ++; in BOOST_AUTO_TEST_CASE_TEMPLATE() 67 BOOST_CHECK_SMALL(coeff.beta[1][i] - 1.0, 1e-15); in BOOST_AUTO_TEST_CASE_TEMPLATE() 70 BOOST_CHECK_SMALL(coeff.phi[2][i].m_v[0] + 1, 1e-15); in BOOST_AUTO_TEST_CASE_TEMPLATE() 72 BOOST_CHECK_SMALL(coeff.phi[2][i].m_v[0] - 1, 1e-14); in BOOST_AUTO_TEST_CASE_TEMPLATE() 74 BOOST_CHECK_SMALL(coeff.phi[2][i].m_v[0] + 1, 1e-14); in BOOST_AUTO_TEST_CASE_TEMPLATE() [all …]
|
/third_party/ffmpeg/libavcodec/ |
D | dcadsp.c | 37 const int8_t *coeff = hf_vq[vq_index[i]]; in decode_hf_c() local 40 dst[i][j + ofs] = clip23(coeff[j] * scale + (1 << 3) >> 4); in decode_hf_c() 299 static void decor_c(int32_t *dst, const int32_t *src, int coeff, ptrdiff_t len) in decor_c() argument 304 dst[i] += (SUINT)((int)(src[i] * (SUINT)coeff + (1 << 2)) >> 3); in decor_c() 319 static void dmix_sub_c(int32_t *dst, const int32_t *src, int coeff, ptrdiff_t len) in dmix_sub_c() argument 324 dst[i] -= (unsigned)mul15(src[i], coeff); in dmix_sub_c() 327 static void dmix_add_c(int32_t *dst, const int32_t *src, int coeff, ptrdiff_t len) in dmix_add_c() argument 332 dst[i] += (unsigned)mul15(src[i], coeff); in dmix_add_c() 351 static void filter0(SUINT32 *dst, const int32_t *src, int32_t coeff, ptrdiff_t len) in filter0() argument 356 dst[i] -= mul22(src[i], coeff); in filter0() [all …]
|
D | rtjpeg.c | 26 i = scan[coeff--]; \ 48 int coeff, i, n; in get_block() local 57 coeff = get_bits(gb, 6); in get_block() 58 if (get_bits_left(gb) < (coeff << 1)) in get_block() 66 while (coeff) { in get_block() 75 if (get_bits_left(gb) < (coeff << 2)) in get_block() 77 while (coeff) { in get_block() 86 if (get_bits_left(gb) < (coeff << 3)) in get_block() 88 while (coeff) { in get_block()
|
D | adx.c | 26 void ff_adx_calculate_coeffs(int cutoff, int sample_rate, int bits, int *coeff) in ff_adx_calculate_coeffs() argument 34 coeff[0] = lrintf(c * 2.0 * (1 << bits)); in ff_adx_calculate_coeffs() 35 coeff[1] = lrintf(-(c * c) * (1 << bits)); in ff_adx_calculate_coeffs() 39 int bufsize, int *header_size, int *coeff) in ff_adx_decode_header() argument 75 if (coeff) { in ff_adx_decode_header() 77 ff_adx_calculate_coeffs(cutoff, avctx->sample_rate, COEFF_BITS, coeff); in ff_adx_decode_header()
|
/third_party/flutter/skia/src/pathops/ |
D | SkPathOpsConic.cpp | 17 double coeff[3]) { in conic_deriv_coeff() 21 coeff[0] = w * P20 - P20; in conic_deriv_coeff() 22 coeff[1] = P20 - 2 * wP10; in conic_deriv_coeff() 23 coeff[2] = wP10; in conic_deriv_coeff() 27 double coeff[3]; in conic_eval_tan() local 28 conic_deriv_coeff(coord, w, coeff); in conic_eval_tan() 29 return t * (t * coeff[0] + coeff[1]) + coeff[2]; in conic_eval_tan() 33 double coeff[3]; in FindExtrema() local 34 conic_deriv_coeff(src, w, coeff); in FindExtrema() 37 int roots = SkDQuad::RootsValidT(coeff[0], coeff[1], coeff[2], tValues); in FindExtrema()
|
/third_party/skia/src/pathops/ |
D | SkPathOpsConic.cpp | 17 double coeff[3]) { in conic_deriv_coeff() 21 coeff[0] = w * P20 - P20; in conic_deriv_coeff() 22 coeff[1] = P20 - 2 * wP10; in conic_deriv_coeff() 23 coeff[2] = wP10; in conic_deriv_coeff() 27 double coeff[3]; in conic_eval_tan() local 28 conic_deriv_coeff(coord, w, coeff); in conic_eval_tan() 29 return t * (t * coeff[0] + coeff[1]) + coeff[2]; in conic_eval_tan() 33 double coeff[3]; in FindExtrema() local 34 conic_deriv_coeff(src, w, coeff); in FindExtrema() 37 int roots = SkDQuad::RootsValidT(coeff[0], coeff[1], coeff[2], tValues); in FindExtrema()
|
/third_party/python/Modules/_decimal/tests/ |
D | bignum.py | 20 def xhash(coeff, exp): argument 22 if coeff < 0: 24 coeff = -coeff 29 hash_ = coeff * exp_hash % _PyHASH_MODULUS 35 coeff = int(x) variable 39 h1 = xhash(coeff, -849999999)
|
D | randdec.py | 134 coeff = ndigits(maxprec) 136 coeff = () 139 coeff = tuple(map(int, str(ndigits(maxprec)))) 142 coeff = tuple(map(int, str(ndigits(maxprec)))) 144 return (sign, coeff, exp) 146 def from_triple(sign, coeff, exp): argument 147 return ''.join((str(sign*coeff), indicator(), str(exp))) 158 for coeff in nines: 159 yield coeff 160 yield -coeff [all …]
|
/third_party/ffmpeg/libavutil/ |
D | lls.c | 76 sum -= factor[i][k] * m->coeff[0][k]; in avpriv_solve_lls() 78 m->coeff[0][i] = sum / factor[i][i]; in avpriv_solve_lls() 83 double sum = m->coeff[0][i]; in avpriv_solve_lls() 86 sum -= factor[k][i] * m->coeff[j][k]; in avpriv_solve_lls() 88 m->coeff[j][i] = sum / factor[i][i]; in avpriv_solve_lls() 94 double sum = m->coeff[j][i] * covar[i][i] - 2 * covar_y[i + 1]; in avpriv_solve_lls() 97 sum += 2 * m->coeff[j][k] * covar[k][i]; in avpriv_solve_lls() 99 m->variance[j] += m->coeff[j][i] * sum; in avpriv_solve_lls() 110 out += param[i] * m->coeff[order][i]; in evaluate_lls()
|
/third_party/ffmpeg/libswscale/arm/ |
D | rgb2yuv_neon_32.S | 64 .macro compute_y_16x1_step action, s8x16, coeff argument 68 \action y32x16_el, \s8x16\()_l, \coeff 69 \action y32x16_eh, \s8x16\()_h, \coeff 70 \action y32x16_ol, n16x16_ol, \coeff 71 \action y32x16_oh, n16x16_oh, \coeff 99 .macro compute_chroma_8x1_step action, s16x8, coeff argument 100 \action c32x8_l, \s16x8\()_l, \coeff 101 \action c32x8_h, \s16x8\()_h, \coeff
|
/third_party/flutter/skia/tests/ |
D | CubicMapTest.cpp | 26 SkCubicCoeff coeff(array); in accurate_solve() local 28 float t = accurate_t(coeff.fA[0], coeff.fB[0], coeff.fC[0], coeff.fD[0] - x); in accurate_solve() 30 float y = coeff.eval(t)[1]; in accurate_solve()
|
/third_party/skia/tests/ |
D | CubicMapTest.cpp | 26 SkCubicCoeff coeff(array); in accurate_solve() local 28 float t = accurate_t(coeff.fA[0], coeff.fB[0], coeff.fC[0], coeff.fD[0] - x); in accurate_solve() 30 float y = coeff.eval(t)[1]; in accurate_solve()
|
/third_party/ffmpeg/libavfilter/ |
D | vf_colorlevels.c | 102 float coeff[4]; member 128 const float coeff = td->coeff[comp]; in colorlevels_slice_8() local 135 dst[x + offset] = av_clip_uint8((src[x + offset] - imin) * coeff + omin); in colorlevels_slice_8() 150 const float coeff = td->coeff[comp]; in colorlevels_slice_16() local 157 dst[x + offset] = av_clip_uint16((src[x + offset] - imin) * coeff + omin); in colorlevels_slice_16() 219 float coeff; in filter_frame() local 243 coeff = (omax - omin) / (double)(imax - imin); in filter_frame() 245 td.coeff[i] = coeff; in filter_frame() 259 float coeff; in filter_frame() local 283 coeff = (omax - omin) / (double)(imax - imin); in filter_frame() [all …]
|
D | af_acrusher.c | 60 double coeff; member 126 const double coeff = s->coeff; in bitreduction() local 155 y = in * coeff; in bitreduction() 158 k /= coeff; in bitreduction() 160 k = k / coeff + ((k + 1) / coeff - k / coeff) * in bitreduction() 163 k = k / coeff - (k / coeff - (k - 1) / coeff) * in bitreduction() 310 s->coeff = exp2(s->bits) - 1; in config_input() 311 s->sqr = sqrt(s->coeff / 2); in config_input()
|