Home
last modified time | relevance | path

Searched refs:dtmax (Results 1 – 25 of 84) sorted by relevance

1234

/dports/devel/android-tools-fastboot/platform_system_core-platform-tools-29.0.5/extras/tests/timetest/
H A Dtimetest.c61 struct timespec t1, dtmin, dtminp, dtmax; in main() local
69 dtmax.tv_sec = 0; in main()
70 dtmax.tv_nsec = 0; in main()
88 dtmax = ts_max(dtmax, dt); in main()
93 dtmax.tv_sec, dtmax.tv_nsec); in main()
/dports/comms/wsjtz/wsjtx/lib/
H A Dafc65b.f9022 chisq=fchisq65(cx,npts,fsample,nflip,a,ccf,dtmax)
55 chisq1=fchisq65(cx,npts,fsample,nflip,a,ccfmax,dtmax)
59 chisq2=fchisq65(cx,npts,fsample,nflip,a,ccfmax,dtmax)
70 chisq3=fchisq65(cx,npts,fsample,nflip,a,ccfmax,dtmax)
84 chisqr=fchisq65(cx,npts,fsample,nflip,a,ccfmax,dtmax)
91 dtbest=dtmax
/dports/comms/wsjtz/wsjtx/map65/libm65/
H A Dafc65b.f9028 chisq1=fchisq(cx,cy,npts,fsample,nflip,a,ccfmax,dtmax)
32 chisq2=fchisq(cx,cy,npts,fsample,nflip,a,ccfmax,dtmax)
43 chisq3=fchisq(cx,cy,npts,fsample,nflip,a,ccfmax,dtmax)
55 chisqr=fchisq(cx,cy,npts,fsample,nflip,a,ccfmax,dtmax)
61 dtbest=dtmax
/dports/science/code_saturne/code_saturne-7.1.0/src/base/
H A Dcs_time_step.c270 .dtmax = -1.e13,
303 double **dtmax,
377 double **dtmax, in cs_f_time_step_options_get_pointers() argument
387 *dtmax = &(_time_step_options.dtmax ); in cs_f_time_step_options_get_pointers()
663 cs_glob_time_step_options->dtmax, in cs_time_step_log_setup()
H A Ddttvar.f90572 if (dtloc.gt.dtmax) then
573 dtloc = dtmax
609 if (dt(iel).gt.dtmax) then
611 dt(iel) = dtmax
632 write (nfecra,1003) icfmin(1),dtmin,icfmax(1),dtmax
/dports/science/py-MDAnalysis/MDAnalysis-0.19.2/MDAnalysis/analysis/
H A Dwaterdynamics.py480 self.dtmax = dtmax
664 h_list, 0, self.tf - 1, self.dtmax)
673 h_list.timeseries, self.t0, self.tf, self.dtmax)
709 def __init__(self, universe, selection, t0, tf, dtmax, nproc=1): argument
714 self.dtmax = dtmax
866 for dt in list(range(1, self.dtmax + 1)):
1053 def __init__(self, universe, selection, t0, tf, dtmax, nproc=1): argument
1058 self.dtmax = dtmax
1171 for dt in list(range(1, self.dtmax + 1)):
1223 if dtmax is not None:
[all …]
/dports/science/py-ase/ase-3.22.0/ase/optimize/
H A Dfire.py9 dt=0.1, maxstep=None, maxmove=None, dtmax=1.0, Nmin=5, argument
70 self.dtmax = dtmax
122 self.dt = min(self.dt * self.finc, self.dtmax)
/dports/math/mfem/mfem-4.3/miniapps/electromagnetics/
H A Dmaxwell.cpp122 int SnapTimeStep(double tmax, double dtmax, double & dt);
275 double dtmax = Maxwell.GetMaximumTimeStep(); in main() local
284 cout << "Maximum Time Step: " << dtmax / tScale_ << "ns" << endl; in main()
288 int nsteps = SnapTimeStep(tf-ti, dtsf * dtmax, dt); in main()
506 SnapTimeStep(double tmax, double dtmax, double & dt) in SnapTimeStep() argument
508 double dsteps = tmax/dtmax; in SnapTimeStep()
/dports/science/py-ase/ase-3.22.0/ase/test/optimize/
H A Dtest_fire.py18 opt = FIRE(a, dtmax=1.0, dt=1.0, maxstep=100.0, downhill_check=False)
35 opt = FIRE(a, dtmax=1.0, dt=1.0, maxstep=100.0, downhill_check=True,
/dports/science/PETSc/petsc-3.14.1/src/snes/tutorials/
H A Dex74fcomd.h5 double precision dt, dtmin, dtmax, dtgrow, tfinal, tplot, tcscal, hcscal
21 common /timcnt/ time, dt, dtmin, dtmax, dtgrow, tfinal, tplot, tcscal, hcscal
/dports/science/py-ase/ase-3.22.0/ase/optimize/precon/
H A Dfire.py11 dt=0.1, maxmove=0.2, dtmax=1.0, Nmin=5, finc=1.1, fdec=0.5, argument
51 self.dtmax = dtmax
123 self.dt = min(self.dt * self.finc, self.dtmax)
/dports/science/py-ase/ase-3.22.0/ase/test/neb/
H A Dtest_neb_tr.py53 qn = FIRE(neb, dt=0.005, maxstep=0.05, dtmax=0.1)
60 qn = FIRE(neb, dt=0.005, maxstep=0.05, dtmax=0.1)
/dports/science/cantera/cantera-2.5.1-611-gc4d6ecc15/src/equil/
H A DMultiPhase.cpp534 double dtmax = 0.5*fabs(Thigh - Tlow); in equilibrate_MultiPhaseEquil() local
535 if (dta > dtmax) { in equilibrate_MultiPhaseEquil()
536 dt *= dtmax/dta; in equilibrate_MultiPhaseEquil()
590 double dtmax = 0.5*fabs(Thigh - Tlow); in equilibrate_MultiPhaseEquil() local
591 dtmax = (dtmax > 500.0 ? 500.0 : dtmax); in equilibrate_MultiPhaseEquil()
593 if (dta > dtmax) { in equilibrate_MultiPhaseEquil()
594 dt *= dtmax/dta; in equilibrate_MultiPhaseEquil()
/dports/science/lammps/lammps-stable_29Sep2021/src/SPIN/
H A Dmin_spin.cpp202 double dtmax; in evaluate_dt() local
236 dtmax = MY_2PI/(discrete_factor*sqrt(fmaxsqall)); in evaluate_dt()
238 return dtmax; in evaluate_dt()
/dports/games/briquolo/briquolo-0.5.7/src/
H A DElementCollision.h74 float tmax, float dtmax);
90 float tmax, float dtmax, float detmax);
/dports/science/code_saturne/code_saturne-7.1.0/src/cdo/
H A Dcs_cdo_main.c433 double dtmax = CS_MAX(ts_opt->dtmax, ts->dt[0]); in _define_current_time_step() local
436 ts_opt->dtmax = dtmax; in _define_current_time_step()
/dports/devel/boost-docs/boost_1_72_0/boost/numeric/odeint/stepper/detail/
H A Dpid_step_adjuster.hpp129 pid_step_adjuster(double abs_tol = 1e-6, double rel_tol = 1e-6, time_type dtmax = 1.0) in pid_step_adjuster()
130 :m_dtmax(dtmax), m_error_storage(), m_dt_storage(), m_init(0), in pid_step_adjuster()
/dports/devel/hyperscan/boost_1_75_0/boost/numeric/odeint/stepper/detail/
H A Dpid_step_adjuster.hpp129 pid_step_adjuster(double abs_tol = 1e-6, double rel_tol = 1e-6, time_type dtmax = 1.0) in pid_step_adjuster()
130 :m_dtmax(dtmax), m_error_storage(), m_dt_storage(), m_init(0), in pid_step_adjuster()
/dports/devel/R-cran-BH/BH/inst/include/boost/numeric/odeint/stepper/detail/
H A Dpid_step_adjuster.hpp129 pid_step_adjuster(double abs_tol = 1e-6, double rel_tol = 1e-6, time_type dtmax = 1.0) in pid_step_adjuster()
130 :m_dtmax(dtmax), m_error_storage(), m_dt_storage(), m_init(0), in pid_step_adjuster()
/dports/math/stanmath/math-4.2.0/lib/boost_1.75.0/boost/numeric/odeint/stepper/detail/
H A Dpid_step_adjuster.hpp129 pid_step_adjuster(double abs_tol = 1e-6, double rel_tol = 1e-6, time_type dtmax = 1.0) in pid_step_adjuster()
130 :m_dtmax(dtmax), m_error_storage(), m_dt_storage(), m_init(0), in pid_step_adjuster()
/dports/science/py-scipy/scipy-1.7.1/scipy/_lib/boost/boost/numeric/odeint/stepper/detail/
H A Dpid_step_adjuster.hpp129 pid_step_adjuster(double abs_tol = 1e-6, double rel_tol = 1e-6, time_type dtmax = 1.0) in pid_step_adjuster()
130 :m_dtmax(dtmax), m_error_storage(), m_dt_storage(), m_init(0), in pid_step_adjuster()
/dports/devel/boost-libs/boost_1_72_0/boost/numeric/odeint/stepper/detail/
H A Dpid_step_adjuster.hpp129 pid_step_adjuster(double abs_tol = 1e-6, double rel_tol = 1e-6, time_type dtmax = 1.0) in pid_step_adjuster()
130 :m_dtmax(dtmax), m_error_storage(), m_dt_storage(), m_init(0), in pid_step_adjuster()
/dports/devel/boost-python-libs/boost_1_72_0/boost/numeric/odeint/stepper/detail/
H A Dpid_step_adjuster.hpp129 pid_step_adjuster(double abs_tol = 1e-6, double rel_tol = 1e-6, time_type dtmax = 1.0) in pid_step_adjuster()
130 :m_dtmax(dtmax), m_error_storage(), m_dt_storage(), m_init(0), in pid_step_adjuster()
/dports/science/siesta/siesta-4.1.5/Src/
H A Dm_fire.f9033 real(dp) :: dtmax = FIRE_DEF_dtmax component
129 b%dt = min(b%dt * b%dt_inc, b%dtmax)
/dports/science/lammps/lammps-stable_29Sep2021/src/
H A Dmin_fire_old.h37 double dt, dtmax;

1234