My Project
programmer's documentation
|
Data Types | |
interface | boundary_conditions_mapped_set |
Set mapped boundary conditions for a given field and mapping locator. More... | |
interface | cs_fan_n_fans |
Return the number of fans. More... | |
interface | cs_map_name_to_id_destroy |
Destroy name to id map structure. More... | |
interface | cs_time_moment_is_active |
Return if moment is active (1) or not (0). More... | |
interface | cs_time_moment_n_moments |
Return the number of temporal moments. More... | |
type | gas_mix_species_prop |
type | gwf_soilwater_partition |
interface | les_filter |
Compute filters for dynamic models. More... | |
interface | log_iteration |
interface | log_l2residual |
interface | max_limiter_building |
interface | parameters_read_restart_info |
Read restart metadata. More... | |
interface | restart_check_base_location |
Check the locations associated with a restart file. More... | |
interface | restart_destroy |
Destroy structure associated with a restart file (and close the file). More... | |
interface | restart_read_bc_coeffs |
Read boundary condition coefficients for all fields from checkpoint. More... | |
interface | restart_read_field_info |
Read field metadata from checkpoint. More... | |
interface | restart_read_fields |
Loop over all fields and read them in the restart file which id is passed in argument if it matches their "restart_file" key value. More... | |
interface | restart_write_bc_coeffs |
Write boundary condition coefficients for all fields to checkpoint. More... | |
interface | restart_write_field_info |
Write field metadata to checkpoint. More... | |
interface | restart_write_fields |
Loop over all fields and save them in the restart file which id is passed in argument if it matches their "restart_file" key value. More... | |
type | solving_info |
interface | time_moment_field_id |
Get field id associated with a given moment. More... | |
interface | time_moment_log_iteration |
Log temporal moments initialization. More... | |
interface | time_moment_restart_read |
Read temporal moments checkpoint information. More... | |
interface | time_moment_restart_write |
Checkpoint temporal moments. More... | |
interface | time_moment_update_all |
Update temporal moments. More... | |
interface | timer_stats_increment_time_step |
Increment time step for timer statistics. More... | |
interface | timer_stats_set_plot |
Enable or disable plotting for a timer statistic. More... | |
interface | timer_stats_start |
Start a timer for a given statistic. More... | |
interface | timer_stats_stop |
Stop a timer for a given statistic. More... | |
interface | timer_stats_switch |
Start a timer for a given statistic, stopping previous timers of the same type which are not a parent, and starting inactive parent timers if necessary. More... | |
interface | turbulence_bc_inlet_hyd_diam |
Set inlet boundary condition values for turbulence variables based on a diameter and the reference velocity for a circular duct flow with smooth wall. More... | |
interface | turbulence_bc_inlet_k_eps |
Set inlet boundary condition values for turbulence variables based on given k and epsilon values. More... | |
interface | turbulence_bc_inlet_turb_intensity |
Set inlet boundary condition values for turbulence variables based on a diameter , a turbulent intensity and the reference velocity for a circular duct flow with smooth wall. More... | |
interface | turbulence_bc_ke_hyd_diam |
Calculation of , and from a diameter and the reference velocity for a circular duct flow with smooth wall (use for inlet boundary conditions). More... | |
interface | turbulence_bc_ke_turb_intensity |
Calculation of and from a diameter , a turbulent intensity and the reference velocity for a circular duct flow with smooth wall (for inlet boundary conditions). More... | |
interface | turbulence_bc_rij_transform |
Compute matrix used in the computation of the Reynolds stress tensor boundary conditions. More... | |
interface | turbulence_bc_set_uninit_inlet_k_eps |
Set inlet boundary condition values for turbulence variables based on given k and epsilon values only if not initialized already. More... | |
interface | user_parameters |
General user parameters. More... | |
interface | user_porosity |
General user parameters. More... | |
type | var_cal_opt |
Functions/Subroutines | |
subroutine | balance_by_zone (sel_crit, name) |
Compute balance on a given zone for a given scalar. More... | |
subroutine | pressure_drop_by_zone (sel_crit) |
Compute pressure drop for a given zone. More... | |
subroutine | promav (isym, ibsize, iesize, f_id, dam, xam, vx, vy) |
subroutine | surface_balance (sel_crit, name, normal) |
Compute surface scalar balance for a given surface area. More... | |
subroutine | boundary_conditions_error (bc_type) |
Handle boundary condition definition errors and associated output. More... | |
type(c_ptr) function | boundary_conditions_map (location_type, n_location_elts, n_faces, location_elts, faces, coord_shift, coord_stride, tolerance) |
Locate shifted boundary face coordinates on possibly filtered cells or boundary faces for later interpolation. More... | |
subroutine | field_set_key_struct_var_cal_opt (f_id, k_value) |
Assign a var_cal_opt for a cs_var_cal_opt_t key to a field. More... | |
subroutine | field_set_key_struct_solving_info (f_id, k_value) |
Assign a solving_info for a cs_solving_info_t key to a field. More... | |
subroutine | field_set_key_struct_gwf_soilwater_partition (f_id, k_value) |
Assign a gwf_soilwater_partition for a cs_gwf_soilwater_partition_t key to a field. More... | |
subroutine | field_set_key_struct_gas_mix_species_prop (f_id, k_value) |
Assign a gas_mix_species_prop for a cs_gas_mix_species_prop_t key to a field. More... | |
subroutine | field_get_key_struct_var_cal_opt (f_id, k_value) |
Return a pointer to the var_cal_opt structure for cs_var_cal_opt key associated with a field. More... | |
subroutine | field_get_key_struct_solving_info (f_id, k_value) |
Return a pointer to the solving_info structure for cs_solving_info_t key associated with a field. More... | |
subroutine | field_get_key_struct_gwf_soilwater_partition (f_id, k_value) |
Return a pointer to the gwf_soilwater_partition structure for cs_gwf_soilwater_partition_t key associated with a field. More... | |
subroutine | field_get_key_struct_gas_mix_species_prop (f_id, k_value) |
Return a pointer to the gas_mix_species_prop structure for cs_gas_mix_species_prop_t key associated with a field. More... | |
subroutine | gradient_s (f_id, imrgra, inc, recompute_cocg, nswrgp, imligp, iwarnp, epsrgp, climgp, extrap, pvar, coefap, coefbp, grad) |
Compute cell gradient. More... | |
subroutine | gradient_potential_s (f_id, imrgra, inc, recompute_cocg, nswrgp, imligp, hyd_p_flag, iwarnp, epsrgp, climgp, extrap, f_ext, pvar, coefap, coefbp, grad) |
Compute cell gradient of potential-type values. More... | |
subroutine | gradient_weighted_s (f_id, imrgra, inc, recompute_cocg, nswrgp, imligp, hyd_p_flag, iwarnp, epsrgp, climgp, extrap, f_ext, pvar, c_weight, coefap, coefbp, grad) |
Compute cell gradient of a scalar with weighting. More... | |
subroutine | locator_destroy (this_locator) |
Destruction of a locator structure. More... | |
subroutine | log_iteration_add_array (name, category, location, is_intensive, dim, val) |
Add array not saved as permanent field to logging of fields. More... | |
subroutine | log_iteration_clipping (name, dim, n_clip_min, n_clip_max, min_pre_clip, max_pre_clip) |
Add array not saved as permanent field to logging of fields. More... | |
subroutine | log_iteration_clipping_field (f_id, n_clip_min, n_clip_max, min_pre_clip, max_pre_clip, n_clip_min_comp, n_clip_max_comp) |
Add array not saved as permanent field to logging of fields. More... | |
subroutine | restart_create (name, path, mode, r) |
Initialize a restart file. More... | |
subroutine | restart_read_variables (r, old_field_map, t_id_flag) |
Read variables from checkpoint. More... | |
subroutine | restart_write_variables (r, t_id_flag) |
Write variables to checkpoint. More... | |
subroutine | restart_read_section_int_t (r, sec_name, location_id, n_loc_vals, val, ierror) |
Read a section of integers from a restart file. More... | |
subroutine | restart_read_int_t_compat (r, sec_name, old_name, location_id, n_loc_vals, val, ierror) |
Read a section of integers from a restart file, when that section may have used a different name in a previous version. More... | |
subroutine | restart_write_section_int_t (r, sec_name, location_id, n_loc_vals, val) |
Write a section of integers to a checkpoint file. More... | |
subroutine | restart_read_section_real_t (r, sec_name, location_id, n_loc_vals, val, ierror) |
Read a section of doubles from a restart file. More... | |
subroutine | restart_read_real_t_compat (r, sec_name, old_name, location_id, n_loc_vals, val, ierror) |
Read a section of double precision reals from a restart file, when that section may have used a different name in a previous version. More... | |
subroutine | restart_read_real_3_t_compat (r, sec_name, old_name_x, old_name_y, old_name_z, location_id, val, ierror) |
Read a vector of double precision reals of dimension (3,*) from a restart file, when that section may have used a different name and been non-interleaved in a previous version. More... | |
subroutine | restart_write_section_real_t (r, sec_name, location_id, n_loc_vals, val) |
write a section of doubles to a checkpoint file. More... | |
subroutine | restart_read_field_vals (r, f_id, t_id, ierror) |
Read field values from checkpoint. More... | |
subroutine | restart_write_field_vals (r, f_id, t_id) |
Write field values to checkpoint. More... | |
subroutine | restart_read_linked_fields (r, old_field_map, key, n_w) |
Read fields depending on others from checkpoint. More... | |
subroutine | restart_write_linked_fields (r, key, n_w) |
Write fields depending on others to checkpoint. More... | |
subroutine | sles_solve_native (f_id, name, isym, ibsize, iesize, dam, xam, epsilp, rnorm, niter, residue, rhs, vx) |
Call sparse linear equation solver using native matrix arrays. More... | |
subroutine | sles_free_native (f_id, name) |
Free sparse linear equation solver setup using native matrix arrays. More... | |
subroutine | sles_push (f_id, name) |
Temporarily replace field id with name for matching calls to sles_solve_native. More... | |
subroutine | sles_pop (f_id) |
Revert to normal behavior of field id for matching calls to sles_solve_native. More... | |
integer function | timer_stats_create (parent_name, name, label) |
Create a timer statistics structure. More... | |
integer function | timer_stats_id_by_name (name) |
Return the id of a defined statistic based on its name. More... | |
subroutine | variable_field_create (name, label, location_id, dim, id) |
Add field defining a general solved variable, with default options. More... | |
subroutine | variable_cdo_field_create (name, label, location_id, dim, has_previous, id) |
Add a CDO field defining a general solved variable, with default options. More... | |
integer function | volume_zone_n_type_zones (type_flag) |
Return the number of volume zones associated with a given type flag. More... | |
integer function | volume_zone_n_type_cells (type_flag) |
Return the number of volume zone cells associated with a given type flag. More... | |
subroutine | volume_zone_select_type_cells (type_flag, cell_list) |
Return the list of volume zone cells associated with a given type flag. More... | |
subroutine | codits (idtvar, iterns, f_id, iconvp, idiffp, ndircp, imrgra, nswrsp, nswrgp, imligp, ircflp, ischcp, isstpp, iescap, imucpp, idftnp, iswdyp, iwarnp, normp, blencp, epsilp, epsrsp, epsrgp, climgp, extrap, relaxp, thetap, pvara, pvark, coefap, coefbp, cofafp, cofbfp, i_massflux, b_massflux, i_viscm, b_viscm, i_visc, b_visc, viscel, weighf, weighb, icvflb, icvfli, rovsdt, smbrp, pvar, dpvar, xcpp, eswork) |
This function solves an advection diffusion equation with source terms for one time step for the variable . More... | |
subroutine | coditv (idtvar, iterns, f_id, iconvp, idiffp, ndircp, imrgra, nswrsp, nswrgp, imligp, ircflp, ivisep, ischcp, isstpp, iescap, idftnp, iswdyp, iwarnp, blencp, epsilp, epsrsp, epsrgp, climgp, relaxp, thetap, pvara, pvark, coefav, coefbv, cofafv, cofbfv, i_massflux, b_massflux, i_viscm, b_viscm, i_visc, b_visc, secvif, secvib, viscce, weighf, weighb, icvflb, icvfli, fimp, smbrp, pvar, eswork) |
This function solves an advection diffusion equation with source terms for one time step for the vector variable . More... | |
subroutine | coditts (idtvar, f_id, iconvp, idiffp, ndircp, imrgra, nswrsp, nswrgp, imligp, ircflp, ischcp, isstpp, idftnp, iswdyp, iwarnp, blencp, epsilp, epsrsp, epsrgp, climgp, relaxp, thetap, pvara, pvark, coefats, coefbts, cofafts, cofbfts, i_massflux, b_massflux, i_viscm, b_viscm, i_visc, b_visc, viscce, weighf, weighb, icvflb, icvfli, fimp, smbrp, pvar) |
This function solves an advection diffusion equation with source terms for one time step for the symmetric tensor variable . More... | |
subroutine | bilsca (idtvar, f_id, iconvp, idiffp, nswrgp, imligp, ircflp, ischcp, isstpp, inc, imrgra, iccocg, iwarnp, imucpp, idftnp, imasac, blencp, epsrgp, climgp, extrap, relaxp, thetap, pvar, pvara, coefap, coefbp, cofafp, cofbfp, flumas, flumab, viscf, viscb, viscce, xcpp, weighf, weighb, icvflb, icvfli, smbrp) |
Wrapper to the function which adds the explicit part of the convection/diffusion terms of a transport equation of a scalar field . More... | |
subroutine | bilscv (idtvar, f_id, iconvp, idiffp, nswrgp, imligp, ircflp, ischcp, isstpp, inc, imrgra, ivisep, iwarnp, idftnp, imasac, blencp, epsrgp, climgp, relaxp, thetap, pvar, pvara, coefav, coefbv, cofafv, cofbfv, flumas, flumab, viscf, viscb, secvif, secvib, viscce, weighf, weighb, icvflb, icvfli, smbrp) |
Wrapper to the function which adds the explicit part of the convection/diffusion terms of a transport equation of a vector field . More... | |
subroutine | field_get_coupled_faces (f_id, cpl_faces) |
Return pointer to coupling face indicator for a field. More... | |
double precision function | notebook_parameter_value_by_name (name) |
Return notebook parameter value. More... | |
Variables | |
integer | mesh_location_none |
integer | mesh_location_cells |
integer | mesh_location_interior_faces |
integer | mesh_location_boundary_faces |
integer | mesh_location_vertices |
integer | mesh_location_particles |
integer | mesh_location_other |
integer | restart_val_type_int_t |
integer | restart_val_type_real_t |
integer | restart_disabled |
integer | restart_main |
integer | restart_auxiliary |
integer | restart_rad_transfer |
integer | restart_lagr |
integer | restart_lagr_stat |
integer | restart_1d_wall_thermal |
integer | restart_les_inflow |
integer | volume_zone_initialization |
integer | volume_zone_porosity |
integer | volume_zone_head_loss |
integer | volume_zone_source_term |
integer | volume_zone_mass_source_term |
subroutine cs_c_bindings::balance_by_zone | ( | character(len=*), intent(in) | sel_crit, |
character(len=*), intent(in) | name | ||
) |
Compute balance on a given zone for a given scalar.
param[in] sel_crit selection criteria of a volume zone param[in] name scalar name
subroutine cs_c_bindings::bilsca | ( | integer, intent(in) | idtvar, |
integer, intent(in) | f_id, | ||
integer, intent(in) | iconvp, | ||
integer, intent(in) | idiffp, | ||
integer, intent(in) | nswrgp, | ||
integer, intent(in) | imligp, | ||
integer, intent(in) | ircflp, | ||
integer, intent(in) | ischcp, | ||
integer, intent(in) | isstpp, | ||
integer, intent(in) | inc, | ||
integer, intent(in) | imrgra, | ||
integer, intent(in) | iccocg, | ||
integer, intent(in) | iwarnp, | ||
integer, intent(in) | imucpp, | ||
integer, intent(in) | idftnp, | ||
integer, intent(in) | imasac, | ||
double precision, intent(in) | blencp, | ||
double precision, intent(in) | epsrgp, | ||
double precision, intent(in) | climgp, | ||
double precision, intent(in) | extrap, | ||
double precision, intent(in) | relaxp, | ||
double precision, intent(in) | thetap, | ||
real(kind=c_double), dimension(*), intent(in) | pvar, | ||
real(kind=c_double), dimension(*), intent(in) | pvara, | ||
real(kind=c_double), dimension(*), intent(in) | coefap, | ||
real(kind=c_double), dimension(*), intent(in) | coefbp, | ||
real(kind=c_double), dimension(*), intent(in) | cofafp, | ||
real(kind=c_double), dimension(*), intent(in) | cofbfp, | ||
real(kind=c_double), dimension(*), intent(in) | flumas, | ||
real(kind=c_double), dimension(*), intent(in) | flumab, | ||
real(kind=c_double), dimension(*), intent(in) | viscf, | ||
real(kind=c_double), dimension(*), intent(in) | viscb, | ||
real(kind=c_double), dimension(*), intent(in) | viscce, | ||
real(kind=c_double), dimension(*), intent(in) | xcpp, | ||
real(kind=c_double), dimension(*), intent(in) | weighf, | ||
real(kind=c_double), dimension(*), intent(in) | weighb, | ||
integer, intent(in) | icvflb, | ||
integer(c_int), dimension(*), intent(in) | icvfli, | ||
real(kind=c_double), dimension(*), intent(inout) | smbrp | ||
) |
Wrapper to the function which adds the explicit part of the convection/diffusion terms of a transport equation of a scalar field .
More precisely, the right hand side is updated as follows:
Warning:
Options for the diffusive scheme:
Options for the convective scheme:
[in] | idtvar | indicator of the temporal scheme |
[in] | f_id | field id (or -1) |
[in] | iconvp | indicator
|
[in] | idiffp | indicator
|
[in] | nswrgp | number of reconstruction sweeps for the gradients |
[in] | imligp | clipping gradient method
|
[in] | ircflp | indicator
|
[in] | ischcp | indicator
|
[in] | isstpp | indicator
|
[in] | inc | indicator
|
[in] | imrgra | indicator
|
[in] | iccocg | indicator
|
[in] | iwarnp | verbosity |
[in] | imucpp | indicator
|
[in] | idftnp | indicator
|
[in] | imasac | take mass accumulation into account? |
[in] | blencp | fraction of upwinding |
[in] | epsrgp | relative precision for the gradient reconstruction |
[in] | climgp | clipping coefficient for the computation of the gradient |
[in] | extrap | coefficient for extrapolation of the gradient |
[in] | relaxp | coefficient of relaxation |
[in] | thetap | weighting coefficient for the theta-schema,
|
[in] | pvar | solved variable (current time step) |
[in] | pvara | solved variable (previous time step) |
[in] | coefap | boundary condition array for the variable (explicit part) |
[in] | coefbp | boundary condition array for the variable (implicit part) |
[in] | cofafp | boundary condition array for the diffusion of the variable (explicit part) |
[in] | cofbfp | boundary condition array for the diffusion of the variable (implicit part) |
[in] | flumas | mass flux at interior faces |
[in] | flumab | mass flux at boundary faces |
[in] | viscf | at interior faces for the r.h.s. |
[in] | viscb | at boundary faces for the r.h.s. |
[in] | viscce | symmetric cell tensor |
[in] | xcpp | array of specific heat (Cp) |
[in] | weighf | internal face weight between cells i j in case of tensor diffusion |
[in] | weighb | boundary face weight for cells i in case of tensor diffusion |
[in] | icvflb | global indicator of boundary convection flux
|
[in] | icvfli | boundary face indicator array of convection flux
|
[in,out] | smbrp | right hand side |
subroutine cs_c_bindings::bilscv | ( | integer, intent(in) | idtvar, |
integer, intent(in) | f_id, | ||
integer, intent(in) | iconvp, | ||
integer, intent(in) | idiffp, | ||
integer, intent(in) | nswrgp, | ||
integer, intent(in) | imligp, | ||
integer, intent(in) | ircflp, | ||
integer, intent(in) | ischcp, | ||
integer, intent(in) | isstpp, | ||
integer, intent(in) | inc, | ||
integer, intent(in) | imrgra, | ||
integer, intent(in) | ivisep, | ||
integer, intent(in) | iwarnp, | ||
integer, intent(in) | idftnp, | ||
integer, intent(in) | imasac, | ||
double precision, intent(in) | blencp, | ||
double precision, intent(in) | epsrgp, | ||
double precision, intent(in) | climgp, | ||
double precision, intent(in) | relaxp, | ||
double precision, intent(in) | thetap, | ||
real(kind=c_double), dimension(*), intent(in) | pvar, | ||
real(kind=c_double), dimension(*), intent(in) | pvara, | ||
real(kind=c_double), dimension(*), intent(in) | coefav, | ||
real(kind=c_double), dimension(*), intent(in) | coefbv, | ||
real(kind=c_double), dimension(*), intent(in) | cofafv, | ||
real(kind=c_double), dimension(*), intent(in) | cofbfv, | ||
real(kind=c_double), dimension(*), intent(in) | flumas, | ||
real(kind=c_double), dimension(*), intent(in) | flumab, | ||
real(kind=c_double), dimension(*), intent(in) | viscf, | ||
real(kind=c_double), dimension(*), intent(in) | viscb, | ||
real(kind=c_double), dimension(*), intent(in) | secvif, | ||
real(kind=c_double), dimension(*), intent(in) | secvib, | ||
real(kind=c_double), dimension(*), intent(in) | viscce, | ||
real(kind=c_double), dimension(*), intent(in) | weighf, | ||
real(kind=c_double), dimension(*), intent(in) | weighb, | ||
integer, intent(in) | icvflb, | ||
integer(c_int), dimension(*), intent(in) | icvfli, | ||
real(kind=c_double), dimension(*), intent(inout) | smbrp | ||
) |
Wrapper to the function which adds the explicit part of the convection/diffusion terms of a transport equation of a vector field .
More precisely, the right hand side is updated as follows:
Remark: if ivisep = 1, then we also take , where is the secondary viscosity, i.e. usually .
Warning:
Options for the diffusive scheme:
Options for the convective scheme:
[in] | idtvar | indicator of the temporal scheme |
[in] | f_id | field id (or -1) |
[in] | iconvp | indicator
|
[in] | idiffp | indicator
|
[in] | nswrgp | number of reconstruction sweeps for the gradients |
[in] | imligp | clipping gradient method
|
[in] | ircflp | indicator
|
[in] | ischcp | indicator
|
[in] | isstpp | indicator
|
[in] | inc | indicator
|
[in] | imrgra | indicator
|
[in] | ivisep | indicator to take
|
[in] | iwarnp | verbosity |
[in] | idftnp | indicator
|
[in] | imasac | take mass accumulation into account? |
[in] | blencp | fraction of upwinding |
[in] | epsrgp | relative precision for the gradient reconstruction |
[in] | climgp | clipping coefficient for the computation of the gradient |
[in] | relaxp | coefficient of relaxation |
[in] | thetap | weighting coefficient for the theta-schema,
|
[in] | pvar | solved velocity (current time step) |
[in] | pvara | solved velocity (previous time step) |
[in] | coefav | boundary condition array for the variable (explicit part) |
[in] | coefbv | boundary condition array for the variable (implicit part) |
[in] | cofafv | boundary condition array for the diffusion of the variable (explicit part) |
[in] | cofbfv | boundary condition array for the diffusion of the variable (implicit part) |
[in] | flumas | mass flux at interior faces |
[in] | flumab | mass flux at boundary faces |
[in] | viscf | at interior faces for the r.h.s. |
[in] | viscb | at boundary faces for the r.h.s. |
[in] | secvif | secondary viscosity at interior faces |
[in] | secvib | secondary viscosity at boundary faces |
[in] | viscce | symmetric cell tensor |
[in] | weighf | internal face weight between cells i j in case of tensor diffusion |
[in] | weighb | boundary face weight for cells i in case of tensor diffusion |
[in] | icvflb | global indicator of boundary convection flux
|
[in] | icvfli | boundary face indicator of convection flux
|
[in,out] | smbrp | right hand side |
subroutine cs_c_bindings::boundary_conditions_error | ( | integer(c_int), dimension(*), intent(in) | bc_type | ) |
Handle boundary condition definition errors and associated output.
For each boundary face, bc_type defines the boundary condition type. As a convention here, zero values correspond to undefined types, positive values to defined types (with no error), and negative values to defined types with inconsistent or incompatible values, the absolute value indicating the original boundary condition type. param[in] bc_type array og BC type ids
type(c_ptr) function cs_c_bindings::boundary_conditions_map | ( | integer, intent(in) | location_type, |
integer, intent(in) | n_location_elts, | ||
integer, intent(in) | n_faces, | ||
integer, dimension(*), intent(in) | location_elts, | ||
integer, dimension(*), intent(in) | faces, | ||
real(kind=c_double), dimension(*) | coord_shift, | ||
integer, intent(in) | coord_stride, | ||
double precision, intent(in) | tolerance | ||
) |
Locate shifted boundary face coordinates on possibly filtered cells or boundary faces for later interpolation.
param[in] location_type matching values location (CS_MESH_LOCATION_CELLS or CS_MESH_LOCATION_BOUNDARY_FACES) param[in] n_location_elts number of selected location elements param[in] n_faces number of selected boundary faces param[in] location_elts list of selected location elements (1 to n), or NULL if no indirection is needed param[in] faces list of selected boundary faces (1 to n), or NULL if no indirection is needed param[in] coord_shift array of coordinates shift relative to selected boundary faces param[in] coord_stride access stride in coord_shift: 0 for uniform shift, 1 for "per face" shift. param[in] tolerance relative tolerance for point location. return associated locator structure
subroutine cs_c_bindings::codits | ( | integer, intent(in) | idtvar, |
integer, intent(in) | iterns, | ||
integer, intent(in) | f_id, | ||
integer, intent(in) | iconvp, | ||
integer, intent(in) | idiffp, | ||
integer, intent(in) | ndircp, | ||
integer, intent(in) | imrgra, | ||
integer, intent(in) | nswrsp, | ||
integer, intent(in) | nswrgp, | ||
integer, intent(in) | imligp, | ||
integer, intent(in) | ircflp, | ||
integer, intent(in) | ischcp, | ||
integer, intent(in) | isstpp, | ||
integer, intent(in) | iescap, | ||
integer, intent(in) | imucpp, | ||
integer, intent(in) | idftnp, | ||
integer, intent(in) | iswdyp, | ||
integer, intent(in) | iwarnp, | ||
double precision, intent(in) | normp, | ||
double precision, intent(in) | blencp, | ||
double precision, intent(in) | epsilp, | ||
double precision, intent(in) | epsrsp, | ||
double precision, intent(in) | epsrgp, | ||
double precision, intent(in) | climgp, | ||
double precision, intent(in) | extrap, | ||
double precision, intent(in) | relaxp, | ||
double precision, intent(in) | thetap, | ||
real(kind=c_double), dimension(*), intent(in) | pvara, | ||
real(kind=c_double), dimension(*), intent(in) | pvark, | ||
real(kind=c_double), dimension(*), intent(in) | coefap, | ||
real(kind=c_double), dimension(*), intent(in) | coefbp, | ||
real(kind=c_double), dimension(*), intent(in) | cofafp, | ||
real(kind=c_double), dimension(*), intent(in) | cofbfp, | ||
real(kind=c_double), dimension(*), intent(in) | i_massflux, | ||
real(kind=c_double), dimension(*), intent(in) | b_massflux, | ||
real(kind=c_double), dimension(*), intent(in) | i_viscm, | ||
real(kind=c_double), dimension(*), intent(in) | b_viscm, | ||
real(kind=c_double), dimension(*), intent(in) | i_visc, | ||
real(kind=c_double), dimension(*), intent(in) | b_visc, | ||
real(kind=c_double), dimension(*), intent(in) | viscel, | ||
real(kind=c_double), dimension(*), intent(in) | weighf, | ||
real(kind=c_double), dimension(*), intent(in) | weighb, | ||
integer, intent(in) | icvflb, | ||
integer(c_int), dimension(*), intent(in) | icvfli, | ||
real(kind=c_double), dimension(*), intent(in) | rovsdt, | ||
real(kind=c_double), dimension(*), intent(inout) | smbrp, | ||
real(kind=c_double), dimension(*), intent(inout) | pvar, | ||
real(kind=c_double), dimension(*), intent(inout) | dpvar, | ||
real(kind=c_double), dimension(*), intent(in) | xcpp, | ||
real(kind=c_double), dimension(*), intent(inout) | eswork | ||
) |
This function solves an advection diffusion equation with source terms for one time step for the variable .
The equation reads:
This equation is rewritten as:
where and
It is in fact solved with the following iterative process:
where Be careful, it is forbidden to modify here!
[in] | idtvar | indicator of the temporal scheme |
[in] | iterns | external sub-iteration number |
[in] | f_id | field id (or -1) |
[in] | iconvp | indicator
|
[in] | idiffp | indicator
|
[in] | ndircp | indicator (0 if the diagonal is stepped aside) |
[in] | imrgra | indicator
|
[in] | nswrsp | number of reconstruction sweeps for the Right Hand Side |
[in] | nswrgp | number of reconstruction sweeps for the gradients |
[in] | imligp | clipping gradient method
|
[in] | ircflp | indicator
|
[in] | ischcp | indicator
|
[in] | isstpp | indicator
|
[in] | iescap | compute the predictor indicator if 1 |
[in] | imucpp | indicator
|
[in] | idftnp | diffusivity type indicator |
[in] | iswdyp | indicator
|
[in] | iwarnp | verbosity |
[in] | normp | (optional) norm residual |
[in] | blencp | fraction of upwinding |
[in] | epsilp | precision pour resol iter |
[in] | epsrsp | relative precision for the iterative process |
[in] | epsrgp | relative precision for the gradient reconstruction |
[in] | climgp | clipping coefficient for the computation of the gradient |
[in] | extrap | coefficient for extrapolation of the gradient |
[in] | relaxp | coefficient of relaxation |
[in] | thetap | weighting coefficient for the theta-schema,
|
[in] | pvara | variable at the previous time step |
[in] | pvark | variable at the previous sub-iteration . If you sub-iter on Navier-Stokes, then it allows to initialize by something else than pvara (usually pvar=pvara) |
[in] | coefap | boundary condition array for the variable (explicit part) |
[in] | coefbp | boundary condition array for the variable (implicit part) |
[in] | cofafp | boundary condition array for the diffusion of the variable (explicit part) |
[in] | cofbfp | boundary condition array for the diffusion of the variable (implicit part) |
[in] | i_massflux | mass flux at interior faces |
[in] | b_massflux | mass flux at boundary faces |
[in] | i_viscm | at interior faces for the matrix |
[in] | b_viscm | at boundary faces for the matrix |
[in] | i_visc | at interior faces for the r.h.s. |
[in] | b_visc | at boundary faces for the r.h.s. |
[in] | viscel | symmetric cell tensor |
[in] | weighf | internal face weight between cells i j in case of tensor diffusion |
[in] | weighb | boundary face weight for cells i in case of tensor diffusion |
[in] | icvflb | global indicator of boundary convection flux
|
[in] | icvfli | boundary face indicator array of convection flux
|
[in] | rovsdt | |
[in] | smbrp | Right hand side |
[in,out] | pvar | current variable |
[in,out] | dpvar | last variable increment |
[in] | xcpp | array of specific heat (Cp) |
[out] | eswork | prediction-stage error estimator (if iescap > 0) |
subroutine cs_c_bindings::coditts | ( | integer, intent(in) | idtvar, |
integer, intent(in) | f_id, | ||
integer, intent(in) | iconvp, | ||
integer, intent(in) | idiffp, | ||
integer, intent(in) | ndircp, | ||
integer, intent(in) | imrgra, | ||
integer, intent(in) | nswrsp, | ||
integer, intent(in) | nswrgp, | ||
integer, intent(in) | imligp, | ||
integer, intent(in) | ircflp, | ||
integer, intent(in) | ischcp, | ||
integer, intent(in) | isstpp, | ||
integer, intent(in) | idftnp, | ||
integer, intent(in) | iswdyp, | ||
integer, intent(in) | iwarnp, | ||
double precision, intent(in) | blencp, | ||
double precision, intent(in) | epsilp, | ||
double precision, intent(in) | epsrsp, | ||
double precision, intent(in) | epsrgp, | ||
double precision, intent(in) | climgp, | ||
double precision, intent(in) | relaxp, | ||
double precision, intent(in) | thetap, | ||
real(kind=c_double), dimension(*), intent(in) | pvara, | ||
real(kind=c_double), dimension(*), intent(in) | pvark, | ||
real(kind=c_double), dimension(*), intent(in) | coefats, | ||
real(kind=c_double), dimension(*), intent(in) | coefbts, | ||
real(kind=c_double), dimension(*), intent(in) | cofafts, | ||
real(kind=c_double), dimension(*), intent(in) | cofbfts, | ||
real(kind=c_double), dimension(*), intent(in) | i_massflux, | ||
real(kind=c_double), dimension(*), intent(in) | b_massflux, | ||
real(kind=c_double), dimension(*), intent(in) | i_viscm, | ||
real(kind=c_double), dimension(*), intent(in) | b_viscm, | ||
real(kind=c_double), dimension(*), intent(in) | i_visc, | ||
real(kind=c_double), dimension(*), intent(in) | b_visc, | ||
real(kind=c_double), dimension(*), intent(in) | viscce, | ||
real(kind=c_double), dimension(*), intent(in) | weighf, | ||
real(kind=c_double), dimension(*), intent(in) | weighb, | ||
integer, intent(in) | icvflb, | ||
integer(c_int), dimension(*), intent(in) | icvfli, | ||
real(kind=c_double), dimension(*), intent(in) | fimp, | ||
real(kind=c_double), dimension(*), intent(inout) | smbrp, | ||
real(kind=c_double), dimension(*), intent(inout) | pvar | ||
) |
This function solves an advection diffusion equation with source terms for one time step for the symmetric tensor variable .
The equation reads:
This equation is rewritten as:
where and
It is in fact solved with the following iterative process:
where
Be careful, it is forbidden to modify here!
[in] | idtvar | indicator of the temporal scheme |
[in] | f_id | field id (or -1) |
[in] | iconvp | indicator
|
[in] | idiffp | indicator
|
[in] | ndircp | indicator (0 if the diagonal is stepped aside) |
[in] | imrgra | indicateur
|
[in] | nswrsp | number of reconstruction sweeps for the Right Hand Side |
[in] | nswrgp | number of reconstruction sweeps for the gradients |
[in] | imligp | clipping gradient method
|
[in] | ircflp | indicator
|
[in] | ischcp | indicator
|
[in] | isstpp | indicator
|
[in] | idftnp | indicator
|
[in] | iswdyp | indicator
|
[in] | iwarnp | verbosity |
[in] | blencp | fraction of upwinding |
[in] | epsilp | precision pour resol iter |
[in] | epsrsp | relative precision for the iterative process |
[in] | epsrgp | relative precision for the gradient reconstruction |
[in] | climgp | clipping coefficient for the computation of the gradient |
[in] | relaxp | coefficient of relaxation |
[in] | thetap | weighting coefficient for the theta-schema,
|
[in] | pvara | variable at the previous time step |
[in] | pvark | variable at the previous sub-iteration . If you sub-iter on Navier-Stokes, then it allows to initialize by something else than pvara (usually pvar=pvara) |
[in] | coefats | boundary condition array for the variable (Explicit part) |
[in] | coefbts | boundary condition array for the variable (Impplicit part) |
[in] | cofafts | boundary condition array for the diffusion of the variable (Explicit part) |
[in] | cofbfts | boundary condition array for the diffusion of the variable (Implicit part) |
[in] | i_massflux | mass flux at interior faces |
[in] | b_massflux | mass flux at boundary faces |
[in] | i_viscm | at interior faces for the matrix |
[in] | b_viscm | at boundary faces for the matrix |
[in] | i_visc | at interior faces for the r.h.s. |
[in] | b_visc | at boundary faces for the r.h.s. |
[in] | viscce | symmetric cell tensor |
[in] | weighf | internal face weight between cells i j in case of tensor diffusion |
[in] | weighb | boundary face weight for cells i in case of tensor diffusion |
[in] | icvflb | global indicator of boundary convection flux
|
[in] | icvfli | boundary face indicator array of convection flux
|
[in] | fimp | |
[in] | smbrp | Right hand side |
[in,out] | pvar | current variable |
subroutine cs_c_bindings::coditv | ( | integer, intent(in) | idtvar, |
integer, intent(in) | iterns, | ||
integer, intent(in) | f_id, | ||
integer, intent(in) | iconvp, | ||
integer, intent(in) | idiffp, | ||
integer, intent(in) | ndircp, | ||
integer, intent(in) | imrgra, | ||
integer, intent(in) | nswrsp, | ||
integer, intent(in) | nswrgp, | ||
integer, intent(in) | imligp, | ||
integer, intent(in) | ircflp, | ||
integer, intent(in) | ivisep, | ||
integer, intent(in) | ischcp, | ||
integer, intent(in) | isstpp, | ||
integer, intent(in) | iescap, | ||
integer, intent(in) | idftnp, | ||
integer, intent(in) | iswdyp, | ||
integer, intent(in) | iwarnp, | ||
double precision, intent(in) | blencp, | ||
double precision, intent(in) | epsilp, | ||
double precision, intent(in) | epsrsp, | ||
double precision, intent(in) | epsrgp, | ||
double precision, intent(in) | climgp, | ||
double precision, intent(in) | relaxp, | ||
double precision, intent(in) | thetap, | ||
real(kind=c_double), dimension(*), intent(in) | pvara, | ||
real(kind=c_double), dimension(*), intent(in) | pvark, | ||
real(kind=c_double), dimension(*), intent(in) | coefav, | ||
real(kind=c_double), dimension(*), intent(in) | coefbv, | ||
real(kind=c_double), dimension(*), intent(in) | cofafv, | ||
real(kind=c_double), dimension(*), intent(in) | cofbfv, | ||
real(kind=c_double), dimension(*), intent(in) | i_massflux, | ||
real(kind=c_double), dimension(*), intent(in) | b_massflux, | ||
real(kind=c_double), dimension(*), intent(in) | i_viscm, | ||
real(kind=c_double), dimension(*), intent(in) | b_viscm, | ||
real(kind=c_double), dimension(*), intent(in) | i_visc, | ||
real(kind=c_double), dimension(*), intent(in) | b_visc, | ||
real(kind=c_double), dimension(*), intent(in) | secvif, | ||
real(kind=c_double), dimension(*), intent(in) | secvib, | ||
real(kind=c_double), dimension(*), intent(in) | viscce, | ||
real(kind=c_double), dimension(*), intent(in) | weighf, | ||
real(kind=c_double), dimension(*), intent(in) | weighb, | ||
integer, intent(in) | icvflb, | ||
integer(c_int), dimension(*), intent(in) | icvfli, | ||
real(kind=c_double), dimension(*), intent(in) | fimp, | ||
real(kind=c_double), dimension(*), intent(inout) | smbrp, | ||
real(kind=c_double), dimension(*), intent(inout) | pvar, | ||
real(kind=c_double), dimension(*), intent(inout) | eswork | ||
) |
This function solves an advection diffusion equation with source terms for one time step for the vector variable .
The equation reads:
This equation is rewritten as:
where and
It is in fact solved with the following iterative process:
where
Be careful, it is forbidden to modify here!
[in] | idtvar | indicator of the temporal scheme |
[in] | iterns | external sub-iteration number |
[in] | f_id | field id (or -1) |
[in] | iconvp | indicator
|
[in] | idiffp | indicator
|
[in] | ndircp | indicator (0 if the diagonal is stepped aside) |
[in] | imrgra | indicateur
|
[in] | nswrsp | number of reconstruction sweeps for the Right Hand Side |
[in] | nswrgp | number of reconstruction sweeps for the gradients |
[in] | imligp | clipping gradient method
|
[in] | ircflp | indicator
|
[in] | ivisep | indicator to take
|
[in] | ischcp | indicator
|
[in] | isstpp | indicator
|
[in] | iescap | compute the predictor indicator if 1 |
[in] | idftnp | indicator
|
[in] | iswdyp | indicator
|
[in] | iwarnp | verbosity |
[in] | blencp | fraction of upwinding |
[in] | epsilp | precision pour resol iter |
[in] | epsrsp | relative precision for the iterative process |
[in] | epsrgp | relative precision for the gradient reconstruction |
[in] | climgp | clipping coefficient for the computation of the gradient |
[in] | relaxp | coefficient of relaxation |
[in] | thetap | weighting coefficient for the theta-schema,
|
[in] | pvara | variable at the previous time step |
[in] | pvark | variable at the previous sub-iteration . If you sub-iter on Navier-Stokes, then it allows to initialize by something else than pvara (usually pvar=pvara) |
[in] | coefav | boundary condition array for the variable (explicit part) |
[in] | coefbv | boundary condition array for the variable (implicit part) |
[in] | cofafv | boundary condition array for the diffusion of the variable (Explicit part) |
[in] | cofbfv | boundary condition array for the diffusion of the variable (Implicit part) |
[in] | i_massflux | mass flux at interior faces |
[in] | b_massflux | mass flux at boundary faces |
[in] | i_viscm | at interior faces for the matrix |
[in] | b_viscm | at boundary faces for the matrix |
[in] | i_visc | at interior faces for the r.h.s. |
[in] | b_visc | at boundary faces for the r.h.s. |
[in] | secvif | secondary viscosity at interior faces |
[in] | secvib | secondary viscosity at boundary faces |
[in] | viscce | symmetric cell tensor |
[in] | weighf | internal face weight between cells i j in case of tensor diffusion |
[in] | weighb | boundary face weight for cells i in case of tensor diffusion |
[in] | icvflb | global indicator of boundary convection flux
|
[in] | icvfli | boundary face indicator array of convection flux
|
[in] | fimp | |
[in] | smbrp | Right hand side |
[in,out] | pvar | current variable |
[out] | eswork | prediction-stage error estimator (if iescap > 0) |
subroutine cs_c_bindings::field_get_coupled_faces | ( | integer, intent(in) | f_id, |
logical(kind=c_bool), dimension(:), intent(inout), pointer | cpl_faces | ||
) |
Return pointer to coupling face indicator for a field.
[in] | f_id | id of given field |
[out] | cpl_faces | pointer to coupling face indicator |
subroutine cs_c_bindings::field_get_key_struct_gas_mix_species_prop | ( | integer, intent(in) | f_id, |
type(gas_mix_species_prop), intent(inout), target | k_value | ||
) |
Return a pointer to the gas_mix_species_prop structure for cs_gas_mix_species_prop_t key associated with a field.
If the field category is not compatible, a fatal error is provoked.
[in] | f_id | field id |
[out] | k_value | integer value associated with key id for this field |
subroutine cs_c_bindings::field_get_key_struct_gwf_soilwater_partition | ( | integer, intent(in) | f_id, |
type(gwf_soilwater_partition), intent(inout), target | k_value | ||
) |
Return a pointer to the gwf_soilwater_partition structure for cs_gwf_soilwater_partition_t key associated with a field.
If the field category is not compatible, a fatal error is provoked.
[in] | f_id | field id |
[out] | k_value | integer value associated with key id for this field |
subroutine cs_c_bindings::field_get_key_struct_solving_info | ( | integer, intent(in) | f_id, |
type(solving_info), intent(inout), target | k_value | ||
) |
Return a pointer to the solving_info structure for cs_solving_info_t key associated with a field.
If the field category is not compatible, a fatal error is provoked.
[in] | f_id | field id |
[out] | k_value | integer value associated with key id for this field |
subroutine cs_c_bindings::field_get_key_struct_var_cal_opt | ( | integer, intent(in) | f_id, |
type(var_cal_opt), intent(inout), target | k_value | ||
) |
Return a pointer to the var_cal_opt structure for cs_var_cal_opt key associated with a field.
If the field category is not compatible, a fatal error is provoked.
[in] | f_id | field id |
[out] | k_value | integer value associated with key id for this field |
subroutine cs_c_bindings::field_set_key_struct_gas_mix_species_prop | ( | integer, intent(in) | f_id, |
type(gas_mix_species_prop), intent(in), target | k_value | ||
) |
Assign a gas_mix_species_prop for a cs_gas_mix_species_prop_t key to a field.
If the field category is not compatible, a fatal error is provoked.
[in] | f_id | field id |
[in] | k_value | structure associated with key |
subroutine cs_c_bindings::field_set_key_struct_gwf_soilwater_partition | ( | integer, intent(in) | f_id, |
type(gwf_soilwater_partition), intent(in), target | k_value | ||
) |
Assign a gwf_soilwater_partition for a cs_gwf_soilwater_partition_t key to a field.
If the field category is not compatible, a fatal error is provoked.
[in] | f_id | field id |
[in] | k_value | structure associated with key |
subroutine cs_c_bindings::field_set_key_struct_solving_info | ( | integer, intent(in) | f_id, |
type(solving_info), intent(in), target | k_value | ||
) |
Assign a solving_info for a cs_solving_info_t key to a field.
If the field category is not compatible, a fatal error is provoked.
[in] | f_id | field id |
[in] | k_value | structure associated with key |
subroutine cs_c_bindings::field_set_key_struct_var_cal_opt | ( | integer, intent(in) | f_id, |
type(var_cal_opt), intent(in), target | k_value | ||
) |
Assign a var_cal_opt for a cs_var_cal_opt_t key to a field.
If the field category is not compatible, a fatal error is provoked.
[in] | f_id | field id |
[in] | k_value | structure associated with key |
subroutine cs_c_bindings::gradient_potential_s | ( | integer, intent(in) | f_id, |
integer, intent(in) | imrgra, | ||
integer, intent(in) | inc, | ||
integer, intent(in) | recompute_cocg, | ||
integer, intent(in) | nswrgp, | ||
integer, intent(in) | imligp, | ||
integer, intent(in) | hyd_p_flag, | ||
integer, intent(in) | iwarnp, | ||
double precision, intent(in) | epsrgp, | ||
double precision, intent(in) | climgp, | ||
double precision, intent(in) | extrap, | ||
real(kind=c_double), dimension(:,:), intent(in), pointer | f_ext, | ||
real(kind=c_double), dimension(ncelet), intent(inout) | pvar, | ||
real(kind=c_double), dimension(nfabor), intent(in) | coefap, | ||
real(kind=c_double), dimension(nfabor), intent(in) | coefbp, | ||
real(kind=c_double), dimension(3, ncelet), intent(out) | grad | ||
) |
Compute cell gradient of potential-type values.
[in] | f_id | field id, or -1 |
[in] | imrgra | gradient computation mode |
[in] | inc | 0: increment; 1: do not increment |
[in] | recompute_cocg | 1 or 0: recompute COCG or not |
[in] | nswrgp | number of sweeps for reconstruction |
[in] | imligp | gradient limitation method: < 0 no limitation = 0 based on neighboring gradients = 1 based on mean gradient |
[in] | hyd_p_flag | flag for hydrostatic pressure |
[in] | iwarnp | verbosity |
[in] | epsrgp | relative precision for reconstruction |
[in] | climgp | limiter coefficient for imligp |
[in] | extrap | gradient extrapolation coefficient |
[in] | f_ext | exterior force generating the hydrostatic pressure |
[in,out] | pvar | cell values whose gradient is computed |
[in] | coefap | boundary coefap coefficients |
[in] | coefbp | boundary coefap coefficients |
[out] | grad | resulting gradient |
subroutine cs_c_bindings::gradient_s | ( | integer, intent(in) | f_id, |
integer, intent(in) | imrgra, | ||
integer, intent(in) | inc, | ||
integer, intent(in) | recompute_cocg, | ||
integer, intent(in) | nswrgp, | ||
integer, intent(in) | imligp, | ||
integer, intent(in) | iwarnp, | ||
double precision, intent(in) | epsrgp, | ||
double precision, intent(in) | climgp, | ||
double precision, intent(in) | extrap, | ||
real(kind=c_double), dimension(ncelet), intent(inout) | pvar, | ||
real(kind=c_double), dimension(nfabor), intent(in) | coefap, | ||
real(kind=c_double), dimension(nfabor), intent(in) | coefbp, | ||
real(kind=c_double), dimension(3, ncelet), intent(out) | grad | ||
) |
Compute cell gradient.
[in] | f_id | field id, or -1 |
[in] | imrgra | gradient computation mode |
[in] | inc | 0: increment; 1: do not increment |
[in] | recompute_cocg | 1 or 0: recompute COCG or not |
[in] | nswrgp | number of sweeps for reconstruction |
[in] | imligp | gradient limitation method: < 0 no limitation = 0 based on neighboring gradients = 1 based on mean gradient |
[in] | iwarnp | verbosity |
[in] | epsrgp | relative precision for reconstruction |
[in] | climgp | limiter coefficient for imligp |
[in] | extrap | gradient extrapolation coefficient |
[in,out] | pvar | cell values whose gradient is computed |
[in] | coefap | boundary coefap coefficients |
[in] | coefbp | boundary coefap coefficients |
[out] | grad | resulting gradient |
subroutine cs_c_bindings::gradient_weighted_s | ( | integer, intent(in) | f_id, |
integer, intent(in) | imrgra, | ||
integer, intent(in) | inc, | ||
integer, intent(in) | recompute_cocg, | ||
integer, intent(in) | nswrgp, | ||
integer, intent(in) | imligp, | ||
integer, intent(in) | hyd_p_flag, | ||
integer, intent(in) | iwarnp, | ||
double precision, intent(in) | epsrgp, | ||
double precision, intent(in) | climgp, | ||
double precision, intent(in) | extrap, | ||
real(kind=c_double), dimension(:,:), intent(in), pointer | f_ext, | ||
real(kind=c_double), dimension(ncelet), intent(inout) | pvar, | ||
real(kind=c_double), dimension(:), intent(in) | c_weight, | ||
real(kind=c_double), dimension(nfabor), intent(in) | coefap, | ||
real(kind=c_double), dimension(nfabor), intent(in) | coefbp, | ||
real(kind=c_double), dimension(3, ncelet), intent(out) | grad | ||
) |
Compute cell gradient of a scalar with weighting.
[in] | f_id | field id, or -1 |
[in] | imrgra | gradient computation mode |
[in] | inc | 0: increment; 1: do not increment |
[in] | recompute_cocg | 1 or 0: recompute COCG or not |
[in] | nswrgp | number of sweeps for reconstruction |
[in] | imligp | gradient limitation method: < 0 no limitation = 0 based on neighboring gradients = 1 based on mean gradient |
[in] | hyd_p_flag | flag for hydrostatic pressure |
[in] | iwarnp | verbosity |
[in] | epsrgp | relative precision for reconstruction |
[in] | climgp | limiter coefficient for imligp |
[in] | extrap | gradient extrapolation coefficient |
[in] | f_ext | exterior force generating the hydrostatic pressure |
[in,out] | pvar | cell values whose gradient is computed |
[in,out] | c_weight | cell weighting coefficient |
[in] | coefap | boundary coefap coefficients |
[in] | coefbp | boundary coefap coefficients |
[out] | grad | resulting gradient |
subroutine cs_c_bindings::locator_destroy | ( | type(c_ptr) | this_locator | ) |
Destruction of a locator structure.
[in,out] | this_locator |
subroutine cs_c_bindings::log_iteration_add_array | ( | character(len=*), intent(in) | name, |
character(len=*), intent(in) | category, | ||
integer, intent(in) | location, | ||
logical, intent(in) | is_intensive, | ||
integer, intent(in) | dim, | ||
real(kind=c_double), dimension(*) | val | ||
) |
Add array not saved as permanent field to logging of fields.
[in] | name | array name |
[in] | category | category name |
[in] | location | associated mesh location |
[in] | is_intensive | associated mesh location |
[in] | dim | associated dimension (interleaved) |
[in] | val | associated values |
subroutine cs_c_bindings::log_iteration_clipping | ( | character(len=*), intent(in) | name, |
integer, intent(in) | dim, | ||
integer, intent(in) | n_clip_min, | ||
integer, intent(in) | n_clip_max, | ||
real(kind=c_double), dimension(*) | min_pre_clip, | ||
real(kind=c_double), dimension(*) | max_pre_clip | ||
) |
Add array not saved as permanent field to logging of fields.
[in] | name | array name |
[in] | dim | associated dimension (interleaved) |
[in] | n_clip_min | local number of clipped to min values |
[in] | n_clip_max | local number of clipped to max values |
[in] | min_pre_clip | min local value prior to clip |
[in] | max_pre_clip | max local value prior to clip |
subroutine cs_c_bindings::log_iteration_clipping_field | ( | integer, intent(in) | f_id, |
integer, intent(in) | n_clip_min, | ||
integer, intent(in) | n_clip_max, | ||
real(kind=c_double), dimension(*) | min_pre_clip, | ||
real(kind=c_double), dimension(*) | max_pre_clip, | ||
integer(c_int), dimension(*), intent(in) | n_clip_min_comp, | ||
integer(c_int), dimension(*), intent(in) | n_clip_max_comp | ||
) |
Add array not saved as permanent field to logging of fields.
[in] | f_id | associated dimension (interleaved) |
[in] | n_clip_min | local number of clipped to min values |
[in] | n_clip_max | local number of clipped to max values |
[in] | min_pre_clip | min local value prior to clip |
[in] | max_pre_clip | max local value prior to clip |
[in] | n_clip_min_comp | number of clip min by component |
[in] | n_clip_max_comp | number of clip max by component |
double precision function cs_c_bindings::notebook_parameter_value_by_name | ( | character(len=*), intent(in) | name | ) |
Return notebook parameter value.
[in] | name | name of the notebook parameter |
subroutine cs_c_bindings::pressure_drop_by_zone | ( | character(len=*), intent(in) | sel_crit | ) |
Compute pressure drop for a given zone.
param[in] sel_crit selection criteria of a volume zone
subroutine cs_c_bindings::promav | ( | integer, value | isym, |
integer, value | ibsize, | ||
integer, value | iesize, | ||
integer, value | f_id, | ||
real(kind=c_double), dimension(*), intent(in) | dam, | ||
real(kind=c_double), dimension(*), intent(in) | xam, | ||
real(kind=c_double), dimension(*), intent(in) | vx, | ||
real(kind=c_double), dimension(*), intent(out) | vy | ||
) |
subroutine cs_c_bindings::restart_create | ( | character(len=*), intent(in) | name, |
character(len=*), intent(in) | path, | ||
integer, intent(in) | mode, | ||
type(c_ptr), intent(out) | r | ||
) |
Initialize a restart file.
[in] | name | file name |
[in] | path | optional directory name for output (automatically created if necessary) |
[in] | mode | read (0) or write (1) |
[out] | r | pointer to restart structure |
subroutine cs_c_bindings::restart_read_field_vals | ( | type(c_ptr), intent(in) | r, |
integer, intent(in) | f_id, | ||
integer, intent(in) | t_id, | ||
integer, intent(out) | ierror | ||
) |
Read field values from checkpoint.
If the values are not found using the default rules based on the field's name, its name itself, or a "restart_rename" keyed string value, an old name may be used for compatibility with older files. For cell-based fields, the old name base is appended automatically with "_ce_phase01", except for scalars, where the name uses a different scheme, based on "scalaire_ce_%04" % s_num;
[in] | r | pointer to restart structure |
[in] | f_id | field id |
[in] | t_id | time id (0 for current, 1 for previous, ...) |
[out] | ierror | return code |
subroutine cs_c_bindings::restart_read_int_t_compat | ( | type(c_ptr), intent(in) | r, |
character(len=*), intent(in) | sec_name, | ||
character(len=*), intent(in) | old_name, | ||
integer, intent(in) | location_id, | ||
integer, intent(in) | n_loc_vals, | ||
integer, dimension(*), target | val, | ||
integer, intent(out) | ierror | ||
) |
Read a section of integers from a restart file, when that section may have used a different name in a previous version.
[in] | r | pointer to restart structure |
[in] | sec_name | name of section |
[in] | old_name | old name of section |
[in] | location_id | id of associated mesh location |
[in] | n_loc_vals | number of values per location |
[out] | val | values array |
[out] | ierror | 0: success, < 0: error code |
subroutine cs_c_bindings::restart_read_linked_fields | ( | type(c_ptr), intent(in) | r, |
type(c_ptr), intent(in) | old_field_map, | ||
character(len=*), intent(in) | key, | ||
integer, intent(out) | n_w | ||
) |
Read fields depending on others from checkpoint.
[in] | r | pointer to restart structure |
[in] | old_field_map | pointer to old field map |
[in] | key | key for field association |
[out] | n_w | number of fields read |
subroutine cs_c_bindings::restart_read_real_3_t_compat | ( | type(c_ptr), intent(in) | r, |
character(len=*), intent(in) | sec_name, | ||
character(len=*), intent(in) | old_name_x, | ||
character(len=*), intent(in) | old_name_y, | ||
character(len=*), intent(in) | old_name_z, | ||
integer, intent(in) | location_id, | ||
real(kind=c_double), dimension(*) | val, | ||
integer, intent(out) | ierror | ||
) |
Read a vector of double precision reals of dimension (3,*) from a restart file, when that section may have used a different name and been non-interleaved in a previous version.
[in] | r | pointer to restart structure |
[in] | sec_name | name of section |
[in] | old_name_x | old name of component x of section |
[in] | old_name_y | old name of component y of section |
[in] | old_name_z | old name of component z of section |
[in] | location_id | id of associated mesh location |
[out] | val | values array |
[out] | ierror | 0: success, < 0: error code |
subroutine cs_c_bindings::restart_read_real_t_compat | ( | type(c_ptr), intent(in) | r, |
character(len=*), intent(in) | sec_name, | ||
character(len=*), intent(in) | old_name, | ||
integer, intent(in) | location_id, | ||
integer, intent(in) | n_loc_vals, | ||
real(kind=c_double), dimension(*), target | val, | ||
integer, intent(out) | ierror | ||
) |
Read a section of double precision reals from a restart file, when that section may have used a different name in a previous version.
[in] | r | pointer to restart structure |
[in] | sec_name | name of section |
[in] | old_name | old name of section |
[in] | location_id | id of associated mesh location |
[in] | n_loc_vals | number of values per location |
[out] | val | values array |
[out] | ierror | 0: success, < 0: error code |
subroutine cs_c_bindings::restart_read_section_int_t | ( | type(c_ptr), intent(in) | r, |
character(len=*), intent(in) | sec_name, | ||
integer, intent(in) | location_id, | ||
integer, intent(in) | n_loc_vals, | ||
integer, dimension(*), target | val, | ||
integer, intent(out) | ierror | ||
) |
Read a section of integers from a restart file.
[in] | r | pointer to restart structure |
[in] | sec_name | name of section |
[in] | location_id | id of associated mesh location |
[in] | n_loc_vals | number of values per location |
[out] | val | values array |
[out] | ierror | 0: success, < 0: error code |
subroutine cs_c_bindings::restart_read_section_real_t | ( | type(c_ptr), intent(in) | r, |
character(len=*), intent(in) | sec_name, | ||
integer, intent(in) | location_id, | ||
integer, intent(in) | n_loc_vals, | ||
real(kind=c_double), dimension(*), target | val, | ||
integer, intent(out) | ierror | ||
) |
Read a section of doubles from a restart file.
[in] | r | pointer to restart structure |
[in] | sec_name | name of section |
[in] | location_id | id of associated mesh location |
[in] | n_loc_vals | number of values per location |
[out] | val | values array |
[out] | ierror | 0: success, < 0: error code |
subroutine cs_c_bindings::restart_read_variables | ( | type(c_ptr), intent(in) | r, |
type(c_ptr), intent(in) | old_field_map, | ||
integer, intent(in) | t_id_flag | ||
) |
Read variables from checkpoint.
[in] | r | pointer to restart structure |
[in] | old_field_map | old field map pointer |
[in] | t_id_flag | -1: all time values; 0: current values; > 0: previous values |
subroutine cs_c_bindings::restart_write_field_vals | ( | type(c_ptr), intent(in) | r, |
integer, intent(in) | f_id, | ||
integer, intent(in) | t_id | ||
) |
Write field values to checkpoint.
[in] | r | pointer to restart structure |
[in] | f_id | field id |
[in] | t_id | time id (0 for current, 1 for previous, ...) |
subroutine cs_c_bindings::restart_write_linked_fields | ( | type(c_ptr), intent(in) | r, |
character(len=*), intent(in) | key, | ||
integer, intent(out) | n_w | ||
) |
Write fields depending on others to checkpoint.
[in] | r | pointer to restart structure |
[in] | key | key for field association |
[out] | n_w | number of fields written |
subroutine cs_c_bindings::restart_write_section_int_t | ( | type(c_ptr), intent(in) | r, |
character(len=*), intent(in) | sec_name, | ||
integer, intent(in) | location_id, | ||
integer, intent(in) | n_loc_vals, | ||
integer, dimension(*), intent(in), target | val | ||
) |
Write a section of integers to a checkpoint file.
[in] | r | pointer to restart structure |
[in] | sec_name | name of section |
[in] | location_id | id of associated mesh location |
[in] | n_loc_vals | number of values per location |
[in] | val | values array |
subroutine cs_c_bindings::restart_write_section_real_t | ( | type(c_ptr), intent(in) | r, |
character(len=*), intent(in) | sec_name, | ||
integer, intent(in) | location_id, | ||
integer, intent(in) | n_loc_vals, | ||
real(kind=c_double), dimension(*), intent(in), target | val | ||
) |
write a section of doubles to a checkpoint file.
[in] | r | pointer to restart structure |
[in] | sec_name | name of section |
[in] | location_id | id of associated mesh location |
[in] | n_loc_vals | number of values per location |
[in] | val | values array |
subroutine cs_c_bindings::restart_write_variables | ( | type(c_ptr), intent(in) | r, |
integer, intent(in) | t_id_flag | ||
) |
Write variables to checkpoint.
[in] | r | pointer to restart structure |
[in] | t_id_flag | -1: all time values; 0: current values; > 0: previous values |
subroutine cs_c_bindings::sles_free_native | ( | integer, intent(in) | f_id, |
character(len=*), intent(in) | name | ||
) |
Free sparse linear equation solver setup using native matrix arrays.
param[in] f_id associated field id, or < 0 param[in] name associated name if f_id < 0, or ignored
subroutine cs_c_bindings::sles_pop | ( | integer, intent(in) | f_id | ) |
Revert to normal behavior of field id for matching calls to sles_solve_native.
param[in] f_id associated field id, or < 0
subroutine cs_c_bindings::sles_push | ( | integer, intent(in) | f_id, |
character(len=*), intent(in) | name | ||
) |
Temporarily replace field id with name for matching calls to sles_solve_native.
param[in] f_id associated field id, or < 0 param[in] name associated name if f_id < 0, or ignored
subroutine cs_c_bindings::sles_solve_native | ( | integer, intent(in) | f_id, |
character(len=*), intent(in) | name, | ||
integer, intent(in) | isym, | ||
integer, intent(in) | ibsize, | ||
integer, intent(in) | iesize, | ||
real(kind=c_double), dimension(*), intent(in) | dam, | ||
real(kind=c_double), dimension(*), intent(in) | xam, | ||
double precision, intent(in) | epsilp, | ||
double precision, intent(in) | rnorm, | ||
integer, intent(out) | niter, | ||
double precision, intent(out) | residue, | ||
real(kind=c_double), dimension(*), intent(in) | rhs, | ||
real(kind=c_double), dimension(*), intent(inout) | vx | ||
) |
Call sparse linear equation solver using native matrix arrays.
param[in] f_id associated field id, or < 0 param[in] name associated name if f_id < 0, or ignored param[in] isym symmetry indicator: 1 symmetric, 2: not symmetric param[in] ibsize block sizes for diagonal param[in] iesize block sizes for extra diagonal param[in] dam matrix diagonal param[in] xam matrix extra-diagonal terms param[in] epsilp precision for iterative resolution param[in] rnorm residue normalization param[out] niter number of "equivalent" iterations param[out] residue residue param[in] rhs right hand side param[in, out] vx system solution
subroutine cs_c_bindings::surface_balance | ( | character(len=*), intent(in) | sel_crit, |
character(len=*), intent(in) | name, | ||
real(kind=c_double), dimension(3), intent(in) | normal | ||
) |
Compute surface scalar balance for a given surface area.
param[in] sel_crit selection criteria of a volume zone
integer function cs_c_bindings::timer_stats_create | ( | character(len=*), intent(in) | parent_name, |
character(len=*), intent(in) | name, | ||
character(len=*), intent(in) | label | ||
) |
Create a timer statistics structure.
If no timer with the given name exists, -1 is returned.
[in] | parent_name | name of parent statistic (may be empty) |
[in] | name | associated canonical name |
[in] | label | associated label (may be empty) |
integer function cs_c_bindings::timer_stats_id_by_name | ( | character(len=*), intent(in) | name | ) |
Return the id of a defined statistic based on its name.
If no timer with the given name exists, -1 is returned.
[in] | name | statistic name |
subroutine cs_c_bindings::variable_cdo_field_create | ( | character(len=*), intent(in) | name, |
character(len=*), intent(in) | label, | ||
integer, intent(in) | location_id, | ||
integer, intent(in) | dim, | ||
integer, intent(in) | has_previous, | ||
integer, intent(out) | id | ||
) |
Add a CDO field defining a general solved variable, with default options.
[in] | name | field name |
[in] | label | field default label, or empty |
[in] | location_id | field location type: 0: none 1: cells 2: interior faces 3: interior faces 4: vertices |
[in] | dim | field dimension |
[in] | has_previous | if greater than 1 then store previous state |
[out] | id | id of defined field |
subroutine cs_c_bindings::variable_field_create | ( | character(len=*), intent(in) | name, |
character(len=*), intent(in) | label, | ||
integer, intent(in) | location_id, | ||
integer, intent(in) | dim, | ||
integer, intent(out) | id | ||
) |
Add field defining a general solved variable, with default options.
[in] | name | field name |
[in] | label | field default label, or empty |
[in] | location_id | field location type: 0: none 1: cells 2: interior faces 3: interior faces 4: vertices |
[in] | dim | field dimension |
[out] | id | id of defined field |
integer function cs_c_bindings::volume_zone_n_type_cells | ( | integer | type_flag | ) |
Return the number of volume zone cells associated with a given type flag.
[in] | type_flag | type flag queried |
integer function cs_c_bindings::volume_zone_n_type_zones | ( | integer | type_flag | ) |
Return the number of volume zones associated with a given type flag.
[in] | type_flag | type flag queried |
subroutine cs_c_bindings::volume_zone_select_type_cells | ( | integer | type_flag, |
integer, dimension(*), intent(out), target | cell_list | ||
) |
Return the list of volume zone cells associated with a given type flag.
[in] | type_flag | type flag queried |
[out] | cell_list | list of cells |
integer mesh_location_boundary_faces |
integer mesh_location_cells |
integer mesh_location_interior_faces |
integer mesh_location_none |
integer mesh_location_other |
integer mesh_location_particles |
integer mesh_location_vertices |
integer restart_1d_wall_thermal |
integer restart_auxiliary |
integer restart_disabled |
integer restart_lagr |
integer restart_lagr_stat |
integer restart_les_inflow |
integer restart_main |
integer restart_rad_transfer |
integer restart_val_type_int_t |
integer restart_val_type_real_t |
integer volume_zone_head_loss |
integer volume_zone_initialization |
integer volume_zone_mass_source_term |
integer volume_zone_porosity |
integer volume_zone_source_term |