9.0
general documentation
Loading...
Searching...
No Matches
cs_cdofb_ac.cpp File Reference

Build an algebraic CDO face-based system for the Navier-Stokes equations and solved it with an artificial compressibility algorithm. More...

#include "base/cs_defs.h"
#include <stdio.h>
#include <stdlib.h>
#include <math.h>
#include <float.h>
#include <assert.h>
#include <string.h>
#include "bft/bft_mem.h"
#include "base/cs_array.h"
#include "alge/cs_blas.h"
#include "cdo/cs_cdo_bc.h"
#include "cdo/cs_cdo_blas.h"
#include "cdo/cs_cdo_solve.h"
#include "cdo/cs_cdofb_priv.h"
#include "cdo/cs_cdofb_scaleq.h"
#include "cdo/cs_cdofb_vecteq.h"
#include "cdo/cs_cdofb_navsto.h"
#include "cdo/cs_equation_bc.h"
#include "cdo/cs_equation_priv.h"
#include "cdo/cs_evaluate.h"
#include "cdo/cs_iter_algo.h"
#include "base/cs_log.h"
#include "base/cs_math.h"
#include "base/cs_parall.h"
#include "base/cs_post.h"
#include "alge/cs_sles.h"
#include "cdo/cs_source_term.h"
#include "cdo/cs_static_condensation.h"
#include "base/cs_timer.h"
#include "cdo/cs_cdofb_ac.h"
Include dependency graph for cs_cdofb_ac.cpp:

Functions

void cs_cdofb_ac_init_common (const cs_cdo_quantities_t *quant, const cs_cdo_connect_t *connect, const cs_time_step_t *time_step)
 Set shared pointers from the main domain members.
void * cs_cdofb_ac_init_scheme_context (const cs_navsto_param_t *nsp, cs_adv_field_t *adv_field, cs_real_t *mflux, cs_real_t *mflux_pre, cs_boundary_type_t *fb_type, void *nsc_input)
 Initialize a cs_cdofb_ac_t structure.
void * cs_cdofb_ac_free_scheme_context (void *scheme_context)
 Destroy a cs_cdofb_ac_t structure.
void cs_cdofb_ac_compute_implicit (const cs_mesh_t *mesh, const cs_navsto_param_t *nsp, void *scheme_context)
 Solve the unsteady Navier-Stokes system with a CDO face-based scheme using a Artificial Compressibility approach and an implicit Euler time scheme.
void cs_cdofb_ac_compute_implicit_nl (const cs_mesh_t *mesh, const cs_navsto_param_t *nsp, void *scheme_context)
 Solve the unsteady Navier-Stokes system with a CDO face-based scheme using a Artificial Compressibility approach and an implicit Euler time scheme For Picard - Navier–Stokes problems.

Detailed Description

Build an algebraic CDO face-based system for the Navier-Stokes equations and solved it with an artificial compressibility algorithm.

Function Documentation

◆ cs_cdofb_ac_compute_implicit()

void cs_cdofb_ac_compute_implicit ( const cs_mesh_t * mesh,
const cs_navsto_param_t * nsp,
void * scheme_context )

Solve the unsteady Navier-Stokes system with a CDO face-based scheme using a Artificial Compressibility approach and an implicit Euler time scheme.

Parameters
[in]meshpointer to a cs_mesh_t structure
[in]nsppointer to a cs_navsto_param_t structure
[in,out]scheme_contextpointer to a structure cast on-the-fly

◆ cs_cdofb_ac_compute_implicit_nl()

void cs_cdofb_ac_compute_implicit_nl ( const cs_mesh_t * mesh,
const cs_navsto_param_t * nsp,
void * scheme_context )

Solve the unsteady Navier-Stokes system with a CDO face-based scheme using a Artificial Compressibility approach and an implicit Euler time scheme For Picard - Navier–Stokes problems.

Parameters
[in]meshpointer to a cs_mesh_t structure
[in]nsppointer to a cs_navsto_param_t structure
[in,out]scheme_contextpointer to a structure cast on-the-fly

◆ cs_cdofb_ac_free_scheme_context()

void * cs_cdofb_ac_free_scheme_context ( void * scheme_context)

Destroy a cs_cdofb_ac_t structure.

Parameters
[in]scheme_contextpointer to a scheme context structure to free
Returns
a null pointer

◆ cs_cdofb_ac_init_common()

void cs_cdofb_ac_init_common ( const cs_cdo_quantities_t * quant,
const cs_cdo_connect_t * connect,
const cs_time_step_t * time_step )

Set shared pointers from the main domain members.

Parameters
[in]quantadditional mesh quantities struct.
[in]connectpointer to a cs_cdo_connect_t struct.
[in]time_steppointer to a cs_time_step_t structure

◆ cs_cdofb_ac_init_scheme_context()

void * cs_cdofb_ac_init_scheme_context ( const cs_navsto_param_t * nsp,
cs_adv_field_t * adv_field,
cs_real_t * mflux,
cs_real_t * mflux_pre,
cs_boundary_type_t * fb_type,
void * nsc_input )

Initialize a cs_cdofb_ac_t structure.

Parameters
[in]nsppointer to a cs_navsto_param_t structure
[in]adv_fieldpointer to cs_adv_field_t structure
[in]mfluxcurrent values of the mass flux across primal faces
[in]mflux_precurrent values of the mass flux across primal faces
[in]fb_typetype of boundary for each boundary face
[in]nsc_inputpointer to a cs_navsto_ac_t structure
Returns
a pointer to a new allocated cs_cdofb_ac_t structure