Searched refs:rho (Results 1 - 25 of 72) sorted by relevance

123

/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DConstrainedConjGrad.h58 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
[all...]
/external/iproute2/netem/
H A Dstats.c24 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));*/
H A Dmaketable.c51 arraystats(double *x, int limit, double *mu, double *sigma, double *rho) argument
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/apache-commons-math/src/main/java/org/apache/commons/math/optimization/direct/
H A DNelderMead.java36 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, argument
66 this.rho = rho;
105 xR[j] = centroid[j] + rho * (centroid[j] - xWorst[j]);
/external/libcxx/test/std/numerics/complex.number/complex.value.ops/
H A Dpolar.pass.cpp14 // polar(const T& rho, const T& theta = 0);
23 test(const T& rho, std::complex<T> x) argument
25 assert(std::polar(rho) == x);
30 test(const T& rho, const T& theta, std::complex<T> x) argument
32 assert(std::polar(rho, theta) == x);
/external/eigen/Eigen/src/IterativeLinearSolvers/
H A DBiCGSTAB.h52 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/
H A Deig33.cpp76 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/opencv/cv/src/
H A Dcvhough.cpp64 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, argument
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 an
191 icvHoughLinesSDiv( const CvMat* img, float rho, float theta, int threshold, int srn, int stn, CvSeq* lines, int linesMax ) argument
483 icvHoughLinesProbabalistic( CvMat* image, float rho, float theta, int threshold, int lineLength, int lineGap, CvSeq *lines, int linesMax ) argument
740 cvHoughLines2( CvArr* src_image, void* lineStorage, int method, double rho, double theta, int threshold, double param1, double param2 ) argument
[all...]
/external/mesa3d/src/gallium/auxiliary/gallivm/
H A Dlp_bld_sample.c203 * 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
610 lp_build_brilinear_rho(struct lp_build_context *bld, LLVMValueRef rho, double factor, LLVMValueRef *out_lod_ipart, LLVMValueRef *out_lod_fpart) argument
758 LLVMValueRef rho; local
1608 lp_build_cube_lookup(struct lp_build_sample_context *bld, LLVMValueRef *coords, const struct lp_derivatives *derivs_in, LLVMValueRef *rho, struct lp_derivatives *derivs_out, boolean need_derivs) argument
[all...]
/external/ImageMagick/MagickCore/
H A Dmorphology.c275 args.rho = args.sigma; /* then width = height */
276 if ( args.rho < 1.0 ) /* if width too small */
277 args.rho = 1.0; /* then width = 1 */
279 args.sigma = args.rho; /* then height = width */
280 kernel->width = (size_t)args.rho;
421 flags, args.rho, args.sigma, args.xi, args.psi );
429 args.rho = 1.0; /* Default scale = 1.0, zero is valid */
446 args.rho = args.sigma; /* then width = height */
447 if ( args.rho < 1.0 ) /* if width too small */
448 args.rho
[all...]
H A Dgeometry.c818 % rho, xi, and psi values. It also returns flags that indicates which
819 % of the four values (sigma, rho, xi, psi) were located in the string, and
874 c=sscanf(geometry,"%lf%*[ ,]%lf%*[ ,]%lf%*[ ,]%lf",&coordinate.rho,
881 geometry_info->rho=coordinate.rho;
981 Parse rho, sigma, xi, psi, and optionally chi.
995 Parse rho.
1005 geometry_info->rho=value;
1114 geometry_info->rho/=geometry_info->sigma;
1133 geometry_info->sigma=geometry_info->rho;
[all...]
H A Dgeometry.h105 rho, member in struct:_GeometryInfo
H A Dconstitute.c634 geometry_info.rho=next->resolution.x;
638 next->resolution.x=geometry_info.rho/geometry_info.sigma;
644 geometry_info.rho=next->resolution.y;
648 next->resolution.y=geometry_info.rho/geometry_info.sigma;
739 if (next->delay > (size_t) floor(geometry_info.rho+0.5))
740 next->delay=(size_t) floor(geometry_info.rho+0.5);
745 if (next->delay < (size_t) floor(geometry_info.rho+0.5))
749 next->delay=(size_t) floor(geometry_info.rho+0.5);
H A Dthreshold.c571 threshold.red=geometry_info.rho;
572 threshold.green=geometry_info.rho;
573 threshold.blue=geometry_info.rho;
574 threshold.black=geometry_info.rho;
1828 threshold.red=geometry_info.rho;
1829 threshold.green=geometry_info.rho;
1830 threshold.blue=geometry_info.rho;
1831 threshold.black=geometry_info.rho;
/external/bouncycastle/bcprov/src/main/java/org/bouncycastle/math/ec/
H A DWTauNafMultiplier.java37 ZTauElement rho = Tnaf.partModReduction(k, m, a, s, mu, (byte)10);
39 return multiplyWTnaf(p, rho, curve.getPreCompInfo(p, PRECOMP_NAME), a, mu);
/external/webrtc/webrtc/modules/audio_processing/intelligibility/
H A Dintelligibility_enhancer.h48 rho(0.02f) {}
57 float rho; member in struct:webrtc::IntelligibilityEnhancer::Config
H A Dintelligibility_enhancer.cc106 RTC_DCHECK_LE(config.rho, 1.0f);
110 // Assumes all rho equal.
112 rho_[i] = config.rho * config.rho;
/external/ImageMagick/MagickWand/
H A Doperation.c88 flags, info.rho, info.sigma, info.xi, info.psi )
1736 new_image=AdaptiveBlurImage(_image,geometry_info.rho,
1757 new_image=AdaptiveSharpenImage(_image,geometry_info.rho,
1781 geometry_info.sigma=geometry_info.rho;
1787 fmod(geometry_info.rho,360.0)));
1789 fmod(geometry_info.rho,360.0)));
1826 geometry_info.rho=1.5;
1832 new_image=BlueShiftImage(_image,geometry_info.rho,_exception);
1842 new_image=BlurImage(_image,geometry_info.rho,geometry_info.sigma,
1880 brightness=geometry_info.rho;
[all...]
H A Dmogrify.c782 mogrify_image=AdaptiveBlurImage(*image,geometry_info.rho,
806 mogrify_image=AdaptiveSharpenImage(*image,geometry_info.rho,
847 geometry_info.sigma=geometry_info.rho;
858 fmod(geometry_info.rho,360.0)));
860 fmod(geometry_info.rho,360.0)));
930 geometry_info.rho=1.5;
933 mogrify_image=BlueShiftImage(*image,geometry_info.rho,exception);
947 mogrify_image=BlurImage(*image,geometry_info.rho,
990 brightness=geometry_info.rho;
1020 mogrify_image=CannyEdgeImage(*image,geometry_info.rho,
[all...]
/external/ImageMagick/PerlMagick/
H A DMagick.xs1217 image->chromaticity.blue_primary.x=geometry_info.rho;
1292 pixel.red=geometry_info.rho;
1360 image->delay=(size_t) floor(geometry_info.rho+0.5);
1392 image->resolution.x=geometry_info.rho;
1583 image->chromaticity.green_primary.x=geometry_info.rho;
1858 pixel.red=geometry_info.rho;
1885 info->image_info->pointsize=geometry_info.rho;
1932 image->chromaticity.red_primary.x=geometry_info.rho;
2228 image->chromaticity.white_point.x=geometry_info.rho;
7978 geometry_info.rho
[all...]
/external/ImageMagick/PerlMagick/quantum/
H A Dquantum.xs.in1217 image->chromaticity.blue_primary.x=geometry_info.rho;
1292 pixel.red=geometry_info.rho;
1360 image->delay=(size_t) floor(geometry_info.rho+0.5);
1392 image->resolution.x=geometry_info.rho;
1583 image->chromaticity.green_primary.x=geometry_info.rho;
1858 pixel.red=geometry_info.rho;
1885 info->image_info->pointsize=geometry_info.rho;
1932 image->chromaticity.red_primary.x=geometry_info.rho;
2228 image->chromaticity.white_point.x=geometry_info.rho;
7978 geometry_info.rho
[all...]
/external/webrtc/webrtc/modules/audio_coding/codecs/isac/main/source/
H A Dfilter_functions.c139 double rho=0.9, *inp, *dp, *dp2; local
176 WebRtcIsac_BwExpand(apolr, apol, rho, PITCH_WLPCORDER+1);
/external/opencv/ml/src/
H A Dmlsvm.cpp727 // calculate rho
728 (this->*calc_rho_func)( si.rho, si.r );
798 CvSVMSolver::calc_rho( double& rho, double& r ) argument
828 rho = nr_free > 0 ? sum_free/nr_free : (ub + lb)*0.5;
903 CvSVMSolver::calc_rho_nu_svm( double& rho, double& r ) argument
945 rho = (r1 - r2)*0.5;
1019 _si.rho *= inv_r;
1284 CvMemStorage* _storage, double* alpha, double& rho )
1295 si.rho = 0;
1308 rho
[all...]
/external/ImageMagick/coders/
H A Dmsl.c951 affine.sx=geometry_info.rho;
1017 affine.tx=geometry_info.rho;
1222 geometry_info.rho=StringToDouble(value,(char **) NULL);
1250 blur_image=BlurImage(msl_info->image[n],geometry_info.rho,
2582 affine.sx=geometry_info.rho;
2648 affine.tx=geometry_info.rho;
2777 geometry_info.rho=StringToDouble(value,(char **) NULL);
2792 edge_image=EdgeImage(msl_info->image[n],geometry_info.rho,
2843 geometry_info.rho=StringToDouble(value,
2871 emboss_image=EmbossImage(msl_info->image[n],geometry_info.rho,
[all...]
H A Dmpc.c378 image->chromaticity.blue_primary.x=geometry_info.rho;
509 image->chromaticity.green_primary.x=geometry_info.rho;
642 image->chromaticity.red_primary.x=geometry_info.rho;
662 image->resolution.x=geometry_info.rho;
743 image->chromaticity.white_point.x=geometry_info.rho;

Completed in 845 milliseconds

123