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

1 2 3

  /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
133 rho = sqrt(1 + s * s); /* = cosh(x) */
135 return (CMPLX((beta * rho * s) / denom, t / denom));
s_ctanhf.c 43 float t, beta, s, rho, denom; local
73 rho = sqrtf(1 + s * s);
75 return (CMPLXF((beta * rho * s) / denom, t / denom));
  /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;
202 double mu, sigma, rho; local
221 arraystats(x, limit, &mu, &sigma, &rho);
223 fprintf(stderr, "%d values, mu %10.4f, sigma %10.4f, rho %10.4f\n",
224 limit, mu, sigma, rho);
  /external/bouncycastle/bcprov/src/main/java/org/bouncycastle/math/ec/
WTauNafMultiplier.java 37 ZTauElement rho = Tnaf.partModReduction(k, m, a, s, mu, (byte)10); local
39 return multiplyWTnaf(p, rho, curve.getPreCompInfo(p, PRECOMP_NAME), a, mu);
Tnaf.java 609 * @return <code>&rho; := k partmod (&tau;<sup>m</sup> - 1)/(&tau; - 1)</code>
661 ZTauElement rho = partModReduction(k, m, (byte)a, s, mu, (byte)10); local
663 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
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/apache-commons-math/src/main/java/org/apache/commons/math/optimization/direct/
NelderMead.java 36 private final double rho; field in class:NelderMead
48 * <p>The default coefficients are 1.0 for rho, 2.0 for khi and 0.5
52 this.rho = 1.0;
59 * @param rho reflection coefficient
64 public NelderMead(final double rho, final double khi,
66 this.rho = rho;
105 xR[j] = centroid[j] + rho * (centroid[j] - xWorst[j]);
  /external/eigen/Eigen/src/IterativeLinearSolvers/
BiCGSTAB.h 52 Scalar rho = 1; local
69 Scalar rho_old = rho;
71 rho = r0.dot(r);
72 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/eigen/bench/
eig33.cpp 76 Scalar rho = std::sqrt(-a_over_3); local
80 roots(2) = c2_over_3 + Scalar(2)*rho*cos_theta;
81 roots(0) = c2_over_3 - rho*(cos_theta + s_sqrt3*sin_theta);
82 roots(1) = c2_over_3 - rho*(cos_theta - s_sqrt3*sin_theta);
  /external/tensorflow/tensorflow/core/kernels/
training_ops_test.cc 216 auto rho = Scalar(g, 0.9); local
221 {var, ms, mom, lr, rho, momentum, epsilon, grad});
training_ops.cc 72 typename TTypes<T>::ConstScalar rho,
76 accum * rho() + grad.square() * (static_cast<T>(1) - rho());
81 accum_update * rho() + update.square() * (static_cast<T>(1) - rho());
336 typename TTypes<T>::ConstScalar rho,
340 ms.device(d) += (grad.square() - ms) * (static_cast<T>(1) - rho());
353 typename TTypes<T>::ConstScalar rho,
357 ms.device(d) += (grad.square() - ms) * (static_cast<T>(1) - rho());
358 mg.device(d) += (grad - mg) * (static_cast<T>(1) - rho());
585 const Tensor& rho = ctx->input(4); local
626 const Tensor& rho = ctx->input(4); local
739 const Tensor& rho = ctx->input(4); local
2775 const Tensor& rho = ctx->input(4); variable
2864 const Tensor& rho = ctx->input(5); variable
3015 const Tensor& rho = ctx->input(4); variable
3147 const Tensor& rho = ctx->input(5); variable
    [all...]
  /external/webrtc/webrtc/modules/audio_coding/codecs/isac/main/source/
filter_functions.c 139 double rho=0.9, *inp, *dp, *dp2; local
176 WebRtcIsac_BwExpand(apolr, apol, rho, PITCH_WLPCORDER+1);
  /external/webrtc/webrtc/modules/audio_processing/intelligibility/
intelligibility_enhancer.h 48 rho(0.02f) {}
57 float rho; member in struct:webrtc::IntelligibilityEnhancer::Config
  /external/ImageMagick/MagickCore/
geometry.h 105 rho, member in struct:_GeometryInfo
  /external/tensorflow/tensorflow/compiler/tf2xla/kernels/
training_ops.cc 274 errors::InvalidArgument("rho is not a scalar: ",
301 xla::ComputationDataHandle rho = ctx->Input(4); variable
306 // ms <- rho * ms_{t-1} + (1-rho) * grad * grad
312 // ms <- ms + (grad**2 - ms) * (1 - rho)
316 // ms <- ms + grad**2 - rho * grad ** 2 - ms + ms * rho
320 // ms <- grad**2 (1 - rho) + ms * rho
326 b->Sub(XlaHelpers::FloatLiteral(b, type, 1.0), rho)));
    [all...]
  /external/eigen/Eigen/src/Eigenvalues/
SelfAdjointEigenSolver.h 595 Scalar rho = sqrt(a_over_3); local
600 roots(0) = c2_over_3 - rho*(cos_theta + s_sqrt3*sin_theta); // == 2*rho*cos(theta+2pi/3)
601 roots(1) = c2_over_3 - rho*(cos_theta - s_sqrt3*sin_theta); // == 2*rho*cos(theta+ pi/3)
602 roots(2) = c2_over_3 + Scalar(2)*rho*cos_theta;
    [all...]
  /external/mesa3d/src/compiler/nir/
nir_lower_tex.c 540 nir_ssa_def *rho; local
542 rho = nir_fmax(b, nir_fabs(b, dPdx), nir_fabs(b, dPdy));
544 rho = nir_fmax(b,
549 /* lod = log2(rho). We're ignoring GL state biases for now. */
550 nir_ssa_def *lod = nir_flog2(b, rho);
  /external/mesa3d/src/mesa/swrast/
s_span.c 425 GLfloat rho = MAX2(x, y); local
426 GLfloat lambda = LOG2(rho);
445 GLfloat maxU, maxV, rho, lambda;
452 rho = MAX2(maxU, maxV);
453 lambda = LOG2(rho);
    [all...]
  /external/mesa3d/src/gallium/auxiliary/gallivm/
lp_bld_sample.c 203 * Generate code to compute coordinate gradient (rho).
206 * The resulting rho has bld->levelf format (per quad or per element).
232 LLVMValueRef rho; local
245 * rho calcs are always per quad except for explicit derivs (excluding
264 rho = lp_build_pack_aos_scalars(bld->gallivm, coord_bld->type,
268 rho = lp_build_swizzle_scalar_aos(coord_bld, cube_rho, 0, 4);
273 /* skipping sqrt hence returning rho squared */
275 rho = lp_build_mul(rho_bld, cubesize, rho);
311 rho = lp_build_max(coord_bld, rho_xvec, rho_yvec)
758 LLVMValueRef rho; local
    [all...]
  /external/mesa3d/src/gallium/drivers/softpipe/
sp_tex_sample.c 501 const float rho = MAX2(dsdx, dsdy) * u_minify(texture->width0, sview->base.u.tex.first_level); local
503 return util_fast_log2(rho);
520 const float rho = MAX2(maxx, maxy); local
522 return util_fast_log2(rho);
542 const float rho = MAX3(maxx, maxy, maxz); local
544 return util_fast_log2(rho);
    [all...]
  /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...]

Completed in 858 milliseconds

1 2 3