HomeSort by relevance Sort by last modified time
    Searched refs:sigma (Results 26 - 50 of 275) sorted by null

12 3 4 5 6 7 8 91011

  /frameworks/base/core/jni/android/graphics/
MaskFilter.cpp 25 SkScalar sigma = SkBlurMask::ConvertRadiusToSigma(radius); local
26 SkMaskFilter* filter = SkBlurMaskFilter::Make((SkBlurStyle)blurStyle, sigma).release();
40 SkScalar sigma = SkBlurMask::ConvertRadiusToSigma(radius); local
41 SkMaskFilter* filter = SkBlurMaskFilter::MakeEmboss(sigma,
  /frameworks/base/libs/hwui/utils/
Blur.h 28 // If radius > 0, return the corresponding sigma, else return 0
30 // If sigma > 0.5, return the corresponding radius, else return 0
31 ANDROID_API static float convertSigmaToRadius(float sigma);
32 // If the original radius was on an integer boundary then after the sigma to
  /cts/tests/tests/renderscript/src/android/renderscript/cts/
intrinsic_blur.rs 55 float sigma = 0.4f * (float)radius + 0.6f;
56 float coeff1 = 1.0f / (sqrt( 2.0f * pi ) * sigma);
57 float coeff2 = - 1.0f / (2.0f * sigma * sigma);
  /external/iproute2/netem/
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);
paretonormal.c 27 normal(double x, double mu, double sigma)
29 return .5 + .5*erf((x-mu)/(sqrt(2.0)*sigma));
  /frameworks/rs/tests/java_api/ImageProcessing/src/com/android/rs/image/
threshold.rs 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/tests/java_api/ImageProcessing2/src/com/android/rs/image/
threshold.rs 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/tests/java_api/ImageProcessing_jb/src/com/android/rs/image/
threshold.rs 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...]
threshold_half.rs 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 half sigma = 0.4f * (half)radius + 0.6f;
54 half coeff1 = 1.0f / (sqrt( 2.0f * pi ) * sigma);
55 half coeff2 = - 1.0f / (2.0f * sigma * sigma)
    [all...]
  /external/boringssl/src/crypto/chacha/
chacha.c 72 /* sigma contains the ChaCha constants, which happen to be an ASCII string. */
73 static const uint8_t sigma[16] = { 'e', 'x', 'p', 'a', 'n', 'd', ' ', '3', variable
128 input[0] = U8TO32_LITTLE(sigma + 0);
129 input[1] = U8TO32_LITTLE(sigma + 4);
130 input[2] = U8TO32_LITTLE(sigma + 8);
131 input[3] = U8TO32_LITTLE(sigma + 12);
  /external/skia/gm/
imageblurrepeatmode.cpp 95 for (auto sigma: { 0.6f, 3.0f, 8.0f, 20.0f }) {
98 SkBlurImageFilter::Make(sigma, 0.0f, nullptr, nullptr,
103 filter = SkBlurImageFilter::Make(0.0f, sigma, nullptr, nullptr,
108 filter = SkBlurImageFilter::Make(sigma, sigma, nullptr, nullptr,
imagefilters.cpp 89 for (SkScalar sigma = 8; sigma <= 128; sigma *= 2) {
91 paint.setImageFilter(SkBlurImageFilter::Make(sigma, sigma, nullptr));
animatedimageblurs.cpp 47 layerPaint.setImageFilter(SkBlurImageFilter::Make(fNodes[i].sigma(),
48 fNodes[i].sigma(),
118 SkScalar sigma() const { return fBlur; } function in class:AnimatedImageBlurs::Node
samplerstress.cpp 84 const SkScalar sigma = 1; local
85 fMaskFilter = SkBlurMaskFilter::Make(kNormal_SkBlurStyle, sigma);
  /external/skia/src/effects/
SkBlurMaskFilter.cpp 43 SkBlurMaskFilterImpl(SkScalar sigma, SkBlurStyle, const SkRect& occluder, uint32_t flags);
131 sk_sp<SkMaskFilter> SkBlurMaskFilter::Make(SkBlurStyle style, SkScalar sigma,
136 if (!SkScalarIsFinite(sigma) || sigma <= 0) {
140 return sk_sp<SkMaskFilter>(new SkBlurMaskFilterImpl(sigma, style, occluder, flags));
196 SkScalar sigma, SkScalar xformedSigma,
205 SkScalar srcBlurRadius = 3.0f * sigma;
288 SkBlurMaskFilterImpl::SkBlurMaskFilterImpl(SkScalar sigma, SkBlurStyle style,
290 : fSigma(sigma)
319 SkScalar sigma = this->computeXformedSigma(matrix) local
326 SkScalar sigma = computeXformedSigma(matrix); local
334 SkScalar sigma = computeXformedSigma(matrix); local
563 const SkScalar sigma = this->computeXformedSigma(matrix); local
697 const SkScalar sigma = this->computeXformedSigma(matrix); local
736 const SkScalar sigma = buffer.readScalar(); local
1006 float sigma = d->fRandom->nextRangeF(3,8); local
1231 SkScalar sigma = d->fRandom->nextRangeF(1.f,10.f); local
    [all...]
SkBlurMask.cpp 29 SkScalar SkBlurMask::ConvertSigmaToRadius(SkScalar sigma) {
30 return sigma > 0.5f ? (sigma - 0.5f) / kBLUR_SIGMA_SCALE : 0.0f;
478 SkScalar sigma, SkBlurStyle style, SkBlurQuality quality,
497 if (!force_quality && sigma <= SkIntToScalar(2)) {
504 // 6*rad+1 while the full Gaussian width is 6*sigma.
505 passRadius = sigma - (1 / 6.0f);
507 // For the low quality path we only attempt to cover 3*sigma of the
508 // Gaussian blur area (1.5*sigma on each side). The single pass box
510 passRadius = 1.5f * sigma - 0.5f
    [all...]
GrCircleBlurFragmentProcessor.h 26 const SkRect& circle, float sigma);
  /external/ImageMagick/www/api/
effect.php 59 <p>AdaptiveBlurImage() adaptively blurs the image by blurring less intensely near image edges and more intensely far from edges. We blur the image with a Gaussian operator of the given radius and standard deviation (sigma). For reasonable results, radius should be larger than sigma. Use a radius of 0 and AdaptiveBlurImage() selects a suitable radius for you.</p>
65 const double sigma,ExceptionInfo *exception)
83 <dt>sigma</dt>
94 <p>AdaptiveSharpenImage() adaptively sharpens the image by sharpening more intensely near image edges and less intensely far from edges. We sharpen the image with a Gaussian operator of the given radius and standard deviation (sigma). For reasonable results, radius should be larger than sigma. Use a radius of 0 and AdaptiveSharpenImage() selects a suitable radius for you.</p>
100 const double sigma,ExceptionInfo *exception)
118 <dt>sigma</dt>
129 <p>BlurImage() blurs an image. We convolve the image with a Gaussian operator of the given radius and standard deviation (sigma). For reasonable results, the radius should be larger than sigma. Use a radius of 0 and BlurImage() selects a suitable radius for you.</p
    [all...]
  /external/skia/src/core/
SkMaskBlurFilter.h 21 // Given a filter specified by sigma, generate various quantities.
24 explicit FilterInfo(double sigma);
26 // The final weight to divide by given a box size calculated from sigma accumulated for
SkGpuBlurUtils.cpp 54 static float adjust_sigma(float sigma, int maxTextureSize, int *scaleFactor, int *radius) {
56 while (sigma > MAX_BLUR_SIGMA) {
58 sigma *= 0.5f;
61 sigma = MAX_BLUR_SIGMA;
64 *radius = static_cast<int>(ceilf(sigma * 3.0f));
66 return sigma;
76 float sigma,
83 std::move(proxy), direction, radius, sigma, mode, bounds));
125 float sigma,
133 std::move(proxy), direction, radius, sigma,
    [all...]
  /external/skia/tools/
imgblur.cpp 20 DEFINE_double(sigma, 1, "Sigma to be used for blur (> 0.0f)");
34 SkDebugf("Sigma must be greater than zero (it is %f).\n", FLAGS_sigma);
  /external/skia/bench/
RectoriBench.cpp 74 sk_sp<SkDrawLooper> createLooper(SkScalar xOff, SkScalar sigma) {
89 paint->setMaskFilter(SkBlurMaskFilter::Make(kNormal_SkBlurStyle, sigma,
  /external/ImageMagick/MagickCore/
morphology.c 275 args.rho = args.sigma; /* then width = height */
278 if ( args.sigma < 1.0 ) /* if height too small */
279 args.sigma = args.rho; /* then height = width */
281 kernel->height = (size_t)args.sigma;
421 flags, args.rho, args.sigma, args.xi, args.psi );
438 args.sigma = 1.0; /* Default scale = 1.0, zero is valid */
446 args.rho = args.sigma; /* then width = height */
449 if ( args.sigma < 1.0 ) /* if height too small */
450 args.sigma = args.rho; /* then height = width */
454 args.psi = (double)(((ssize_t)args.sigma-1)/2)
1049 sigma = fabs(args->sigma), local
1142 sigma = fabs(args->sigma), local
1230 sigma = fabs(args->sigma), local
    [all...]
  /external/eigen/unsupported/Eigen/src/Eigenvalues/
ArpackSelfAdjointEigenSolver.h 374 RealScalar sigma = 0.0; local
396 // specifying the sigma value to cluster the evs around
398 sigma = atof(eigs_sigma.c_str());
480 if (sigma == 0.0)
486 // Note: We will never enter here because sigma must be 0.0
492 AminusSigmaB.coeffRef(i,i) -= sigma;
498 MatrixType AminusSigmaB = A - sigma * B;
555 // OP = (A-\sigmaB)B (\sigma could be 0, and B could be I)
603 &sigma, bmat, &n, whch, &nev, &tol, resid, &ncv,
656 float *z, int *ldz, float *sigma,
    [all...]
  /external/eigen/Eigen/src/Cholesky/
LLT.h 199 LLT rankUpdate(const VectorType& vec, const RealScalar& sigma = 1);
229 static Index llt_rank_update_lower(MatrixType& mat, const VectorType& vec, const typename MatrixType::RealScalar& sigma)
245 if(sigma>0)
249 // i.e., for sigma > 0
250 temp = sqrt(sigma) * vec;
275 RealScalar swj2 = sigma*numext::abs2(wj);
291 mat.col(j).tail(rs) = (nLjj/Ljj) * mat.col(j).tail(rs) + (nLjj * sigma*numext::conj(wj)/gamma)*temp.tail(rs);
360 static Index rankUpdate(MatrixType& mat, const VectorType& vec, const RealScalar& sigma)
362 return Eigen::internal::llt_rank_update_lower(mat, vec, sigma);
383 static Index rankUpdate(MatrixType& mat, const VectorType& vec, const RealScalar& sigma)
    [all...]

Completed in 1173 milliseconds

12 3 4 5 6 7 8 91011