HomeSort by relevance Sort by last modified time
    Searched defs:coeff (Results 101 - 125 of 145) sorted by null

1 2 3 45 6

  /external/libxaac/decoder/
ixheaacd_mps_dec.c 188 ia_cmplx_flt_struct coeff; local
214 coeff.re = ixheaacd_tsd_mul_re[self->bs_tsd_tr_phase_data[sb_sample]];
215 coeff.im = ixheaacd_tsd_mul_im[self->bs_tsd_tr_phase_data[sb_sample]];
219 coeff.re * scratch[sb_sample][idx].re -
220 coeff.im * scratch[sb_sample][idx].im;
222 coeff.im * scratch[sb_sample][idx].re +
223 coeff.re * scratch[sb_sample][idx].im;
    [all...]
  /external/python/cpython3/Modules/_decimal/libmpdec/
io.c 133 const char *coeff = NULL; local
154 if (coeff == NULL && *exp == NULL) {
159 coeff = s;
162 coeff = s;
171 return coeff;
178 const char *coeff; local
182 coeff = s;
188 return (*s == '\0') ? coeff : NULL;
197 const char *coeff, *end; local
222 if ((coeff = scan_payload(s, &end)) == NULL
    [all...]
  /external/webp/src/dsp/
enc_mips_dsp_r2.c 1278 int sign, coeff, level; local
    [all...]
enc.c 31 // Compute susceptibility based on DCT-coeff histograms:
660 const uint32_t coeff = (sign ? -in[j] : in[j]) + mtx->sharpen_[j]; local
661 if (coeff > mtx->zthresh_[j]) {
665 int level = QUANTDIV(coeff, iQ, B);
  /external/ImageMagick/MagickCore/
distort.c 90 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];
97 static void InvertAffineCoefficients(const double *coeff,double *inverse
378 *coeff; local
1679 *coeff, local
2891 *coeff; local
    [all...]
  /external/adhd/cras/src/tests/
cras_test_client.c 1392 float *coeff; local
    [all...]
  /external/apache-commons-math/src/main/java/org/apache/commons/math/geometry/
Rotation.java 181 double coeff = FastMath.sin(halfAngle) / norm; local
184 q1 = coeff * axis.getX();
185 q2 = coeff * axis.getY();
186 q3 = coeff * axis.getZ();
333 double coeff = FastMath.sqrt (u1u1 / v1v1); local
334 double v1x = coeff * v1.getX();
335 double v1y = coeff * v1.getY();
336 double v1z = coeff * v1.getZ();
469 double coeff = 1.0 / (2.0 * q0 * normProduct); local
470 q1 = coeff * (v.getY() * u.getZ() - v.getZ() * u.getY())
    [all...]
  /external/eigen/Eigen/src/Core/
CoreEvaluators.h 161 CoeffReturnType coeff(Index row, Index col) const function in struct:Eigen::internal::evaluator
170 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::evaluator
281 CoeffReturnType coeff(Index row, Index col) const function in struct:Eigen::internal::unary_evaluator
283 return m_argImpl.coeff(col, row);
287 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::unary_evaluator
289 return m_argImpl.coeff(index);
409 // The trick is thus to defer the proper instantiation of nullary_wrapper when coeff(),
482 CoeffReturnType coeff(IndexType row, IndexType col) const function in struct:Eigen::internal::evaluator
489 CoeffReturnType coeff(IndexType index) const function in struct:Eigen::internal::evaluator
541 CoeffReturnType coeff(Index row, Index col) cons function in struct:Eigen::internal::unary_evaluator
547 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::unary_evaluator
625 CoeffReturnType coeff(Index row, Index col) const function in struct:Eigen::internal::ternary_evaluator
631 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::ternary_evaluator
711 CoeffReturnType coeff(Index row, Index col) const function in struct:Eigen::internal::binary_evaluator
717 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::binary_evaluator
772 CoeffReturnType coeff(Index row, Index col) const function in struct:Eigen::internal::unary_evaluator
778 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::unary_evaluator
832 CoeffReturnType coeff(Index row, Index col) const function in struct:Eigen::internal::mapbase_evaluator
838 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::mapbase_evaluator
1032 CoeffReturnType coeff(Index row, Index col) const function in struct:Eigen::internal::unary_evaluator
1038 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::unary_evaluator
1142 CoeffReturnType coeff(Index row, Index col) const function in struct:Eigen::internal::evaluator
1151 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::evaluator
1196 CoeffReturnType coeff(Index row, Index col) const function in struct:Eigen::internal::unary_evaluator
1210 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::unary_evaluator
1287 const Scalar coeff(Index i, Index j) const function in struct:Eigen::internal::evaluator
1296 const Scalar coeff(Index index) const function in struct:Eigen::internal::evaluator
1332 CoeffReturnType coeff(Index row, Index col) const function in struct:Eigen::internal::evaluator_wrapper_base
1338 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::evaluator_wrapper_base
1453 CoeffReturnType coeff(Index row, Index col) const function in struct:Eigen::internal::unary_evaluator
1460 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::unary_evaluator
1562 CoeffReturnType coeff(Index row, Index) const function in struct:Eigen::internal::evaluator
1568 CoeffReturnType coeff(Index index) const function in struct:Eigen::internal::evaluator
    [all...]
  /external/eigen/Eigen/src/SparseCore/
SparseMatrix.h 188 inline Scalar coeff(Index row, Index col) const function in class:Eigen::SparseMatrix
    [all...]
  /external/eigen/unsupported/Eigen/CXX11/src/Tensor/
TensorContraction.h 526 EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE CoeffReturnType coeff(Index index) const { function in struct:Eigen::TensorContractionEvaluatorBase
TensorConvolution.h 394 buffer[i] += coeff(i);
399 EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE CoeffReturnType coeff(Index index) const function in struct:Eigen::TensorEvaluator
497 accum += m_inputImpl.coeff(input) * m_kernel[kernel];
594 s[i + plane_kernel_offset] = eval.coeff(tensor_index);
653 s[i + input_offset] = eval.coeff(tensor_index);
718 s[i + num_x_input * (j + num_y_input * (k + plane_kernel_offset))] = eval.coeff(tensor_index);
1050 EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE CoeffReturnType coeff(Index index) const function in struct:Eigen::TensorEvaluator
    [all...]
TensorImagePatch.h 324 EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE CoeffReturnType coeff(Index index) const function in struct:Eigen::TensorEvaluator
359 return m_impl.coeff(inputIndex);
453 values[i] = coeff(index+i);
TensorVolumePatch.h 353 EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE CoeffReturnType coeff(Index index) const function in struct:Eigen::TensorEvaluator
405 return m_impl.coeff(inputIndex);
530 values[i] = coeff(index+i);
  /external/libvpx/libvpx/vp9/encoder/
vp9_encodemb.c 67 const tran_low_t *const coeff = BLOCK_OFFSET(p->coeff, block); local
138 const int diff_for_zero_raw = (0 - coeff[rc]) * (1 << shift);
150 const int diff0_raw = (dqcoeff[rc] - coeff[rc]) * (1 << shift);
179 // Calculate RDCost for current coeff for the two candidates.
193 // Calculate RD Cost effect on the next coeff for the two candidates.
329 tran_low_t *const coeff = BLOCK_OFFSET(p->coeff, block); local
343 highbd_fdct32x32(x->use_lp32x32fdct, src_diff, coeff, diff_stride);
344 vp9_highbd_quantize_fp_32x32(coeff, 1024, x->skip_block, p->round_fp
405 tran_low_t *const coeff = BLOCK_OFFSET(p->coeff, block); local
479 tran_low_t *const coeff = BLOCK_OFFSET(p->coeff, block); local
740 tran_low_t *coeff = BLOCK_OFFSET(p->coeff, block); local
    [all...]
vp9_pickmode.c 708 tran_low_t *const coeff = BLOCK_OFFSET(p->coeff, block); local
718 vpx_hadamard_16x16(src_diff, diff_stride, coeff);
719 vp9_quantize_fp(coeff, 256, x->skip_block, p->round_fp, p->quant_fp,
724 vpx_hadamard_8x8(src_diff, diff_stride, coeff);
725 vp9_quantize_fp(coeff, 64, x->skip_block, p->round_fp, p->quant_fp,
730 x->fwd_txfm4x4(src_diff, coeff, diff_stride);
731 vp9_quantize_fp(coeff, 16, x->skip_block, p->round_fp, p->quant_fp,
758 tran_low_t *const coeff = BLOCK_OFFSET(p->coeff, block) local
    [all...]
  /external/libxaac/decoder/drc_src/
impd_drc_eq.c 79 FLOAT32* coeff, FLOAT32 frequency_radian,
91 sum += coeff[o2 - m] * (FLOAT32)cos(m * frequency_radian);
94 sum = coeff[o2];
97 sum += coeff[o2 - m] * (FLOAT32)sin(m * frequency_radian);
105 sum += coeff[o2 - m] * (FLOAT32)cos((m - 0.5f) * frequency_radian);
109 sum += coeff[o2 - m] * (FLOAT32)sin((m - 0.5f) * frequency_radian);
424 FLOAT32* coeff; local
438 coeff = pstr_2nd_oder_filt_params->coeff;
441 coeff[0] = 0.0f
534 FLOAT32* coeff = fir_filter->coeff; local
591 FLOAT32* coeff; local
1207 FLOAT32* coeff = fir_filter->coeff; local
    [all...]
  /external/opencv/cvaux/src/
cveigenobjects.cpp 1535 double coeff = DBL_MAX; local
    [all...]
  /external/skia/src/core/
SkGeometry.cpp 289 SkQuadCoeff coeff;
295 coeff.fA = P3 + Sk2s(3) * (P1 - P2) - P0;
296 coeff.fB = times_2(P2 - times_2(P1) + P0);
297 coeff.fC = P1 - P0;
298 return to_vector(coeff.eval(t));
755 /* Solve coeff(t) == 0, returning the number of roots that
757 coeff[0]t^3 + coeff[1]t^2 + coeff[2]t + coeff[3
979 SkScalar coeff[3]; local
    [all...]
  /external/skqp/src/core/
SkGeometry.cpp 289 SkQuadCoeff coeff;
295 coeff.fA = P3 + Sk2s(3) * (P1 - P2) - P0;
296 coeff.fB = times_2(P2 - times_2(P1) + P0);
297 coeff.fC = P1 - P0;
298 return to_vector(coeff.eval(t));
755 /* Solve coeff(t) == 0, returning the number of roots that
757 coeff[0]t^3 + coeff[1]t^2 + coeff[2]t + coeff[3
979 SkScalar coeff[3]; local
    [all...]
  /external/tensorflow/tensorflow/compiler/xla/service/
elemental_ir_emitter.cc 842 auto coeff = local
    [all...]
  /external/tensorflow/tensorflow/core/kernels/
eigen_volume_patch.h 251 coeff(Index index) const { function in struct:Eigen::CustomTensorEvaluator
328 return m_impl.coeff(inputIndex);
461 coeff(const array<Index, NumDims>& coords) const { function in struct:Eigen::CustomTensorEvaluator
535 return m_impl.coeff(inputCoords);
549 return m_impl.coeff(inputIndex);
559 values[i] = coeff(index + i);
  /external/mesa3d/src/gallium/drivers/vc4/
vc4_program.c 648 float coeff[] = { local
665 struct qreg sum = qir_FMUL(c, x, qir_uniform_f(c, coeff[0]));
666 for (int i = 1; i < ARRAY_SIZE(coeff); i++) {
672 qir_uniform_f(c, coeff[i])));
680 float coeff[] = { local
696 struct qreg sum = qir_uniform_f(c, coeff[0]);
699 for (int i = 1; i < ARRAY_SIZE(coeff); i++) {
705 qir_uniform_f(c, coeff[i]));
    [all...]
  /cts/apps/CtsVerifier/src/com/android/cts/verifier/sensors/
RVCVXCheckAnalyzer.java 818 MatOfDouble coeff = new MatOfDouble(); // dummy local
866 Calib3d.solvePnP(grid, centers, camMat, coeff, rvec, tvec,
878 Calib3d.projectPoints(grid, rvec, tvec, camMat, coeff, reprojCenters);
    [all...]
  /external/aac/libDRCdec/src/
drcDec_selectionProcess.cpp 2880 FIXP_DBL coeff; local
    [all...]
  /external/mesa3d/src/gallium/auxiliary/gallivm/
lp_bld_arit.c 3222 LLVMValueRef coeff; local
    [all...]

Completed in 919 milliseconds

1 2 3 45 6