HomeSort by relevance Sort by last modified time
    Searched defs:beta (Results 51 - 75 of 146) sorted by null

1 23 4 5 6

  /external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/interpolation/
BicubicSplineInterpolatingFunction.java 144 final double[] beta = new double[] { local
151 splines[i][j] = new BicubicSplineFunction(computeSplineCoefficients(beta));
325 * @param beta List of function values and function partial derivatives
329 private double[] computeSplineCoefficients(double[] beta) {
336 result += row[j] * beta[j];
LoessInterpolator.java 300 final double beta; local
302 beta = 0;
304 beta = (meanXY - meanX * meanY) / (meanXSquared - meanX * meanX);
307 final double alpha = meanY - beta * meanX;
309 res[i] = beta * x + alpha;
TricubicSplineInterpolatingFunction.java 258 final double[] beta = new double[] { local
300 splines[i][j][k] = new TricubicSplineFunction(computeSplineCoefficients(beta));
397 * @param beta List of function values and function partial derivatives
401 private double[] computeSplineCoefficients(double[] beta) {
409 result += row[j] * beta[j];
  /external/apache-commons-math/src/main/java/org/apache/commons/math/linear/
BiDiagonalTransformer.java 191 double beta = 0; local
193 beta -= cachedV.getEntry(i, j) * hK[i];
195 beta /= diagonal[k - diagOffset] * hK[k];
198 cachedV.addToEntry(i, j, -beta * hK[i]);
301 double beta = 0; local
303 beta -= hI[j] * hK[j];
305 beta /= b * hK[k + 1];
307 hI[j] -= beta * hK[j];
364 double beta = 0; local
367 beta -= hI[j] * hI[k]
    [all...]
TriDiagonalTransformer.java 116 double beta = 1.0 / secondary[k - 1]; local
117 cachedQt.setEntry(k, k, 1 + beta * hK[k]);
119 cachedQt.setEntry(k, i, beta * hK[i]);
122 beta = 0;
124 beta += cachedQt.getEntry(j, i) * hK[i];
126 beta *= inv;
127 cachedQt.setEntry(j, k, beta * hK[k]);
129 cachedQt.addToEntry(j, i, beta * hK[i]);
224 final double beta = -1 / (a * hK[k + 1]); local
226 // compute a = beta A v, where v is the Householder vecto
    [all...]
  /external/apache-commons-math/src/main/java/org/apache/commons/math/optimization/general/
NonLinearConjugateGradientOptimizer.java 47 /** Update formula for the beta parameter. */
64 * @param updateFormula formula to use for updating the β parameter,
177 // compute beta
185 final double beta; local
187 beta = delta / deltaOld;
193 beta = (delta - deltaMid) / deltaOld;
198 if ((getIterations() % n == 0) || (beta < 0)) {
204 searchDirection[i] = steepestDescent[i] + beta * searchDirection[i];
  /external/dng_sdk/source/
dng_matrix.cpp 967 real64 beta = temp [k] [i]; local
972 temp [k] [j] -= beta * temp [i] [j];
  /external/eigen/Eigen/src/Eigenvalues/
GeneralizedEigenSolver.h 40 * and real \f$ \beta \f$ such that: \f$ \lambda_i = \alpha_i / \beta_i \f$. If \f$ \beta_i \f$ is (nearly) zero,
219 /** \returns A const reference to the vectors containing the beta values
335 const Scalar beta = m_betas.coeffRef(i); local
343 Matrix<Scalar, 2, 1> rhs = (alpha*mT.template block<2,Dynamic>(j-1,st,2,sz) - beta*mS.template block<2,Dynamic>(j-1,st,2,sz)) .lazyProduct( v.segment(st,sz) );
344 Matrix<Scalar, 2, 2> lhs = beta * mS.template block<2,2>(j-1,j-1) - alpha * mT.template block<2,2>(j-1,j-1);
350 v.coeffRef(j) = -v.segment(st,sz).transpose().cwiseProduct(beta*mS.block(j,st,1,sz) - alpha*mT.block(j,st,1,sz)).sum() / (beta*mS.coeffRef(j,j) - alpha*mT.coeffRef(j,j));
363 // Then taking beta=T_00*T_11, we can avoid any division, and alpha is the eigenvalues of A = (U^-1 * S * U) * diag(T_11,T_00):
369 const RealScalar beta = m_betas.coeffRef(i) = m_betas.coeffRef(i+1) = a*b; local
376 const ComplexScalar alpha = ComplexScalar(S2.coeff(1,1) + p, (beta > 0) ? z : -z)
    [all...]
RealSchur.h 502 Scalar tau, beta; local
504 v.makeHouseholder(ess, tau, beta);
506 if (beta != Scalar(0)) // if v is not zero
511 m_matT.coeffRef(k,k-1) = beta;
522 Scalar tau, beta; local
524 v.makeHouseholder(ess, tau, beta);
526 if (beta != Scalar(0)) // if v is not zero
528 m_matT.coeffRef(iu-1, iu-2) = beta;
Tridiagonalization.h 359 RealScalar beta; local
361 matA.col(i).tail(remainingSize).makeHouseholderInPlace(h, beta);
375 matA.col(i).coeffRef(i+1) = beta;
483 RealScalar beta = sqrt(numext::abs2(mat(1,0)) + v1norm2); local
484 RealScalar invBeta = RealScalar(1)/beta;
490 subdiag[0] = beta;
  /external/eigen/Eigen/src/QR/
CompleteOrthogonalDecomposition.h 445 // [X(k, k), X(k, r:n)] * Z(k) = [beta, 0, .., 0].
446 RealScalar beta; local
449 .makeHouseholderInPlace(m_zCoeffs(k), beta); local
450 m_cpqr.m_qr(k, rank - 1) = beta;
HouseholderQR.h 279 RealScalar beta; local
280 mat.col(k).tail(remainingRows).makeHouseholderInPlace(hCoeffs.coeffRef(k), beta);
281 mat.coeffRef(k,k) = beta;
ColPivHouseholderQR.h 537 RealScalar beta; local
538 m_qr.col(k).tail(rows-k).makeHouseholderInPlace(m_hCoeffs.coeffRef(k), beta);
541 m_qr.coeffRef(k,k) = beta;
544 if(abs(beta) > m_maxpivot) m_maxpivot = abs(beta);
  /external/libhevc/common/
ihevc_deblk_edge_filter.c 109 WORD32 beta, tc; local
130 beta = gai4_ihevc_beta_table[beta_indx];
156 if(d < beta)
159 if((2 * d0 < (beta >> 2))
161 < (beta >> 3))
169 if((2 * d3 < (beta >> 2))
171 < (beta >> 3))
179 dep = (dp < (beta + (beta >> 1)) >> 3) ? 1 : 0;
180 deq = (dq < (beta + (beta >> 1)) >> 3) ? 1 : 0
346 WORD32 beta, tc; local
    [all...]
  /external/libopus/celt/
quant_bands.c 166 opus_val16 beta; local
173 beta = beta_intra;
175 beta = beta_coef[LM];
255 prev[c] = prev[c] + SHL32(q,7) - MULT16_16(beta,PSHR32(q,8));
433 opus_val16 beta; local
440 beta = beta_intra;
442 beta = beta_coef[LM];
487 prev[c] = prev[c] + SHL32(q,7) - MULT16_16(beta,PSHR32(q,8));
  /external/pdfium/xfa/fde/
cfde_path.cpp 47 FX_FLOAT beta = local
49 if (FXSYS_fabs(beta - alpha) > FX_PI) {
50 if (beta > alpha)
51 beta -= 2 * FX_PI;
56 FX_FLOAT half_delta = (beta - alpha) / 2;
59 FX_FLOAT sin_beta = FXSYS_sin(beta);
61 FX_FLOAT cos_beta = FXSYS_cos(beta);
  /external/speex/libspeex/
scal.c 152 float beta, beta2; local
174 beta = 1.-.3*amount*amount;
176 beta = 1-sqrt(.4*amount);
178 beta = 1-0.63246*amount;
179 if (beta<0)
180 beta = 0;
182 beta2 = beta;
185 st->y[i] = alpha*(x[i-ALLPASS_ORDER+order]-beta*x[i-ALLPASS_ORDER+order-1])*st->vorbis_win[st->frame_size+i+order]
188 - beta*ring[ringID+1>=order?0:ringID+1]);
214 float tmp = alpha*(x[i-ALLPASS_ORDER+order]-beta*x[i-ALLPASS_ORDER+order-1])*st->vorbis_win[i+order]
    [all...]
  /frameworks/av/media/libaudioprocessing/
AudioResamplerFirGen.h 319 * Note: Beta cannot exceed 15 (hence Stopband cannot exceed 144dB = 24b).
339 * This is used for Beta>15, but is disabled here as
340 * we never use Beta that high.
354 * NOT USED, but reference for large Beta.
651 // Kaiser window and beta parameter
654 // beta = | 0.5842*(A - 21)^0.4 + 0.07886*(A - 21) 21 <= A <= 50
669 const double beta = 0.1102 * (stopBandAtten - 8.7); // >= 50dB always local
672 const double yscale = atten * L / (I0(beta) * M_PI);
673 const double sqrbeta = sqr(beta);
692 // y = I0(beta * sqrt(1.0 - sqr(x * xfrac))) * yscale * sg.valueAdvance() / x
    [all...]
  /frameworks/av/media/libstagefright/codecs/on2/h264dec/omxdl/arm11/vc/m4p10/src/
armVCM4P10_DeblockingLuma_unsafe_s.s 45 beta RN 14 label
134 ;// Since beta <= 18 and alpha <= 255 we know
162 ;// if (ap < beta) tC++;
163 ;// if (aq < beta) tC++;
omxVCM4P10_FilterDeblockingChroma_HorEdge_I_s.s 56 beta RN 7 label
185 ;// Check |p1-p0|<Beta
189 USUB8 a, a, beta
192 ;// Check |q1-q0|<Beta
196 USUB8 a, a, beta
243 M_LDRD alpha, beta, pAlphaBeta0
256 ;// Since beta <= 18 and alpha <= 255 we know
322 M_LDRD alpha, beta, pAlphaBeta0
335 M_LDRD alpha, beta, pAlphaBeta1
338 M_STRD alpha, beta, pAlphaBeta
    [all...]
  /cts/tests/tests/location/src/android/location/cts/psedorange/
TroposphericModelEgnos.java 187 double beta; local
210 beta = latDegreeToBetaAvgMapKPM[INDEX_15_DEGREES] - latDegreeToBetaAmpMapKPM[INDEX_15_DEGREES]
247 beta = averageBeta - amplitudeBeta * amplitudeScalefactor;
263 beta = latDegreeToBetaAvgMapKPM[INDEX_75_DEGREES] - latDegreeToBetaAmpMapKPM[INDEX_75_DEGREES]
271 / (GM * (lambda + 1.0) - beta * RD)) * (waterVaporPressureMbar / tempKelvin));
272 double commonBase = 1.0 - ((beta * heightMetersAboveSeaLevel) / tempKelvin);
274 double powerDry = (GRAVITY_MPS2 / (RD * beta));
275 double powerWet = (((lambda + 1.0) * GRAVITY_MPS2) / (RD * beta)) - 1.0;
  /cts/tests/tests/location/src/android/location/cts/suplClient/
SuplRrlpController.java 172 double[] beta = new double[4]; local
173 beta[0] = ionoModel.getBeta0().getInteger().byteValue() * IONOSPHERIC_BETA_0_SCALE_FACTOR;
174 beta[1] = ionoModel.getBeta1().getInteger().byteValue() * IONOSPHERIC_BETA_1_SCALE_FACTOR;
175 beta[2] = ionoModel.getBeta2().getInteger().byteValue() * IONOSPHERIC_BETA_2_SCALE_FACTOR;
176 beta[3] = ionoModel.getBeta3().getInteger().byteValue() * IONOSPHERIC_BETA_3_SCALE_FACTOR;
177 ionosphericModelProto.beta = beta;
  /external/ImageMagick/MagickCore/
compare.c 1189 beta; local
1220 beta; local
    [all...]
gem.c 1047 beta; local
1469 beta, local
1599 beta, local
1640 beta, local
    [all...]
  /external/eigen/Eigen/src/Cholesky/
LLT.h 269 RealScalar beta = 1; local
276 RealScalar gamma = dj*beta + swj2;
278 RealScalar x = dj + swj2/beta;
283 beta += swj2/dj;

Completed in 541 milliseconds

1 23 4 5 6