Searched defs:residual (Results 1 - 25 of 26) sorted by relevance

12

/external/chromium_org/third_party/webrtc/modules/audio_coding/codecs/ilbc/
H A Dstate_search.c32 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);
27 WebRtcIlbcfix_StateSearch( iLBC_Enc_Inst_t *iLBCenc_inst, iLBC_bits *iLBC_encbits, int16_t *residual, int16_t *syntDenum, int16_t *weightDenum ) argument
H A Dencode.c56 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[inde
[all...]
/external/compiler-rt/lib/builtins/
H A Ddivsf3.c124 // 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;
H A Ddivdf3.c139 // 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;
H A Ddivtf3.c153 // 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/ceres-solver/internal/ceres/
H A Dlevenberg_marquardt_strategy_test.cc121 double residual = 1.0; local
152 lms.ComputeStep(pso, &dsm, &residual, x);
H A Dgradient_checking_cost_function_test.cc149 double residual; local
154 // Since residual is one dimensional the jacobians have the same
174 &residual,
176 EXPECT_EQ(original_residual, residual);
205 double residual; local
208 // Since residual is one dimensional the jacobians have the same size as the
233 &residual,
251 &residual,
H A Dautodiff_test.cc517 double residual = 0; local
532 functor, parameters, 1, &residual, jacobians)));
533 EXPECT_EQ(residual, pow(2, num_variables + 1) - 2);
543 functor, parameters, 1, &residual, jacobians)));
544 EXPECT_EQ(residual, pow(2, num_variables + 1) - 2);
554 functor, parameters, 1, &residual, jacobians)));
555 EXPECT_EQ(residual, pow(2, num_variables + 1) - 2);
565 functor, parameters, 1, &residual, jacobians)));
566 EXPECT_EQ(residual, pow(2, num_variables + 1) - 2);
576 functor, parameters, 1, &residual, jacobian
[all...]
/external/chromium_org/third_party/webrtc/system_wrappers/source/
H A Dtimestamp_extrapolator.cc106 double residual = local
109 if (DelayChangeDetection(residual) &&
127 _w[0] = _w[0] + K[0] * residual;
128 _w[1] = _w[1] + K[1] * residual;
/external/aac/libFDK/include/
H A DFDK_trigFcts.h142 * 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, error local
[all...]
/external/aac/libFDK/src/
H A DFDK_trigFcts.cpp298 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/ceres-solver/examples/
H A Dmore_garbow_hillstrom.cc79 bool operator()(const T* const x, T* residual) const {
87 residual[0] = T(10.0) * (x2 - x1 * x1); member in namespace:ceres::examples
88 residual[1] = T(1.0) - x1; member in namespace:ceres::examples
102 residual[0] = T(-13.0) + x1 + ((T(5.0) - x2) * x2 - T(2.0)) * x2; member in namespace:ceres::examples
103 residual[1] = T(-29.0) + x1 + ((x2 + T(1.0)) * x2 - T(14.0)) * x2; member in namespace:ceres::examples
117 residual[0] = T(10000.0) * x1 * x2 - T(1.0); member in namespace:ceres::examples
118 residual[1] = exp(-x1) + exp(-x2) - T(1.0001); member in namespace:ceres::examples
131 residual[0] = x1 - T(1000000.0); member in namespace:ceres::examples
132 residual[1] = x2 - T(0.000002); member in namespace:ceres::examples
133 residual[ member in namespace:ceres::examples
146 residual[0] = T(1.5) - x1 * (T(1.0) - x2); member in namespace:ceres::examples
147 residual[1] = T(2.25) - x1 * (T(1.0) - x2 * x2); member in namespace:ceres::examples
148 residual[2] = T(2.625) - x1 * (T(1.0) - x2 * x2 * x2); member in namespace:ceres::examples
182 residual[0] = T(10.0) * (x3 - T(10.0) * theta); member in namespace:ceres::examples
183 residual[1] = T(10.0) * (sqrt(x1 * x1 + x2 * x2) - T(1.0)); member in namespace:ceres::examples
184 residual[2] = x3; member in namespace:ceres::examples
[all...]
/external/eigen/test/
H A Djacobisvd.cpp91 RealScalar residual = (m*x-rhs).norm(); local
93 if(!test_isMuchSmallerThan(residual,rhs.norm()))
95 // If the residual is very small, then we have an exact solution, so we are already good.
101 VERIFY( test_isApprox(residual_y,residual) || residual < residual_y );
105 VERIFY( test_isApprox(residual_y,residual) || residual < residual_y );
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DIterationController.h77 double m_resmax; ///< maximum residual
80 double m_res; ///< last computed residual
108 double residual() const { return m_res; } function in class:Eigen::IterationController
/external/flac/libFLAC/
H A Dfixed.c58 /* rbps stands for residual bits per sample
256 /* Estimate the expected number of bits per residual signal sample. */
257 /* 'total_error*' is linearly related to the variance of the residual */
318 /* Estimate the expected number of bits per residual signal sample. */
319 /* 'total_error*' is linearly related to the variance of the residual */
352 void FLAC__fixed_compute_residual(const FLAC__int32 data[], unsigned data_len, unsigned order, FLAC__int32 residual[]) argument
359 FLAC__ASSERT(sizeof(residual[0]) == sizeof(data[0]));
360 memcpy(residual, data, sizeof(residual[0])*data_len);
364 residual[
395 FLAC__fixed_restore_signal(const FLAC__int32 residual[], unsigned data_len, unsigned order, FLAC__int32 data[]) argument
[all...]
H A Dlpc.c265 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[]) argument
296 *(residual++) = *(data++) - (sum >> lp_quantization);
304 residual[i] = data[i] - (sum >> lp_quantization);
339 residual[i] = data[i] - (sum >> lp_quantization);
356 residual[i] = data[i] - (sum >> lp_quantization);
374 residual[i] = data[i] - (sum >> lp_quantization);
389 residual[i] = data[i] - (sum >> lp_quantization);
407 residual[i] = data[i] - (sum >> lp_quantization);
420 residual[i] = data[i] - (sum >> lp_quantization);
434 residual[
531 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[]) argument
795 FLAC__lpc_restore_signal(const FLAC__int32 residual[], unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 data[]) argument
1063 FLAC__lpc_restore_signal_wide(const FLAC__int32 residual[], unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 data[]) argument
[all...]
H A Dstream_encoder_framing.c48 static FLAC__bool add_residual_partitioned_rice_(FLAC__BitWriter *bw, const FLAC__int32 residual[], const unsigned residual_samples, const unsigned predictor_order, const unsigned rice_parameters[], const unsigned raw_bits[], const unsigned partition_order, const FLAC__bool is_extended);
400 subframe->residual,
446 subframe->residual,
497 FLAC__bool add_residual_partitioned_rice_(FLAC__BitWriter *bw, const FLAC__int32 residual[], const unsigned residual_samples, const unsigned predictor_order, const unsigned rice_parameters[], const unsigned raw_bits[], const unsigned partition_order, const FLAC__bool is_extended) argument
508 if(!FLAC__bitwriter_write_rice_signed_block(bw, residual, residual_samples, rice_parameters[0]))
518 if(!FLAC__bitwriter_write_raw_int32(bw, residual[i], raw_bits[0]))
536 if(!FLAC__bitwriter_write_rice_signed_block(bw, residual+k_last, k-k_last, rice_parameters[i]))
545 if(!FLAC__bitwriter_write_raw_int32(bw, residual[j], raw_bits[i]))
H A Dstream_decoder.c125 static FLAC__bool read_residual_partitioned_rice_(FLAC__StreamDecoder *decoder, unsigned predictor_order, unsigned partition_order, FLAC__EntropyCodingMethod_PartitionedRiceContents *partitioned_rice_contents, FLAC__int32 *residual, FLAC__bool is_extended);
163 void (*local_lpc_restore_signal)(const FLAC__int32 residual[], unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 data[]);
165 void (*local_lpc_restore_signal_64bit)(const FLAC__int32 residual[], unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 data[]);
167 void (*local_lpc_restore_signal_16bit)(const FLAC__int32 residual[], unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 data[]);
169 void (*local_lpc_restore_signal_16bit_order8)(const FLAC__int32 residual[], unsigned data_len, const FLAC__int32 qlp_coeff[], unsigned order, int lp_quantization, FLAC__int32 data[]);
175 FLAC__int32 *residual[FLAC__MAX_CHANNELS]; /* WATCHOUT: these are the aligned pointers; the real pointers that should be free()'d are residual_unaligned[] below */ member in struct:FLAC__StreamDecoderPrivate
323 decoder->private_->residual_unaligned[i] = decoder->private_->residual[i] = 0;
703 decoder->private_->residual_unaligned[i] = decoder->private_->residual[i] = 0;
1324 decoder->private_->residual_unaligned[i] = decoder->private_->residual[i] = 0;
1346 if(!FLAC__memory_alloc_aligned_int32_array(size, &decoder->private_->residual_unaligned[i], &decoder->private_->residual[
2700 FLAC__int32 x, *residual = decoder->private_->residual[channel]; local
2720 read_residual_partitioned_rice_(FLAC__StreamDecoder *decoder, unsigned predictor_order, unsigned partition_order, FLAC__EntropyCodingMethod_PartitionedRiceContents *partitioned_rice_contents, FLAC__int32 *residual, FLAC__bool is_extended) argument
[all...]
/external/chromium_org/third_party/webrtc/modules/remote_bitrate_estimator/
H A Doveruse_detector.cc182 const double residual = t_ts_delta - slope_*h[0] - offset_; local
188 if (fabs(residual) < 3 * sqrt(var_noise_)) {
189 UpdateNoiseEstimate(residual, min_frame_period, stable_state);
215 slope_ = slope_ + K[0] * residual;
217 offset_ = offset_ + K[1] * residual;
236 void OveruseDetector::UpdateNoiseEstimate(double residual, argument
253 + (1 - beta) * residual;
255 + (1 - beta) * (avg_noise_ - residual) * (avg_noise_ - residual);
/external/eigen/Eigen/src/IterativeLinearSolvers/
H A DConjugateGradient.h43 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 residue
76 residualNorm2 = residual.squaredNorm();
80 z = precond.solve(residual); // approximately solve for "A z = residual"
83 absNew = numext::real(residual
[all...]
/external/kernel-headers/original/uapi/linux/
H A Dvirtio_blk.h123 __u32 residual; member in struct:virtio_scsi_inhdr
/external/chromium_org/third_party/mesa/src/src/gallium/auxiliary/vl/
H A Dvl_mpeg12_bitstream.c639 int residual = vl_vlc_get_uimsbf(&bs->vlc, r_size) + 1; local
640 delta[t] = ((abs(motion_code) - 1) << r_size) + residual;
/external/mesa3d/src/gallium/auxiliary/vl/
H A Dvl_mpeg12_bitstream.c639 int residual = vl_vlc_get_uimsbf(&bs->vlc, r_size) + 1; local
640 delta[t] = ((abs(motion_code) - 1) << r_size) + residual;
/external/chromium_org/third_party/WebKit/Source/platform/graphics/gpu/
H A DWebGLImageConversion.cpp1515 unsigned residual = validRowSize % alignment; local
1516 if (residual) {
1517 padding = alignment - residual;
/external/flac/include/FLAC/
H A Dformat.h211 /** Contents of a Rice partitioned residual
230 /** Header for a Rice partitioned residual. (c.f. <A HREF="../format.html#partitioned_rice">format specification</A>)
252 /** Header for the entropy coding method. (c.f. <A HREF="../format.html#residual">format specification</A>)
299 /**< The residual coding method. */
307 const FLAC__int32 *residual; member in struct:__anon21465
308 /**< The residual signal, length == (blocksize minus order) samples. */
316 /**< The residual coding method. */
333 const FLAC__int32 *residual; member in struct:__anon21466
334 /**< The residual signal, length == (blocksize minus order) samples. */

Completed in 391 milliseconds

12