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

1 2

  /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 163 double rho[3]; local
164 loss_function_->Evaluate(squared_norm, rho);
165 *cost = 0.5 * rho[0];
175 Corrector correct(squared_norm, rho);
conjugate_gradients_solver.cc 111 double rho = 1.0; local
127 double last_rho = rho;
128 rho = r.dot(z);
129 if (IsZeroOrInfinity(rho)) {
131 summary.message = StringPrintf("Numerical failure. rho = r'z = %e.", rho);
138 double beta = rho / last_rho;
158 const double alpha = rho / pq;
162 StringPrintf("Numerical failure. alpha = rho / pq = %e", alpha);
  /external/chromium_org/third_party/mesa/src/src/mesa/drivers/dri/i965/
brw_lower_texture_gradients.cpp 127 /* Calculate rho from equation 3.20 of the GL 3.0 specification. */
128 ir_rvalue *rho; local
130 rho = expr(ir_binop_max, expr(ir_unop_abs, dPdx),
133 rho = expr(ir_binop_max, expr(ir_unop_sqrt, dot(dPdx, dPdx)),
137 /* lambda_base = log2(rho). We're ignoring GL state biases for now. */
139 ir->lod_info.lod = expr(ir_unop_log2, rho);
  /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/mesa3d/src/mesa/drivers/dri/i965/
brw_lower_texture_gradients.cpp 127 /* Calculate rho from equation 3.20 of the GL 3.0 specification. */
128 ir_rvalue *rho; local
130 rho = expr(ir_binop_max, expr(ir_unop_abs, dPdx),
133 rho = expr(ir_binop_max, expr(ir_unop_sqrt, dot(dPdx, dPdx)),
137 /* lambda_base = log2(rho). We're ignoring GL state biases for now. */
139 ir->lod_info.lod = expr(ir_unop_log2, rho);
  /external/bouncycastle/bcprov/src/main/java/org/bouncycastle/math/ec/
WTauNafMultiplier.java 34 ZTauElement rho = Tnaf.partModReduction(k, m, a, s, mu, (byte)10); local
36 return multiplyWTnaf(p, rho, curve.getPreCompInfo(p), a, mu);
Tnaf.java 590 * @return <code>&rho; := k partmod (&tau;<sup>m</sup> - 1)/(&tau; - 1)</code>
642 ZTauElement rho = partModReduction(k, m, a, s, mu, (byte)10); local
644 return multiplyTnaf(p, rho);
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
ConstrainedConjGrad.h 58 Scalar rho, rho_1, alpha; local
67 rho = 1.0;
72 while (rho >= 1e-38)
77 alpha = rho / p.dot(q);
80 rho_1 = rho;
81 rho = r.dot(r);
82 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
  /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/chromium_org/third_party/webrtc/modules/audio_coding/codecs/isac/main/source/
filter_functions.c 133 double rho=0.9, *inp, *dp, *dp2; local
170 WebRtcIsac_BwExpand(apolr, apol, rho, PITCH_WLPCORDER+1);
  /external/eigen/Eigen/src/IterativeLinearSolvers/
BiCGSTAB.h 53 Scalar rho = 1; local
70 Scalar rho_old = rho;
72 rho = r0.dot(r);
73 if (abs(rho) < eps2*r0_sqnorm)
78 rho = r0_sqnorm = r.squaredNorm();
82 Scalar beta = (rho/rho_old) * (alpha / w);
89 alpha = rho / r0.dot(v);
  /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 524 Scalar rho = sqrt(-a_over_3); local
528 roots(0) = c2_over_3 + Scalar(2)*rho*cos_theta;
529 roots(1) = c2_over_3 - rho*(cos_theta + s_sqrt3*sin_theta);
530 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/chromium_org/third_party/mesa/src/src/gallium/auxiliary/gallivm/
lp_bld_sample.c 178 * Generate code to compute coordinate gradient (rho).
181 * The resulting rho is scalar per quad.
203 LLVMValueRef rho; local
289 rho = rho_vec;
306 rho = lp_build_max(coord_bld, rho_s, rho_t);
314 rho = lp_build_max(coord_bld, rho, rho_r);
318 rho = lp_build_pack_aos_scalars(bld->gallivm, coord_bld->type,
319 perquadf_bld->type, rho);
328 rho = rho_vec
523 LLVMValueRef rho; local
    [all...]
  /external/chromium_org/third_party/mesa/src/src/mesa/swrast/
s_span.c 424 GLfloat rho = MAX2(x, y); local
425 GLfloat lambda = LOG2(rho);
444 GLfloat maxU, maxV, rho, lambda;
451 rho = MAX2(maxU, maxV);
452 lambda = LOG2(rho);
    [all...]
  /external/mesa3d/src/gallium/auxiliary/gallivm/
lp_bld_sample.c 178 * Generate code to compute coordinate gradient (rho).
181 * The resulting rho is scalar per quad.
203 LLVMValueRef rho; local
289 rho = rho_vec;
306 rho = lp_build_max(coord_bld, rho_s, rho_t);
314 rho = lp_build_max(coord_bld, rho, rho_r);
318 rho = lp_build_pack_aos_scalars(bld->gallivm, coord_bld->type,
319 perquadf_bld->type, rho);
328 rho = rho_vec
523 LLVMValueRef rho; local
    [all...]
  /external/mesa3d/src/mesa/swrast/
s_span.c 424 GLfloat rho = MAX2(x, y); local
425 GLfloat lambda = LOG2(rho);
444 GLfloat maxU, maxV, rho, lambda;
451 rho = MAX2(maxU, maxV);
452 lambda = LOG2(rho);
    [all...]
  /external/chromium_org/third_party/mesa/src/src/gallium/drivers/softpipe/
sp_tex_sample.c 496 float rho = MAX2(dsdx, dsdy) * u_minify(texture->width0, samp->view->u.tex.first_level); local
498 return util_fast_log2(rho);
515 float rho = MAX2(maxx, maxy); local
517 return util_fast_log2(rho);
537 float rho; local
539 rho = MAX2(maxx, maxy);
540 rho = MAX2(rho, maxz);
542 return util_fast_log2(rho);
    [all...]

Completed in 674 milliseconds

1 2