/external/eigen/bench/spbench/ |
H A D | spbenchsolver.cpp | 62 double tol = 1e-08; local 65 tol = atof(inval.c_str()); 71 Browse_Matrices<double>(matrix_dir, statFileExists, statFile,maxiters, tol); 74 Browse_Matrices<std::complex<double> >(matrix_dir, statFileExists, statFile, maxiters, tol);
|
H A D | spbenchsolver.h | 490 void Browse_Matrices(const string folder, bool statFileExists, std::string& statFile, int maxiters, double tol) argument 493 RelErr = tol; //Relative residual error as stopping criterion for iterative solvers
|
/external/ceres-solver/internal/ceres/ |
H A D | test_util.cc | 73 double tol) { 104 EXPECT_NEAR(p_norm, q_norm, tol) << "i=" << i; 111 double tol) { 117 EXPECT_NEAR(p[i], q[i], tol) << "i=" << i; 70 ExpectArraysCloseUptoScale(int n, const double* p, const double* q, double tol) argument 108 ExpectArraysClose(int n, const double* p, const double* q, double tol) argument
|
H A D | autodiff_test.cc | 161 double const tol = 1e-10; // floating-point tolerance. local 201 ASSERT_NEAR(ad_x1[i], b_x[i], tol); 216 ASSERT_NEAR(ad_x2[i], b_x[i], tol); 226 ASSERT_NEAR(J_PX[(12 + 4) * i + j], J_P[12 * i + j], tol); 229 ASSERT_NEAR(J_PX[(12 + 4) * i + 12 + j], J_X[4 * i + j], tol); 282 double const tol = 1e-10; // floating-point tolerance. local 309 ASSERT_NEAR(fd_x[i], b_x[i], tol); 323 ASSERT_NEAR(ad_x[i], b_x[i], tol);
|
/external/eigen/unsupported/test/ |
H A D | matrix_exponential.cpp | 27 void test2dRotation(double tol) argument 40 VERIFY(C.isApprox(B, static_cast<T>(tol))); 44 VERIFY(C.isApprox(B, static_cast<T>(tol))); 49 void test2dHyperbolicRotation(double tol) argument 65 VERIFY(C.isApprox(B, static_cast<T>(tol))); 69 VERIFY(C.isApprox(B, static_cast<T>(tol))); 74 void testPascal(double tol) argument 89 VERIFY(C.isApprox(B, static_cast<T>(tol))); 93 VERIFY(C.isApprox(B, static_cast<T>(tol))); 98 void randomTest(const MatrixType& m, double tol) argument [all...] |
H A D | matrix_power.cpp | 40 void test2dRotation(double tol) argument 56 VERIFY(C.isApprox(B, static_cast<T>(tol))); 61 void test2dHyperbolicRotation(double tol) argument 78 VERIFY(C.isApprox(B, static_cast<T>(tol))); 83 void testExponentLaws(const MatrixType& m, double tol) argument 100 VERIFY(m4.isApprox(m5, static_cast<RealScalar>(tol))); 104 VERIFY(m4.isApprox(m5, static_cast<RealScalar>(tol))); 108 VERIFY(m4.isApprox(m5, static_cast<RealScalar>(tol)));
|
/external/skia/src/core/ |
H A D | SkCubicClipper.cpp | 37 const SkScalar tol = SK_Scalar1 / 16384; // This leaves 2 fixed noise bits. local 53 converged = SkScalarAbs(t1 - t0) <= tol; // NaN-safe 83 const SkScalar tol = SK_Scalar1 / 65536; // 1 for fixed, 1e-5 for float. 100 } while (!(SkScalarAbs(tPos - tNeg) <= tol)); // Nan-safe
|
H A D | SkBitmapProcState.cpp | 80 const SkScalar tol = SK_Scalar1 / 32768; local 82 if (!SkScalarNearlyZero(matrix[SkMatrix::kMScaleX] - SK_Scalar1, tol)) { 85 if (!SkScalarNearlyZero(matrix[SkMatrix::kMScaleY] - SK_Scalar1, tol)) {
|
H A D | SkGeometry.h | 250 bool asQuadTol(SkScalar tol) const; 256 int computeQuadPOW2(SkScalar tol) const; 311 const SkPoint* computeQuads(const SkConic& conic, SkScalar tol) { argument 312 int pow2 = conic.computeQuadPOW2(tol); 320 SkScalar tol) { 323 return computeQuads(conic, tol); 319 computeQuads(const SkPoint pts[3], SkScalar weight, SkScalar tol) argument
|
/external/skia/tests/ |
H A D | ClipCubicTest.cpp | 43 float tol) { 45 if (SkScalarAbs(c0[i].fX - c1[i].fX) > tol || 46 SkScalarAbs(c0[i].fY - c1[i].fY) > tol 82 const float tol = 1e-4f; local 90 0, 0, 2, 3, 1, 10, 4, 12, shouldbe), tol)); 98 0, 0, 2, 3, 1, 10, 4, 12, shouldbe), tol)); 106 0, 0, 2, 3, 1, 10, 4, 12, shouldbe), tol)); 124 shouldbe), tol)); 136 shouldbe), tol)); 148 shouldbe), tol)); 41 CurvesAreEqual(const SkPoint c0[4], const SkPoint c1[4], float tol) argument [all...] |
H A D | PathCoverageTest.cpp | 59 static inline uint32_t compute_pointCount(SkScalar d, SkScalar tol) { argument 60 if (d < tol) { 63 int temp = SkScalarCeilToInt(SkScalarSqrt(d / tol)); 74 static uint32_t quadraticPointCount_EC(const SkPoint points[], SkScalar tol) { argument 76 return compute_pointCount(SkIntToScalar(distance), tol); 84 static uint32_t quadraticPointCount_CC(const SkPoint points[], SkScalar tol) { argument 86 return compute_pointCount(distance, tol);
|
H A D | BlurTest.cpp | 315 static bool match(int* first, int* second, int count, int tol) { argument 319 if (delta > tol || delta < -tol) {
|
/external/eigen/unsupported/Eigen/src/IterativeSolvers/ |
H A D | Scaling.h | 162 void setTolerance(double tol) argument 164 m_tol = tol;
|
H A D | GMRES.h | 67 RealScalar tol = tol_error; local 77 if(abs(r0.norm()) < tol) { 150 bool stop=(k==m || abs(w(k)) < tol || iters == maxIters);
|
/external/eigen/Eigen/src/IterativeLinearSolvers/ |
H A D | BiCGSTAB.h | 38 RealScalar tol = tol_error; local 62 RealScalar tol2 = tol*tol;
|
H A D | ConjugateGradient.h | 38 RealScalar tol = tol_error; local 53 RealScalar threshold = tol*tol*rhsNorm2;
|
/external/skia/samplecode/ |
H A D | SamplePath.cpp | 331 const SkScalar tol = 4; variable 332 const SkRect r = SkRect::MakeXYWH(x - tol, y - tol, tol * 2, tol * 2);
|
H A D | SampleFatBits.cpp | 481 SkScalar tol = 12; variable 484 if (fPts[i].equalsWithinTolerance(pt, tol)) {
|
/external/skia/src/pdf/ |
H A D | SkPDFUtils.cpp | 162 const SkScalar tol = SK_Scalar1 / 4; local 164 const SkPoint* quads = converter.computeQuads(args, iter.conicWeight(), tol);
|
/external/skia/src/utils/ |
H A D | SkParsePath.cpp | 223 const SkScalar tol = SK_Scalar1 / 1024; // how close to a quad local 225 const SkPoint* quadPts = quadder.computeQuads(pts, iter.conicWeight(), tol);
|
/external/eigen/Eigen/src/SPQRSupport/ |
H A D | SuiteSparseQRSupport.h | 199 /// Set the tolerance tol to treat columns with 2-norm < =tol as zero 200 void setPivotThreshold(const RealScalar& tol) { m_tolerance = tol; } argument
|
/external/eigen/unsupported/Eigen/src/Eigenvalues/ |
H A D | ArpackSelfAdjointEigenSolver.h | 93 * \param[in] tol What tolerance to find the eigenvalues to. Default is 0, which 103 int options=ComputeEigenvectors, RealScalar tol=0.0) 111 compute(A, B, nbrEigenvalues, eigs_sigma, options, tol); 127 * \param[in] tol What tolerance to find the eigenvalues to. Default is 0, which 138 int options=ComputeEigenvectors, RealScalar tol=0.0) 146 compute(A, nbrEigenvalues, eigs_sigma, options, tol); 162 * \param[in] tol What tolerance to find the eigenvalues to. Default is 0, which 175 int options=ComputeEigenvectors, RealScalar tol=0.0); 188 * \param[in] tol What tolerance to find the eigenvalues to. Default is 0, which 201 int options=ComputeEigenvectors, RealScalar tol 101 ArpackGeneralizedSelfAdjointEigenSolver(const MatrixType& A, const MatrixType& B, Index nbrEigenvalues, std::string eigs_sigma=�, int options=ComputeEigenvectors, RealScalar tol=0.0) argument 136 ArpackGeneralizedSelfAdjointEigenSolver(const MatrixType& A, Index nbrEigenvalues, std::string eigs_sigma=�, int options=ComputeEigenvectors, RealScalar tol=0.0) argument 335 compute(const MatrixType& A, Index nbrEigenvalues, std::string eigs_sigma, int options, RealScalar tol) argument 348 compute(const MatrixType& A, const MatrixType& B, Index nbrEigenvalues, std::string eigs_sigma, int options, RealScalar tol) argument 682 saupd(int *ido, char *bmat, int *n, char *which, int *nev, RealScalar *tol, Scalar *resid, int *ncv, Scalar *v, int *ldv, int *iparam, int *ipntr, Scalar *workd, Scalar *workl, int *lworkl, int *info) argument 690 seupd(int *rvec, char *All, int *select, Scalar *d, Scalar *z, int *ldz, RealScalar *sigma, char *bmat, int *n, char *which, int *nev, RealScalar *tol, Scalar *resid, int *ncv, Scalar *v, int *ldv, int *iparam, int *ipntr, Scalar *workd, Scalar *workl, int *lworkl, int *ierr) argument 703 saupd(int *ido, char *bmat, int *n, char *which, int *nev, float *tol, float *resid, int *ncv, float *v, int *ldv, int *iparam, int *ipntr, float *workd, float *workl, int *lworkl, int *info) argument 711 seupd(int *rvec, char *All, int *select, float *d, float *z, int *ldz, float *sigma, char *bmat, int *n, char *which, int *nev, float *tol, float *resid, int *ncv, float *v, int *ldv, int *iparam, int *ipntr, float *workd, float *workl, int *lworkl, int *ierr) argument 725 saupd(int *ido, char *bmat, int *n, char *which, int *nev, double *tol, double *resid, int *ncv, double *v, int *ldv, int *iparam, int *ipntr, double *workd, double *workl, int *lworkl, int *info) argument 733 seupd(int *rvec, char *All, int *select, double *d, double *z, int *ldz, double *sigma, char *bmat, int *n, char *which, int *nev, double *tol, double *resid, int *ncv, double *v, int *ldv, int *iparam, int *ipntr, double *workd, double *workl, int *lworkl, int *ierr) argument [all...] |
/external/mesa3d/src/gallium/auxiliary/util/ |
H A D | u_math.h | 328 util_is_approx(float a, float b, float tol) argument 330 return fabs(b - a) <= tol;
|
/external/skia/src/gpu/ |
H A D | GrDefaultPathRenderer.cpp | 654 SkScalar tol = GrPathUtils::kDefaultTolerance; local 655 SkScalar srcSpaceTol = GrPathUtils::scaleToleranceToSrc(tol, viewMatrix, path.getBounds()); 762 SkScalar tol = GrPathUtils::kDefaultTolerance; local 763 SkScalar srcSpaceTol = GrPathUtils::scaleToleranceToSrc(tol, viewMatrix, bounds);
|
H A D | GrPathUtils.cpp | 39 SkScalar tol) { 40 if (tol < gMinCurveTol) { 41 tol = gMinCurveTol; 43 SkASSERT(tol > 0); 46 if (d <= tol) { 50 // subdivide x = log4(d/tol) times. x subdivisions creates 2^(x) 53 SkScalar divSqrt = SkScalarSqrt(d / tol); 96 SkScalar tol) { 97 if (tol < gMinCurveTol) { 98 tol 38 quadraticPointCount(const SkPoint points[], SkScalar tol) argument 95 cubicPointCount(const SkPoint points[], SkScalar tol) argument 156 worstCasePointCount(const SkPath& path, int* subpaths, SkScalar tol) argument [all...] |