/external/aac/libFDK/include/ |
H A D | 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, error local [all...] |
/external/ceres-solver/examples/ |
H A D | powell.cc | 61 T* residual) const { 63 residual[0] = x1[0] + T(10.0) * x2[0]; 71 T* residual) const { 73 residual[0] = T(sqrt(5.0)) * (x3[0] - x4[0]); 81 T* residual) const { 83 residual[0] = (x2[0] - T(2.0) * x4[0]) * (x2[0] - T(2.0) * x4[0]); 91 T* residual) const { 93 residual[0] = T(sqrt(10.0)) * (x1[0] - x4[0]) * (x1[0] - x4[0]); 111 // Add residual terms to the problem using the using the autodiff
|
H A D | helloworld.cc | 45 // A templated cost functor that implements the residual r = 10 - 50 template <typename T> bool operator()(const T* const x, T* residual) const { 51 residual[0] = T(10.0) - x[0]; 67 // Set up the only cost function (also known as residual). This uses
|
H A D | helloworld_numeric_diff.cc | 44 // A cost functor that implements the residual r = 10 - x. 46 bool operator()(const double* const x, double* residual) const { 47 residual[0] = 10.0 - x[0]; 63 // Set up the only cost function (also known as residual). This uses
|
H A D | quadratic_auto_diff.cc | 47 // A templated cost functor that implements the residual r = 10 - 53 template <typename T> bool operator()(const T* const x, T* residual) const { 54 residual[0] = T(10.0) - x[0]; 70 // Set up the only cost function (also known as residual). This uses
|
H A D | quadratic_numeric_diff.cc | 46 // A cost functor that implements the residual r = 10 - x. 49 bool operator()(const double* const x, double* residual) const { 50 residual[0] = 10.0 - x[0]; 63 // Set up the only cost function (also known as residual). This uses
|
H A D | circle_fit.cc | 71 // The cost for a single sample. The returned residual is related to the 82 T* residual) const { 92 // residual[0] = r - sqrt(xp*xp + yp*yp); 100 residual[0] = r*r - xp*xp - yp*yp;
|
H A D | curve_fitting.cc | 127 T* residual) const { 128 residual[0] = T(y_) - exp(m[0] * T(x_) + c[0]);
|
H A D | data_fitting.cc | 128 T* residual) const { 129 residual[0] = T(y_) - exp(m[0] * T(x_) + c[0]);
|
H A D | robust_curve_fitting.cc | 129 T* residual) const { 130 residual[0] = T(y_) - exp(m[0] * T(x_) + c[0]);
|
/external/flac/libFLAC/include/private/ |
H A D | lpc.h | 130 * Compute the residual signal obtained from sutracting the predicted 138 * OUT residual[0,data_len-1] residual signal 140 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[]); 141 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[]); 145 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[]); 146 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[]); 156 * Restore the original signal by summing the residual and the 159 * IN residual[0,data_len-1] residual signa [all...] |
H A D | fixed.h | 46 * of the residual signal for each order. The _wide() version uses 72 * Compute the residual signal obtained from sutracting the predicted 78 * OUT residual[0,data_len-1] residual signal 80 void FLAC__fixed_compute_residual(const FLAC__int32 data[], unsigned data_len, unsigned order, FLAC__int32 residual[]); 85 * Restore the original signal by summing the residual and the 88 * IN residual[0,data_len-1] residual signal 95 void FLAC__fixed_restore_signal(const FLAC__int32 residual[], unsigned data_len, unsigned order, FLAC__int32 data[]);
|
/external/flac/libFLAC/ |
H A D | fixed.c | 58 /* 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 D | lpc.c | 265 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 D | stream_encoder_framing.c | 48 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]))
|
/external/aac/libFDK/src/ |
H A D | 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/compiler-rt/lib/ |
H A D | divdf3.c | 138 // In either case, we are going to compute a residual of the form 150 rep_t residual; local 152 residual = (aSignificand << 53) - quotient * bSignificand; 156 residual = (aSignificand << 52) - quotient * bSignificand; 173 const bool round = (residual << 1) > bSignificand;
|
H A D | divsf3.c | 123 // In either case, we are going to compute a residual of the form 135 rep_t residual; local 137 residual = (aSignificand << 24) - quotient * bSignificand; 141 residual = (aSignificand << 23) - quotient * bSignificand; 158 const bool round = (residual << 1) > bSignificand;
|
/external/ceres-solver/internal/ceres/ |
H A D | autodiff_test.cc | 517 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...] |
H A D | gradient_checking_cost_function_test.cc | 149 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 D | levenberg_marquardt_strategy_test.cc | 121 double residual = 1.0; local 152 lms.ComputeStep(pso, &dsm, &residual, x);
|
H A D | system_test.cc | 166 // solutions by comparing their residual vectors. We do not 179 << "Not close enough residual:" << j 237 T* residual) const { 239 *residual = *x1 + T(10.0) * *x2; 248 T* residual) const { 250 *residual = T(sqrt(5.0)) * (*x3 - *x4); 259 T* residual) const { 261 residual[0] = (x2[0] - T(2.0) * x4[0]) * (x2[0] - T(2.0) * x4[0]); 270 T* residual) const { 272 residual[ [all...] |
/external/eigen/Eigen/src/IterativeLinearSolvers/ |
H A D | ConjugateGradient.h | 43 VectorType residual = rhs - mat * x; //initial residual local 46 p = precond.solve(residual); //initial search direction 49 RealScalar absNew = internal::real(residual.dot(p)); // the square of the absolute value of r scaled by invM 60 residual -= alpha * tmp; // update residue 62 residualNorm2 = residual.squaredNorm(); 66 z = precond.solve(residual); // approximately solve for "A z = residual" 69 absNew = internal::real(residual.dot(z)); // update the absolute value of r
|
/external/chromium_org/net/quic/congestion_control/ |
H A D | inter_arrival_overuse_detector.h | 127 // Update the estimate with this residual. 128 void UpdateDeltaEstimate(QuicTime::Delta residual);
|
H A D | inter_arrival_overuse_detector.cc | 135 QuicTime::Delta residual) { 137 int64 residual_us = residual.ToMicroseconds(); 134 UpdateDeltaEstimate( QuicTime::Delta residual) argument
|