Searched refs:tol (Results 1 - 25 of 49) sorted by relevance

12

/external/chromium_org/third_party/skia/tests/
H A DClipCubicTest.cpp43 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 DPathCoverageTest.cpp59 static inline uint32_t compute_pointCount(SkScalar d, SkScalar tol) { argument
60 if (d < tol) {
63 int temp = SkScalarCeilToInt(SkScalarSqrt(SkScalarDiv(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);
/external/skia/tests/
H A DClipCubicTest.cpp43 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 DPathCoverageTest.cpp59 static inline uint32_t compute_pointCount(SkScalar d, SkScalar tol) { argument
60 if (d < tol) {
63 int temp = SkScalarCeilToInt(SkScalarSqrt(SkScalarDiv(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);
/external/eigen/bench/spbench/
H A Dspbenchsolver.cpp62 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);
/external/ceres-solver/internal/ceres/
H A Dtest_util.cc73 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 Dautodiff_test.cc161 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 Dmatrix_exponential.cpp27 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 Dmatrix_power.cpp40 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/eigen/unsupported/Eigen/src/Eigenvalues/
H A DArpackSelfAdjointEigenSolver.h93 * \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/chromium_org/third_party/skia/src/core/
H A DSkGeometry.h237 bool asQuadTol(SkScalar tol) const;
243 int computeQuadPOW2(SkScalar tol) const;
290 const SkPoint* computeQuads(const SkConic& conic, SkScalar tol) { argument
291 int pow2 = conic.computeQuadPOW2(tol);
299 SkScalar tol) {
302 return computeQuads(conic, tol);
298 computeQuads(const SkPoint pts[3], SkScalar weight, SkScalar tol) argument
H A DSkCubicClipper.cpp37 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
/external/skia/src/core/
H A DSkGeometry.h237 bool asQuadTol(SkScalar tol) const;
243 int computeQuadPOW2(SkScalar tol) const;
290 const SkPoint* computeQuads(const SkConic& conic, SkScalar tol) { argument
291 int pow2 = conic.computeQuadPOW2(tol);
299 SkScalar tol) {
302 return computeQuads(conic, tol);
298 computeQuads(const SkPoint pts[3], SkScalar weight, SkScalar tol) argument
H A DSkCubicClipper.cpp37 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
/external/eigen/unsupported/Eigen/src/LevenbergMarquardt/
H A DLevenbergMarquardt.h136 const Scalar tol = std::sqrt(NumTraits<Scalar>::epsilon())
142 const Scalar tol = std::sqrt(NumTraits<Scalar>::epsilon())
327 const Scalar tol
334 if (n <= 0 || m < n || tol < 0.)
338 m_ftol = tol;
339 m_xtol = tol;
352 const Scalar tol
359 if (n <= 0 || m < n || tol < 0.)
365 lm.setFtol(tol);
366 lm.setXtol(tol);
[all...]
H A DLMcovar.h23 Scalar tol = std::sqrt(NumTraits<Scalar>::epsilon()) )
34 const Scalar tolr = tol * abs(r(0,0));
/external/chromium_org/third_party/skia/src/gpu/
H A DGrPathUtils.h25 /// Since we divide by tol if we're computing exact worst-case bounds,
29 SkScalar tol);
31 /// Since we divide by tol if we're computing exact worst-case bounds,
33 uint32_t quadraticPointCount(const SkPoint points[], SkScalar tol);
42 /// Since we divide by tol if we're computing exact worst-case bounds,
44 uint32_t cubicPointCount(const SkPoint points[], SkScalar tol);
H A DGrPathUtils.cpp40 SkScalar tol) {
41 if (tol < gMinCurveTol) {
42 tol = gMinCurveTol;
44 SkASSERT(tol > 0);
47 if (d <= tol) {
51 // subdivide x = log4(d/tol) times. x subdivisions creates 2^(x)
54 int temp = SkScalarCeilToInt(SkScalarSqrt(SkScalarDiv(d, tol)));
92 SkScalar tol) {
93 if (tol < gMinCurveTol) {
94 tol
39 quadraticPointCount(const SkPoint points[], SkScalar tol) argument
91 cubicPointCount(const SkPoint points[], SkScalar tol) argument
147 worstCasePointCount(const SkPath& path, int* subpaths, SkScalar tol) argument
[all...]
/external/skia/src/gpu/
H A DGrPathUtils.h25 /// Since we divide by tol if we're computing exact worst-case bounds,
29 SkScalar tol);
31 /// Since we divide by tol if we're computing exact worst-case bounds,
33 uint32_t quadraticPointCount(const SkPoint points[], SkScalar tol);
42 /// Since we divide by tol if we're computing exact worst-case bounds,
44 uint32_t cubicPointCount(const SkPoint points[], SkScalar tol);
H A DGrPathUtils.cpp40 SkScalar tol) {
41 if (tol < gMinCurveTol) {
42 tol = gMinCurveTol;
44 SkASSERT(tol > 0);
47 if (d <= tol) {
51 // subdivide x = log4(d/tol) times. x subdivisions creates 2^(x)
54 int temp = SkScalarCeilToInt(SkScalarSqrt(SkScalarDiv(d, tol)));
92 SkScalar tol) {
93 if (tol < gMinCurveTol) {
94 tol
39 quadraticPointCount(const SkPoint points[], SkScalar tol) argument
91 cubicPointCount(const SkPoint points[], SkScalar tol) argument
147 worstCasePointCount(const SkPath& path, int* subpaths, SkScalar tol) argument
[all...]
/external/eigen/unsupported/Eigen/src/NonLinearOptimization/
H A Dcovar.h9 Scalar tol = std::sqrt(NumTraits<Scalar>::epsilon()) )
21 const Scalar tolr = tol * abs(r(0,0));
H A DLevenbergMarquardt.h75 const Scalar tol = std::sqrt(NumTraits<Scalar>::epsilon())
86 const Scalar tol = std::sqrt(NumTraits<Scalar>::epsilon())
91 const Scalar tol = std::sqrt(NumTraits<Scalar>::epsilon())
130 const Scalar tol
137 if (n <= 0 || m < n || tol < 0.)
141 parameters.ftol = tol;
142 parameters.xtol = tol;
358 const Scalar tol
365 if (n <= 0 || m < n || tol < 0.)
369 parameters.ftol = tol;
[all...]
H A DHybridNonLinearSolver.h73 const Scalar tol = std::sqrt(NumTraits<Scalar>::epsilon())
82 const Scalar tol = std::sqrt(NumTraits<Scalar>::epsilon())
124 const Scalar tol
130 if (n <= 0 || tol < 0.)
135 parameters.xtol = tol;
360 const Scalar tol
366 if (n <= 0 || tol < 0.)
371 parameters.xtol = tol;
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DScaling.h162 void setTolerance(double tol) argument
164 m_tol = tol;
/external/eigen/Eigen/src/IterativeLinearSolvers/
H A DBiCGSTAB.h38 RealScalar tol = tol_error; local
63 RealScalar tol2 = tol*tol;

Completed in 697 milliseconds

12