  | 
  
    My Project
    
   programmer's documentation 
   | 
 
 
 
 
Go to the documentation of this file.    1 #ifndef __CS_CDOFB_NAVSTO_H__ 
    2 #define __CS_CDOFB_NAVSTO_H__ 
   99                                     .pressure_bc_val = NULL };
 
  149   for (
short int f = 0; f < cm->
n_fc; f++) {
 
  155     _div_f[0] = i_f * pfq.
unitv[0];
 
  156     _div_f[1] = i_f * pfq.
unitv[1];
 
  157     _div_f[2] = i_f * pfq.
unitv[2];
 
 
void cs_cdofb_navsto_extra_op(const cs_navsto_param_t *nsp, const cs_cdo_quantities_t *quant, const cs_cdo_connect_t *connect, const cs_adv_field_t *adv_field)
Perform extra-operation related to Fb schemes when solving Navier-Stokes.
Definition: cs_cdofb_navsto.c:659
 
void cs_cdofb_navsto_add_grad_div(short int n_fc, const cs_real_t zeta, const cs_real_t div[], cs_sdm_t *mat)
Add the grad-div part to the local matrix (i.e. for the current cell)
Definition: cs_cdofb_navsto.c:366
 
void cs_cdofb_symmetry(short int f, const cs_equation_param_t *eqp, const cs_cell_mesh_t *cm, cs_cell_builder_t *cb, cs_cell_sys_t *csys)
Take into account a symmetric boundary (treated as a sliding BCs on the three velocity components....
Definition: cs_cdofb_navsto.c:1121
 
cs_boundary_type_t
Definition: cs_boundary.h:51
 
void cs_cdofb_block_dirichlet_alge(short int f, const cs_equation_param_t *eqp, const cs_cell_mesh_t *cm, cs_cell_builder_t *cb, cs_cell_sys_t *csys)
Take into account a Dirichlet BCs on the three velocity components. For instance for a velocity inlet...
Definition: cs_cdofb_navsto.c:790
 
static void cs_cdofb_navsto_free_builder(cs_cdofb_navsto_builder_t *nsb)
Destroy the given cs_cdofb_navsto_builder_t structure.
Definition: cs_cdofb_navsto.h:120
 
Structure storing the parameters related to the resolution of the Navier-Stokes system.
Definition: cs_navsto_param.h:255
 
void cs_cdofb_block_dirichlet_weak(short int f, const cs_equation_param_t *eqp, const cs_cell_mesh_t *cm, cs_cell_builder_t *cb, cs_cell_sys_t *csys)
Take into account a Dirichlet BCs on the three velocity components. For instance for a velocity inlet...
Definition: cs_cdofb_navsto.c:948
 
#define END_C_DECLS
Definition: cs_defs.h:468
 
double meas
Definition: cs_cdo_quantities.h:88
 
double cs_real_t
Floating-point value.
Definition: cs_defs.h:302
 
cs_boundary_type_t * bf_type
Definition: cs_cdofb_navsto.h:75
 
#define BEGIN_C_DECLS
Definition: cs_defs.h:467
 
void cs_cdofb_fixed_wall(short int f, const cs_equation_param_t *eqp, const cs_cell_mesh_t *cm, cs_cell_builder_t *cb, cs_cell_sys_t *csys)
Take into account a wall BCs by a weak enforcement using Nitsche technique plus a symmetric treatment...
Definition: cs_cdofb_navsto.c:1222
 
void cs_cdofb_navsto_set_zero_mean_pressure(const cs_cdo_quantities_t *quant, cs_real_t values[])
Update the pressure field in order to get a field with a zero-mean average.
Definition: cs_cdofb_navsto.c:611
 
void cs_cdofb_navsto_define_builder(cs_real_t t_eval, const cs_navsto_param_t *nsp, const cs_cell_mesh_t *cm, const cs_cell_sys_t *csys, const cs_cdo_bc_face_t *pr_bc, const cs_boundary_type_t *bf_type, cs_cdofb_navsto_builder_t *nsb)
Set the members of the cs_cdofb_navsto_builder_t structure.
Definition: cs_cdofb_navsto.c:185
 
cs_real_t * div_op
Definition: cs_cdofb_navsto.h:71
 
Set of parameters to handle an unsteady convection-diffusion-reaction equation with term sources.
Definition: cs_equation_param.h:148
 
void cs_cdofb_navsto_init_face_pressure(const cs_navsto_param_t *nsp, const cs_cdo_quantities_t *quant, const cs_time_step_t *ts, cs_real_t *pr_f)
Initialize the pressure values when the pressure is defined at faces.
Definition: cs_cdofb_navsto.c:532
 
void cs_cdofb_navsto_init_pressure(const cs_navsto_param_t *nsp, const cs_cdo_quantities_t *quant, const cs_time_step_t *ts, cs_field_t *pr)
Initialize the pressure values.
Definition: cs_cdofb_navsto.c:436
 
void cs_cdofb_block_dirichlet_pena(short int f, const cs_equation_param_t *eqp, const cs_cell_mesh_t *cm, cs_cell_builder_t *cb, cs_cell_sys_t *csys)
Take into account a Dirichlet BCs on the three velocity components. For instance for a velocity inlet...
Definition: cs_cdofb_navsto.c:886
 
#define BFT_MALLOC(_ptr, _ni, _type)
Allocate memory for _ni elements of type _type.
Definition: bft_mem.h:62
 
time step descriptor
Definition: cs_time_step.h:51
 
#define BFT_FREE(_ptr)
Free allocated memory.
Definition: bft_mem.h:101
 
Definition: cs_cdo_bc.h:86
 
double unitv[3]
Definition: cs_cdo_quantities.h:89
 
void cs_int_t cs_int_t cs_int_t cs_real_t * ts
Definition: cs_at_plugin.h:63
 
Definition: cs_cdo_quantities.h:94
 
int cs_lnum_t
local mesh entity id
Definition: cs_defs.h:298
 
Definition: cs_cdo_connect.h:74
 
Set of local and temporary buffers useful for building the algebraic system with a cellwise process....
Definition: cs_cdo_local.h:56
 
Definition: cs_mesh_adjacencies.h:90
 
short int n_fc
Definition: cs_cdo_local.h:175
 
cs_quant_t * face
Definition: cs_cdo_local.h:182
 
int n_max_fbyc
Definition: cs_cdo_connect.h:108
 
double precision, dimension(ncharm), save zeta
Definition: cpincl.f90:99
 
short int * f_sgn
Definition: cs_cdo_local.h:178
 
static void cs_cdofb_navsto_divergence_vect(const cs_cell_mesh_t *cm, cs_real_t div[])
Compute the divergence vector associated to the current cell. WARNING: mind that, differently form th...
Definition: cs_cdofb_navsto.h:141
 
cs_real_t cs_cdofb_navsto_cell_divergence(const cs_lnum_t c_id, const cs_cdo_quantities_t *quant, const cs_adjacency_t *c2f, const cs_real_t *f_vals)
Compute the divergence of a cell using the cs_cdo_quantities_t structure.
Definition: cs_cdofb_navsto.c:322
 
Definition: cs_cdofb_navsto.h:68
 
Definition: cs_cdo_quantities.h:86
 
static cs_cdofb_navsto_builder_t cs_cdofb_navsto_create_builder(const cs_cdo_connect_t *connect)
Create and allocate a local NavSto builder when Fb schemes are used.
Definition: cs_cdofb_navsto.h:95
 
Set of arrays and local (small) dense matrices related to a mesh cell This is a key structure for bui...
Definition: cs_cdo_local.h:93
 
void cs_cdofb_block_dirichlet_wsym(short int f, const cs_equation_param_t *eqp, const cs_cell_mesh_t *cm, cs_cell_builder_t *cb, cs_cell_sys_t *csys)
Take into account a Dirichlet BCs on the three velocity components. For instance for a velocity inlet...
Definition: cs_cdofb_navsto.c:1027
 
Definition: cs_advection_field.h:149
 
Field descriptor.
Definition: cs_field.h:124
 
Set of local quantities and connectivities related to a mesh cell This is a key structure for all cel...
Definition: cs_cdo_local.h:146
 
cs_real_t * pressure_bc_val
Definition: cs_cdofb_navsto.h:76