/aosp_15_r20/external/eigen/unsupported/test/ |
H A D | matrix_power.cpp | 13 void test2dRotation(const T& tol) in test2dRotation() 34 void test2dHyperbolicRotation(const T& tol) in test2dHyperbolicRotation() 56 void test3dRotation(const T& tol) in test3dRotation() 70 void testGeneral(const MatrixType& m, const typename MatrixType::RealScalar& tol) in testGeneral() 100 void testSingular(const MatrixType& m_const, const typename MatrixType::RealScalar& tol) in testSingular() 133 void testLogThenExp(const MatrixType& m_const, const typename MatrixType::RealScalar& tol) in testLogThenExp()
|
H A D | matrix_exponential.cpp | 27 void test2dRotation(double tol) in test2dRotation() 49 void test2dHyperbolicRotation(double tol) in test2dHyperbolicRotation() 74 void testPascal(double tol) in testPascal() 98 void randomTest(const MatrixType& m, double tol) in randomTest()
|
/aosp_15_r20/external/skia/src/gpu/ganesh/ops/ |
H A D | TriangulatingPathRenderer.cpp | 97 static sk_sp<SkData> create_data(int numVertices, bool isLinear, SkScalar tol) { in create_data() 102 bool cache_match(const SkData* data, SkScalar tol) { in cache_match() 307 SkScalar tol, in Triangulate() 332 SkScalar tol = GrPathUtils::scaleToleranceToSrc(GrPathUtils::kDefaultTolerance, in createNonAAMesh() local 400 SkScalar tol = GrPathUtils::kDefaultTolerance; in createAAMesh() local 491 SkScalar tol = GrPathUtils::scaleToleranceToSrc(GrPathUtils::kDefaultTolerance, in onPrePrepareDraws() local
|
/aosp_15_r20/external/tensorflow/tensorflow/python/kernel_tests/linalg/ |
H A D | svd_op_test.py | 123 def CompareSingularValues(self, x, y, tol): argument 127 def CompareSingularVectors(self, x, y, rank, tol): argument 144 def CheckApproximation(self, a, u, s, v, full_matrices_, tol): argument 161 def CheckUnitary(self, x, tol): argument
|
H A D | self_adjoint_eig_op_test.py | 121 def CompareEigenVectors(self, x, y, tol): argument 125 def CompareEigenDecompositions(self, x_e, x_v, y_e, y_v, tol): argument
|
H A D | eig_op_test.py | 137 def CompareEigenVectors(self, x, y, tol): argument 141 def CompareEigenDecompositions(self, x_e, x_v, y_e, y_v, tol): argument
|
/aosp_15_r20/external/sdv/vsomeip/third_party/boost/numeric/ublas/test/ |
D | utils.hpp | 87 bool close_to(T1 x, T2 y, T3 tol) in close_to() 103 bool close_to(::std::complex<T1> const& x, ::std::complex<T2> const& y, T3 tol) in close_to() 122 bool rel_close_to(T1 x, T2 y, T3 tol) in rel_close_to() 138 bool rel_close_to(::std::complex<T1> const& x, ::std::complex<T2> const& y, T3 tol) in rel_close_to()
|
/aosp_15_r20/external/tensorflow/tensorflow/compiler/xla/service/ |
H A D | eigh_expander.cc | 120 auto tol = ScalarLike(w_tr, 1e-6); in HermitianEigenDecomposition2x2() local 314 auto tol = norms.frobenius_sq_norm * Square(values[1]); in Sweeps() local 332 XlaOp tol, w_tl, w_tr, w_bl, w_br, v_tl, v_tr, v_bl, v_br; in Sweeps() local 429 XlaOp EighExpander::BuildEigh(XlaOp a, bool lower, int64_t max_iter, float tol, in BuildEigh() 575 float tol; in ExpandInstruction() local
|
/aosp_15_r20/external/tensorflow/tensorflow/python/kernel_tests/math_ops/ |
H A D | cwise_ops_unary_test.py | 117 def _check(self, result_tensor, result_np, input_sp_t, tol): argument 127 def _compareSparseCpu(self, x, np_func, tf_func, tol): argument 144 def _compareSparseGpu(self, x, np_func, tf_func, tol): argument 155 def _compareBothSparse(self, x, np_func, tf_func, tol=None): argument
|
/aosp_15_r20/external/skia/tests/ |
H A D | PathCoverageTest.cpp | 66 static inline uint32_t compute_pointCount(SkScalar d, SkScalar tol) { in compute_pointCount() 81 static uint32_t quadraticPointCount_EC(const SkPoint points[], SkScalar tol) { in quadraticPointCount_EC() 91 static uint32_t quadraticPointCount_CC(const SkPoint points[], SkScalar tol) { in quadraticPointCount_CC()
|
H A D | ClipCubicTest.cpp | 52 float tol) { in CurvesAreEqual() 91 const float tol = 1e-4f; in DEF_TEST() local
|
/aosp_15_r20/external/pytorch/torch/csrc/api/include/torch/ |
H A D | linalg.h | 235 inline Tensor matrix_rank(const Tensor& input, double tol, bool hermitian) { in matrix_rank() 241 const Tensor& tol, in matrix_rank() 265 double tol, in matrix_rank_out() 273 const Tensor& tol, in matrix_rank_out() 763 inline Tensor matrix_rank(const Tensor& input, double tol, bool hermitian) { in matrix_rank() 769 const Tensor& tol, in matrix_rank() 793 double tol, in matrix_rank_out() 801 const Tensor& tol, in matrix_rank_out()
|
/aosp_15_r20/external/skia/src/core/ |
H A D | SkRect.cpp | 268 float tol) { in QuadContainsRect() 272 bool SkRectPriv::QuadContainsRect(const SkM44& m, const SkRect& a, const SkRect& b, float tol) { in QuadContainsRect() 279 float tol) { in QuadContainsRectMask()
|
H A D | SkCubicClipper.cpp | 40 const SkScalar tol = SK_Scalar1 / 16384; // This leaves 2 fixed noise bits. in ChopMonoAtY() local 86 const SkScalar tol = SK_Scalar1 / 65536; // 1 for fixed, 1e-5 for float. in ChopMonoAtY() local
|
/aosp_15_r20/external/python/cpython3/Lib/test/ |
D | test_statistics.py | 82 def approx_equal(x, y, tol=1e-12, rel=1e-7): argument 209 tol = rel = 0 variable in NumericTestCase 212 self, first, second, tol=None, rel=None, msg=None argument 255 def _check_approx_seq(self, first, second, tol, rel, msg): argument 266 def _check_approx_num(self, first, second, tol, rel, msg, idx=None): argument 276 def _make_std_err_msg(first, second, tol, rel, idx): argument 362 def do_symmetry_test(self, a, b, tol, rel): argument 375 def do_exactly_equal_test(self, x, tol, rel): argument 556 def do_check_both(self, a, b, tol, rel, tol_flag, rel_flag): argument 654 def generate_substrings(self, first, second, tol, rel, idx): argument
|
/aosp_15_r20/external/eigen/unsupported/Eigen/src/NonLinearOptimization/ |
H A D | LevenbergMarquardt.h | 137 const Scalar tol in lmder1() 365 const Scalar tol in lmstr1() 630 const Scalar tol in lmdif1()
|
H A D | HybridNonLinearSolver.h | 124 const Scalar tol in hybrj1() 360 const Scalar tol in hybrd1()
|
/aosp_15_r20/external/pytorch/aten/src/ATen/test/ |
H A D | cuda_complex_math_test.cu | 20 #define C10_ASSERT_NEAR(a, b, tol) assert(abs(a - b) < tol) argument 38 #define C10_ASSERT_NEAR(a, b, tol) ASSERT_NEAR(a, b, tol) argument
|
/aosp_15_r20/external/ComputeLibrary/examples/gemm_tuner/ |
H A D | GemmTuner.py | 141 def is_close_to(self, other, tol): argument 144 def is_better_than(self, other, tol): argument 207 def __init__(self, tol=0.01): argument
|
/aosp_15_r20/external/skia/tools/viewer/ |
H A D | PathSlide.cpp | 258 const SkScalar tol = 4; in onFindClickHandler() local 378 const SkScalar tol = 4; in onFindClickHandler() local 510 const SkScalar tol = 8; in onFindClickHandler() local 649 const SkScalar tol = 8; in onFindClickHandler() local
|
/aosp_15_r20/external/eigen/test/ |
H A D | eigensolver_complex.cpp | 16 template<typename MatrixType> bool find_pivot(typename MatrixType::Scalar tol, MatrixType &diffs, I… in find_pivot() 65 …RealScalar tol = test_precision<RealScalar>()*test_precision<RealScalar>()*numext::maxi(vec1.squar… in verify_is_approx_upto_permutation() local
|
/aosp_15_r20/external/pytorch/test/inductor/ |
H A D | test_padding.py | 113 def check_close(self, ref, act, tol=1e-3): argument 127 def common_numeric_check(self, f, *args, tol=1e-3, **kwargs): argument 243 def run_acc_and_perf_test(self, model, inputs, perf_inputs=None, tol=1e-3): argument
|
/aosp_15_r20/external/eigen/unsupported/Eigen/src/Eigenvalues/ |
H A D | ArpackSelfAdjointEigenSolver.h | 321 std::string eigs_sigma, int options, RealScalar tol) in compute() 334 std::string eigs_sigma, int options, RealScalar tol) in compute()
|
/aosp_15_r20/external/tensorflow/tensorflow/python/kernel_tests/signal/ |
H A D | spectral_ops_test.py | 83 def _compare(self, signal, frame_length, frame_step, fft_length, tol): argument 163 frame_step, fft_length, np_rtype, tol): argument
|
/aosp_15_r20/external/tensorflow/tensorflow/core/kernels/linalg/ |
H A D | tridiagonal_solve_op.cc | 241 RealScalar tol = eps * std::abs(denom); in SolveWithGaussianEliminationWithPivotingAndPerturbSingular() local 314 RealScalar tol = eps * max_abs_u; in SolveWithGaussianEliminationWithPivotingAndPerturbSingular() local
|