My Project
programmer's documentation
Enumerations | Functions | Variables
cs_gradient.h File Reference
#include "cs_base.h"
#include "cs_halo.h"
#include "cs_internal_coupling.h"
Include dependency graph for cs_gradient.h:

Go to the source code of this file.

Enumerations

enum  cs_gradient_type_t { CS_GRADIENT_ITER, CS_GRADIENT_LSQ, CS_GRADIENT_LSQ_ITER, CS_GRADIENT_ITER_OLD }
 

Functions

void CS_PROCF (grdpor, GRDPOR)(const cs_int_t *const inc)
 
void CS_PROCF (cgdcel, CGDCEL)(const cs_int_t *const f_id
 
void CS_PROCF (cgdvec, CGDVEC)(const cs_int_t *const f_id
 
void CS_PROCF (cgdts, CGDTS)(const cs_int_t *const f_id
 
void cs_gradient_initialize (void)
 Initialize gradient computation API. More...
 
void cs_gradient_finalize (void)
 Finalize gradient computation API. More...
 
void cs_gradient_scalar (const char *var_name, cs_gradient_type_t gradient_type, cs_halo_type_t halo_type, int inc, bool recompute_cocg, int n_r_sweeps, int tr_dim, int hyd_p_flag, int w_stride, int verbosity, int clip_mode, double epsilon, double extrap, double clip_coeff, cs_real_3_t f_ext[], const cs_real_t bc_coeff_a[], const cs_real_t bc_coeff_b[], cs_real_t *restrict var, cs_real_t *restrict c_weight, cs_internal_coupling_t *cpl, cs_real_3_t *restrict grad)
 Compute cell gradient of scalar field or component of vector or tensor field. More...
 
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, int clip_mode, double epsilon, double clip_coeff, const cs_real_3_t bc_coeff_a[], const cs_real_33_t bc_coeff_b[], cs_real_3_t *restrict var, cs_real_t *restrict c_weight, cs_internal_coupling_t *cpl, cs_real_33_t *restrict gradv)
 Compute cell gradient of vector field. More...
 
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, int clip_mode, double epsilon, double clip_coeff, const cs_real_6_t bc_coeff_a[], const cs_real_66_t bc_coeff_b[], cs_real_6_t *restrict var, cs_real_63_t *restrict grad)
 Compute cell gradient of tensor. More...
 
void cs_gradient_scalar_synced_input (const char *var_name, cs_gradient_type_t gradient_type, cs_halo_type_t halo_type, int inc, bool recompute_cocg, int n_r_sweeps, int tr_dim, int hyd_p_flag, int w_stride, int verbosity, int clip_mode, double epsilon, double extrap, double clip_coeff, cs_real_t f_ext[][3], const cs_real_t bc_coeff_a[], const cs_real_t bc_coeff_b[], 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. More...
 
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, int clip_mode, double epsilon, double clip_coeff, const cs_real_t bc_coeff_a[][3], const cs_real_t bc_coeff_b[][3][3], const cs_real_t var[restrict][3], const cs_real_t c_weight[restrict], const cs_internal_coupling_t *cpl, cs_real_33_t *restrict gradv)
 Compute cell gradient of vector field. More...
 
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, int clip_mode, double epsilon, double clip_coeff, const cs_real_t bc_coeff_a[][6], const cs_real_t bc_coeff_b[][6][6], const cs_real_t var[restrict][6], cs_real_63_t *restrict grad)
 Compute cell gradient of tensor. More...
 
void cs_gradient_type_by_imrgra (int imrgra, cs_gradient_type_t *gradient_type, cs_halo_type_t *halo_type)
 

Variables

const char * cs_gradient_type_name []
 
void const cs_int_t *const imrgra
 
void const cs_int_t *const const cs_int_t *const inc
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const iccocg
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const n_r_sweeps
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const idimtr
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const iphydp
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const ipond
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const iwarnp
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const imligp
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const epsrgp
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const extrap
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const const cs_real_t *const climgp
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const const cs_real_t *const cs_real_3_t f_ext []
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const const cs_real_t *const cs_real_3_t const cs_real_t coefap []
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const const cs_real_t *const cs_real_3_t const cs_real_t const cs_real_t coefbp []
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const const cs_real_t *const cs_real_3_t const cs_real_t const cs_real_t cs_real_t pvar []
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const const cs_real_t *const cs_real_3_t const cs_real_t const cs_real_t cs_real_t cs_real_t ktvar []
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const const cs_real_t *const cs_real_3_t const cs_real_t const cs_real_t cs_real_t cs_real_t cs_real_3_t grad []
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const const cs_real_3_t coefav []
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const const cs_real_3_t const cs_real_33_t coefbv []
 
void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const const cs_real_3_t const cs_real_33_t cs_real_3_t cs_real_33_t gradv []
 

Enumeration Type Documentation

◆ cs_gradient_type_t

Enumerator
CS_GRADIENT_ITER 
CS_GRADIENT_LSQ 
CS_GRADIENT_LSQ_ITER 
CS_GRADIENT_ITER_OLD 

Function Documentation

◆ cs_gradient_finalize()

void cs_gradient_finalize ( void  )

Finalize gradient computation API.

◆ cs_gradient_initialize()

void cs_gradient_initialize ( void  )

Initialize gradient computation API.

◆ cs_gradient_scalar()

void cs_gradient_scalar ( const char *  var_name,
cs_gradient_type_t  gradient_type,
cs_halo_type_t  halo_type,
int  inc,
bool  recompute_cocg,
int  n_r_sweeps,
int  tr_dim,
int  hyd_p_flag,
int  w_stride,
int  verbosity,
int  clip_mode,
double  epsilon,
double  extrap,
double  clip_coeff,
cs_real_3_t  f_ext[],
const cs_real_t  bc_coeff_a[],
const cs_real_t  bc_coeff_b[],
cs_real_t *restrict  var,
cs_real_t *restrict  c_weight,
cs_internal_coupling_t cpl,
cs_real_3_t *restrict  grad 
)

Compute cell gradient of scalar field or component of vector or tensor field.

Parameters
[in]var_namevariable name
[in]gradient_typegradient type
[in]halo_typehalo type
[in]incif 0, solve on increment; 1 otherwise
[in]recompute_cocgshould COCG FV quantities be recomputed ?
[in]n_r_sweepsif > 1, number of reconstruction sweeps
[in]tr_dim2 for tensor with periodicity of rotation, 0 otherwise
[in]hyd_p_flagflag for hydrostatic pressure
[in]w_stridestride for weighting coefficient
[in]verbosityverbosity level
[in]clip_modeclipping mode
[in]epsilonprecision for iterative gradient calculation
[in]extrapboundary gradient extrapolation coefficient
[in]clip_coeffclipping coefficient
[in]f_extexterior force generating the hydrostatic pressure
[in]bc_coeff_aboundary condition term a
[in]bc_coeff_bboundary condition term b
[in,out]vargradient's base variable
[in,out]c_weightweighted gradient coefficient variable, or NULL
[in,out]cplstructure associated with internal coupling, or NULL
[out]gradgradient

◆ cs_gradient_scalar_synced_input()

void cs_gradient_scalar_synced_input ( const char *  var_name,
cs_gradient_type_t  gradient_type,
cs_halo_type_t  halo_type,
int  inc,
bool  recompute_cocg,
int  n_r_sweeps,
int  tr_dim,
int  hyd_p_flag,
int  w_stride,
int  verbosity,
int  clip_mode,
double  epsilon,
double  extrap,
double  clip_coeff,
cs_real_t  f_ext[][3],
const cs_real_t  bc_coeff_a[],
const cs_real_t  bc_coeff_b[],
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.

Parameters
[in]var_namevariable name
[in]gradient_typegradient type
[in]halo_typehalo type
[in]incif 0, solve on increment; 1 otherwise
[in]recompute_cocgshould COCG FV quantities be recomputed ?
[in]n_r_sweepsif > 1, number of reconstruction sweeps
[in]tr_dim2 for tensor with periodicity of rotation, 0 otherwise
[in]hyd_p_flagflag for hydrostatic pressure
[in]w_stridestride for weighting coefficient
[in]verbosityverbosity level
[in]clip_modeclipping mode
[in]epsilonprecision for iterative gradient calculation
[in]extrapboundary gradient extrapolation coefficient
[in]clip_coeffclipping coefficient
[in]f_extexterior force generating the hydrostatic pressure
[in]bc_coeff_aboundary condition term a
[in]bc_coeff_bboundary condition term b
[in]vargradient's base variable
[in]c_weightweighted gradient coefficient variable, or NULL
[in,out]cplstructure associated with internal coupling, or NULL
[out]gradgradient

◆ cs_gradient_tensor()

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,
int  clip_mode,
double  epsilon,
double  clip_coeff,
const cs_real_6_t  bc_coeff_a[],
const cs_real_66_t  bc_coeff_b[],
cs_real_6_t *restrict  var,
cs_real_63_t *restrict  grad 
)

Compute cell gradient of tensor.

Parameters
[in]var_namevariable name
[in]gradient_typegradient type
[in]halo_typehalo type
[in]incif 0, solve on increment; 1 otherwise
[in]n_r_sweepsif > 1, number of reconstruction sweeps
[in]verbosityverbosity level
[in]clip_modeclipping mode
[in]epsilonprecision for iterative gradient calculation
[in]clip_coeffclipping coefficient
[in]bc_coeff_aboundary condition term a
[in]bc_coeff_bboundary condition term b
[in,out]vargradient's base variable
[out]gradgradient ( $ \der{t_ij}{x_k} $ is grad[][ij][k])
[in]var_namevariable name
[in]gradient_typegradient type
[in]halo_typehalo type
[in]incif 0, solve on increment; 1 otherwise
[in]n_r_sweepsif > 1, number of reconstruction sweeps
[in]verbosityverbosity level
[in]clip_modeclipping mode
[in]epsilonprecision for iterative gradient calculation
[in]clip_coeffclipping coefficient
[in]bc_coeff_aboundary condition term a
[in]bc_coeff_bboundary condition term b
[in,out]vargradient's base variable
[out]gradgradient ( $ \der{u_i}{x_j} $ is grad[][i][j])

◆ cs_gradient_tensor_synced_input()

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,
int  clip_mode,
double  epsilon,
double  clip_coeff,
const cs_real_t  bc_coeff_a[][6],
const cs_real_t  bc_coeff_b[][6][6],
const cs_real_t  var[restrict][6],
cs_real_63_t *restrict  grad 
)

Compute cell gradient of tensor.

Parameters
[in]var_namevariable name
[in]gradient_typegradient type
[in]halo_typehalo type
[in]incif 0, solve on increment; 1 otherwise
[in]n_r_sweepsif > 1, number of reconstruction sweeps
[in]verbosityverbosity level
[in]clip_modeclipping mode
[in]epsilonprecision for iterative gradient calculation
[in]clip_coeffclipping coefficient
[in]bc_coeff_aboundary condition term a
[in]bc_coeff_bboundary condition term b
[in,out]vargradient's base variable
[out]gradgradient ( $ \der{t_ij}{x_k} $ is grad[][ij][k])

◆ cs_gradient_type_by_imrgra()

void cs_gradient_type_by_imrgra ( int  imrgra,
cs_gradient_type_t gradient_type,
cs_halo_type_t halo_type 
)

◆ cs_gradient_vector()

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,
int  clip_mode,
double  epsilon,
double  clip_coeff,
const cs_real_3_t  bc_coeff_a[],
const cs_real_33_t  bc_coeff_b[],
cs_real_3_t *restrict  var,
cs_real_t *restrict  c_weight,
cs_internal_coupling_t cpl,
cs_real_33_t *restrict  grad 
)

Compute cell gradient of vector field.

Parameters
[in]var_namevariable name
[in]gradient_typegradient type
[in]halo_typehalo type
[in]incif 0, solve on increment; 1 otherwise
[in]n_r_sweepsif > 1, number of reconstruction sweeps
[in]verbosityverbosity level
[in]clip_modeclipping mode
[in]epsilonprecision for iterative gradient calculation
[in]clip_coeffclipping coefficient
[in]bc_coeff_aboundary condition term a
[in]bc_coeff_bboundary condition term b
[in,out]vargradient's base variable
[in,out]c_weightweighted gradient coefficient variable, or NULL
[in,out]cplstructure associated with internal coupling, or NULL
[out]gradvgradient ( $ \der{u_i}{x_j} $ is gradv[][i][j])
[in]var_namevariable name
[in]gradient_typegradient type
[in]halo_typehalo type
[in]incif 0, solve on increment; 1 otherwise
[in]n_r_sweepsif > 1, number of reconstruction sweeps
[in]verbosityverbosity level
[in]clip_modeclipping mode
[in]epsilonprecision for iterative gradient calculation
[in]clip_coeffclipping coefficient
[in]bc_coeff_aboundary condition term a
[in]bc_coeff_bboundary condition term b
[in,out]vargradient's base variable
[in,out]c_weightweighted gradient coefficient variable, or NULL
[in,out]cplstructure associated with internal coupling, or NULL
[out]gradgradient ( $ \der{u_i}{x_j} $ is grad[][i][j])

◆ cs_gradient_vector_synced_input()

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,
int  clip_mode,
double  epsilon,
double  clip_coeff,
const cs_real_t  bc_coeff_a[][3],
const cs_real_t  bc_coeff_b[][3][3],
const cs_real_t  var[restrict][3],
const cs_real_t  c_weight[restrict],
const cs_internal_coupling_t cpl,
cs_real_33_t *restrict  grad 
)

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.

Parameters
[in]var_namevariable name
[in]gradient_typegradient type
[in]halo_typehalo type
[in]incif 0, solve on increment; 1 otherwise
[in]n_r_sweepsif > 1, number of reconstruction sweeps
[in]verbosityverbosity level
[in]clip_modeclipping mode
[in]epsilonprecision for iterative gradient calculation
[in]clip_coeffclipping coefficient
[in]bc_coeff_aboundary condition term a
[in]bc_coeff_bboundary condition term b
[in,out]vargradient's base variable
[in,out]c_weightweighted gradient coefficient variable, or NULL
[in,out]cplstructure associated with internal coupling, or NULL
[out]gradvgradient ( $ \der{u_i}{x_j} $ is gradv[][i][j])

This variant of the cs_gradient_vector function assumes ghost cell values for input arrays (var and optionally c_weight) have already been synchronized.

Parameters
[in]var_namevariable name
[in]gradient_typegradient type
[in]halo_typehalo type
[in]incif 0, solve on increment; 1 otherwise
[in]n_r_sweepsif > 1, number of reconstruction sweeps
[in]verbosityverbosity level
[in]clip_modeclipping mode
[in]epsilonprecision for iterative gradient calculation
[in]clip_coeffclipping coefficient
[in]bc_coeff_aboundary condition term a
[in]bc_coeff_bboundary condition term b
[in,out]vargradient's base variable
[in,out]c_weightweighted gradient coefficient variable, or NULL
[in,out]cplstructure associated with internal coupling, or NULL
[out]gradgradient ( $ \der{u_i}{x_j} $ is grad[][i][j])

◆ CS_PROCF() [1/4]

void CS_PROCF ( cgdcel  ,
CGDCEL   
) const

◆ CS_PROCF() [2/4]

void CS_PROCF ( cgdts  ,
CGDTS   
) const

◆ CS_PROCF() [3/4]

void CS_PROCF ( cgdvec  ,
CGDVEC   
) const

◆ CS_PROCF() [4/4]

void CS_PROCF ( grdpor  ,
GRDPOR   
) const

Variable Documentation

◆ climgp

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_real_t* const const cs_real_t* const climgp

◆ coefap

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_real_t* const const cs_real_t* const const cs_real_t* const cs_real_3_t const cs_real_t coefap[]

◆ coefav

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_real_t* const const cs_real_t* const const cs_real_6_t coefav[]

◆ coefbp

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_real_t* const const cs_real_t* const const cs_real_t* const cs_real_3_t const cs_real_t const cs_real_t coefbp[]

◆ coefbv

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_real_t* const const cs_real_t* const const cs_real_6_t const cs_real_66_t coefbv[]

◆ cs_gradient_type_name

const char* cs_gradient_type_name[]

◆ epsrgp

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_real_t* const epsrgp

◆ extrap

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_real_t* const const cs_real_t* const extrap

◆ f_ext

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_real_t* const const cs_real_t* const const cs_real_t* const cs_real_3_t f_ext[]

◆ grad

void const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_int_t *const const cs_real_t *const const cs_real_t *const const cs_real_6_t const cs_real_66_t cs_real_6_t cs_real_63_t grad

◆ gradv

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_real_t* const const cs_real_t* const const cs_real_3_t const cs_real_33_t cs_real_3_t cs_real_33_t gradv[]

◆ iccocg

void const cs_int_t* const const cs_int_t* const const cs_int_t* const iccocg

◆ idimtr

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const idimtr

◆ imligp

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const imligp

◆ imrgra

void const cs_int_t* const imrgra

◆ inc

void const cs_int_t* const const cs_int_t* const inc

◆ iphydp

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const iphydp

◆ ipond

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const ipond

◆ iwarnp

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const iwarnp

◆ ktvar

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_real_t* const const cs_real_t* const const cs_real_t* const cs_real_3_t const cs_real_t const cs_real_t cs_real_t cs_real_t ktvar[]

◆ n_r_sweeps

void const cs_int_t *const const cs_int_t *const const cs_int_t *const n_r_sweeps

◆ pvar

void const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_int_t* const const cs_real_t* const const cs_real_t* const const cs_real_6_t const cs_real_66_t cs_real_6_t pvar[]