Home
last modified time | relevance | path

Searched defs:atol (Results 1 – 25 of 1156) sorted by relevance

12345678910>>...47

/dports/science/py-OpenFermion/OpenFermion-1.3.0/src/openfermion/circuits/primitives/
H A Dbogoliubov_transform_test.py48 atol=5e-6): argument
68 atol=5e-5): argument
122 atol=5e-5): argument
181 n_qubits, atol): argument
202 n_qubits, real, particle_conserving, atol): argument
235 def test_bogoliubov_transform_compose(n_qubits, atol): argument
H A Dstate_preparation_test.py34 atol=1e-5): argument
77 atol=1e-5): argument
149 atol=1e-7): argument
/dports/science/py-ase/ase-3.22.0/ase/test/
H A Dtest_calculator_equal.py14 def test_single_value(a, b, rtol, atol): argument
22 def test_array_equal(a, b, rtol, atol): argument
38 def test_array_almost_equal(a, b, rtol, atol): argument
49 def test_array_not_equal(a, b, rtol, atol): argument
/dports/science/py-pymatgen/pymatgen-2022.0.15/pymatgen/util/
H A Dcoord.py23 def find_in_coord_list(coord_list, coord, atol=1e-8): argument
42 def in_coord_list(coord_list, coord, atol=1e-8): argument
58 def is_coord_subset(subset, superset, atol=1e-8): argument
76 def coord_list_mapping(subset, superset, atol=1e-8): argument
99 def coord_list_mapping_pbc(subset, superset, atol=1e-8): argument
206 def find_in_coord_list_pbc(fcoord_list, fcoord, atol=1e-8): argument
228 def in_coord_list_pbc(fcoord_list, fcoord, atol=1e-8): argument
243 def is_coord_subset_pbc(subset, superset, atol=1e-8, mask=None): argument
/dports/science/py-scipy/scipy-1.7.1/scipy/sparse/linalg/isolve/
H A Diterative.py67 def _stoptest(residual, atol): argument
78 def _get_atol(tol, atol, bnrm2, get_residual, routine_name): argument
150 def bicg(A, b, x0=None, tol=1e-5, maxiter=None, M=None, callback=None, atol=None): argument
222 def bicgstab(A, b, x0=None, tol=1e-5, maxiter=None, M=None, callback=None, atol=None): argument
289 def cg(A, b, x0=None, tol=1e-5, maxiter=None, M=None, callback=None, atol=None): argument
360 def cgs(A, b, x0=None, tol=1e-5, maxiter=None, M=None, callback=None, atol=None): argument
433 restrt=None, atol=None, callback_type=None): argument
666 atol=None): argument
/dports/math/py-pymc3/pymc-3.11.4/pymc3/tests/
H A Dtest_posteriors.py29 atol = 0.05 variable in TestNUTSUniform
39 atol = 0.05 variable in TestMetropolisUniform
49 atol = 0.05 variable in TestSliceUniform
67 atol = 0.05 variable in TestNUTSNormal
86 atol = 0.05 variable in TestNUTSStudentT
97 atol = 0.001 variable in TestNUTSNormalLong
/dports/science/cantera/cantera-2.5.1-611-gc4d6ecc15/interfaces/cython/cantera/test/
H A Dutilities.py71 def assertNear(self, a, b, rtol=1e-8, atol=1e-12, msg=None): argument
80 def assertArrayNear(self, A, B, rtol=1e-8, atol=1e-12, msg=None): argument
102 def compare(self, data, reference_file, rtol=1e-8, atol=1e-12): argument
121 def compareProfiles(reference, sample, rtol=1e-5, atol=1e-12, xtol=1e-5): argument
/dports/devel/py-pythran/pythran-0.11.0/pythran/pythonic/numpy/
H A Dallclose.hpp18 bool _allclose(I0 begin, I0 end, I1 ibegin, double rtol, double atol, in _allclose()
34 bool _allclose(I0 begin, I0 end, I1 ibegin, double rtol, double atol, in _allclose()
46 bool allclose(U const &u, V const &v, double rtol, double atol) in allclose()
/dports/astro/py-pykep/pykep-2.6/pykep/pontryagin/
H A D_leg.py251 def _propagate(self, atol, rtol): argument
286 def mismatch_constraints(self, atol=1e-5, rtol=1e-5): argument
429 def get_states(self, atol=1e-12, rtol=1e-12): argument
522 def plot_traj(self, axes, mark="k", atol=1e-11, rtol=1e-11, units=AU, quiver=False, length=1): argument
597 …def plot(self, x, y, mark="k.-", atol=1e-12, rtol=1e-12, unitsx=1, unitsy=1, xlabel=False, ylabel=… argument
/dports/astro/pykep/pykep-2.6/pykep/pontryagin/
H A D_leg.py251 def _propagate(self, atol, rtol): argument
286 def mismatch_constraints(self, atol=1e-5, rtol=1e-5): argument
429 def get_states(self, atol=1e-12, rtol=1e-12): argument
522 def plot_traj(self, axes, mark="k", atol=1e-11, rtol=1e-11, units=AU, quiver=False, length=1): argument
597 …def plot(self, x, y, mark="k.-", atol=1e-12, rtol=1e-12, unitsx=1, unitsy=1, xlabel=False, ylabel=… argument
/dports/finance/py-quantecon/quantecon-0.5.2/quantecon/
H A Drank_nullspace.py5 def rank_est(A, atol=1e-13, rtol=0): argument
52 def nullspace(A, atol=1e-13, rtol=0): argument
/dports/misc/mxnet/incubator-mxnet-1.9.0/3rdparty/tvm/tests/python/unittest/
H A Dtest_custom_datatypes.py90 def compare(module, input, src_dtype, dst_dtype, rtol, atol, params={}, target="llvm"): argument
332 def run_ops(src_dtype, dst_dtype, rtol=1e-7, atol=1e-7): argument
394 def run_model(get_workload, input, src_dtype, dst_dtype, rtol=1e-4, atol=1e-4): argument
402 def run_conv2d(src_dtype, dst_dtype, rtol=1e-7, atol=1e-4): argument
492 def run_batchnorm(src_dtype, dst_dtype, rtol=1e-6, atol=1e-6): argument
/dports/lang/rust/rustc-1.58.1-src/src/test/ui/abi/
H A Dc-stack-returning-int64.rs15 pub fn atol(x: *const c_char) -> c_long; in atol() function
20 fn atol(s: String) -> isize { in atol() function
/dports/lang/rust/rustc-1.58.1-src/src/test/incremental/
H A Dforeign.rs17 pub fn atol(x: *const c_char) -> c_long; in atol() function
22 fn atol(s: String) -> isize { in atol() function
/dports/science/py-pymatgen/pymatgen-2022.0.15/pymatgen/symmetry/
H A Dbandstructure.py58 atol=1e-5, argument
191 def _get_lm_kpath(self, has_magmoms, magmom_axis, symprec, angle_tolerance, atol): argument
199 def _get_sc_kpath(self, symprec, angle_tolerance, atol): argument
213 def _get_hin_kpath(self, symprec, angle_tolerance, atol, tri): argument
H A Dkpath.py46 def __init__(self, structure, symprec=0.01, angle_tolerance=5, atol=1e-5, *args, **kwargs): argument
152 def __init__(self, structure, symprec=0.01, angle_tolerance=5, atol=1e-5): argument
1093 atol=1e-5, argument
1745 def _get_magnetic_symmetry_operations(self, struct, grey_ops, atol): argument
1875 def _all_ints(arr, atol): argument
1879 def _get_IRBZ(self, recip_point_group, W, key_points, face_center_inds, atol): argument
2074 def _get_reciprocal_point_group_dict(recip_point_group, atol): argument
2153 def _op_maps_IRBZ_to_self(op, IRBZ_points, atol): argument
2168 def _reduce_IRBZ(IRBZ_points, boundaries, g, atol): argument
2185 def _get_orbit_labels(self, orbit_cosines_orig, key_points_inds_orbits, atol): argument
[all …]
/dports/math/py-jax/jax-0.2.9/jax/experimental/
H A Dode.py73 def initial_step_size(fun, t0, y0, order, rtol, atol, f0): argument
129 def error_ratio(error_estimate, rtol, atol, y0, y1): argument
145 def odeint(func, y0, t, *args, rtol=1.4e-8, atol=1.4e-8, mxstep=jnp.inf): argument
176 def _odeint_wrapper(func, rtol, atol, mxstep, y0, ts, *args): argument
183 def _odeint(func, rtol, atol, mxstep, y0, ts, *args): argument
217 def _odeint_fwd(func, rtol, atol, mxstep, y0, ts, *args): argument
221 def _odeint_rev(func, rtol, atol, mxstep, res, g): argument
/dports/math/openturns/openturns-1.18/python/test/
H A Dt_GaussianNonLinearCalibration_noobs.py72 atol = 0.5 variable
96 atol = 0.5 variable
108 atol = 0.5 variable
/dports/cad/calculix-ccx/CalculiX/ccx_2.18/src/
H A Dmoehring.f369 real*8 f_k,x,rpar(8),rtol,atol,y(1),info(15), local
424 real*8 f_p,x,rpar(8),rtol,atol,y(1),info(15),Rurd, local
476 real*8 f_t,x,rpar(8),rtol,atol,y(1),info(15),Rurd, local
533 real*8 f_m,x,rpar(8),rtol,atol,y(1),info(15), local
588 real*8 f_cm,x,rpar(8),rtol,atol,y(1),info(15), local
/dports/astro/py-astropy/astropy-5.0/astropy/utils/
H A Ddiff.py18 def diff_values(a, b, rtol=0.0, atol=0.0): argument
141 def where_not_allclose(a, b, rtol=1e-5, atol=1e-8): argument
/dports/math/openturns/openturns-1.18/lib/include/openturns/
H A DOTtestcode.hxx299 …t_equal(const Scalar a, const Scalar b, const Scalar rtol = 1.0e-5, const Scalar atol = 1.0e-8, co… in assert_almost_equal()
320 …equal(const Point & a, const Point & b, const Scalar rtol = 1.0e-5, const Scalar atol = 1.0e-8, co… in assert_almost_equal()
332 …ual(const Sample & a, const Sample & b, const Scalar rtol = 1.0e-5, const Scalar atol = 1.0e-8, co… in assert_almost_equal()
349 …equal(const Matrix &a, const Matrix &b, const Scalar rtol = 1.0e-5, const Scalar atol = 1.0e-8, co… in assert_almost_equal()
367 …ricMatrix &a, const SymmetricMatrix &b, const Scalar rtol = 1.0e-5, const Scalar atol = 1.0e-8, co… in assert_almost_equal()
/dports/www/grafana8/grafana-8.3.6/vendor/github.com/apache/arrow/cpp/src/arrow/
H A Dcompare.h52 double atol() const { return atol_; } in atol() function
55 EqualOptions atol(double v) const { in atol() function
/dports/databases/arrow/apache-arrow-6.0.1/cpp/src/arrow/
H A Dcompare.h52 double atol() const { return atol_; } in atol() function
55 EqualOptions atol(double v) const { in atol() function
/dports/security/vault/vault-1.8.2/vendor/github.com/apache/arrow/cpp/src/arrow/
H A Dcompare.h52 double atol() const { return atol_; } in atol() function
55 EqualOptions atol(double v) const { in atol() function
/dports/math/octave-forge-octclip/octclip-2.0.1/src/
H A Ddpeucker.c58 double atol=fabs(tol); in AligeraPolilinea() local
125 double atol=fabs(tol); in DouglasPeuckerOriginal() local
246 double atol=fabs(tol); in DouglasPeuckerRobusto() local

12345678910>>...47