#include "cs_base.h"
#include "cs_halo.h"
#include "cs_internal_coupling.h"
#include "cs_mesh.h"
#include "cs_mesh_quantities.h"
Go to the source code of this file.
Enumerations | |
enum | cs_gradient_type_t { CS_GRADIENT_GREEN_ITER , CS_GRADIENT_LSQ , CS_GRADIENT_GREEN_LSQ , CS_GRADIENT_GREEN_VTX , CS_GRADIENT_GREEN_R } |
enum | cs_gradient_limit_t { CS_GRADIENT_LIMIT_NONE = -1 , CS_GRADIENT_LIMIT_CELL = 0 , CS_GRADIENT_LIMIT_FACE = 1 } |
Functions | |
void | cs_gradient_initialize (void) |
Initialize gradient computation API. | |
void | cs_gradient_finalize (void) |
Finalize gradient computation API. | |
void | cs_gradient_free_quantities (void) |
Free saved gradient quantities. | |
void | cs_gradient_scalar (const char *var_name, cs_gradient_type_t gradient_type, cs_halo_type_t halo_type, int inc, int n_r_sweeps, int hyd_p_flag, int w_stride, int verbosity, cs_gradient_limit_t clip_mode, double epsilon, double clip_coeff, cs_real_3_t f_ext[], const cs_field_bc_coeffs_t *bc_coeffs, cs_real_t var[restrict], cs_real_t *restrict c_weight, const cs_internal_coupling_t *cpl, cs_real_t grad[restrict][3]) |
Compute cell gradient of scalar field or component of vector or tensor field. | |
void | cs_gradient_vector (const char *var_name, cs_gradient_type_t gradient_type, cs_halo_type_t halo_type, int inc, int n_r_sweeps, int verbosity, cs_gradient_limit_t clip_mode, double epsilon, double clip_coeff, const cs_field_bc_coeffs_t *bc_coeffs_v, cs_real_t var[restrict][3], cs_real_t *restrict c_weight, const cs_internal_coupling_t *cpl, cs_real_t gradv[restrict][3][3]) |
Compute cell gradient of vector field. | |
void | cs_gradient_tensor (const char *var_name, cs_gradient_type_t gradient_type, cs_halo_type_t halo_type, int inc, int n_r_sweeps, int verbosity, cs_gradient_limit_t clip_mode, double epsilon, double clip_coeff, const cs_field_bc_coeffs_t *bc_coeffs_ts, cs_real_6_t *restrict var, cs_real_63_t *restrict grad) |
Compute cell gradient of tensor. | |
void | cs_gradient_scalar_synced_input (const char *var_name, cs_gradient_type_t gradient_type, cs_halo_type_t halo_type, int inc, int n_r_sweeps, int hyd_p_flag, int w_stride, int verbosity, cs_gradient_limit_t clip_mode, double epsilon, double clip_coeff, cs_real_t f_ext[][3], const cs_field_bc_coeffs_t *bc_coeffs, const cs_real_t var[restrict], const cs_real_t c_weight[restrict], const cs_internal_coupling_t *cpl, cs_real_t grad[restrict][3]) |
Compute cell gradient of scalar field or component of vector or tensor field. | |
void | cs_gradient_vector_synced_input (const char *var_name, cs_gradient_type_t gradient_type, cs_halo_type_t halo_type, int inc, int n_r_sweeps, int verbosity, cs_gradient_limit_t clip_mode, double epsilon, double clip_coeff, const cs_field_bc_coeffs_t *bc_coeffs_v, const cs_real_t var[restrict][3], const cs_real_t c_weight[restrict], const cs_internal_coupling_t *cpl, cs_real_t grad[restrict][3][3]) |
Compute cell gradient of vector field. | |
void | cs_gradient_tensor_synced_input (const char *var_name, cs_gradient_type_t gradient_type, cs_halo_type_t halo_type, int inc, int n_r_sweeps, int verbosity, cs_gradient_limit_t clip_mode, double epsilon, double clip_coeff, const cs_field_bc_coeffs_t *bc_coeffs_ts, const cs_real_t var[restrict][6], cs_real_63_t *restrict grad) |
Compute cell gradient of tensor. | |
void | cs_gradient_scalar_cell (const cs_mesh_t *m, const cs_mesh_quantities_t *fvq, cs_lnum_t c_id, cs_halo_type_t halo_type, const cs_field_bc_coeffs_t *bc_coeffs, const cs_real_t var[], const cs_real_t c_weight[], cs_real_t grad[3]) |
Compute the gradient of a scalar field at a given cell using least-squares reconstruction. | |
void | cs_gradient_vector_cell (const cs_mesh_t *m, const cs_mesh_quantities_t *fvq, cs_lnum_t c_id, cs_halo_type_t halo_type, const cs_field_bc_coeffs_t *bc_coeffs_v, const cs_real_t var[restrict][3], const cs_real_t c_weight[], cs_real_t grad[3][3]) |
Compute the gradient of a vector field at a given cell using least-squares reconstruction. | |
void | cs_gradient_tensor_cell (const cs_mesh_t *m, const cs_mesh_quantities_t *fvq, cs_lnum_t c_id, cs_halo_type_t halo_type, const cs_field_bc_coeffs_t *bc_coeffs_ts, const cs_real_t var[restrict][6], const cs_real_t c_weight[], cs_real_t grad[6][3]) |
Compute the gradient of a tensor field at a given cell using least-squares reconstruction. | |
void | cs_gradient_type_by_imrgra (int imrgra, cs_gradient_type_t *gradient_type, cs_halo_type_t *halo_type) |
void | cs_gradient_porosity_balance (int inc) |
compute the steady balance due to porous modelling for the pressure gradient. |
Variables | |
const char * | cs_gradient_type_name [] |
enum cs_gradient_limit_t |
enum cs_gradient_type_t |
void cs_gradient_finalize | ( | void | ) |
Finalize gradient computation API.
void cs_gradient_free_quantities | ( | void | ) |
Free saved gradient quantities.
This is required when the mesh changes, so that the on-demand computation will be updated.
void cs_gradient_initialize | ( | void | ) |
Initialize gradient computation API.
void cs_gradient_porosity_balance | ( | int | inc | ) |
compute the steady balance due to porous modelling for the pressure gradient.
[in] | inc | if 0, solve on increment; 1 otherwise |
void cs_gradient_scalar | ( | const char * | var_name, |
cs_gradient_type_t | gradient_type, | ||
cs_halo_type_t | halo_type, | ||
int | inc, | ||
int | n_r_sweeps, | ||
int | hyd_p_flag, | ||
int | w_stride, | ||
int | verbosity, | ||
cs_gradient_limit_t | clip_mode, | ||
double | epsilon, | ||
double | clip_coeff, | ||
cs_real_3_t | f_ext[], | ||
const cs_field_bc_coeffs_t * | bc_coeffs, | ||
cs_real_t | var[restrict], | ||
cs_real_t *restrict | c_weight, | ||
const cs_internal_coupling_t * | cpl, | ||
cs_real_t | grad[restrict][3] ) |
Compute cell gradient of scalar field or component of vector or tensor field.
[in] | var_name | variable name |
[in] | gradient_type | gradient type |
[in] | halo_type | halo type |
[in] | inc | if 0, solve on increment; 1 otherwise |
[in] | n_r_sweeps | if > 1, number of reconstruction sweeps (only used by CS_GRADIENT_GREEN_ITER) |
[in] | hyd_p_flag | flag for hydrostatic pressure |
[in] | w_stride | stride for weighting coefficient |
[in] | verbosity | verbosity level |
[in] | clip_mode | clipping mode |
[in] | epsilon | precision for iterative gradient calculation |
[in] | clip_coeff | clipping coefficient |
[in] | f_ext | exterior force generating the hydrostatic pressure |
[in] | bc_coeffs | boundary condition structure |
[in,out] | var | gradient's base variable |
[in,out] | c_weight | cell variable weight, or nullptr |
[in] | cpl | associated internal coupling, or nullptr |
[out] | grad | gradient |
[in] | var_name | variable name |
[in] | gradient_type | gradient type |
[in] | halo_type | halo type |
[in] | inc | if 0, solve on increment; 1 otherwise |
[in] | n_r_sweeps | if > 1, number of reconstruction sweeps (only used by CS_GRADIENT_GREEN_ITER) |
[in] | hyd_p_flag | flag for hydrostatic pressure |
[in] | w_stride | stride for weighting coefficient |
[in] | verbosity | verbosity level |
[in] | clip_mode | clipping mode |
[in] | epsilon | precision for iterative gradient calculation |
[in] | clip_coeff | clipping coefficient |
[in] | f_ext | exterior force generating the hydrostatic pressure |
[in] | bc_coeffs | boundary condition structure |
[in,out] | var | gradient's base variable |
[in,out] | c_weight | cell variable weight, or NULL |
[in] | cpl | associated internal coupling, or NULL |
[out] | grad | gradient |
void cs_gradient_scalar_cell | ( | const cs_mesh_t * | m, |
const cs_mesh_quantities_t * | fvq, | ||
cs_lnum_t | c_id, | ||
cs_halo_type_t | halo_type, | ||
const cs_field_bc_coeffs_t * | bc_coeffs, | ||
const cs_real_t | var[], | ||
const cs_real_t | c_weight[], | ||
cs_real_t | grad[3] ) |
Compute the gradient of a scalar field at a given cell using least-squares reconstruction.
This assumes ghost cell values which might be used are already synchronized.
When boundary conditions are provided, both the bc_coeff_a and bc_coeff_b arrays must be given. If boundary values are known, bc_coeff_a can point to the boundary values array, and bc_coeff_b set to nullptr. If bc_coeff_a is nullptr, bc_coeff_b is ignored.
[in] | m | pointer to associated mesh structure |
[in] | fvq | pointer to associated finite volume quantities |
[in] | c_id | cell id |
[in] | halo_type | halo type |
[in] | bc_coeffs | boundary condition structure |
[in] | var | gradient's base variable |
[in] | c_weight | cell variable weight, or nullptr |
[out] | grad | gradient |
This assumes ghost cell values which might be used are already synchronized.
When boundary conditions are provided, both the bc_coeff_a and bc_coeff_b arrays must be given. If boundary values are known, bc_coeff_a can point to the boundary values array, and bc_coeff_b set to NULL. If bc_coeff_a is nullptr, bc_coeff_b is ignored.
[in] | m | pointer to associated mesh structure |
[in] | fvq | pointer to associated finite volume quantities |
[in] | c_id | cell id |
[in] | halo_type | halo type |
[in] | bc_coeffs | boundary condition structure, or NULL |
[in] | var | gradient's base variable |
[in] | c_weight | cell variable weight, or NULL |
[out] | grad | gradient |
void cs_gradient_scalar_synced_input | ( | const char * | var_name, |
cs_gradient_type_t | gradient_type, | ||
cs_halo_type_t | halo_type, | ||
int | inc, | ||
int | n_r_sweeps, | ||
int | hyd_p_flag, | ||
int | w_stride, | ||
int | verbosity, | ||
cs_gradient_limit_t | clip_mode, | ||
double | epsilon, | ||
double | clip_coeff, | ||
cs_real_t | f_ext[][3], | ||
const cs_field_bc_coeffs_t * | bc_coeffs, | ||
const cs_real_t | var[restrict], | ||
const cs_real_t | c_weight[restrict], | ||
const cs_internal_coupling_t * | cpl, | ||
cs_real_t | grad[restrict][3] ) |
Compute cell gradient of scalar field or component of vector or tensor field.
This variant of the cs_gradient_scalar function assumes ghost cell values for input arrays (var and optionally c_weight) have already been synchronized.
[in] | var_name | variable name |
[in] | gradient_type | gradient type |
[in] | halo_type | halo type |
[in] | inc | if 0, solve on increment; 1 otherwise |
[in] | n_r_sweeps | if > 1, number of reconstruction sweeps (only used by CS_GRADIENT_GREEN_ITER) |
[in] | hyd_p_flag | flag for hydrostatic pressure |
[in] | w_stride | stride for weighting coefficient |
[in] | verbosity | verbosity level |
[in] | clip_mode | clipping mode |
[in] | epsilon | precision for iterative gradient calculation |
[in] | clip_coeff | clipping coefficient |
[in] | f_ext | exterior force generating the hydrostatic pressure |
[in] | bc_coeffs | boundary condition structure |
[in] | var | gradient's base variable |
[in] | c_weight | cell variable weight, or nullptr |
[in] | cpl | associated internal coupling, or nullptr |
[out] | grad | gradient |
This variant of the cs_gradient_scalar function assumes ghost cell values for input arrays (var and optionally c_weight) have already been synchronized.
[in] | var_name | variable name |
[in] | gradient_type | gradient type |
[in] | halo_type | halo type |
[in] | inc | if 0, solve on increment; 1 otherwise |
[in] | n_r_sweeps | if > 1, number of reconstruction sweeps (only used by CS_GRADIENT_GREEN_ITER) |
[in] | hyd_p_flag | flag for hydrostatic pressure |
[in] | w_stride | stride for weighting coefficient |
[in] | verbosity | verbosity level |
[in] | clip_mode | clipping mode |
[in] | epsilon | precision for iterative gradient calculation |
[in] | clip_coeff | clipping coefficient |
[in] | f_ext | exterior force generating the hydrostatic pressure |
[in] | bc_coeffs | boundary condition structure |
[in] | var | gradient's base variable |
[in] | c_weight | cell variable weight, or NULL |
[in] | cpl | associated internal coupling, or NULL |
[out] | grad | gradient |
void cs_gradient_tensor | ( | const char * | var_name, |
cs_gradient_type_t | gradient_type, | ||
cs_halo_type_t | halo_type, | ||
int | inc, | ||
int | n_r_sweeps, | ||
int | verbosity, | ||
cs_gradient_limit_t | clip_mode, | ||
double | epsilon, | ||
double | clip_coeff, | ||
const cs_field_bc_coeffs_t * | bc_coeffs_ts, | ||
cs_real_6_t *restrict | var, | ||
cs_real_63_t *restrict | grad ) |
Compute cell gradient of tensor.
[in] | var_name | variable name |
[in] | gradient_type | gradient type |
[in] | halo_type | halo type |
[in] | inc | if 0, solve on increment; 1 otherwise |
[in] | n_r_sweeps | if > 1, number of reconstruction sweeps (only used by CS_GRADIENT_GREEN_ITER) |
[in] | verbosity | verbosity level |
[in] | clip_mode | clipping mode |
[in] | epsilon | precision for iterative gradient calculation |
[in] | clip_coeff | clipping coefficient |
[in] | bc_coeffs_ts | boundary condition structure |
[in,out] | var | gradient's base variable |
[out] | grad | gradient ( ![]() |
void cs_gradient_tensor_cell | ( | const cs_mesh_t * | m, |
const cs_mesh_quantities_t * | fvq, | ||
cs_lnum_t | c_id, | ||
cs_halo_type_t | halo_type, | ||
const cs_field_bc_coeffs_t * | bc_coeffs_ts, | ||
const cs_real_t | var[restrict][6], | ||
const cs_real_t | c_weight[], | ||
cs_real_t | grad[6][3] ) |
Compute the gradient of a tensor field at a given cell using least-squares reconstruction.
This assumes ghost cell values which might be used are already synchronized.
When boundary conditions are provided, both the bc_coeff_a and bc_coeff_b arrays must be given. If boundary values are known, bc_coeff_a can point to the boundary values array, and bc_coeff_b set to nullptr. If bc_coeff_a is nullptr, bc_coeff_b is ignored.
[in] | m | pointer to associated mesh structure |
[in] | fvq | pointer to associated finite volume quantities |
[in] | c_id | cell id |
[in] | halo_type | halo type |
[in] | bc_coeffs_ts | boundary condition structure |
[in] | var | gradient's base variable |
[in] | c_weight | cell variable weight, or nullptr |
[out] | grad | gradient |
This assumes ghost cell values which might be used are already synchronized.
When boundary conditions are provided, both the bc_coeff_a and bc_coeff_b arrays must be given. If boundary values are known, bc_coeff_a can point to the boundary values array, and bc_coeff_b set to NULL. If bc_coeff_a is nullptr, bc_coeff_b is ignored.
[in] | m | pointer to associated mesh structure |
[in] | fvq | pointer to associated finite volume quantities |
[in] | c_id | cell id |
[in] | halo_type | halo type |
[in] | bc_coeffs_ts | boundary condition structure, or NULL |
[in] | var | gradient's base variable |
[in] | c_weight | cell variable weight, or NULL |
[out] | grad | gradient |
void cs_gradient_tensor_synced_input | ( | const char * | var_name, |
cs_gradient_type_t | gradient_type, | ||
cs_halo_type_t | halo_type, | ||
int | inc, | ||
int | n_r_sweeps, | ||
int | verbosity, | ||
cs_gradient_limit_t | clip_mode, | ||
double | epsilon, | ||
double | clip_coeff, | ||
const cs_field_bc_coeffs_t * | bc_coeffs_ts, | ||
const cs_real_t | var[restrict][6], | ||
cs_real_63_t *restrict | grad ) |
Compute cell gradient of tensor.
This variant of the cs_gradient_tensor function assumes ghost cell values for input arrays (var and optionally c_weight) have already been synchronized.
[in] | var_name | variable name |
[in] | gradient_type | gradient type |
[in] | halo_type | halo type |
[in] | inc | if 0, solve on increment; 1 otherwise |
[in] | n_r_sweeps | if > 1, number of reconstruction sweeps (only used by CS_GRADIENT_GREEN_ITER) |
[in] | verbosity | verbosity level |
[in] | clip_mode | clipping mode |
[in] | epsilon | precision for iterative gradient calculation |
[in] | clip_coeff | clipping coefficient |
[in] | bc_coeffs_ts | boundary condition structure |
[in,out] | var | gradient's base variable |
[out] | grad | gradient ( ![]() |
void cs_gradient_type_by_imrgra | ( | int | imrgra, |
cs_gradient_type_t * | gradient_type, | ||
cs_halo_type_t * | halo_type ) |
void cs_gradient_vector | ( | const char * | var_name, |
cs_gradient_type_t | gradient_type, | ||
cs_halo_type_t | halo_type, | ||
int | inc, | ||
int | n_r_sweeps, | ||
int | verbosity, | ||
cs_gradient_limit_t | clip_mode, | ||
double | epsilon, | ||
double | clip_coeff, | ||
const cs_field_bc_coeffs_t * | bc_coeffs_v, | ||
cs_real_t | var[restrict][3], | ||
cs_real_t *restrict | c_weight, | ||
const cs_internal_coupling_t * | cpl, | ||
cs_real_t | gradv[restrict][3][3] ) |
Compute cell gradient of vector field.
[in] | var_name | variable name |
[in] | gradient_type | gradient type |
[in] | halo_type | halo type |
[in] | inc | if 0, solve on increment; 1 otherwise |
[in] | n_r_sweeps | if > 1, number of reconstruction sweeps (only used by CS_GRADIENT_GREEN_ITER) |
[in] | verbosity | verbosity level |
[in] | clip_mode | clipping mode |
[in] | epsilon | precision for iterative gradient calculation |
[in] | clip_coeff | clipping coefficient |
[in] | bc_coeffs_v | boundary condition structure |
[in,out] | var | gradient's base variable |
[in,out] | c_weight | cell variable weight, or nullptr |
[in] | cpl | associated internal coupling, or nullptr |
[out] | gradv | gradient ( ![]() |
[in] | var_name | variable name |
[in] | gradient_type | gradient type |
[in] | halo_type | halo type |
[in] | inc | if 0, solve on increment; 1 otherwise |
[in] | n_r_sweeps | if > 1, number of reconstruction sweeps (only used by CS_GRADIENT_GREEN_ITER) |
[in] | verbosity | verbosity level |
[in] | clip_mode | clipping mode |
[in] | epsilon | precision for iterative gradient calculation |
[in] | clip_coeff | clipping coefficient |
[in] | bc_coeffs_v | boundary condition structure |
[in,out] | var | gradient's base variable |
[in,out] | c_weight | cell variable weight, or NULL |
[in] | cpl | associated internal coupling, or NULL |
[out] | gradv | gradient ( ![]() |
void cs_gradient_vector_cell | ( | const cs_mesh_t * | m, |
const cs_mesh_quantities_t * | fvq, | ||
cs_lnum_t | c_id, | ||
cs_halo_type_t | halo_type, | ||
const cs_field_bc_coeffs_t * | bc_coeffs, | ||
const cs_real_t | var[restrict][3], | ||
const cs_real_t | c_weight[], | ||
cs_real_t | grad[3][3] ) |
Compute the gradient of a vector field at a given cell using least-squares reconstruction.
This assumes ghost cell values which might be used are already synchronized.
When boundary conditions are provided, both the bc_coeff_a and bc_coeff_b arrays must be given. If boundary values are known, bc_coeff_a can point to the boundary values array, and bc_coeff_b set to nullptr. If bc_coeff_a is nullptr, bc_coeff_b is ignored.
[in] | m | pointer to associated mesh structure |
[in] | fvq | pointer to associated finite volume quantities |
[in] | c_id | cell id |
[in] | halo_type | halo type |
[in] | bc_coeffs | boundary condition structure |
[in] | var | gradient's base variable |
[in] | c_weight | cell variable weight, or nullptr |
[out] | grad | gradient |
This assumes ghost cell values which might be used are already synchronized.
When boundary conditions are provided, both the bc_coeff_a and bc_coeff_b arrays must be given. If boundary values are known, bc_coeff_a can point to the boundary values array, and bc_coeff_b set to NULL. If bc_coeff_a is nullptr, bc_coeff_b is ignored.
[in] | m | pointer to associated mesh structure |
[in] | fvq | pointer to associated finite volume quantities |
[in] | c_id | cell id |
[in] | halo_type | halo type |
[in] | bc_coeffs | boundary condition structure, or NULL |
[in] | var | gradient's base variable |
[in] | c_weight | cell variable weight, or NULL |
[out] | grad | gradient |
void cs_gradient_vector_synced_input | ( | const char * | var_name, |
cs_gradient_type_t | gradient_type, | ||
cs_halo_type_t | halo_type, | ||
int | inc, | ||
int | n_r_sweeps, | ||
int | verbosity, | ||
cs_gradient_limit_t | clip_mode, | ||
double | epsilon, | ||
double | clip_coeff, | ||
const cs_field_bc_coeffs_t * | bc_coeffs_v, | ||
const cs_real_t | var[restrict][3], | ||
const cs_real_t | c_weight[restrict], | ||
const cs_internal_coupling_t * | cpl, | ||
cs_real_t | grad[restrict][3][3] ) |
Compute cell gradient of vector field.
This variant of the cs_gradient_vector function assumes ghost cell values for input arrays (var and optionally c_weight) have already been synchronized.
[in] | var_name | variable name |
[in] | gradient_type | gradient type |
[in] | halo_type | halo type |
[in] | inc | if 0, solve on increment; 1 otherwise |
[in] | n_r_sweeps | if > 1, number of reconstruction sweeps (only used by CS_GRADIENT_GREEN_ITER) |
[in] | verbosity | verbosity level |
[in] | clip_mode | clipping mode |
[in] | epsilon | precision for iterative gradient calculation |
[in] | clip_coeff | clipping coefficient |
[in] | bc_coeffs_v | boundary condition structure |
[in] | var | gradient's base variable |
[in] | c_weight | cell variable weight, or nullptr |
[in] | cpl | associated internal coupling, or nullptr |
[out] | grad | gradient ( ![]() |
This variant of the cs_gradient_vector function assumes ghost cell values for input arrays (var and optionally c_weight) have already been synchronized.
[in] | var_name | variable name |
[in] | gradient_type | gradient type |
[in] | halo_type | halo type |
[in] | inc | if 0, solve on increment; 1 otherwise |
[in] | n_r_sweeps | if > 1, number of reconstruction sweeps (only used by CS_GRADIENT_GREEN_ITER) |
[in] | verbosity | verbosity level |
[in] | clip_mode | clipping mode |
[in] | epsilon | precision for iterative gradient calculation |
[in] | clip_coeff | clipping coefficient |
[in] | bc_coeffs_v | boundary condition structure |
[in] | var | gradient's base variable |
[in] | c_weight | cell variable weight, or NULL |
[in] | cpl | associated internal coupling, or NULL |
[out] | grad | gradient ( ![]() |
|
extern |