HomeSort by relevance Sort by last modified time
    Searched refs:residual (Results 1 - 25 of 102) sorted by null

1 2 3 4 5

  /external/webrtc/webrtc/modules/audio_coding/codecs/ilbc/
state_search.h 33 int16_t *residual, /* (i) target residual vector */
state_search.c 32 int16_t *residual, /* (i) target residual vector */
51 max = WebRtcSpl_MaxAbsValueW16(residual, iLBCenc_inst->state_short_len);
59 /* Copy the residual to a temporary buffer that we can filter
62 WEBRTC_SPL_MEMCPY_W16(residualLong, residual, iLBCenc_inst->state_short_len);
encode.c 56 int16_t *residual; local
80 residual = &iLBCenc_inst->lpc_buffer[LPC_LOOKBACK+BLOCKL_MAX-iLBCenc_inst->blockl];
82 decresidual = residual; /* Already encoded residual is overwritten by the decoded version */
84 reverseDecresidual = reverseResidual; /* Already encoded residual is overwritten by the decoded version */
125 /* high pass filtering of input signal and scale down the residual (*0.5) */
137 /* inverse filter to get residual */
140 &data[n*SUBL], &residual[n*SUBL],
150 iLBCbits_inst->startIdx = WebRtcIlbcfix_FrameClassify(iLBCenc_inst,residual);
156 max=WebRtcSpl_MaxAbsValueW16(&residual[index], 2*SUBL)
    [all...]
  /external/aac/libFDK/include/
FDK_trigFcts.h 142 * Returns delta x residual.
146 FIXP_DBL residual; local
152 residual = fMult(x, FL2FXCONST_DBL(1.0/M_PI));
153 s = ((LONG)residual) >> shift;
155 residual &= ( (1<<shift) - 1 );
156 residual = fMult(residual, FL2FXCONST_DBL(M_PI/4.0)) << 2;
157 residual <<= scale;
202 return residual;
215 FIXP_DBL residual, error0, error1, sine, cosine local
    [all...]
  /external/flac/libFLAC/include/private/
stream_encoder.h 51 extern void FLAC__precompute_partition_info_sums_intrin_sse2(const FLAC__int32 residual[], FLAC__uint64 abs_residual_partition_sums[],
56 extern void FLAC__precompute_partition_info_sums_intrin_ssse3(const FLAC__int32 residual[], FLAC__uint64 abs_residual_partition_sums[],
61 extern void FLAC__precompute_partition_info_sums_intrin_avx2(const FLAC__int32 residual[], FLAC__uint64 abs_residual_partition_sums[],
lpc.h 144 * Compute the residual signal obtained from sutracting the predicted
152 * OUT residual[0,data_len-1] residual signal
154 void FLAC__lpc_compute_residual_from_qlp_coefficients(const FLAC__int32 *data, unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 residual[]);
155 void FLAC__lpc_compute_residual_from_qlp_coefficients_wide(const FLAC__int32 *data, unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 residual[]);
159 void FLAC__lpc_compute_residual_from_qlp_coefficients_asm_ia32(const FLAC__int32 *data, unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 residual[]);
160 void FLAC__lpc_compute_residual_from_qlp_coefficients_asm_ia32_mmx(const FLAC__int32 *data, unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 residual[]);
161 void FLAC__lpc_compute_residual_from_qlp_coefficients_wide_asm_ia32(const FLAC__int32 *data, unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 residual[]);
166 void FLAC__lpc_compute_residual_from_qlp_coefficients_16_intrin_sse2(const FLAC__int32 *data, unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 residual[]);
167 void FLAC__lpc_compute_residual_from_qlp_coefficients_intrin_sse2(const FLAC__int32 *data, unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 residual[]);
    [all...]
fixed.h 48 * of the residual signal for each order. The _wide() version uses
82 * Compute the residual signal obtained from sutracting the predicted
88 * OUT residual[0,data_len-1] residual signal
90 void FLAC__fixed_compute_residual(const FLAC__int32 data[], unsigned data_len, unsigned order, FLAC__int32 residual[]);
95 * Restore the original signal by summing the residual and the
98 * IN residual[0,data_len-1] residual signal
105 void FLAC__fixed_restore_signal(const FLAC__int32 residual[], unsigned data_len, unsigned order, FLAC__int32 data[]);
  /frameworks/av/media/libstagefright/codecs/on2/h264dec/source/
h264bsd_image.h 64 i32 residual[][16]);
h264bsd_util.h 72 /* macro to mark a residual block empty, i.e. contain zero coefficients */
73 #define MARK_RESIDUAL_EMPTY(residual) ((residual)[0] = EMPTY_RESIDUAL_INDICATOR)
74 /* macro to check if residual block is empty */
75 #define IS_RESIDUAL_EMPTY(residual) ((residual)[0] == EMPTY_RESIDUAL_INDICATOR)
h264bsd_intra_prediction.h 57 u32 h264bsdIntra16x16Prediction(mbStorage_t *pMb, u8 *data, i32 residual[][16],
60 u32 h264bsdIntraChromaPrediction(mbStorage_t *pMb, u8 *data, i32 residual[][16],
  /external/webrtc/webrtc/modules/remote_bitrate_estimator/
overuse_estimator.cc 74 const double residual = t_ts_delta - slope_*h[0] - offset_; local
80 if (fabs(residual) < max_residual) {
81 UpdateNoiseEstimate(residual, min_frame_period, in_stable_state);
83 UpdateNoiseEstimate(residual < 0 ? -max_residual : max_residual,
112 slope_ = slope_ + K[0] * residual;
114 offset_ = offset_ + K[1] * residual;
130 void OveruseEstimator::UpdateNoiseEstimate(double residual,
147 + (1 - beta) * residual;
149 + (1 - beta) * (avg_noise_ - residual) * (avg_noise_ - residual);
    [all...]
overuse_estimator.h 51 void UpdateNoiseEstimate(double residual, double ts_delta, bool stable_state);
  /external/webrtc/webrtc/common_audio/signal_processing/
min_max_operations_neon.c 77 size_t residual = length & 0x7; local
86 for (i = 0; i < length - residual; i += 8) {
110 for (i = residual; i > 0; i--) {
129 size_t residual = length & 0x7; local
137 for (i = 0; i < length - residual; i += 8) {
154 for (i = residual; i > 0; i--) {
167 size_t residual = length & 0x7; local
176 for (i = 0; i < length - residual; i += 8) {
196 for (i = residual; i > 0; i--) {
209 size_t residual = length & 0x7 local
247 size_t residual = length & 0x7; local
    [all...]
  /external/flac/libFLAC/
fixed.c 51 /* rbps stands for residual bits per sample
249 /* Estimate the expected number of bits per residual signal sample. */
250 /* 'total_error*' is linearly related to the variance of the residual */
311 /* Estimate the expected number of bits per residual signal sample. */
312 /* 'total_error*' is linearly related to the variance of the residual */
336 void FLAC__fixed_compute_residual(const FLAC__int32 data[], unsigned data_len, unsigned order, FLAC__int32 residual[])
343 FLAC__ASSERT(sizeof(residual[0]) == sizeof(data[0]));
344 memcpy(residual, data, sizeof(residual[0])*data_len);
348 residual[i] = data[i] - data[i-1]
    [all...]
lpc.c 268 void FLAC__lpc_compute_residual_from_qlp_coefficients(const FLAC__int32 * flac_restrict data, unsigned data_len, const FLAC__int32 * flac_restrict qlp_coeff, unsigned order, int lp_quantization, FLAC__int32 * flac_restrict residual)
294 *(residual++) = *(data++) - (sum >> lp_quantization);
302 residual[i] = data[i] - (sum >> lp_quantization);
337 residual[i] = data[i] - (sum >> lp_quantization);
354 residual[i] = data[i] - (sum >> lp_quantization);
372 residual[i] = data[i] - (sum >> lp_quantization);
387 residual[i] = data[i] - (sum >> lp_quantization);
405 residual[i] = data[i] - (sum >> lp_quantization);
418 residual[i] = data[i] - (sum >> lp_quantization);
432 residual[i] = data[i] - (sum >> lp_quantization)
    [all...]
  /device/google/contexthub/firmware/os/algos/common/math/
levenberg_marquardt.h 35 // Function pointer for computing residual, f(X), and Jacobian, J = df(X)/dX
43 // residual will be computed and returned.
46 float *residual, float *jacobian);
75 float residual[MAX_LM_MEAS_DIMENSION]; member in struct:LmData
103 // Function for computing residual (f(x)) and jacobian (df(x)/dx).
146 * residual: f(x) for the current state x.
154 float computeGainRatio(const float *residual, const float *residual_new,
levenberg_marquardt.c 21 float *residual, float *gradient,
83 meas_dim, data->residual,
113 // Compute new cost function residual.
117 const float gain_ratio = computeGainRatio(data->residual,
133 state_dim, meas_dim, data->residual,
155 float computeGainRatio(const float *residual, const float *residual_new,
159 // Compute true_gain = residual' residual - residual_new' residual_new.
160 const float true_gain = vecDot(residual, residual, meas_dim
    [all...]
  /external/aac/libFDK/src/
FDK_trigFcts.cpp 298 FIXP_DBL residual, error, sine, cosine; local
300 residual = fixp_sin_cos_residual_inline(x, scale, &sine, &cosine);
301 error = fMult(sine, residual);
308 FIXP_DBL residual, error, sine, cosine; local
310 residual = fixp_sin_cos_residual_inline(x, scale, &sine, &cosine);
311 error = fMult(cosine, residual);
318 FIXP_DBL residual, error0, error1, sine, cosine; local
320 residual = fixp_sin_cos_residual_inline(x, scale, &sine, &cosine);
321 error0 = fMult(sine, residual);
322 error1 = fMult(cosine, residual);
    [all...]
  /external/apache-commons-math/src/main/java/org/apache/commons/math/estimation/
AbstractEstimator.java 163 double residual = wm.getResidual(); local
164 residuals[i] = FastMath.sqrt(wm.getWeight()) * residual;
165 cost += wm.getWeight() * residual * residual;
186 double residual = wm[i].getResidual(); local
187 criterion += wm[i].getWeight() * residual * residual;
201 double residual = wm[i].getResidual(); local
202 chiSquare += residual * residual / wm[i].getWeight()
    [all...]
  /external/compiler-rt/lib/builtins/
divdf3.c 139 // In either case, we are going to compute a residual of the form
151 rep_t residual; local
153 residual = (aSignificand << 53) - quotient * bSignificand;
157 residual = (aSignificand << 52) - quotient * bSignificand;
174 const bool round = (residual << 1) > bSignificand;
divsf3.c 124 // In either case, we are going to compute a residual of the form
136 rep_t residual; local
138 residual = (aSignificand << 24) - quotient * bSignificand;
142 residual = (aSignificand << 23) - quotient * bSignificand;
159 const bool round = (residual << 1) > bSignificand;
divtf3.c 153 // In either case, we are going to compute a residual of the form
165 rep_t residual; local
170 residual = (aSignificand << 113) - qb;
175 residual = (aSignificand << 112) - qb;
190 const bool round = (residual << 1) >= bSignificand;
  /external/eigen/Eigen/src/IterativeLinearSolvers/
ConjugateGradient.h 43 VectorType residual = rhs - mat * x; //initial residual local
54 RealScalar residualNorm2 = residual.squaredNorm();
63 p = precond.solve(residual); // initial search direction
66 RealScalar absNew = numext::real(residual.dot(p)); // the square of the absolute value of r scaled by invM
74 residual -= alpha * tmp; // update residual
76 residualNorm2 = residual.squaredNorm();
80 z = precond.solve(residual); // approximately solve for "A z = residual"
    [all...]
  /development/ndk/platforms/android-21/include/linux/
virtio_blk.h 79 __u32 residual; member in struct:virtio_scsi_inhdr
  /device/google/contexthub/firmware/os/algos/calibration/common/
sphere_fit_calibration.h 137 float *residual, float *jacobian);

Completed in 462 milliseconds

1 2 3 4 5