HomeSort by relevance Sort by last modified time
    Searched defs:rho (Results 1 - 22 of 22) sorted by null

  /bionic/libm/upstream-freebsd/lib/msun/src/
s_ctanh.c 41 * rho = cosh(x)
55 * beta rho s + i t
78 double t, beta, s, rho, denom; local
132 rho = sqrt(1 + s * s); /* = cosh(x) */
134 return (cpack((beta * rho * s) / denom, t / denom));
s_ctanhf.c 43 float t, beta, s, rho, denom; local
72 rho = sqrtf(1 + s * s);
74 return (cpackf((beta * rho * s) / denom, t / denom));
  /external/ceres-solver/internal/ceres/
corrector_test.cc 44 // If rho[1] is zero, the Corrector constructor should crash.
51 // If rho[1] is negative, the Corrector constructor should crash.
65 // In light of the rho'' < 0 clamping now implemented in
66 // corrector.cc, alpha = 0 whenever rho'' < 0.
121 // rho[2] < 0 -> alpha = 0.0
130 // sqrt(rho[1]) * (1 - alpha) * J.
148 double rho[3]; local
178 rho[0] = sq_norm;
179 rho[1] = RandDouble();
180 rho[2] = 2.0 * RandDouble() - 1.0
216 double rho[3]; local
    [all...]
loss_function_test.cc 44 // Compares the values of rho'(s) and rho''(s) computed by the
46 // of rho(s).
50 // Evaluate rho(s), rho'(s) and rho''(s).
51 double rho[3]; local
52 loss.Evaluate(s, rho);
54 // Use symmetric finite differencing to estimate rho'(s) and
55 // rho''(s)
122 double rho[3]; local
200 double rho[3]; local
    [all...]
residual_block.cc 160 double rho[3]; local
161 loss_function_->Evaluate(squared_norm, rho);
162 *cost = 0.5 * rho[0];
172 Corrector correct(squared_norm, rho);
conjugate_gradients_solver.cc 110 double rho = 1.0; local
128 double last_rho = rho;
129 rho = r.dot(z);
131 if (IsZeroOrInfinity(rho)) {
132 LOG(ERROR) << "Numerical failure. rho = " << rho;
140 double beta = rho / last_rho;
160 double alpha = rho / pq;
  /external/iproute2/netem/
stats.c 24 double mu=0.0, sigma=0.0, sumsquare=0.0, sum=0.0, top=0.0, rho=0.0; local
51 rho = top/sigma2;
55 printf("rho = %12.6f\n", rho);
57 /*printf("correlation rho = %10.6f\n", top/((double)(n-1)*sigma*sigma));*/
maketable.c 51 arraystats(double *x, int limit, double *mu, double *sigma, double *rho)
70 *rho = top/sigma2;
200 double mu, sigma, rho; local
219 arraystats(x, limit, &mu, &sigma, &rho);
221 fprintf(stderr, "%d values, mu %10.4f, sigma %10.4f, rho %10.4f\n",
222 limit, mu, sigma, rho);
  /external/bouncycastle/bcprov/src/main/java/org/bouncycastle/math/ec/
WTauNafMultiplier.java 35 ZTauElement rho = Tnaf.partModReduction(k, m, a, s, mu, (byte)10); local
37 return multiplyWTnaf(p, rho, preCompInfo, a, mu);
Tnaf.java 604 * @return <code>&rho; := k partmod (&tau;<sup>m</sup> - 1)/(&tau; - 1)</code>
656 ZTauElement rho = partModReduction(k, m, a, s, mu, (byte)10); local
658 return multiplyTnaf(p, rho);
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
ConstrainedConjGrad.h 62 Scalar rho, rho_1, alpha; local
69 rho = 1.0;
74 while (rho >= 1e-38)
79 alpha = rho / p.dot(q);
82 rho_1 = rho;
83 rho = r.dot(r);
84 p = (rho/rho_1) * p + r;
114 Scalar rho = 1.0, rho_1, lambda, gamma; local
157 rho_1 = rho;
158 rho = r.dot(z)
    [all...]
  /external/opencv/cv/src/
_cvlist.h 367 float rho, theta; member in struct:__index
cvhough.cpp 64 float rho; member in struct:CvLinePolar
78 rho and theta are discretization steps (in pixels and radians correspondingly).
81 array of (rho, theta) pairs. linesMax is the buffer size (number of pairs).
85 icvHoughLinesStandard( const CvMat* img, float rho, float theta,
104 float irho = 1 / rho;
115 numrho = cvRound(((width + height) * 2 + 1) / rho);
165 line.rho = (r - (numrho - 1)*0.5f) * rho;
192 float rho, float theta, int threshold,
211 int rn, tn; /* number of rho and theta discrete values *
    [all...]
cvimgwarp.cpp 2178 int phi, rho; local
2237 double rho = bufp.data.fl[x]*M; local
    [all...]
  /external/eigen/Eigen/src/IterativeLinearSolvers/
BiCGSTAB.h 46 Scalar rho = 1; local
61 Scalar rho_old = rho;
63 rho = r0.dot(r);
64 if (rho == Scalar(0)) return false; /* New search directions cannot be found */
65 Scalar beta = (rho/rho_old) * (alpha / w);
72 alpha = rho / r0.dot(v);
  /external/eigen/bench/
eig33.cpp 76 Scalar rho = internal::sqrt(-a_over_3); local
80 roots(0) = c2_over_3 + Scalar(2)*rho*cos_theta;
81 roots(1) = c2_over_3 - rho*(cos_theta + s_sqrt3*sin_theta);
82 roots(2) = c2_over_3 - rho*(cos_theta - s_sqrt3*sin_theta);
  /external/webrtc/src/modules/audio_coding/codecs/isac/main/source/
filter_functions.c 132 double rho=0.9, *inp, *dp, *dp2; local
169 WebRtcIsac_BwExpand(apolr, apol, rho, PITCH_WLPCORDER+1);
  /external/eigen/Eigen/src/Eigenvalues/
SelfAdjointEigenSolver.h 522 Scalar rho = sqrt(-a_over_3); local
526 roots(0) = c2_over_3 + Scalar(2)*rho*cos_theta;
527 roots(1) = c2_over_3 - rho*(cos_theta + s_sqrt3*sin_theta);
528 roots(2) = c2_over_3 - rho*(cos_theta - s_sqrt3*sin_theta);
  /external/openssl/crypto/bn/
bn_gf2m.c 942 BIGNUM *a, *z, *rho, *w, *w2, *tmp; local
982 rho = BN_CTX_get(ctx);
988 if (!BN_rand(rho, p[0], 0, 0)) goto err;
989 if (!BN_GF2m_mod_arr(rho, rho, p)) goto err;
991 if (!BN_copy(w, rho)) goto err;
998 if (!BN_GF2m_add(w, w2, rho)) goto err;
  /external/opencv/ml/include/
ml.h 382 double rho; member in struct:CvSVMSolutionInfo
393 typedef void (CvSVMSolver::*CalcRho)( double& rho, double& r );
463 virtual void calc_rho( double& rho, double& r );
464 virtual void calc_rho_nu_svm( double& rho, double& r );
474 double rho; member in struct:CvSVMDecisionFunc
532 CvMemStorage* _storage, double* alpha, double& rho );
    [all...]
  /prebuilts/devtools/tools/lib/
bcprov-jdk15on-1.48.jar 
  /prebuilts/tools/common/m2/repository/org/bouncycastle/bcprov-jdk15on/1.48/
bcprov-jdk15on-1.48.jar 

Completed in 313 milliseconds