#include "cs_base.h"
#include "cs_domain.h"
#include "cs_field.h"
#include "cs_mesh.h"
#include "cs_mesh_quantities.h"
#include "cs_mesh_bad_cells.h"
#include "cs_probe.h"
#include "cs_time_control.h"
#include "cs_volume_zone.h"
Go to the source code of this file.
Functions | |
void | csinit (const int *irgpar, const int *nrgpar) |
void | findpt (const cs_lnum_t *ncelet, const cs_lnum_t *ncel, const cs_real_t *xyzcen, const cs_real_t *xx, const cs_real_t *yy, const cs_real_t *zz, cs_lnum_t *node, int *ndrang) |
int | cs_add_variable_field_indexes (int f_id) |
int | cs_add_model_field_indexes (int f_id) |
void | cs_add_model_thermal_field_indexes (int f_id) |
void | cs_atmo_chem_source_terms (int iscal, cs_real_t st_exp[], cs_real_t st_imp[]) |
void | cs_at_source_term_for_inlet (cs_real_3_t st_exp[]) |
Additional right-hand side source terms for momentum equation in case of free inlet. More... | |
void | cs_summon_cressman (cs_real_t the_time) |
Prepare for the cressman interpolation of the variables. More... | |
cs_real_t | cs_gas_combustion_h_to_t (const cs_real_t x_sp[], cs_real_t h) |
Convert an enthalpy to temperature value for gas combustion. More... | |
cs_real_t | cs_gas_combustion_t_to_h (const cs_real_t x_sp[], cs_real_t t) |
Convert a temperature to enthalpy value for gas combustion. More... | |
void | cs_lagr_status (int *model_flag, int *restart_flag, int *frozen_flag) |
void | cs_field_map_and_init_bcs (void) |
Initialize all field BC coefficients. More... | |
void | cs_mass_flux_prediction (cs_real_t dt[]) |
Update the convective mass flux before the Navier Stokes equations (prediction and correction steps). More... | |
void | cs_physical_model_source_terms (int iscal, cs_real_t st_imp[], cs_real_t st_exp[]) |
void | cs_prediction_mass_flux (cs_lnum_t ncesmp, cs_lnum_t icetsm[], cs_real_t dt[]) |
Update the convective mass flux before the Navier Stokes equations (prediction and correction steps). More... | |
void | cs_user_1d_wall_thermal (int iappel) |
void | cs_user_atmo_1d_rad_prf (cs_real_t preray[], cs_real_t temray[], cs_real_t romray[], cs_real_t qvray[], cs_real_t qlray[], cs_real_t ncray[], cs_real_t aeroso[]) |
Fill in vertical profiles of atmospheric properties prior to solving 1D radiative transfers. More... | |
void | cs_user_wall_condensation (int iappel) |
Source terms associated at the boundary faces and the neighboring cells with surface condensation. More... | |
void | cs_user_boundary_conditions_setup (cs_domain_t *domain) |
Set boundary conditions to be applied. More... | |
void | cs_user_boundary_conditions (cs_domain_t *domain, int bc_type[]) |
User definition of boundary conditions. More... | |
void | cs_user_boundary_conditions_ale (cs_domain_t *domain, int bc_type[], int ale_bc_type[], int impale[]) |
User definition of boundary conditions for ALE. More... | |
void | cs_user_extra_operations_initialize (cs_domain_t *domain) |
Initialize variables. More... | |
void | cs_user_extra_operations (cs_domain_t *domain) |
This function is called at the end of each time step. More... | |
void | cs_user_extra_operations_finalize (cs_domain_t *domain) |
This function is called at the end of the calculation. More... | |
void | cs_user_fsi_structure_define (int is_restart, int n_structs, int *plot, cs_time_control_t *plot_time_control, cs_real_t *aexxst, cs_real_t *bexxst, cs_real_t *cfopre, cs_real_t xstr0[][3], cs_real_t vstr0[][3], cs_real_t xstreq[][3]) |
Definition of internal mobile structures and corresponding initial conditions (initial displacement and velocity ). More... | |
void | cs_user_fsi_structure_values (int n_structs, const cs_time_step_t *ts, const cs_real_t xstreq[][3], const cs_real_t xstr[][3], const cs_real_t vstr[][3], cs_real_t xmstru[][3][3], cs_real_t xcstru[][3][3], cs_real_t xkstru[][3][3], cs_real_t forstr[][3], cs_real_t dtstr[]) |
Time-based settings for internal mobile structures. More... | |
void | cs_user_fsi_structure_num (cs_domain_t *domain, int structure_num[]) |
Define structure numbers for faces associated with internal or external (code_aster) structures. More... | |
void | cs_user_head_losses (const cs_zone_t *zone, cs_real_t cku[][6]) |
Compute GUI-defined head losses for a given volume zone. More... | |
void | cs_user_initialization (cs_domain_t *domain) |
This function is called one time step to initialize problem. More... | |
void | cs_user_initial_conditions (cs_domain_t *domain) |
This function is called at startup and allows overloading the GUI defined initialization functions. More... | |
void | cs_user_internal_coupling (void) |
Define internal coupling options. More... | |
void | cs_user_internal_coupling_add_volumes (cs_mesh_t *mesh) |
Define volumes as internal coupling zones. More... | |
void | cs_user_internal_coupling_from_disjoint_meshes (cs_mesh_t *mesh) |
Define volumesi from separated meshes as internal coupling zones. More... | |
void | cs_user_physical_properties (cs_domain_t *domain) |
This function is called each time step to define physical properties. More... | |
void | cs_user_physical_properties_h_to_t (cs_domain_t *domain, const cs_zone_t *z, bool z_local, const cs_real_t h[], cs_real_t t[]) |
User definition of enthalpy to temperature conversion. More... | |
void | cs_user_physical_properties_t_to_h (cs_domain_t *domain, const cs_zone_t *z, bool z_local, const cs_real_t t[], cs_real_t h[]) |
User definition of temperature to enthalpy conversion. More... | |
void | cs_user_physical_properties_td_pressure (cs_real_t *td_p) |
User function to define a custom law for the thermodynamic pressure. More... | |
void | cs_user_physical_properties_turb_viscosity (cs_domain_t *domain) |
User modification of the turbulence viscosity. More... | |
void | cs_user_source_terms (cs_domain_t *domain, int f_id, cs_real_t *st_exp, cs_real_t *st_imp) |
Additional user-defined source terms for variable equations (momentum, scalars, turbulence...). More... | |
void | cs_user_porosity (cs_domain_t *domain) |
Compute the porosity (volume factor ![]() | |
void | cs_user_join (void) |
Define mesh joinings. More... | |
void | cs_user_linear_solvers (void) |
Define linear solver options. More... | |
void | cs_user_finalize_setup (cs_domain_t *domain) |
Define or modify output user parameters. For CDO schemes, specify the elements such as properties, advection fields, user-defined equations and modules which have been previously added. More... | |
void | cs_user_mesh_bad_cells_tag (cs_mesh_t *mesh, cs_mesh_quantities_t *mesh_quantities) |
Tag bad cells within the mesh based on user-defined geometric criteria. More... | |
void | cs_user_mesh_restart_mode (void) |
Force preprocessing behavior in case of restart. More... | |
void | cs_user_mesh_input (void) |
Define mesh files to read and optional associated transformations. More... | |
void | cs_user_mesh_modify (cs_mesh_t *mesh) |
Modify geometry and mesh. More... | |
void | cs_user_mesh_boundary (cs_mesh_t *mesh) |
Insert boundaries into a mesh. More... | |
void | cs_user_mesh_smoothe (cs_mesh_t *mesh) |
Mesh smoothing. More... | |
void | cs_user_mesh_save (cs_mesh_t *mesh) |
Enable or disable mesh saving. More... | |
void | cs_user_mesh_warping (void) |
Set options for cutting of warped faces. More... | |
void | cs_user_mesh_modify_partial (cs_mesh_t *mesh, cs_mesh_quantities_t *mesh_quantities) |
Apply partial modifications to the mesh after the preprocessing and initial postprocessing mesh building stage. More... | |
void | cs_user_mesh_cartesian_define (void) |
Define a cartesian mesh. More... | |
void | cs_user_model (void) |
Select physical model options, including user fields. More... | |
void | cs_user_numbering (void) |
Define advanced mesh numbering options. More... | |
void | cs_user_parallel_io (void) |
Define parallel IO settings. More... | |
void | cs_user_partition (void) |
Define advanced partitioning options. More... | |
void | cs_user_radiative_transfer_parameters (void) |
User function for input of radiative transfer module options. More... | |
void | cs_user_matrix_tuning (void) |
Define sparse matrix tuning options. More... | |
void | cs_user_parameters (cs_domain_t *domain) |
Define or modify general numerical and physical user parameters. More... | |
void | cs_user_radiative_transfer_bcs (cs_domain_t *domain, const int bc_type[], int isothp[], cs_real_t *tmin, cs_real_t *tmax, cs_real_t *tx, const cs_real_t dt[], const cs_real_t thwall[], const cs_real_t qincid[], cs_real_t hfcnvp[], cs_real_t flcnvp[], cs_real_t xlamp[], cs_real_t epap[], cs_real_t epsp[], cs_real_t textp[]) |
User definition of radiative transfer boundary conditions. More... | |
void | cs_user_periodicity (void) |
Define periodic faces. More... | |
void | cs_user_postprocess_writers (void) |
Define post-processing writers. More... | |
void | cs_user_postprocess_probes (void) |
Define monitoring probes and profiles. More... | |
void | cs_user_postprocess_meshes (void) |
Define post-processing meshes. More... | |
void | cs_user_postprocess_values (const char *mesh_name, int mesh_id, int cat_id, cs_probe_set_t *probes, cs_lnum_t n_cells, cs_lnum_t n_i_faces, cs_lnum_t n_b_faces, cs_lnum_t n_vertices, const cs_lnum_t cell_list[], const cs_lnum_t i_face_list[], const cs_lnum_t b_face_list[], const cs_lnum_t vertex_list[], const cs_time_step_t *ts) |
User function for output of values on a post-processing mesh. More... | |
void | cs_user_postprocess_activate (int nt_max_abs, int nt_cur_abs, double t_cur_abs) |
void | cs_user_rad_transfer_absorption (const int bc_type[], cs_real_t ck[]) |
Absorption coefficient for radiative module. More... | |
void | cs_user_rad_transfer_net_flux (const int itypfb[], const cs_real_t twall[], const cs_real_t qincid[], const cs_real_t xlam[], const cs_real_t epa[], const cs_real_t eps[], const cs_real_t ck[], cs_real_t net_flux[]) |
Compute the net radiation flux. More... | |
int | cs_user_solver_set (void) |
Set user solver. More... | |
void | cs_user_solver (const cs_mesh_t *mesh, const cs_mesh_quantities_t *mesh_quantities) |
Main call to user solver. More... | |
void | cs_user_saturne_coupling (void) |
Define couplings with other instances of code_saturne. More... | |
void | cs_user_syrthes_coupling (void) |
Define couplings with SYRTHES code. More... | |
void | cs_user_syrthes_coupling_volume_h (int coupling_id, const char *syrthes_name, cs_lnum_t n_elts, const cs_lnum_t elt_ids[], cs_real_t h_vol[]) |
Compute a volume exchange coefficient for SYRTHES couplings. More... | |
void | cs_user_cathare_coupling (void) |
Define couplings with SYRTHES code. More... | |
void | cs_user_time_moments (void) |
Define time moments. More... | |
void | cs_user_time_table (void) |
Define time tables using C API. This function is called at the begin of the simulation only. More... | |
void | cs_user_turbomachinery (void) |
Define rotor/stator model. More... | |
void | cs_user_turbomachinery_rotor (void) |
Define rotor axes, associated cells, and rotor/stator faces. More... | |
void | cs_user_turbomachinery_set_rotation_velocity (void) |
Define rotation velocity of rotor. More... | |
void | cs_user_zones (void) |
Define volume and surface zones. More... | |
void | cs_user_scaling_elec (const cs_mesh_t *mesh, const cs_mesh_quantities_t *mesh_quantities, cs_real_t *dt) |
Define scaling parameter for electric model. More... | |
void | cs_user_hgn_thermo_relax_time (const cs_mesh_t *mesh, const cs_real_t *alpha_eq, const cs_real_t *y_eq, const cs_real_t *z_eq, const cs_real_t *ei, const cs_real_t *v, cs_real_t *relax_tau) |
Computation of the relaxation time-scale. More... | |
void | cs_user_paramedmem_define_couplings (void) |
Define ParaMEDMEM coupling(s) More... | |
void | cs_user_paramedmem_define_meshes (void) |
Define coupled meshes. More... | |
void | cs_user_paramedmem_define_fields (void) |
Define fields to couple with ParaMEDMEM. More... | |
int cs_add_model_field_indexes | ( | int | f_id | ) |
void cs_add_model_thermal_field_indexes | ( | int | f_id | ) |
int cs_add_variable_field_indexes | ( | int | f_id | ) |
void cs_at_source_term_for_inlet | ( | cs_real_3_t | st_exp[] | ) |
Additional right-hand side source terms for momentum equation in case of free inlet.
[in] | st_exp | explicit part of the momentum source term |
void cs_field_map_and_init_bcs | ( | void | ) |
Initialize all field BC coefficients.
Convert an enthalpy to temperature value for gas combustion.
[in] | x_sp | mass fraction of constituents |
[in] | h | enthalpy |
Convert a temperature to enthalpy value for gas combustion.
[in] | x_sp | mass fraction of constituents |
[in] | t | temperature at cells |
void cs_lagr_status | ( | int * | model_flag, |
int * | restart_flag, | ||
int * | frozen_flag | ||
) |
void cs_mass_flux_prediction | ( | cs_real_t | dt[] | ) |
Update the convective mass flux before the Navier Stokes equations (prediction and correction steps).
This function computes a potential solving the equation:
This potential is then used to update the mass flux as follows:
[in] | dt | time step (per cell) |
Update the convective mass flux before the Navier Stokes equations (prediction and correction steps).
This function computes a potential solving the equation:
This potential is then used to update the mass flux as follows:
[in] | ncesmp | number of cells with mass source term |
[in] | icetsm | index of cells with mass source term |
[in] | dt | time step (per cell) |
void cs_summon_cressman | ( | cs_real_t | the_time | ) |
Prepare for the cressman interpolation of the variables.
[in] | the_time | current time |
void cs_user_1d_wall_thermal | ( | int | iappel | ) |
void cs_user_atmo_1d_rad_prf | ( | cs_real_t | preray[], |
cs_real_t | temray[], | ||
cs_real_t | romray[], | ||
cs_real_t | qvray[], | ||
cs_real_t | qlray[], | ||
cs_real_t | ncray[], | ||
cs_real_t | aeroso[] | ||
) |
Fill in vertical profiles of atmospheric properties prior to solving 1D radiative transfers.
[in,out] | preray | pressure vertical profile |
[in,out] | temray | real temperature vertical profile |
[in,out] | romray | density vertical profile |
[in,out] | qvray | water vapor content vertical profile |
[in,out] | qlray | water liquid content vertical profile |
[in,out] | ncray | droplets density vertical profile |
[in,out] | aeroso | aerosol concentration vertical profile |
void cs_user_boundary_conditions | ( | cs_domain_t * | domain, |
int | bc_type[] | ||
) |
User definition of boundary conditions.
[in,out] | domain | pointer to a cs_domain_t structure |
[in,out] | bc_type | boundary face types |
The icodcl and rcodcl arrays are pre-initialized based on default and GUI-defined definitions, and may be modified here.
For a given variable field f, and a given face "face_id", these arrays may be used as follows:
For vector or tensor fields, these arrays are not interleaved, so for a given face "face_id" and field component "comp_id", access is as follows (where n_b_faces is domain->mesh->n_b_faces):
f->bc_coeffs->rcodcl1[n_b_faces*comp_id + face_id]
f->bc_coeffs->rcodcl2[n_b_faces*comp_id + face_id]
f->bc_coeffs->rcodcl3[n_b_faces*comp_id + face_id]
Only the icodcl code values from the first component are used in the case of vector or tensor fields, so the icodcl values can be defined as for a scalar.
void cs_user_boundary_conditions_ale | ( | cs_domain_t * | domain, |
int | bc_type[], | ||
int | ale_bc_type[], | ||
int | impale[] | ||
) |
User definition of boundary conditions for ALE.
See Boundary conditions for ALE (Arbitrary Lagrangian Eulerian) for additional details.
[in,out] | domain | pointer to a cs_domain_t structure |
[in,out] | bc_type | boundary face types |
[in,out] | ale_bc_type | boundary face types for mesh velocity (see cs_boundary_ale_subtype_bits_t) |
[in] | impale | indicator for prescribed node displacement (0 or 1) |
The icodcl and rcodcl arrays are pre-initialized based on default and GUI-defined definitions, and may be modified here.
For a given variable field f, and a given face "face_id", these arrays may be used as follows:
For vector or tensor fields, these arrays are not interleaved, so for a given face "face_id" and field component "comp_id", access is as follows (where n_b_faces is domain->mesh->n_b_faces):
f->bc_coeffs->rcodcl1[n_b_faces*comp_id + face_id]
f->bc_coeffs->rcodcl2[n_b_faces*comp_id + face_id]
f->bc_coeffs->rcodcl3[n_b_faces*comp_id + face_id]
Only the icodcl code values from the first component are used in the case of vector or tensor fields, so the icodcl values can be defined as for a scalar.
void cs_user_boundary_conditions_setup | ( | cs_domain_t * | domain | ) |
Set boundary conditions to be applied.
This function is called just before cs_user_finalize_setup, and boundary conditions can be defined in either of those functions, depending on whichever is considered more readable or practical for a given use.
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_cathare_coupling | ( | void | ) |
Define couplings with SYRTHES code.
This is done by calling the cs_syr_coupling_define function for each coupling to add.
void cs_user_extra_operations | ( | cs_domain_t * | domain | ) |
This function is called at the end of each time step.
It has a very general purpose, although it is recommended to handle mainly postprocessing or data-extraction type operations.
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_extra_operations_finalize | ( | cs_domain_t * | domain | ) |
This function is called at the end of the calculation.
It has a very general purpose, although it is recommended to handle mainly postprocessing or data-extraction type operations.
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_extra_operations_initialize | ( | cs_domain_t * | domain | ) |
Initialize variables.
This function is called at beginning of the computation (restart or not) before the time step loop.
This is intended to initialize or modify (when restarted) variable and time step values.
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_finalize_setup | ( | cs_domain_t * | domain | ) |
Define or modify output user parameters. For CDO schemes, specify the elements such as properties, advection fields, user-defined equations and modules which have been previously added.
Define or modify output user parameters. For CDO schemes, specify the elements such as properties, advection fields, user-defined equations and modules which have been previously added.
For CDO schemes, this function concludes the setup of properties, equations, source terms...
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_fsi_structure_define | ( | int | is_restart, |
int | n_structs, | ||
int * | plot, | ||
cs_time_control_t * | plot_time_control, | ||
cs_real_t * | aexxst, | ||
cs_real_t * | bexxst, | ||
cs_real_t * | cfopre, | ||
cs_real_t | xstr0[][3], | ||
cs_real_t | vstr0[][3], | ||
cs_real_t | xstreq[][3] | ||
) |
Definition of internal mobile structures and corresponding initial conditions (initial displacement and velocity ).
[in] | is_restart | indicate if computation is restarted |
[in] | n_structs | number of mobile structures |
[in,out] | plot; | monitoring format mask 0: no plot 1: plot to text (.dat) format 2: plot to .csv format 3: plot to both formats |
[in,out] | plot_time_control | plot time output frequency control |
[in,out] | aexxst | coefficient for predicted displacement |
[in,out] | bexxst | coefficient for predicted displacement |
[in,out] | cfopre | coefficient for predicted force |
[in,out] | xstr0 | initial displacement per structure |
[in,out] | vstr0 | initial velocity per structure |
[in,out] | xstreq | displacement of initial mesh relative to structures position at equilibrium |
[in,out] | plot_time_control | time control associated to plotting |
void cs_user_fsi_structure_num | ( | cs_domain_t * | domain, |
int | structure_num[] | ||
) |
Define structure numbers for faces associated with internal or external (code_aster) structures.
Structure numbers associated to a given face have the following values:
[in,out] | domain | pointer to a cs_domain_t structure |
[in,out] | structure_num | structure id associated to each face |
void cs_user_fsi_structure_values | ( | int | n_structs, |
const cs_time_step_t * | ts, | ||
const cs_real_t | xstreq[][3], | ||
const cs_real_t | xstr[][3], | ||
const cs_real_t | vstr[][3], | ||
cs_real_t | xmstru[][3][3], | ||
cs_real_t | xcstru[][3][3], | ||
cs_real_t | xkstru[][3][3], | ||
cs_real_t | forstr[][3], | ||
cs_real_t | dtstr[] | ||
) |
Time-based settings for internal mobile structures.
[in] | n_structs | number of mobile structures |
[in] | ts | time step structure |
[in] | xstreq | displacement of initial mesh rel. to equilibrium |
[in] | xstr | structural displacement |
[in] | vstr | structural velocity |
[in,out] | xmstru | matrix of structural mass |
[in,out] | xcstru | matrix of structural friction |
[in,out] | xkstru | matrix of structural stiffness |
[in,out] | forstr | forces acting on structures (take forces) |
[in,out] | dtstr | structural time step |
Compute GUI-defined head losses for a given volume zone.
Head loss tensor coefficients for each cell are organized as follows: cku11, cku22, cku33, cku12, cku13, cku23.
[in] | zone | pointer to zone structure |
[in,out] | cku | head loss coefficients |
Compute GUI-defined head losses for a given volume zone.
Head loss tensor coefficients for each cell are organized as follows: ck11, ck22, ck33, ck12, ck13, ck23.
Coefficients are set to zero (then computed based on definitions provided through the GUI if this is the case) before calling this function, so setting values to zero is usually not necessary, unless we want to fully overwrite a GUI-based definition.
Diagonal coefficients must be positive; the calculation may diverge if this is not the case.
[in] | zone | pointer to zone structure |
[in,out] | cku | head loss coefficients |
void cs_user_hgn_thermo_relax_time | ( | const cs_mesh_t * | mesh, |
const cs_real_t * | alpha_eq, | ||
const cs_real_t * | y_eq, | ||
const cs_real_t * | z_eq, | ||
const cs_real_t * | ei, | ||
const cs_real_t * | v, | ||
cs_real_t * | relax_tau | ||
) |
Computation of the relaxation time-scale.
This function computes the value of the relaxation time-scale (for the return to equilibrium).
[in] | mesh | pointer to mesh |
[in] | alpha_eq | equilibrium volume fraction |
[in] | y_eq | equilibrium mass fraction |
[in] | z_eq | equilibrium energy fraction |
[in] | ei | specific internal energy |
[in] | v | specific volume |
[in] | relax_tau | relaxation time scale towards equilibrium |
void cs_user_initial_conditions | ( | cs_domain_t * | domain | ) |
This function is called at startup and allows overloading the GUI defined initialization functions.
This function is called before the beginning of the computation allowing an overload of the GUI defined initialization (called just after cs_gui_initial_conditions).
[in,out] | domain | pointer to a cs_domain_t structure |
This function is called at startup and allows overloading the GUI defined initialization functions.
This function is not yet called by code_saturne, use cs_user_initialization
for the time being This function is called before the beginning of the computation allowing an overload of the GUI defined initialization (called just after cs_gui_initial_conditions).
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_initialization | ( | cs_domain_t * | domain | ) |
This function is called one time step to initialize problem.
[in,out] | domain | pointer to a cs_domain_t structure |
This function is called one time step to initialize problem.
This function is called at beginning of the computation (restart or not) before the time step loop.
This is intended to initialize or modify (when restarted) variable and time step values.
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_internal_coupling | ( | void | ) |
Define internal coupling options.
Options are usually defined using cs_internal_coupling_add_entity.
void cs_user_internal_coupling_add_volumes | ( | cs_mesh_t * | mesh | ) |
Define volumes as internal coupling zones.
These zones will be separated from the rest of the domain using automatically defined thin walls.
[in,out] | mesh | pointer to a cs_mesh_t structure |
These zones will be separated from the rest of the domain using automatically defined thin walls.
[in,out] | mesh | pointer to a cs_mesh_t structure |
void cs_user_internal_coupling_from_disjoint_meshes | ( | cs_mesh_t * | mesh | ) |
Define volumesi from separated meshes as internal coupling zones.
These zones must be disjoint and the face selection criteria must be specified.
[in,out] | mesh | pointer to a cs_mesh_t structure |
Define volumesi from separated meshes as internal coupling zones.
These zones must be disjoint and the face selection criteria must be specified.
[in,out] | mesh | pointer to a cs_mesh_t structure |
void cs_user_join | ( | void | ) |
Define mesh joinings.
void cs_user_linear_solvers | ( | void | ) |
Define linear solver options.
This function is called at the setup stage, once user and most model-based fields are defined.
Available native iterative linear solvers include conjugate gradient, Jacobi, BiCGStab, BiCGStab2, and GMRES. For symmetric linear systems, an algebraic multigrid solver is available (and recommended).
External solvers may also be setup using this function, the cs_sles_t mechanism allowing such through user-define functions.
void cs_user_matrix_tuning | ( | void | ) |
Define sparse matrix tuning options.
void cs_user_mesh_bad_cells_tag | ( | cs_mesh_t * | mesh, |
cs_mesh_quantities_t * | mesh_quantities | ||
) |
Tag bad cells within the mesh based on user-defined geometric criteria.
[in,out] | mesh | pointer to a cs_mesh_t structure |
[in,out] | mesh_quantities | pointer to a cs_mesh_quantities_t structure |
void cs_user_mesh_boundary | ( | cs_mesh_t * | mesh | ) |
Insert boundaries into a mesh.
[in,out] | mesh | pointer to a cs_mesh_t structure |
void cs_user_mesh_cartesian_define | ( | void | ) |
Define a cartesian mesh.
void cs_user_mesh_input | ( | void | ) |
Define mesh files to read and optional associated transformations.
void cs_user_mesh_modify | ( | cs_mesh_t * | mesh | ) |
Modify geometry and mesh.
[in,out] | mesh | pointer to a cs_mesh_t structure |
void cs_user_mesh_modify_partial | ( | cs_mesh_t * | mesh, |
cs_mesh_quantities_t * | mesh_quantities | ||
) |
Apply partial modifications to the mesh after the preprocessing and initial postprocessing mesh building stage.
[in,out] | mesh | pointer to a cs_mesh_t structure |
[in,out] | mesh_quantities | pointer to a cs_mesh_quantities_t structure |
Apply partial modifications to the mesh after the preprocessing and initial postprocessing mesh building stage.
[in,out] | mesh | pointer to a cs_mesh_t structure |
[in,out] | mesh_quantities | pointer to a cs_mesh_quantities_t structure |
void cs_user_mesh_restart_mode | ( | void | ) |
Force preprocessing behavior in case of restart.
By default, in case of restart, if a "restart/mesh_input.csm" file is present, it will be read and proprocessing will be skipped.
This behavior may be changed in the GUI (in the "Mesh" section, unchecking "Use unmodified checkpoint mesh in case of restart"), or by calling cs_preprocessor_data_set_restart_mode in this function.
void cs_user_mesh_save | ( | cs_mesh_t * | mesh | ) |
Enable or disable mesh saving.
By default, mesh is saved when modified.
[in,out] | mesh | pointer to a cs_mesh_t structure |
void cs_user_mesh_smoothe | ( | cs_mesh_t * | mesh | ) |
Mesh smoothing.
[in,out] | mesh | pointer to a cs_mesh_t structure |
void cs_user_mesh_warping | ( | void | ) |
Set options for cutting of warped faces.
void cs_user_model | ( | void | ) |
Select physical model options, including user fields.
This function is called at the earliest stages of the data setup, so field ids are not available yet.
void cs_user_numbering | ( | void | ) |
Define advanced mesh numbering options.
void cs_user_parallel_io | ( | void | ) |
Define parallel IO settings.
void cs_user_paramedmem_define_couplings | ( | void | ) |
Define ParaMEDMEM coupling(s)
void cs_user_paramedmem_define_fields | ( | void | ) |
Define fields to couple with ParaMEDMEM.
void cs_user_paramedmem_define_meshes | ( | void | ) |
Define coupled meshes.
void cs_user_parameters | ( | cs_domain_t * | domain | ) |
Define or modify general numerical and physical user parameters.
At the calling point of this function, most model-related most variables and other fields have been defined, so specific settings related to those fields may be set here.
At this stage, the mesh is not built or read yet, so associated data such as field values are not accessible yet, though pending mesh operations and some fields may have been defined.
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_partition | ( | void | ) |
Define advanced partitioning options.
void cs_user_periodicity | ( | void | ) |
Define periodic faces.
void cs_user_physical_properties | ( | cs_domain_t * | domain | ) |
This function is called each time step to define physical properties.
[in,out] | domain | pointer to a cs_domain_t structure |
This function is called each time step to define physical properties.
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_physical_properties_h_to_t | ( | cs_domain_t * | domain, |
const cs_zone_t * | z, | ||
bool | z_local, | ||
const cs_real_t | h[], | ||
cs_real_t | t[] | ||
) |
User definition of enthalpy to temperature conversion.
This allows overwriting the solver defaults if necessary.
This function may be called on a per-zone basis, so as to allow different conversion relations in zones representing solids or different fluids.
[in,out] | domain | pointer to a cs_domain_t structure |
[in] | z | zone (volume or boundary) applying to current call |
[in] | z_local | if true, h and t arrays are defined in a compact (contiguous) manner for this zone only; if false, h and t are defined on the zone's parent location (usually all cells or boundary faces) |
[in] | h | enthalpy values |
[in,out] | t | temperature values |
void cs_user_physical_properties_t_to_h | ( | cs_domain_t * | domain, |
const cs_zone_t * | z, | ||
bool | z_local, | ||
const cs_real_t | t[], | ||
cs_real_t | h[] | ||
) |
User definition of temperature to enthalpy conversion.
This allows overwriting the solver defaults if necessary.
This function may be called on a per-zone basis, so as to allow different conversion relations in zones representing solids or different fluids.
[in,out] | domain | pointer to a cs_domain_t structure |
[in] | z | zone (volume or boundary) applying to current call |
[in] | z_local | if true, h and t arrays are defined in a compact (contiguous) manner for this zone only; if false, h and t are defined on the zone's parent location (usually all cells or boundary faces) |
[in] | h | temperature values |
[in,out] | t | enthalpy values |
void cs_user_physical_properties_td_pressure | ( | cs_real_t * | td_p | ) |
User function to define a custom law for the thermodynamic pressure.
Allows to define a custom law for the constant uniform thermodynamic pressure (whenn cs_velocity_pressure_model_t::idilat = 3 or cs_fluid_properties_t::ipthrm = 1).
The density is then updated (in cs_compute_thermo_pressure_density.c) as:
.
[in,out] | td_p | Updated value of the thermodynamic pressure |
void cs_user_physical_properties_turb_viscosity | ( | cs_domain_t * | domain | ) |
User modification of the turbulence viscosity.
[in,out] | domain | pointer to a cs_domain_t structure |
Turbulent viscosity (kg/(m s)) can be modified. You can access the field by its name.
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_porosity | ( | cs_domain_t * | domain | ) |
Compute the porosity (volume factor when the porosity model is activated. (cs_glob_porous_model > 0).
This function is called at the begin of the simulation only.
[in,out] | domain | pointer to a cs_domain_t structure |
Compute the porosity (volume factor when the porosity model is activated. (cs_glob_porous_model > 0).
This function is called at the begin of the simulation only.
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_postprocess_activate | ( | int | nt_max_abs, |
int | nt_cur_abs, | ||
double | t_cur_abs | ||
) |
Override default frequency or calculation end based output.
This allows fine-grained control of activation or deactivation,
[in] | nt_max_abs | maximum time step number |
[in] | nt_cur_abs | current time step number |
[in] | t_cur_abs | absolute time at the current time step |
void cs_user_postprocess_meshes | ( | void | ) |
Define post-processing meshes.
The main post-processing meshes may be configured, and additional post-processing meshes may be defined as a subset of the main mesh's cells or faces (both interior and boundary).
void cs_user_postprocess_probes | ( | void | ) |
Define monitoring probes and profiles.
Profiles are defined as sets of probes.
void cs_user_postprocess_values | ( | const char * | mesh_name, |
int | mesh_id, | ||
int | cat_id, | ||
cs_probe_set_t * | probes, | ||
cs_lnum_t | n_cells, | ||
cs_lnum_t | n_i_faces, | ||
cs_lnum_t | n_b_faces, | ||
cs_lnum_t | n_vertices, | ||
const cs_lnum_t | cell_list[], | ||
const cs_lnum_t | i_face_list[], | ||
const cs_lnum_t | b_face_list[], | ||
const cs_lnum_t | vertex_list[], | ||
const cs_time_step_t * | ts | ||
) |
User function for output of values on a post-processing mesh.
[in] | mesh_name | name of the output mesh for the current call |
[in] | mesh_id | id of the output mesh for the current call |
[in] | cat_id | category id of the output mesh for the current call |
[in] | probes | pointer to associated probe set structure if the mesh is a probe set, null otherwise |
[in] | n_cells | local number of cells of post_mesh |
[in] | n_i_faces | local number of interior faces of post_mesh |
[in] | n_b_faces | local number of boundary faces of post_mesh |
[in] | n_vertices | local number of vertices faces of post_mesh |
[in] | cell_list | list of cells (0 to n-1) of post-processing mesh |
[in] | i_face_list | list of interior faces (0 to n-1) of post-processing mesh |
[in] | b_face_list | list of boundary faces (0 to n-1) of post-processing mesh |
[in] | vertex_list | list of vertices (0 to n-1) of post-processing mesh |
[in] | ts | time step status structure, or nullptr |
void cs_user_postprocess_writers | ( | void | ) |
Define post-processing writers.
The default output format and frequency may be configured, and additional post-processing writers allowing outputs in different formats or with different format options and output frequency than the main writer may be defined.
void cs_user_rad_transfer_absorption | ( | const int | bc_type[], |
cs_real_t | ck[] | ||
) |
Absorption coefficient for radiative module.
It is necessary to define the value of the fluid's absorption coefficient Ck.
This value is defined automatically for specific physical models, such as gas and coal combustion, so this function is not used by these models.
For a transparent medium, the coefficient should be set to 0.
In the case of the P-1 model, we check that the optical length is at least of the order of 1.
[in] | bc_type | boundary face types |
[out] | ck | medium's absorption coefficient (zero if transparent) |
void cs_user_rad_transfer_net_flux | ( | const int | bc_type[], |
const cs_real_t | twall[], | ||
const cs_real_t | qincid[], | ||
const cs_real_t | xlam[], | ||
const cs_real_t | epa[], | ||
const cs_real_t | eps[], | ||
const cs_real_t | ck[], | ||
cs_real_t | net_flux[] | ||
) |
Compute the net radiation flux.
The density of net radiation flux must be calculated consistently with the boundary conditions of the intensity. The density of net flux is the balance between the radiative emiting part of a boundary face (and not the reflecting one) and the radiative absorbing part.
[in] | bc_type | boundary face types |
[in] | twall | inside current wall temperature (K) |
[in] | qincid | radiative incident flux (W/m2) |
[in] | xlam | conductivity (W/m/K) |
[in] | epa | thickness (m) |
[in] | eps | emissivity (>0) |
[in] | ck | absorption coefficient |
[out] | net_flux | net flux (W/m2) |
void cs_user_radiative_transfer_bcs | ( | cs_domain_t * | domain, |
const int | bc_type[], | ||
int | isothp[], | ||
cs_real_t * | tmin, | ||
cs_real_t * | tmax, | ||
cs_real_t * | tx, | ||
const cs_real_t | dt[], | ||
const cs_real_t | thwall[], | ||
const cs_real_t | qincid[], | ||
cs_real_t | hfcnvp[], | ||
cs_real_t | flcnvp[], | ||
cs_real_t | xlamp[], | ||
cs_real_t | epap[], | ||
cs_real_t | epsp[], | ||
cs_real_t | textp[] | ||
) |
User definition of radiative transfer boundary conditions.
See Examples of data settings for radiative transfers for examples.
For each boundary face face_id, a specific output (logging and postprocessing) class id may be assigned. This allows realizing balance sheets by treating them separately for each zone. By default, the output class id is set to the general (input) zone id associated to a face.
To access output class ids (both for reading and modifying), use the cs_boundary_zone_face_class_id function. The zone id values are arbitrarily chosen by the user, but must be positive integers; very high numbers may also lead to higher memory consumption.
The following face characteristics must be set:
Depending on the value of isothp, other values may also need to be set:
[in,out] | domain | pointer to a cs_domain_t structure |
[in] | bc_type | boundary face types |
[in] | isothp | boundary face type for radiative transfer |
[out] | tmin | min allowed value of the wall temperature |
[out] | tmax | max allowed value of the wall temperature |
[in] | tx | relaxation coefficient (0 < tx < 1) |
[in] | dt | time step (per cell) |
[in] | thwall | inside current wall temperature (K) |
[in] | qincid | radiative incident flux (W/m2) |
[in] | hfcnvp | convective exchange coefficient (W/m2/K) |
[in] | flcnvp | convective flux (W/m2) |
[out] | xlamp | conductivity (W/m/K) |
[out] | epap | thickness (m) |
[out] | epsp | emissivity (>0) |
[out] | textp | outside temperature (K) |
void cs_user_radiative_transfer_parameters | ( | void | ) |
User function for input of radiative transfer module options.
void cs_user_saturne_coupling | ( | void | ) |
Define couplings with other instances of code_saturne.
This is done by calling the cs_sat_coupling_define function for each coupling to add.
void cs_user_scaling_elec | ( | const cs_mesh_t * | mesh, |
const cs_mesh_quantities_t * | mesh_quantities, | ||
cs_real_t * | dt | ||
) |
Define scaling parameter for electric model.
Define scaling parameter for electric model.
[in] | mesh | pointer to a cs_mesh_t structure |
[in,out] | mesh_quantities | pointer to a cs_mesh_quantities_t structure |
[in] | dt | pointer to a cs_real_t |
These options allow defining the time step synchronization policy, as well as a time step multiplier.
void cs_user_solver | ( | const cs_mesh_t * | mesh, |
const cs_mesh_quantities_t * | mesh_quantities | ||
) |
Main call to user solver.
[in] | mesh | pointer to a cs_mesh_t structure |
[in,out] | mesh_quantities | pointer to a cs_mesh_quantities_t structure |
int cs_user_solver_set | ( | void | ) |
Set user solver.
void cs_user_source_terms | ( | cs_domain_t * | domain, |
int | f_id, | ||
cs_real_t * | st_exp, | ||
cs_real_t * | st_imp | ||
) |
Additional user-defined source terms for variable equations (momentum, scalars, turbulence...).
[in,out] | domain | pointer to a cs_domain_t structure |
[in] | f_id | field id of the variable |
[out] | st_exp | explicit source term |
[out] | st_imp | implicit part of the source term |
This function is called at each time step, for each relevant field. It is therefore necessary to test the value of the field id or name to separate the treatments of the different variables.
The additional source term is decomposed into an explicit part (st_exp) and an implicit part (st_imp) that must be provided here. The resulting equation solved by the code for a scalar f is:
Note that st_exp and st_imp are defined after the Finite Volume integration over the cells, so they include the "volume" term. More precisely:
The st_exp and st_imp arrays are already initialized to 0 (or a value defined through the GUI or defined by a model) before entering the function. It is generally not useful to reset them here.
For stability reasons, code_saturne will not add -st_imp directly to the diagonal of the matrix, but Max(-st_imp,0). This way, the st_imp term is treated implicitely only if it strengthens the diagonal of the matrix. However, when using the second-order in time scheme, this limitation cannot be done anymore and -st_imp is added directly. The user should therefore check for the negativity of st_imp.
When using the second-order in time scheme, one should supply:
If the variable is a temperature, the resulting equation solved is:
rho*Cp*volume*dT/dt + .... = st_imp*T + st_exp
Note that st_exp and st_imp are defined after the Finite Volume integration over the cells, so they include the "volume" term. More precisely:
In case of a complex, non-linear source term, say F(f), for variable f, the easiest method is to implement the source term explicitly.
df/dt = .... + F(f(n)) where f(n) is the value of f at time tn, the beginning of the time step.
This yields: st_exp = volume*F(f(n)) st_imp = 0
However, if the source term is potentially steep, this fully explicit method will probably generate instabilities. It is therefore wiser to partially implicit the term by writing:
df/dt = .... + dF/df*f(n+1) - dF/df*f(n) + F(f(n))
This yields: st_exp = volume*( F(f(n)) - dF/df*f(n) ) st_imp = volume*dF/df
[in,out] | domain | pointer to a cs_domain_t structure |
[in] | f_id | field id of the variable |
[out] | st_exp | explicit source term |
[out] | st_imp | implicit part of the source term |
void cs_user_syrthes_coupling | ( | void | ) |
Define couplings with SYRTHES code.
This is done by calling the cs_syr_coupling_define function for each coupling to add.
void cs_user_syrthes_coupling_volume_h | ( | int | coupling_id, |
const char * | syrthes_name, | ||
cs_lnum_t | n_elts, | ||
const cs_lnum_t | elt_ids[], | ||
cs_real_t | h_vol[] | ||
) |
Compute a volume exchange coefficient for SYRTHES couplings.
[in] | coupling_id | Syrthes coupling id |
[in] | syrthes_name | name of associated Syrthes instance |
[in] | n_elts | number of associated cells |
[in] | elt_ids | associated cell ids |
[out] | h_vol | associated exchange coefficient (size: n_elts) |
void cs_user_time_moments | ( | void | ) |
Define time moments.
This function is called at the setup stage, once user and most model-based fields are defined, and before fine control of field output options is defined.
void cs_user_time_table | ( | void | ) |
Define time tables using C API. This function is called at the begin of the simulation only.
[in,out] | domain | pointer to a cs_domain_t structure |
void cs_user_turbomachinery | ( | void | ) |
Define rotor/stator model.
void cs_user_turbomachinery_rotor | ( | void | ) |
Define rotor axes, associated cells, and rotor/stator faces.
void cs_user_turbomachinery_set_rotation_velocity | ( | void | ) |
Define rotation velocity of rotor.
void cs_user_wall_condensation | ( | int | iappel | ) |
Source terms associated at the boundary faces and the neighboring cells with surface condensation.
This function fills the condensation source terms for each variable at the cell center associated to the boundary faces identifed in the mesh. The fluid exchange coefficient is computed with a empirical law to be imposed at the boundary face where the condensation phenomenon occurs.
This user function is called which allows the setting of the condensation source term.
This function fills the condensation source term array gamma_cond adding to the following equations:
discretized as below:
is the value of
associated to the injected condensation rate.
With 2 options are available:
The three stages in the code where this User subroutine is called (with
)
[in] | iappel | indicates which at which stage the routine is |
void cs_user_zones | ( | void | ) |
Define volume and surface zones.
See Element selection criteria for details on selection criteria.
void csinit | ( | const int * | irgpar, |
const int * | nrgpar | ||
) |