HomeSort by relevance Sort by last modified time
    Searched full:sigma (Results 1 - 25 of 154) sorted by null

1 2 3 4 5 6 7

  /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
44 sigma = sqrt((sumsquare - (double)n*mu*mu)/(double)(n-1));
54 printf("sigma = %12.6f\n", sigma);
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)
63 *sigma = sqrt((sumsquare - (double)n*(*mu)*(*mu))/(double)(n-1));
93 makedist(double *x, int limit, double mu, double sigma)
107 input = (x[i]-mu)/sigma;
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);
225 table = makedist(x, limit, mu, sigma);
normal.c 18 normal(double x, double mu, double sigma)
20 return .5 + .5*erf((x-mu)/(sqrt(2.0)*sigma));
paretonormal.c 27 normal(double x, double mu, double sigma)
29 return .5 + .5*erf((x-mu)/(sqrt(2.0)*sigma));
  /frameworks/rs/java/tests/ImageProcessing/src/com/android/rs/image/
threshold.fs 39 // g(x) = ( 1 / sqrt( 2 * pi ) * sigma) * e ^ ( -x^2 / 2 * sigma^2 )
41 // and sigma varies with radius.
42 // Based on some experimental radius values and sigma's
43 // we approximately fit sigma = f(radius) as
44 // sigma = radius * 0.4 + 0.6
46 // will resemble a box blur since with large sigma
48 float sigma = 0.4f * (float)radius + 0.6f;
54 float coeff1 = 1.0f / (sqrt( 2.0f * pi ) * sigma);
55 float coeff2 = - 1.0f / (2.0f * sigma * sigma)
    [all...]
  /frameworks/rs/java/tests/ImageProcessing2/src/com/android/rs/image/
threshold.fs 39 // g(x) = ( 1 / sqrt( 2 * pi ) * sigma) * e ^ ( -x^2 / 2 * sigma^2 )
41 // and sigma varies with radius.
42 // Based on some experimental radius values and sigma's
43 // we approximately fit sigma = f(radius) as
44 // sigma = radius * 0.4 + 0.6
46 // will resemble a box blur since with large sigma
48 float sigma = 0.4f * (float)radius + 0.6f;
54 float coeff1 = 1.0f / (sqrt( 2.0f * pi ) * sigma);
55 float coeff2 = - 1.0f / (2.0f * sigma * sigma)
    [all...]
  /frameworks/rs/java/tests/ImageProcessing_jb/src/com/android/rs/image/
threshold.fs 39 // g(x) = ( 1 / sqrt( 2 * pi ) * sigma) * e ^ ( -x^2 / 2 * sigma^2 )
41 // and sigma varies with radius.
42 // Based on some experimental radius values and sigma's
43 // we approximately fit sigma = f(radius) as
44 // sigma = radius * 0.4 + 0.6
46 // will resemble a box blur since with large sigma
48 float sigma = 0.4f * (float)radius + 0.6f;
54 float coeff1 = 1.0f / (sqrt( 2.0f * pi ) * sigma);
55 float coeff2 = - 1.0f / (2.0f * sigma * sigma)
    [all...]
  /external/v8/test/mjsunit/
cyrillic.js 42 var SIGMA = "\u03a3";
43 var sigma = "\u03c3"; variable
52 MIDDLE: SIGMA, // SIGMA
53 middle: sigma, // sigma
134 // Sigma is special because there are two lower case versions of the same upper
136 // convert everything to upper case, so the two sigma variants are equal to each
141 var regex = simple ? SIGMA : "[" + SIGMA + "]"
    [all...]
string-indexof-1.js 63 assertEquals(2, twoByteString.indexOf("\u03a3"), "First Sigma");
64 assertEquals(3, twoByteString.indexOf("\u03a3",3), "Second Sigma");
70 assertEquals(1, twoByteString.indexOf("\u0391\u03a3"), "Alpha Sigma");
71 assertEquals(2, twoByteString.indexOf("\u03a3\u03a3"), "Sigma Sigma");
72 assertEquals(3, twoByteString.indexOf("\u03a3\u0395"), "Sigma Epsilon");
75 "Not Alpha Sigma Epsilon");
regexp-UC16.js 30 // "\u03a3\u03c2\u03c3\u039b\u03bb" - Sigma, final sigma, sigma, Lambda, lamda
  /frameworks/base/libs/hwui/utils/
Blur.cpp 31 // g(x) = ( 1 / sqrt( 2 * pi ) * sigma) * e ^ ( -x^2 / 2 * sigma^2 )
33 // and sigma varies with radius.
34 // Based on some experimental radius values and sigma's
35 // we approximately fit sigma = f(radius) as
36 // sigma = radius * 0.3 + 0.6
38 // will resemble a box blur since with large sigma
40 float sigma = 0.3f * (float) radius + 0.6f; local
46 float coeff1 = 1.0f / (sqrt(2.0f * pi) * sigma);
47 float coeff2 = - 1.0f / (2.0f * sigma * sigma)
    [all...]
  /external/skia/gm/
spritebitmap.cpp 81 SkScalar sigma = 8; local
82 SkAutoTUnref<SkImageFilter> filter(new SkBlurImageFilter(sigma, sigma));
  /external/skia/legacy/include/effects/
SkBlurImageFilter.h 18 virtual bool asABlur(SkSize* sigma) const SK_OVERRIDE;
  /external/eigen/Eigen/src/Cholesky/
LLT_MKL.h 75 static typename MatrixType::Index rankUpdate(MatrixType& mat, const VectorType& vec, const typename MatrixType::RealScalar& sigma) \
76 { return Eigen::internal::llt_rank_update_lower(mat, vec, sigma); } \
86 static typename MatrixType::Index rankUpdate(MatrixType& mat, const VectorType& vec, const typename MatrixType::RealScalar& sigma) \
89 return llt_inplace<EIGTYPE, Lower>::rankUpdate(matt, vec.conjugate(), sigma); \
LLT.h 174 LLT rankUpdate(const VectorType& vec, const RealScalar& sigma = 1);
191 static typename MatrixType::Index llt_rank_update_lower(MatrixType& mat, const VectorType& vec, const typename MatrixType::RealScalar& sigma)
207 if(sigma>0)
211 // i.e., for sigma > 0
212 temp = sqrt(sigma) * vec;
237 RealScalar swj2 = sigma*abs2(wj);
253 mat.col(j).tail(rs) = (nLjj/Ljj) * mat.col(j).tail(rs) + (nLjj * sigma*conj(wj)/gamma)*temp.tail(rs);
323 static typename MatrixType::Index rankUpdate(MatrixType& mat, const VectorType& vec, const RealScalar& sigma)
325 return Eigen::internal::llt_rank_update_lower(mat, vec, sigma);
346 static typename MatrixType::Index rankUpdate(MatrixType& mat, const VectorType& vec, const RealScalar& sigma)
    [all...]
LDLT.h 102 * \sa rankUpdate(w,sigma)
342 static bool updateInPlace(MatrixType& mat, MatrixBase<WDerived>& w, typename MatrixType::RealScalar sigma=1)
364 RealScalar swj2 = sigma*abs2(wj);
375 mat.col(j).tail(rs) += (sigma*conj(wj)/gamma)*w.tail(rs);
381 static bool update(MatrixType& mat, const TranspositionType& transpositions, Workspace& tmp, const WType& w, typename MatrixType::RealScalar sigma=1)
386 return ldlt_inplace<Lower>::updateInPlace(mat,tmp,sigma);
400 static EIGEN_STRONG_INLINE bool update(MatrixType& mat, TranspositionType& transpositions, Workspace& tmp, WType& w, typename MatrixType::RealScalar sigma=1)
403 return ldlt_inplace<Lower>::update(matt, transpositions, tmp, w.conjugate(), sigma);
445 /** Update the LDLT decomposition: given A = L D L^T, efficiently compute the decomposition of A + sigma w w^T.
447 * \param sigma a scalar, +1 for updates and -1 for "downdates," which correspond to removing previously-added col (…)
    [all...]
  /external/skia/src/gpu/effects/
GrConvolutionEffect.h 63 // samples per fragment program run in DX9SM2 (32). A sigma param of 4.0
64 // on a blur filter gives a kernel width of 25 while a sigma of 5.0
  /packages/inputmethods/LatinIME/native/jni/src/
proximity_info_utils.h 119 // Normal distribution N(u, sigma^2).
122 NormalDistribution(const float u, const float sigma)
123 : mU(u), mSigma(sigma),
124 mPreComputedNonExpPart(1.0f / sqrtf(2.0f * M_PI_F * SQUARE_FLOAT(sigma))),
125 mPreComputedExponentPart(-1.0f / (2.0f * SQUARE_FLOAT(sigma))) {}
136 const float mPreComputedNonExpPart; // = 1 / sqrt(2 * PI * sigma^2)
137 const float mPreComputedExponentPart; // = -1 / (2 * sigma^2)
  /external/eigen/test/eigen2/
eigen2_svd.cpp 34 MatrixType sigma = MatrixType::Zero(rows,cols); local
36 sigma.block(0,0,cols,cols) = svd.singularValues().asDiagonal();
38 VERIFY_IS_APPROX(a, matU * sigma * svd.matrixV().transpose());
  /packages/inputmethods/LatinIME/java/res/xml/
keys_pcqwerty_symbols2.xml 45 <!-- U+03CC: "?" GREEK SMALL LETTER SIGMA
46 U+03A3: "?" GREEK CAPITAL LETTER SIGMA -->
  /frameworks/rs/cpu_ref/
rsCpuIntrinsicBlur.cpp 68 // g(x) = ( 1 / sqrt( 2 * pi ) * sigma) * e ^ ( -x^2 / 2 * sigma^2 )
70 // and sigma varies with radius.
71 // Based on some experimental radius values and sigma's
72 // we approximately fit sigma = f(radius) as
73 // sigma = radius * 0.4 + 0.6
75 // will resemble a box blur since with large sigma
77 float sigma = 0.4f * mRadius + 0.6f; local
81 float coeff1 = 1.0f / (sqrtf(2.0f * pi) * sigma);
82 float coeff2 = - 1.0f / (2.0f * sigma * sigma)
    [all...]
  /external/eigen/unsupported/Eigen/src/Polynomials/
Companion.h 149 //one finds \f$ \sigma \f$ such that
150 // \f$ 2^{2\sigma-1} < rowNorm / colNorm \le 2^{2\sigma+1} \f$
151 // then the balancing coefficient for the row is \f$ 1/2^{\sigma} \f$
152 // and the balancing coefficient for the column is \f$ 2^{\sigma} \f$
  /external/skia/legacy/include/core/
SkImageFilter.h 79 * set the sigma to the values for horizontal and vertical.
81 virtual bool asABlur(SkSize* sigma) const;
  /external/webkit/LayoutTests/dom/xhtml/level1/core/
xhtml-symbol.ent 51 <!ENTITY Sigma "&#931;"> <!-- greek capital letter sigma,
88 <!ENTITY sigmaf "&#962;"> <!-- greek small letter final sigma,
90 <!ENTITY sigma "&#963;"> <!-- greek small letter sigma,
169 <!-- sum is NOT the same character as U+03A3 'greek capital letter sigma'
  /external/webkit/LayoutTests/dom/xhtml/level2/core/
xhtml-symbol.ent 51 <!ENTITY Sigma "&#931;"> <!-- greek capital letter sigma,
88 <!ENTITY sigmaf "&#962;"> <!-- greek small letter final sigma,
90 <!ENTITY sigma "&#963;"> <!-- greek small letter sigma,
169 <!-- sum is NOT the same character as U+03A3 'greek capital letter sigma'

Completed in 1325 milliseconds

1 2 3 4 5 6 7