8.2
general documentation
Loading...
Searching...
No Matches
cs_c_bindings Module Reference

Data Types

interface  boundary_conditions_mapped_set
 Set mapped boundary conditions for a given field and mapping locator. More...
interface  cs_boundary_conditions_legacy_turbulence
 Define automatic turbulence values for specific physical modules. More...
interface  cs_f_field_get_key_struct_var_cal_opt
interface  cs_f_field_set_key_struct_var_cal_opt
interface  cs_f_scalar_clipping
interface  cs_fan_n_fans
 Return the number of fans. More...
interface  cs_gas_combustion_h_to_t
 Convert enthalpy to temperature for gas combustion. More...
interface  cs_gas_combustion_t_to_h
 Convert temperature to enthalpy for gas combustion. More...
interface  cs_immersed_boundary_wall_functions
 Compute boundary contributions for all immersed boundaries. More...
interface  cs_intprf
interface  cs_intprz
interface  cs_log_default_activate
interface  cs_log_default_is_active
interface  cs_log_iteration_prepare
interface  cs_map_name_to_id_destroy
 Destroy name to id map structure. More...
interface  cs_sat_coupling_array_exchange
interface  cs_set_type_order_turbulence_model
interface  cs_syr_coupling_n_couplings
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...
interface  cs_turb_model_init
interface  csccel
interface  equation_param_from_vcopt
type  gas_mix_species_prop
interface  les_balance_compute
 Compute the LES balance. More...
interface  les_balance_create
 Create the LES balance structure. More...
interface  les_balance_finalize
 Destroy the LES balance structure. More...
interface  les_balance_update_gradients
 Compute additional time averages for LES balance. More...
interface  les_balance_write_restart
 Write the LES balance restart file. More...
interface  les_filter
 Compute filters for dynamic models. More...
interface  log_iteration
interface  log_l2residual
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_clean_multiwriters_history
 Remove all previous dumps of checkpoint files which are not to be saved. More...
interface  restart_destroy
 Destroy structure associated with a restart file (and close the file). More...
interface  restart_main_and_aux_read
interface  restart_main_and_aux_write
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 $ D_H $ and the reference velocity $ U_{ref} $ 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 $ D_H $, a turbulent intensity $ I $ and the reference velocity $ U_{ref} $ for a circular duct flow with smooth wall. More...
interface  turbulence_bc_ke_hyd_diam
 Calculation of $ u^\star $, $ k $ and $\varepsilon $ from a diameter $ D_H $ and the reference velocity $ U_{ref} $ for a circular duct flow with smooth wall (use for inlet boundary conditions). More...
interface  turbulence_bc_ke_turb_intensity
 Calculation of $ k $ and $\varepsilon$ from a diameter $ D_H $, a turbulent intensity $ I $ and the reference velocity $ U_{ref} $ for a circular duct flow with smooth wall (for inlet boundary conditions). More...
interface  turbulence_bc_rij_transform
 Compute matrix $ \tens{alpha} $ 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
interface  yg2xye
 Compute molar and mass fractions of elementary species Ye, Xe (fuel, O2, CO2, H2O, N2) from global species Yg (fuel, oxidant, products) More...

Functions/Subroutines

subroutine balance_by_zone (sel_crit, name)
 Compute balance on a given zone for a given scalar.
subroutine intprf (nprofz, nproft, profz, proft, profv, xz, temps, var)
 Temporal and z-axis interpolation for meteorological profiles.
subroutine intprz (nprofz, profz, profv, xz, iz1, iz2, var)
 z-axis interpolation for meteorological profiles
subroutine pressure_drop_by_zone (sel_crit)
 Compute pressure drop for a given zone.
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.
subroutine boundary_conditions_error (bc_type)
 Handle boundary condition definition errors and associated output.
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.
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.
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.
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.
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.
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.
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.
subroutine gradient_hn_s (f_id, imrgra, inc, nswrgp, imligp, iwarnp, epsrgp, climgp, pvar, grad)
 Compute cell gradient for scalar with homegeneous gradient.
subroutine locator_destroy (this_locator)
 Destruction of a locator structure.
subroutine log_iteration_add_array (name, category, location, is_intensive, dim, val)
 Add array not saved as permanent field to logging of fields.
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.
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.
subroutine restart_create (name, path, mode, r)
 Initialize a restart file.
subroutine restart_read_variables (r, old_field_map, t_id_flag)
 Read variables from checkpoint.
subroutine restart_write_variables (r, t_id_flag)
 Write variables to checkpoint.
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.
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.
subroutine restart_write_section_int_t (r, sec_name, location_id, n_loc_vals, val)
 Write a section of integers to a checkpoint file.
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.
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.
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.
subroutine restart_write_section_real_t (r, sec_name, location_id, n_loc_vals, val)
 write a section of doubles to a checkpoint file.
subroutine restart_read_field_vals (r, f_id, t_id, ierror)
 Read field values from checkpoint.
subroutine restart_initialize_fields_read_status ()
 Initialize fields checkpoint read status array.
subroutine restart_finalize_fields_read_status ()
 Finalize fields checkpoint read status array.
subroutine restart_get_field_read_status (f_id, retval)
 Get field checkpoint read status. Returns 1 if field was read, 0.
subroutine restart_write_field_vals (r, f_id, t_id)
 Write field values to checkpoint.
subroutine restart_read_linked_fields (r, old_field_map, key, n_w)
 Read fields depending on others from checkpoint.
subroutine restart_write_linked_fields (r, key, n_w)
 Write fields depending on others to checkpoint.
subroutine sles_free_native (f_id, name)
 Free sparse linear equation solver setup using native matrix arrays.
integer function timer_stats_create (parent_name, name, label)
 Create a timer statistics structure.
integer function timer_stats_id_by_name (name)
 Return the id of a defined statistic based on its name.
subroutine user_f_boundary_conditions (itrifb, itypfb, izfppp, dt)
 Wrapper to Fortran user boundary condition definitions.
subroutine variable_field_create (name, label, location_id, dim, id)
 Add field defining a general solved variable, with default options.
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.
integer function volume_zone_n_type_zones (type_flag)
 Return the number of volume zones associated with a given type flag.
integer function volume_zone_n_type_cells (type_flag)
 Return the number of volume zone cells associated with a given type flag.
subroutine volume_zone_select_type_cells (type_flag, cell_list)
 Return the list of volume zone cells associated with a given type flag.
double precision function notebook_parameter_value_by_name (name)
 Return notebook parameter value.
integer function cell_is_active (iel)
 Indicate of a cell is active fo the current variable.
subroutine atmo_set_meteo_file_name (name)
 Sets the meteo file name.
subroutine atmo_set_chem_conc_file_name (name)
 Sets the chemistry concentration file name.
subroutine atmo_set_aero_conc_file_name (name)
 Sets the aerosol concentration file name.
subroutine atmo_chemistry_set_spack_file_name (name)
 Sets the file name used to initialize SPACK.
subroutine atmo_chemistry_set_aerosol_file_name (name)
 Sets the file name used to initialize the aerosol shared library.
subroutine clpsca (iscal)
 brief Clipping scalar field.

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
procedure() csexit
procedure() dmtmps
procedure() cslogname

Function/Subroutine Documentation

◆ atmo_chemistry_set_aerosol_file_name()

subroutine atmo_chemistry_set_aerosol_file_name ( character(len=*), intent(in) name)

Sets the file name used to initialize the aerosol shared library.

Parameters
[in]namename of the file

◆ atmo_chemistry_set_spack_file_name()

subroutine atmo_chemistry_set_spack_file_name ( character(len=*), intent(in) name)

Sets the file name used to initialize SPACK.

Parameters
[in]namename of the file

◆ atmo_set_aero_conc_file_name()

subroutine atmo_set_aero_conc_file_name ( character(len=*), intent(in) name)

Sets the aerosol concentration file name.

Parameters
[in]namename of the file

◆ atmo_set_chem_conc_file_name()

subroutine atmo_set_chem_conc_file_name ( character(len=*), intent(in) name)

Sets the chemistry concentration file name.

Parameters
[in]namename of the file

◆ atmo_set_meteo_file_name()

subroutine atmo_set_meteo_file_name ( character(len=*), intent(in) name)

Sets the meteo file name.

Parameters
[in]namename of the file

◆ balance_by_zone()

subroutine 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

◆ boundary_conditions_error()

subroutine 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

◆ boundary_conditions_map()

type(c_ptr) function 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

◆ cell_is_active()

integer function cell_is_active ( integer iel)

Indicate of a cell is active fo the current variable.

Parameters
[in]ielcell number (cell_id + 1)
Returns
is_active

◆ clpsca()

subroutine clpsca ( integer, intent(in) iscal)

brief Clipping scalar field.

◆ field_get_key_struct_gas_mix_species_prop()

subroutine 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.

Parameters
[in]f_idfield id
[out]k_valueinteger value associated with key id for this field

◆ field_get_key_struct_solving_info()

subroutine 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.

Parameters
[in]f_idfield id
[out]k_valueinteger value associated with key id for this field

◆ field_get_key_struct_var_cal_opt()

subroutine field_get_key_struct_var_cal_opt ( integer, intent(in) f_id,
type(var_cal_opt), intent(out), 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.

Parameters
[in]f_idfield id
[out]k_valueinteger value associated with key id for this field

◆ field_set_key_struct_gas_mix_species_prop()

subroutine 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.

Parameters
[in]f_idfield id
[in]k_valuestructure associated with key

◆ field_set_key_struct_solving_info()

subroutine 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.

Parameters
[in]f_idfield id
[in]k_valuestructure associated with key

◆ field_set_key_struct_var_cal_opt()

subroutine 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.

Parameters
[in]f_idfield id
[in]k_valuestructure associated with key

◆ gradient_hn_s()

subroutine gradient_hn_s ( integer, intent(in) f_id,
integer, intent(in) imrgra,
integer, intent(in) inc,
integer, intent(in) nswrgp,
integer, intent(in) imligp,
integer, intent(in) iwarnp,
double precision, intent(in) epsrgp,
double precision, intent(in) climgp,
real(kind=c_double), dimension(ncelet), intent(inout) pvar,
real(kind=c_double), dimension(3, ncelet), intent(out) grad )

Compute cell gradient for scalar with homegeneous gradient.

Parameters
[in]f_idfield id, or -1
[in]imrgragradient computation mode
[in]inc0: increment; 1: do not increment
[in]nswrgpnumber of sweeps for reconstruction
[in]imligpgradient limitation method: < 0 no limitation = 0 based on neighboring gradients = 1 based on mean gradient
[in]iwarnpverbosity
[in]epsrgprelative precision for reconstruction
[in]climgplimiter coefficient for imligp
[in,out]pvarcell values whose gradient is computed
[out]gradresulting gradient

◆ intprf()

subroutine intprf ( integer(c_int), intent(in), value nprofz,
integer(c_int), intent(in), value nproft,
real(kind=c_double), dimension(nprofz), intent(in) profz,
real(kind=c_double), dimension(nproft), intent(in) proft,
real(kind=c_double), dimension(nprofz, nproft), intent(in) profv,
real(kind=c_double), intent(in), value xz,
real(kind=c_double), intent(in), value temps,
real(kind=c_double), intent(out) var )

Temporal and z-axis interpolation for meteorological profiles.

An optimized linear interpolation is used.

◆ intprz()

subroutine intprz ( integer(c_int), intent(in), value nprofz,
real(kind=c_double), dimension(nprofz), intent(in) profz,
real(kind=c_double), dimension(nprofz), intent(in) profv,
real(kind=c_double), intent(in), value xz,
integer(c_int), intent(out) iz1,
integer(c_int), intent(out) iz2,
real(kind=c_double), intent(out) var )

z-axis interpolation for meteorological profiles

An optimized linear interpolation is used.

◆ locator_destroy()

subroutine locator_destroy ( type(c_ptr) this_locator)

Destruction of a locator structure.

Parameters
[in,out]this_locator

◆ log_iteration_add_array()

subroutine 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.

Parameters
[in]namearray name
[in]categorycategory name
[in]locationassociated mesh location
[in]is_intensiveassociated mesh location
[in]dimassociated dimension (interleaved)
[in]valassociated values

◆ log_iteration_clipping()

subroutine 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.

Parameters
[in]namearray name
[in]dimassociated dimension (interleaved)
[in]n_clip_minlocal number of clipped to min values
[in]n_clip_maxlocal number of clipped to max values
[in]min_pre_clipmin local value prior to clip
[in]max_pre_clipmax local value prior to clip

◆ log_iteration_clipping_field()

subroutine 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.

Parameters
[in]f_idassociated dimension (interleaved)
[in]n_clip_minlocal number of clipped to min values
[in]n_clip_maxlocal number of clipped to max values
[in]min_pre_clipmin local value prior to clip
[in]max_pre_clipmax local value prior to clip
[in]n_clip_min_compnumber of clip min by component
[in]n_clip_max_compnumber of clip max by component

◆ notebook_parameter_value_by_name()

double precision function notebook_parameter_value_by_name ( character(len=*), intent(in) name)

Return notebook parameter value.

Parameters
[in]namename of the notebook parameter
Returns
val

◆ pressure_drop_by_zone()

subroutine 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

◆ promav()

subroutine 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 )

◆ restart_create()

subroutine 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.

Parameters
[in]namefile name
[in]pathoptional directory name for output (automatically created if necessary)
[in]moderead (0) or write (1)
[out]rpointer to restart structure

◆ restart_finalize_fields_read_status()

subroutine restart_finalize_fields_read_status

Finalize fields checkpoint read status array.

◆ restart_get_field_read_status()

subroutine restart_get_field_read_status ( integer, intent(in) f_id,
integer, intent(out) retval )

Get field checkpoint read status. Returns 1 if field was read, 0.

Parameters
[in]f_idfield id
[out]retvalreturn value. 1 f field was read, 0 otherwise

◆ restart_initialize_fields_read_status()

subroutine restart_initialize_fields_read_status

Initialize fields checkpoint read status array.

◆ restart_read_field_vals()

subroutine 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;

Parameters
[in]rpointer to restart structure
[in]f_idfield id
[in]t_idtime id (0 for current, 1 for previous, ...)
[out]ierrorreturn code

◆ restart_read_int_t_compat()

subroutine 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.

Parameters
[in]rpointer to restart structure
[in]sec_namename of section
[in]old_nameold name of section
[in]location_idid of associated mesh location
[in]n_loc_valsnumber of values per location
[out]valvalues array
[out]ierror0: success, < 0: error code

◆ restart_read_linked_fields()

subroutine 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.

Parameters
[in]rpointer to restart structure
[in]old_field_mappointer to old field map
[in]keykey for field association
[out]n_wnumber of fields read

◆ restart_read_real_3_t_compat()

subroutine 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.

Parameters
[in]rpointer to restart structure
[in]sec_namename of section
[in]old_name_xold name of component x of section
[in]old_name_yold name of component y of section
[in]old_name_zold name of component z of section
[in]location_idid of associated mesh location
[out]valvalues array
[out]ierror0: success, < 0: error code

◆ restart_read_real_t_compat()

subroutine 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.

Parameters
[in]rpointer to restart structure
[in]sec_namename of section
[in]old_nameold name of section
[in]location_idid of associated mesh location
[in]n_loc_valsnumber of values per location
[out]valvalues array
[out]ierror0: success, < 0: error code

◆ restart_read_section_int_t()

subroutine 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.

Parameters
[in]rpointer to restart structure
[in]sec_namename of section
[in]location_idid of associated mesh location
[in]n_loc_valsnumber of values per location
[out]valvalues array
[out]ierror0: success, < 0: error code

◆ restart_read_section_real_t()

subroutine 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.

Parameters
[in]rpointer to restart structure
[in]sec_namename of section
[in]location_idid of associated mesh location
[in]n_loc_valsnumber of values per location
[out]valvalues array
[out]ierror0: success, < 0: error code

◆ restart_read_variables()

subroutine 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.

Parameters
[in]rpointer to restart structure
[in]old_field_mapold field map pointer
[in]t_id_flag-1: all time values; 0: current values; > 0: previous values

◆ restart_write_field_vals()

subroutine 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.

Parameters
[in]rpointer to restart structure
[in]f_idfield id
[in]t_idtime id (0 for current, 1 for previous, ...)

◆ restart_write_linked_fields()

subroutine 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.

Parameters
[in]rpointer to restart structure
[in]keykey for field association
[out]n_wnumber of fields written

◆ restart_write_section_int_t()

subroutine 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.

Parameters
[in]rpointer to restart structure
[in]sec_namename of section
[in]location_idid of associated mesh location
[in]n_loc_valsnumber of values per location
[in]valvalues array

◆ restart_write_section_real_t()

subroutine 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.

Parameters
[in]rpointer to restart structure
[in]sec_namename of section
[in]location_idid of associated mesh location
[in]n_loc_valsnumber of values per location
[in]valvalues array

◆ restart_write_variables()

subroutine restart_write_variables ( type(c_ptr), intent(in) r,
integer, intent(in) t_id_flag )

Write variables to checkpoint.

Parameters
[in]rpointer to restart structure
[in]t_id_flag-1: all time values; 0: current values; > 0: previous values

◆ sles_free_native()

subroutine 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

◆ surface_balance()

subroutine 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

◆ timer_stats_create()

integer function 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.

Parameters
[in]parent_namename of parent statistic (may be empty)
[in]nameassociated canonical name
[in]labelassociated label (may be empty)

◆ timer_stats_id_by_name()

integer function 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.

Parameters
[in]namestatistic name

◆ user_f_boundary_conditions()

subroutine user_f_boundary_conditions ( integer(kind=c_int), dimension(*), intent(in) itrifb,
integer(kind=c_int), dimension(*), intent(inout) itypfb,
integer(kind=c_int), dimension(*), intent(inout) izfppp,
real(c_double), dimension(*), intent(in) dt )

Wrapper to Fortran user boundary condition definitions.

Parameters
[in,out]bc_typeboundary face types

◆ variable_cdo_field_create()

subroutine 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.

Parameters
[in]namefield name
[in]labelfield default label, or empty
[in]location_idfield location type: 0: none 1: cells 2: interior faces 3: interior faces 4: vertices
[in]dimfield dimension
[in]has_previousif greater than 1 then store previous state
[out]idid of defined field

◆ variable_field_create()

subroutine 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.

Parameters
[in]namefield name
[in]labelfield default label, or empty
[in]location_idfield location type: 0: none 1: cells 2: interior faces 3: interior faces 4: vertices
[in]dimfield dimension
[out]idid of defined field

◆ volume_zone_n_type_cells()

integer function volume_zone_n_type_cells ( integer type_flag)

Return the number of volume zone cells associated with a given type flag.

Parameters
[in]type_flagtype flag queried

◆ volume_zone_n_type_zones()

integer function volume_zone_n_type_zones ( integer type_flag)

Return the number of volume zones associated with a given type flag.

Parameters
[in]type_flagtype flag queried

◆ volume_zone_select_type_cells()

subroutine 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.

Parameters
[in]type_flagtype flag queried
[out]cell_listlist of cells

Variable Documentation

◆ csexit

procedure() csexit

◆ cslogname

procedure() cslogname

◆ dmtmps

procedure() dmtmps

◆ mesh_location_boundary_faces

integer mesh_location_boundary_faces

◆ mesh_location_cells

integer mesh_location_cells

◆ mesh_location_interior_faces

integer mesh_location_interior_faces

◆ mesh_location_none

integer mesh_location_none

◆ mesh_location_other

integer mesh_location_other

◆ mesh_location_particles

integer mesh_location_particles

◆ mesh_location_vertices

integer mesh_location_vertices

◆ restart_1d_wall_thermal

integer restart_1d_wall_thermal

◆ restart_auxiliary

integer restart_auxiliary

◆ restart_disabled

integer restart_disabled

◆ restart_lagr

integer restart_lagr

◆ restart_lagr_stat

integer restart_lagr_stat

◆ restart_les_inflow

integer restart_les_inflow

◆ restart_main

integer restart_main

◆ restart_rad_transfer

integer restart_rad_transfer

◆ restart_val_type_int_t

integer restart_val_type_int_t

◆ restart_val_type_real_t

integer restart_val_type_real_t

◆ volume_zone_head_loss

integer volume_zone_head_loss

◆ volume_zone_initialization

integer volume_zone_initialization

◆ volume_zone_mass_source_term

integer volume_zone_mass_source_term

◆ volume_zone_porosity

integer volume_zone_porosity

◆ volume_zone_source_term

integer volume_zone_source_term