Home
last modified time | relevance | path

Searched refs:t_eval (Results 1 – 25 of 76) sorted by relevance

1234

/dports/science/py-scipy/scipy-1.7.1/scipy/integrate/_ivp/
H A Divp.py519 if t_eval is not None:
520 t_eval = np.asarray(t_eval)
521 if t_eval.ndim != 1:
524 if np.any(t_eval < min(t0, tf)) or np.any(t_eval > max(t0, tf)):
527 d = np.diff(t_eval)
535 t_eval = t_eval[::-1]
537 t_eval_i = t_eval.shape[0]
544 if t_eval is None:
615 if t_eval is None:
646 if t_eval is None:
[all …]
/dports/science/code_saturne/code_saturne-7.1.0/src/cdo/
H A Dcs_xdef_cw_eval.h367 cs_real_t t_eval, in cs_xdef_cw_eval_scalar_face_avg_by_value() argument
373 CS_UNUSED(t_eval); in cs_xdef_cw_eval_scalar_face_avg_by_value()
409 CS_UNUSED(t_eval); in cs_xdef_cw_eval_scalar_face_avg_by_array()
446 cs_real_t t_eval, in cs_xdef_cw_eval_face_drhm_by_analytic() argument
482 CS_UNUSED(t_eval); in cs_xdef_cw_eval_vector_face_avg_by_value()
518 CS_UNUSED(t_eval); in cs_xdef_cw_eval_vector_face_avg_by_array()
560 CS_UNUSED(t_eval); in cs_xdef_cw_eval_tensor_face_avg_by_value()
598 CS_UNUSED(t_eval); in cs_xdef_cw_eval_tensor_face_avg_by_array()
776 cs_real_t t_eval,
799 cs_real_t t_eval,
[all …]
H A Dcs_equation_bc.h114 cs_equation_init_boundary_flux_from_bc(cs_real_t t_eval,
141 cs_real_t t_eval,
207 cs_equation_compute_dirichlet_vb(cs_real_t t_eval,
239 cs_real_t t_eval,
292 cs_equation_compute_neumann_sv(cs_real_t t_eval,
314 cs_equation_compute_neumann_fb(cs_real_t t_eval,
335 cs_equation_compute_robin(cs_real_t t_eval,
358 cs_equation_compute_circulation_eb(cs_real_t t_eval,
H A Dcs_property.c236 t_eval, in _get_cell_value()
309 t_eval, in _get_cell_tensor()
323 t_eval, in _get_cell_tensor()
338 t_eval, in _get_cell_tensor()
360 t_eval, in _get_cell_tensor()
1786 t_eval, in cs_property_eval_at_cells()
1804 t_eval, in cs_property_eval_at_cells()
1836 t_eval, in cs_property_eval_at_cells()
1856 t_eval, in cs_property_eval_at_cells()
1890 t_eval, in cs_property_eval_at_cells()
[all …]
H A Dcs_property.h726 cs_property_iso_get_cell_values(cs_real_t t_eval,
743 cs_property_eval_at_cells(cs_real_t t_eval,
762 cs_real_t t_eval,
781 cs_real_t t_eval,
801 cs_real_t t_eval,
821 cs_real_t t_eval);
836 cs_real_t t_eval,
H A Dcs_equation_bc.c337 ac->func(t_eval, in cs_equation_init_boundary_flux_from_bc()
422 cs_equation_compute_neumann_sv(t_eval, in cs_equation_vb_set_cell_bc()
437 cs_equation_compute_robin(t_eval, in cs_equation_vb_set_cell_bc()
698 t_eval, in cs_equation_compute_dirichlet_vb()
722 t_eval, in cs_equation_compute_dirichlet_vb()
913 t_eval, in cs_equation_compute_dirichlet_fb()
947 t_eval, in cs_equation_compute_dirichlet_fb()
1140 t_eval, in cs_equation_compute_neumann_sv()
1239 t_eval, in cs_equation_compute_neumann_fb()
1246 t_eval, in cs_equation_compute_neumann_fb()
[all …]
H A Dcs_hho_builder.h207 cs_real_t t_eval,
233 cs_real_t t_eval,
257 cs_real_t t_eval,
281 cs_real_t t_eval,
H A Dcs_cdovb_scaleq.h160 cs_cdovb_scaleq_init_values(cs_real_t t_eval,
312 cs_cdovb_scaleq_boundary_diff_flux(const cs_real_t t_eval,
363 cs_real_t t_eval,
386 cs_real_t t_eval,
H A Dcs_gwf_priv.c99 _update_vb_darcy_flux_at_boundary(cs_real_t t_eval, in _update_vb_darcy_flux_at_boundary() argument
118 cs_equation_compute_boundary_diff_flux(t_eval, eq, nflx_val); in _update_vb_darcy_flux_at_boundary()
326 cs_gwf_darcy_flux_update(const cs_real_t t_eval, in cs_gwf_darcy_flux_update() argument
361 t_eval, in cs_gwf_darcy_flux_update()
372 cs_advection_field_in_cells(adv, t_eval, vel->val); in cs_gwf_darcy_flux_update()
378 t_eval, in cs_gwf_darcy_flux_update()
383 _update_vb_darcy_flux_at_boundary(t_eval, eq, adv); in cs_gwf_darcy_flux_update()
410 cs_advection_field_across_boundary(adv, t_eval, bdy_nflx->val); in cs_gwf_darcy_flux_update()
H A Dcs_xdef_cw_eval.c123 qfunc(t_eval, cm->xv+3*v0, cm->xv+3*v1, cm->xv+3*v2, pfq.meas, in cs_xdef_cw_eval_f_int_by_analytic()
171 qfunc(t_eval, cm->xv, cm->xv+3, cm->xv+6, cm->xv+9, cm->vol_c, in cs_xdef_cw_eval_c_int_by_analytic()
315 q_tet(t_eval, xv0, xv1, xv2, cm->xc, hf_coef * pfq.meas, in cs_xdef_cw_eval_fc_int_by_analytic()
335 q_tri(t_eval, xv0, xv1, pfq.center, tef[e], in cs_xdef_cw_eval_fc_int_by_analytic()
433 cs_xdef_cw_eval_f_int_by_analytic(cm, t_eval, f, in cs_xdef_cw_eval_vector_face_avg_by_analytic()
477 cs_xdef_cw_eval_f_int_by_analytic(cm, t_eval, f, in cs_xdef_cw_eval_tensor_face_avg_by_analytic()
520 cs_xdef_cw_eval_c_int_by_analytic(cm, t_eval, in cs_xdef_cw_eval_scalar_avg_by_analytic()
563 cs_xdef_cw_eval_c_int_by_analytic(cm, t_eval, in cs_xdef_cw_eval_vector_avg_by_analytic()
608 cs_xdef_cw_eval_c_int_by_analytic(cm, t_eval, in cs_xdef_cw_eval_tensor_avg_by_analytic()
1729 cs_xdef_cw_eval_fc_int_by_analytic(cm, t_eval, in cs_xdef_cw_eval_scal_avg_reduction_by_analytic()
[all …]
H A Dcs_cdovcb_scaleq.h160 cs_cdovcb_scaleq_init_values(cs_real_t t_eval,
319 cs_cdovcb_scaleq_boundary_diff_flux(const cs_real_t t_eval,
370 cs_real_t t_eval,
392 cs_real_t t_eval,
H A Dcs_gwf_tracer.c121 CS_UNUSED(t_eval); in _get_time_pty4std_sat_tracer()
164 CS_UNUSED(t_eval); in _get_time_pty4std_sat_tracer_cw()
211 CS_UNUSED(t_eval); in _get_time_pty4std_tracer()
256 CS_UNUSED(t_eval); in _get_time_pty4std_tracer_cw()
301 CS_UNUSED(t_eval); in _get_reaction_pty4std_sat_tracer()
344 CS_UNUSED(t_eval); in _get_reaction_pty4std_sat_tracer_cw()
391 CS_UNUSED(t_eval); in _get_reaction_pty4std_tracer()
445 CS_UNUSED(t_eval); in _get_reaction_pty4std_tracer_cw()
485 CS_UNUSED(t_eval); in _update_sat_diff_pty()
572 CS_UNUSED(t_eval); in _update_diff_pty()
[all …]
H A Dcs_thermal_system.c149 cs_real_t t_eval, in _eval_aniso_kappa() argument
161 const cs_real_t rho = cs_property_get_cell_value(0, t_eval, thm->rho); in _eval_aniso_kappa()
162 const cs_real_t cp = cs_property_get_cell_value(0, t_eval, thm->cp); in _eval_aniso_kappa()
170 cs_property_get_cell_tensor(i, t_eval, thm->lambda, false, in _eval_aniso_kappa()
185 cs_property_get_cell_tensor(c_id, t_eval, thm->lambda, false, in _eval_aniso_kappa()
210 cs_real_t t_eval, in _eval_aniso_kappa_cw() argument
218 const cs_real_t rho = cs_property_get_cell_value(0, t_eval, thm->rho); in _eval_aniso_kappa_cw()
219 const cs_real_t cp = cs_property_get_cell_value(0, t_eval, thm->cp); in _eval_aniso_kappa_cw()
222 cs_property_get_cell_tensor(cm->c_id, t_eval, thm->lambda, false, in _eval_aniso_kappa_cw()
H A Dcs_cdofb_vecteq.h190 cs_cdofb_vecteq_init_values(cs_real_t t_eval,
242 cs_cdofb_vecteq_setup(cs_real_t t_eval,
320 const cs_real_t t_eval, in cs_cdofb_vecteq_sourceterm() argument
336 t_eval, in cs_cdofb_vecteq_sourceterm()
H A Dcs_hho_builder.c1503 _add_tetra_reduction(t_eval, ac, cbf, in cs_hho_builder_reduction_from_analytic()
1521 _add_tria_reduction(t_eval, ac, fbf, in cs_hho_builder_reduction_from_analytic()
1567 _add_tetra_reduction(t_eval, ac, cbf, in cs_hho_builder_reduction_from_analytic()
1681 _add_tetra_reduction_v(t_eval, ac, cbf, in cs_hho_builder_reduction_from_analytic_v()
1701 _add_tria_reduction_v(t_eval, ac, fbf, in cs_hho_builder_reduction_from_analytic_v()
1752 _add_tria_reduction_v(t_eval, ac, in cs_hho_builder_reduction_from_analytic_v()
1757 _add_tetra_reduction_v(t_eval, ac, cbf, in cs_hho_builder_reduction_from_analytic_v()
1906 _add_tria_reduction(t_eval, ac, fbf, in cs_hho_builder_compute_dirichlet()
1923 _add_tria_reduction(t_eval, ac, fbf, in cs_hho_builder_compute_dirichlet()
2040 _add_tria_reduction_v(t_eval, ac, fbf, in cs_hho_builder_compute_dirichlet_v()
[all …]
H A Dcs_hodge.h406 const cs_real_t t_eval,
426 const cs_real_t t_eval,
975 cs_real_t t_eval,
996 cs_real_t t_eval,
H A Dcs_advection_field.h862 cs_advection_field_update(cs_real_t t_eval,
879 cs_real_t t_eval,
911 cs_real_t t_eval);
H A Dcs_cdo_advection.h184 cs_real_t t_eval,
719 cs_real_t t_eval,
741 cs_real_t t_eval,
H A Dcs_cdofb_scaleq.h188 cs_cdofb_scaleq_init_values(cs_real_t t_eval,
325 cs_cdofb_scaleq_boundary_diff_flux(const cs_real_t t_eval,
/dports/science/code_saturne/code_saturne-7.1.0/src/base/
H A Dcs_volume_mass_injection.c261 const cs_real_t t_eval = cs_glob_time_step->t_cur; in _volume_mass_injection_eval() local
280 t_eval, in _volume_mass_injection_eval()
292 t_eval, in _volume_mass_injection_eval()
310 t_eval, in _volume_mass_injection_eval()
324 t_eval, in _volume_mass_injection_eval()
337 t_eval, in _volume_mass_injection_eval()
373 t_eval, in _volume_mass_injection_eval()
383 t_eval, in _volume_mass_injection_eval()
390 t_eval, in _volume_mass_injection_eval()
403 t_eval, in _volume_mass_injection_eval()
[all …]
H A Dcs_xdef_eval_at_zone.c126 cs_real_t t_eval, in cs_xdef_eval_at_zone() argument
177 ac->func(t_eval, in cs_xdef_eval_at_zone()
411 t_eval, in cs_xdef_eval_at_zone()
421 t_eval, in cs_xdef_eval_at_zone()
431 t_eval, in cs_xdef_eval_at_zone()
/dports/science/py-scipy/scipy-1.7.1/scipy/integrate/_ivp/tests/
H A Dtest_ivp.py604 t_eval=t_eval)
616 t_eval=t_eval)
617 assert_equal(res.t, t_eval)
628 t_eval=t_eval)
629 assert_equal(res.t, t_eval)
636 t_eval=t_eval)
648 t_eval=t_eval)
654 t_eval = [4, 6]
656 rtol=rtol, atol=atol, t_eval=t_eval)
666 t_eval=t_eval)
[all …]
/dports/graphics/py-mpl-interactions/mpl_interactions-0.19.0/docs/examples/
H A Drossler-attractor.ipynb62 "t_eval = np.linspace(0, 500, 1550)\n",
81 " out = solve_ivp(deriv, t_span, y0=[x0, y0, z0], t_eval=t_eval).y[:2]\n",
141 " out = solve_ivp(deriv, t_span, y0=[0, 1, 0], t_eval=t_eval).y[:2]\n",
159 " c=t_eval,\n",
/dports/graphics/gmt/gmt-6.3.0/src/potential/
H A Dgrdflexure.c1023 unsigned int t_eval, t_load, n_load_times = 0; in GMT_grdflexure() local
1156 …for (t_eval = 0; t_eval < Ctrl->T.n_eval_times; t_eval++) { /* For each time step (i.e., at least … in GMT_grdflexure()
1160 R->eval_time_yr = Ctrl->T.time[t_eval].value; /* In years */ in GMT_grdflexure()
1161 …on for time %g %s\n", Ctrl->T.time[t_eval].value * Ctrl->T.time[t_eval].scale, gmt_modeltime_unit … in GMT_grdflexure()
1175 if (This_Load->Time->u == Ctrl->T.time[t_eval].u) { /* Same time units even */ in GMT_grdflexure()
1176 …_Load->Time->value * This_Load->Time->scale - Ctrl->T.time[t_eval].value * Ctrl->T.time[t_eval].sc… in GMT_grdflexure()
1215 gmt_modeltime_name (GMT, file, Ctrl->G.file, &Ctrl->T.time[t_eval]); in GMT_grdflexure()
1216 …sprintf (remark, "Solution for t = %g %s", Ctrl->T.time[t_eval].value * Ctrl->T.time[t_eval].scale, in GMT_grdflexure()
1217 gmt_modeltime_unit (Ctrl->T.time[t_eval].u)); in GMT_grdflexure()
1244 …sprintf (tmp, time_fmt, Ctrl->T.time[t_eval].value * Ctrl->T.time[t_eval].scale, Ctrl->T.time[t_ev… in GMT_grdflexure()
[all …]
/dports/science/cp2k/cp2k-2e995eec7fd208c8a72d9544807bd8b8ba8cd1cc/src/
H A Dqs_scf_lanczos.F147 ALLOCATE (krylov_space%t_eval(ndim))
195 REAL(dp), DIMENSION(:), POINTER :: c_res, t_eval local
205 NULLIFY (c_res, t_eval)
216 t_eval => krylov_space%t_eval
416 CALL choose_eigv_solver(t_mat, t_vec, t_eval)
534 REAL(dp), DIMENSION(:), POINTER :: c_res, t_eval local
546 NULLIFY (c_res, t_eval)
559 t_eval => krylov_space%t_eval
801 CALL dsyevd('V', 'U', ndim, t_mat(1, 1), ndim, t_eval(1), &

1234