Menum_cell_advection_term_scheme | Enumeration modules associated to cell scalar advection term discretization |
Menum_cell_bc_scheme | Enumeration modules associated to cell scalar boundary condition scheme |
Menum_cell_bc_type | Enumeration of the different type of boundary condition |
Menum_cell_diffusion_term_scheme | Enumeration modules associated to cell scalar diffusion term discretization |
Menum_checkpoint_metric | Enumerations associated to the checkpoint metric |
Menum_coordinate_system | Enumerations associated to the mesh |
Menum_diagnostic_quantities | Diagnostic quantity enumerators |
Menum_discretization_type | Discretization types identifiers |
Menum_energy_equation_formulation | Enumerations associated to the energy equation |
Menum_enforced_stencil | Enumeration of the different type of boundary condition |
Menum_face_bc_scheme | Enumeration modules associated to face-centered vector field boundary condition scheme |
Menum_face_bc_type | Boundary condition types for a face-centered vector field |
Menum_flux_limiter | Time order discrezation enumeration |
Menum_ibc_method | Methods for immersed boundaries |
Menum_ibc_type | Types of immersed boundaries |
Menum_isd_metrics_direction_computational_method | Methods to compute direction to shape boundary |
Menum_les_model | Enumeration for Large Eddy Simulation models |
Menum_levelset | Main module |
Menum_levelset_advection_scheme | Module containing the list of the various advection method related to Level Set representation Associated to the advection_scheme parameter |
Menum_levelset_curvature_type | Module containing the list of the various curvature computation schemes |
Menum_levelset_reinit_method | Module containing the list of the various reinitialization methods |
Menum_levelset_representation | Module containing the different representation Associated to the representation parameter |
Menum_levelset_time_order | Module containing the list of the various time schemes related to Level Set representation Associated to the time_order parameter |
Menum_levelset_volume_fraction_method | Module containing the list of the various reinitialization methods |
Menum_mumps_partitioning | Enumeration for MUMPS direct solver associated partitioning libraries |
Menum_navier_diffusion_term_scheme | Discretization schemes for the diffusion momentum term (divergence of the stress tensor) |
Menum_navier_nonlinear_term_scheme | Discretization schemes for the nonlinear momentum term |
Menum_navier_velocity_pressure_method | Enumerations associated to the Navier-Stokes equations |
Menum_phase_representation | Module containing the list of the various phase representations |
Menum_rans_model | Enumeration for RANS models |
Menum_refined_velocity_method | Time order discrezation enumeration |
Menum_smoothing_method | Module containing the list of the various phase representations |
Menum_test_case | Test case identifiers |
Menum_time_order_discretization | Time order discrezation enumeration |
Menum_turbulence_model | Enumeration for turbulence models |
Menum_vof_schemes | Module containing the list of the various advection schemes related to VoF representation |
Mfields_diagnostic_quantities | Diagnostic quantity fields |
Mfields_energy | Contains the field arrays associated to the Energy equation |
Mfields_immersed_subdomain | Global field for immersed subdomains |
Mfields_material_properties | Local properties of material defined on cells or faces |
Mfields_mof | Module containing the fields related to the Moment-of-Fluid method |
Mfields_navier | Declaration of the field arrays associated to the Navier-Stokes equations |
Mfields_particles | The fields associated to lagrangian particles |
Mfields_phase_advection | Contains the fields describing the various phases |
►Mfields_reference_solution | Define the field associated to the reference solutions |
Ct_reference_solution_species_set | Derived type to store individually the species concentration |
Mfields_species_transport | Contains the field arrays associated to the species transport equation |
Mfields_statistics | Define fields associated to the statistics of instantaneous fields |
Mfields_turbulence | Declaration of the field arrays associated to the turbulence models |
Mfields_turbulence_rans | Declaration of the field arrays associated to the turbulence RANS models |
Mfields_validation | Fields associated to the validation |
Minterface_hypre_common | Common functions and constants |
Minterface_hypre_parcsr | ParCSR specific functions |
Minterface_hypre_sstruct | SStruct specific functions |
Minterface_hypre_struct | Struct specific functions |
Mmod_advect_field | Quick explicit advection method for a scalar field |
►Mmod_apply_cell_advection_scheme | Set line coefficients of the matrix associated to the discretization of the advection term \( \varrho * \nabla \cdot (\mathbf{u}_{n+1} S_{n+1}) \) with various schemes: |
Capply_cell_advection_face_scheme_func | The interface for flux routines |
Mmod_apply_cell_diffusion_scheme | Set line coefficients of the matrix associated to the discretization of the diffusion term with the following schemes: |
Mmod_apply_immersed_boundary_condition_cell | Apply immersed boundaries, cell version |
Mmod_apply_immersed_boundary_condition_face | Apply immersed boundaries, face version |
Mmod_arrays | Useful functions for manipulating arrays |
Mmod_cell_scalar_implicit_discretization_collection | Module that encapsulates all cell scalar term by term discretization modules |
Mmod_compressible_predict_density | Predict the density at the next time step |
Mmod_compute_cell_advection_term_exp_semi_lagrangian | Explicit semi lagrangian method for the advection equation |
Mmod_compute_cell_cons_advection_term_exp_generic_fast_rec | Explicit Fast Reconstruction scheme (generic) for the advection equation |
Mmod_compute_cell_cons_advection_term_exp_generic_fast_weno | Explicit WENO scheme (generic) for the advection equation |
Mmod_compute_cell_cons_advection_term_exp_generic_rec | Explicit Reconstruction scheme (generic) for the advection equation |
Mmod_compute_cell_cons_advection_term_exp_generic_weno | Explicit WENO scheme (generic) for the advection equation |
Mmod_compute_cell_cons_advection_term_exp_opt_weno | Explicit WENO scheme (generic) for the advection equation |
Mmod_compute_cell_cons_advection_term_exp_rec_schemes | Explicit reconstruction schemes (wrappers) for the advection equationmod_compute_cell_cons_advection_term_exp_generic_rec::compute_cell_cons_advection_term_exp_upwind_generic_rec() and mod_compute_cell_cons_advection_term_exp_generic_rec::compute_cell_cons_advection_term_exp_centered_generic_rec() for further details |
Mmod_compute_cell_cons_advection_term_exp_weno_schemes | Explicit WENO schemes (wrappers) for the advection equation |
Mmod_compute_div_u_psi_term_explicit_generic_fast_rec | Explicit conservative advection term for a vector field with an generic fast reconstruction scheme |
Mmod_compute_div_u_psi_term_explicit_generic_fast_weno | Explicit inertial term with an upwind generic weno scheme |
Mmod_compute_div_u_psi_term_explicit_generic_rec | Explicit conservative advection term for a vector field with an upwind generic reconstruction scheme |
Mmod_compute_div_u_psi_term_explicit_generic_weno | Explicit inertial term with an upwind generic weno scheme |
Mmod_compute_div_u_psi_term_explicit_opt_weno | Explicit inertial term with an upwind optimized weno scheme |
Mmod_compute_div_u_psi_term_explicit_rec_schemes | Explicit vector conservative advection term with upwind reconstruction schemes |
Mmod_compute_div_u_psi_term_explicit_weno_schemes | Explicit vector conservative advection term with upwind WENO schemes |
Mmod_compute_field_statistics | Compute statistics of cell and face fields (time averaged, fluctuations and rms) |
Mmod_compute_ib_surface_diagnostics | Compute immersed boundary surface diagnostics (surface, pressure drag, shear drag, nusselt_number, etc.) |
Mmod_compute_immersed_boundary_distance | Compute distance from shape boundary |
Mmod_compute_k_omega_functions | Compute k-ω STD and SST functions |
Mmod_compute_pressure_gradient | Compute pressure gradient on the face grid |
Mmod_compute_turbulent_species_diffusion_coefficient | Compute turvulent species transport diffusion coefficient |
Mmod_compute_v2_f_functions | Compute v2_f functions |
Mmod_compute_wall_distance | Compute wall distance (physical and immersed boundaries) |
Mmod_create_immersed_boundary_metrics | Interface to create immersed boundaries |
Mmod_dd_init | Initialization of the DD system |
Mmod_dd_polynomial | Discrete derivative polynomial function evaluation |
Mmod_discrete_derivative_weights | Discrete derivatives dictionnary |
Mmod_discretize_cell_explicit_diffusion_term_o2 | Compute cell explicit diffusion term with centered second order scheme |
Mmod_div_u_psi_term_explicit | Explicit inertial term module |
Mmod_eval_ib_metrics_node_types | Building blocks for immersed boundaries: Nodes |
►Mmod_eval_ib_metrics_points | Preparation routine building blocks for immersed boundaries |
Ceval_boundary_points | Evaluate boundary points |
Ceval_ib_metrics_ghost_points | Evaluate ghost points |
Mmod_eval_ibm_matrix_coefficients | Preparation routine building blocks for immersed boundaries |
Mmod_explicit_add_cell_bc | Fill ghost nodes with given boundary conditions for cell scalars |
Mmod_explicit_add_cell_bc_nh | Fill ghost nodes with homogeneous Neumann boundary conditions for cell scalars |
Mmod_extrapolate_cell_to_cell_neumann | Extrapolate cell values toward other cells (usualy ghost cells) with Neumann condition |
Mmod_extrapolate_cell_to_face | Extrapolate from a field known on cells (i,j,k) towards a faces |
Mmod_extrapolate_cell_to_face_boundary | Second order extrapolation from cell to face boundary |
Mmod_extrapolate_cell_to_face_neumann | Extrapolate from cells to faces with Neumann conditions |
Mmod_extrapolate_cell_to_point | Extrapolate from a field known on cells (i,j,k) towards a point |
Mmod_extrapolate_cell_to_point_neumann | Extrapolate from a field known on cells (i,j,k) towards a point with a given neumann condition (ie. the derivative of the function at the destination point) |
Mmod_extrapolate_cells_outside_boundaries | Extrapolate the cell field outside the boundaries of the domain (in the ghost cells) |
Mmod_extrapolate_cells_to_cells_neumann | Extrapolate the field defined on cells onto faces. This is used whenever you need to compute what would be the Dirichlet boundary value associated to the Neumann condition, given a field inside the domain. Order 2 version |
Mmod_extrapolate_cells_to_cells_on_plane | Extrapolate cells to cells on a plane (for boundaries) |
Mmod_extrapolate_cells_to_faces_neumann | Extrapolate the field defined on cells onto faces. This is used whenever you need to compute what would be the Dirichlet boundary value associated to the Neumann condition, given a field inside the domain. Order 2 version |
Mmod_extrapolate_edge_to_edge_boundary | Second order extrapolation from edge to edge boundary |
Mmod_extrapolate_face_to_cell | Extrapolate from a field known on faces (u,v,w) towards a cell's center |
Mmod_extrapolate_face_to_edge | Extrapolate from a field known on faces (u,v,w) towards a cell's edges |
Mmod_extrapolate_faces_outside_boundaries | Extrapolate faces outside boundaries |
Mmod_extrapolate_faces_to_faces | Extrapolate faces to faces |
Mmod_extrapolate_faces_to_plane | Extrapolate faces to a whole plane |
Mmod_extrapolate_field_time | Extrapolate a field (for example the velocity or pressure) foward in time |
Mmod_extrapolation_computer | Computer for evaluating Extrapolation Schemes |
Mmod_extrapolation_init | Initialization of declared extrapolation chemes |
Mmod_extrapolation_neumann_schemes | Extrapolation Neumann Schemes Concretly, those schemes are pointers to FD schemes, see the init procedure |
Mmod_extrapolation_scheme_o1 | Extrapolation Schemes for at order 1 |
Mmod_extrapolation_scheme_o2 | Extrapolation Schemes for at order 2 |
Mmod_extrapolation_scheme_o3 | Extrapolation Schemes for at order 3 |
Mmod_extrapolation_scheme_o4 | Extrapolation Schemes for at order 4 |
Mmod_face_advection_tvd_superbee | Explicit dimensional splitting Lax-Wendroff TVD SuperBee (LW-TVD-SB) scheme for the advection equation |
Mmod_face_vector_implicit_discretization_collection | Module that encapsulates all face vector term by term discretization modules |
►Mmod_field_operation | Cell and face field operations that use OpenMP directives |
Cfield_operation_add | \( x = a + b \) or \( a = a + b \) |
Cfield_operation_add_add | \( x = a + b + c \) or \( a = a + b + c \) |
Cfield_operation_add_divide | \( x = a + b \div c \) or \( a = a + b \div c \) |
Cfield_operation_add_mult | \( x = a + b \times c \) or \( a = a + b \times c \) |
Cfield_operation_add_subst | \( x = a + b - c \) or \( a = a + b - c \) |
Cfield_operation_add_subst_mult | \( x = a + b - c \times d \) or \( a = a + b - c \times d \) |
Cfield_operation_divide | \( x = a \div b \) or \( a = a \div b \) |
Cfield_operation_divide_add_divide | \( x = a \div b + c \div d \) |
Cfield_operation_divide_padd | \( x = a \div (b + c) \) or \( a = a \div (b + c) \) |
Cfield_operation_divide_pmult | \( x = a \div (b \times c) \) or \( a = a \div (b \times c) \) |
Cfield_operation_divide_psub | \( x = a \div (b - c) \) or \( a = a \div (b - c) \) |
Cfield_operation_divide_subst_divide | \( x = a \div b - c \div d \) |
Cfield_operation_mult | \( x = a \times b \) or \( a = a \times b \) |
Cfield_operation_mult_divide | \( x = a \times b \div c \) or \( a = a \times b \div c \) |
Cfield_operation_mult_mult | \( x = a \times b \times c \) or \( a = a \times b \times c \) |
Cfield_operation_mult_padd | \( x = a \times (b + c) \) or \( a = a \times (b + c) \) |
Cfield_operation_mult_psub | \( x = a \times (b - c) \) or \( a = a \times (b - c) \) |
Cfield_operation_subst | \( x = a - b \) or \( a = a - b \) |
Cfield_operation_subst_add | \( x = a - b + c \) or \( a = a - b + c \) |
Cfield_operation_subst_divide | \( x = a - b \div c \) or \( a = a - b \div c \) |
Cfield_operation_subst_mult | \( x = a - b \times c \) or \( a = a - b \times c \) |
Cfield_operation_subst_mult_subst_mult | \( x = a - b \times c - d \times e \) or \( a = a - b \times c - d \times e \) |
Cfield_operation_subst_subst | \( x = a - b - c \) or \( a = a - b - c \) |
Mmod_fill_ghost_nodes | Specify how ghost cells are filled This depends on the type of boundaries |
Mmod_finite_differences_3d_stencils | Stencil filling for 3D schemes |
Mmod_finite_differences_computer | Computer for evaluating Finite Difference Schemes |
Mmod_finite_differences_init | Initialization of declared finite differences schemes |
Mmod_finite_differences_scheme_fifth_o1 | Finite Difference Schemes for the third derivative at order 3 |
Mmod_finite_differences_scheme_fifth_o2 | Finite Difference Schemes for the first derivative at order 5 |
Mmod_finite_differences_scheme_first_o1 | Finite Difference Schemes for the first derivative at order 1 |
Mmod_finite_differences_scheme_first_o2 | Finite Difference Schemes for the first derivative at order 2 |
Mmod_finite_differences_scheme_first_o3 | Finite Difference Schemes for first derivative at order 3 |
Mmod_finite_differences_scheme_first_o4 | Finite Difference Schemes for the first derivative at order 4 |
Mmod_finite_differences_scheme_first_o5 | Finite Difference Schemes for the first derivative at order 5 |
Mmod_finite_differences_scheme_first_o6 | Finite Difference Schemes for the first derivative at order 5 |
Mmod_finite_differences_scheme_fourth_o1 | Finite Difference Schemes for fourth derivative at order 1 |
Mmod_finite_differences_scheme_fourth_o2 | Finite Difference Schemes for the third derivative at order 3 |
Mmod_finite_differences_scheme_fourth_o3 | Finite Difference Schemes for the first derivative at order 5 |
Mmod_finite_differences_scheme_second_o1 | Finite Difference Schemes for second derivative at order 1 |
Mmod_finite_differences_scheme_second_o2 | Finite Difference Schemes for second derivative at order 2 |
Mmod_finite_differences_scheme_second_o3 | Finite Difference Schemes for second derivative at order 3 |
Mmod_finite_differences_scheme_second_o4 | Finite Difference Schemes for second derivative at order 4 |
Mmod_finite_differences_scheme_second_o5 | Finite Difference Schemes for the first derivative at order 5 |
Mmod_finite_differences_scheme_sixth_o1 | Finite Difference Schemes for the first derivative at order 5 |
Mmod_finite_differences_scheme_third_o1 | Finite Difference Schemes for second derivative at order 1 |
Mmod_finite_differences_scheme_third_o2 | Finite Difference Schemes for third derivative at order 2 |
Mmod_finite_differences_scheme_third_o3 | Finite Difference Schemes for the third derivative at order 3 |
Mmod_finite_differences_scheme_third_o4 | Finite Difference Schemes for the first derivative at order 5 |
Mmod_finite_differences_scheme_zero | Finite Difference Schemes for the zero'th derivative (the value) |
Mmod_finite_differences_weno_scheme_first_o2z | Finite Difference Weno Scheme for first derivative at order 2Z |
Mmod_finite_differences_weno_scheme_first_o3 | Finite Difference Weno Scheme for first derivative at order 3 |
Mmod_finite_differences_weno_scheme_first_o3z | Finite Difference Weno Scheme for first derivative at order 3Z |
Mmod_finite_differences_weno_scheme_first_o5 | Finite Difference Weno Scheme for first derivative at order 5 |
Mmod_finite_differences_weno_scheme_first_o5z | Finite Difference Weno Scheme for first derivative at order 5Z |
Mmod_fv_fluxes | Finite Volume fluxes functions |
Mmod_generate_seed | Generate a seed, randomly or not |
Mmod_generic_initialize | Generic initialization routines for arrays of various type |
Mmod_generic_list | Generic list |
►Mmod_generic_node_type | Any node type variables |
Cguess_node_type | Guess the node type from the given grid sizes |
Mmod_generic_stack | |
Mmod_generic_unalloc | Generic unallocation of integer, double, character arrays |
Mmod_get_discrete_derivative | Discrete derivatives dictionnary |
Mmod_global_max | Generic max routine for integer or double (maximum between different values given on each processor) |
Mmod_global_max_array | Generic maxval routine for an array of integer or double (maxval between different arrays given on each processor) |
Mmod_global_min | Generic min routine for integer or double scalar (minimum value between different values given on each processor) |
Mmod_global_min_array | Generic minval routine for an array of integer or double (minval between different arrays given on each processor) |
Mmod_global_reduction | Global reduction functions |
Mmod_global_sum | Sums a scalar across processes in place |
Mmod_gradient_operator_cell_to_cell | Gradient operator from cells to cells |
Mmod_gradient_operator_cell_to_face | Gradient operator from cells to faces |
Mmod_gradient_operator_cell_to_face_vector | Gradient operator from cells to each face (full gradient on each face) |
►Mmod_grid_interpolation_common | Common interfaces, subroutines and functions that can be used in interpolation schemes |
Cinterface_func_integer | A pure function that returns an integer |
Mmod_grid_interpolation_init | Initialization of declared extrapolation chemes |
Mmod_grid_physical_points | Functions to manage physical points in/out the mesh |
Mmod_harmonic_interpolation | 1D and 2D harmonic interpolation |
Mmod_hessian_operator_cell_to_cell | Hessian operator from cells to cells |
►Mmod_immersed_boundary_analysis | Preparation routine building blocks for immersed boundaries |
Canalyze_ib | Analyse immersed boundaries |
Mmod_immersed_boundary_condition_tools | Tools to manipulate immersed boundaries variables |
Mmod_immersed_boundary_surface_integrals | Tools to compute surface integrals |
Mmod_initialize_immersed_subdomain | Immersed Boundaries Initializers |
Mmod_int_dscheme_o1 | Derivative interpolation scheme at order 1 The scheme is defined in the interval [0:+1] |
Mmod_int_dscheme_o2 | Derivative interpolation scheme at order 2 The scheme is defined in the interval [-1:+1] |
Mmod_int_dscheme_o3 | Derivative interpolation scheme at order 3 The scheme is defined in the interval [-1:+2] |
Mmod_int_fast_scheme_o2_centered | Reconstruction Schemes with houc at order 3 (at the fixed +1/2 position). This scheme is compatible with non uniform grids |
Mmod_int_fast_scheme_o4_centered | Reconstruction Schemes with houc at order 3 (at the fixed +1/2 position). This scheme is compatible with non uniform grids |
►Mmod_int_point_fast_lagrange_o2 | The fourth order Lagrange interpolation |
Ct_int_point_fast_lagrange_o2_1d | The 1D type |
Ct_int_point_fast_lagrange_o2_2d | The 2D type |
Ct_int_point_fast_lagrange_o2_3d | The 3D type |
►Mmod_int_point_fast_lagrange_o4 | The fourth order Lagrange interpolation |
Ct_int_point_fast_lagrange_o4_1d | The 1D type |
Ct_int_point_fast_lagrange_o4_2d | The 2D type |
Ct_int_point_fast_lagrange_o4_3d | The 3D type |
►Mmod_int_point_fast_lagrange_o6 | The fourth order Lagrange interpolation |
Ct_int_point_fast_lagrange_o6_1d | The 1D type |
Ct_int_point_fast_lagrange_o6_2d | The 2D type |
Ct_int_point_fast_lagrange_o6_3d | The 3D type |
►Mmod_int_point_lagrange_o2 | The second order Lagrange interpolation |
Ct_int_point_lagrange_o2_1d | The 1D type |
Ct_int_point_lagrange_o2_2d | The 2D type |
Ct_int_point_lagrange_o2_3d | The 3D type |
►Mmod_int_point_lagrange_o3 | The third order Lagrange interpolation |
Ct_int_point_lagrange_o3_1d | The 1D type |
Ct_int_point_lagrange_o3_2d | The 2D type |
Ct_int_point_lagrange_o3_3d | The 3D type |
►Mmod_int_point_lagrange_o4 | The fourth order Lagrange interpolation |
Ct_int_point_lagrange_o4_1d | The 1D type |
Ct_int_point_lagrange_o4_2d | The 2D type |
Ct_int_point_lagrange_o4_3d | The 3D type |
►Mmod_int_point_lagrange_o5 | The fifth order Lagrange interpolation |
Ct_int_point_lagrange_o5_1d | The 1D type |
Ct_int_point_lagrange_o5_2d | The 2D type |
Ct_int_point_lagrange_o5_3d | The 3D type |
►Mmod_int_point_lagrange_o6 | The fourth order Lagrange interpolation |
Ct_int_point_lagrange_o6_1d | The 1D type |
Ct_int_point_lagrange_o6_2d | The 2D type |
Ct_int_point_lagrange_o6_3d | The 3D type |
►Mmod_int_point_lambda_2_1 | The \(\Lambda_{2,1}\) interpolation kernel |
Ct_int_point_lambda_2_1_1d | The 1D type |
Ct_int_point_lambda_2_1_2d | The 2D type |
Ct_int_point_lambda_2_1_3d | The 3D type |
►Mmod_int_point_lambda_2_2 | The \(\Lambda_{2,2}\) interpolation kernel |
Ct_int_point_lambda_2_2_1d | The 1D type |
Ct_int_point_lambda_2_2_2d | The 2D type |
Ct_int_point_lambda_2_2_3d | The 3D type |
►Mmod_int_point_lambda_4_2 | The \(\Lambda_{4,2}\) interpolation kernel |
Ct_int_point_lambda_4_2_1d | The 1D type |
Ct_int_point_lambda_4_2_2d | The 2D type |
Ct_int_point_lambda_4_2_3d | The 3D type |
►Mmod_int_point_peskin_o4 | The Peskin interpolation//smoothing kernel with 4 points |
Ct_int_point_peskin_o4_1d | The 1D type |
Ct_int_point_peskin_o4_2d | The 2D type |
Ct_int_point_peskin_o4_3d | The 3D type |
Mmod_int_scheme_o1 | Interpolation Schemes at order 1 The scheme is defined in the interval [0:0] |
Mmod_int_scheme_o2 | Interpolation Schemes at order 2 The scheme is defined in the interval [0:+1] |
Mmod_int_scheme_o3 | Interpolation Schemes at order 3 The scheme is defined in the interval [-1:+1] |
Mmod_int_scheme_o4 | Interpolation Schemes at order 4 The scheme is defined in the interval [-1:+2] |
Mmod_int_scheme_o5 | Interpolation Schemes at order 5 The scheme is defined in the interval [-2:+2] |
►Mmod_integrate_cell_advection_term_explicit_generic | Integration methods for the advection equation |
Cdivut_term_computer_interface | The abstract function for computing div(U phi) |
Cdivut_term_computer_interface_fd | The abstract function for computing div(U phi) for the FD WENO schemes |
►Mmod_integrate_face_advection_term_explicit_generic | Explicit inertial (or face advection) term with a generic (given) scheme |
Cdivupsi_term_computer_split_interface | The abstract function for computing \( div(\rho U \cdot U) \) (possibly split) |
Mmod_integrate_face_advection_term_explicit_generic_split | Explicit inertial (or face advection) term with a generic (given) scheme, with direction split |
Mmod_integration_computer | Computer for evaluating Integration Schemes |
Mmod_integration_init | Integration schemes initialization |
Mmod_interpolate_face_to_edge | Interpolate scalar from faces to edges |
Mmod_interpolate_face_to_face | Interpolate vector components from faces to faces |
Mmod_interpolate_field_time | Interpolate between fields. As most of interpolationg of fields are done in time, the module has been explicitely named with "time" |
Mmod_interpolate_scalar_cell_to_face | Interpolate scalar from cells to faces |
Mmod_interpolate_scalar_cell_to_vertices | Interpolate scalar from cells to vertices |
Mmod_interpolate_scalar_face_to_cell | Interpolate scalar from faces to cells |
Mmod_interpolate_vector_cell_to_face | Interpolate a vector field from cells to faces |
Mmod_interpolate_vector_face_to_cell | Interpolate vector field from faces to cells |
Mmod_interpolation_computer | Computer for evaluating Interpolation Schemes |
Mmod_interpolation_init | Initialization of declared interpolation schemes |
Mmod_interpolation_polynomial | Polynomial functions |
Mmod_interpolation_weno_dscheme_o2z_reconstruction | Interpolation WENO Reconstruction Derivativ Schemes at order 2 |
Mmod_interpolation_weno_dscheme_o4z | Derivative interpolation WENO Schemes at order 4 |
Mmod_interpolation_weno_dscheme_o5 | Interpolation WENO Derivative Schemes at order 5 |
Mmod_interpolation_weno_fast_scheme_o3z_reconstruction | Interpolation WENO Reconstruction Schemes at order 3 at the fixed position. This scheme is compatible with non uniform grids |
Mmod_interpolation_weno_fast_scheme_o5z_reconstruction | Interpolation WENO Reconstruction Schemes at order 5 at the fixed position. This scheme is compatible with non uniform grids |
Mmod_interpolation_weno_scheme_o3 | Interpolation WENO Schemes at order 3 |
Mmod_interpolation_weno_scheme_o3_reconstruction | Interpolation WENO Reconstruction Schemes at order 3 |
Mmod_interpolation_weno_scheme_o3z | Interpolation WENO Schemes at order 3 |
Mmod_interpolation_weno_scheme_o3z_reconstruction | Interpolation WENO Reconstruction Schemes at order 3 |
Mmod_interpolation_weno_scheme_o4_interpolation | Interpolation WENO interpolation Centered Schemes at order 4 |
Mmod_interpolation_weno_scheme_o4_reconstruction | Interpolation WENO Reconstruction Centered Schemes at order 4 |
Mmod_interpolation_weno_scheme_o5z | Interpolation WENO Schemes at order 5 |
Mmod_interpolation_weno_scheme_o5z_reconstruction | Interpolation WENO Reconstruction Schemes at order 5 |
Mmod_interpolation_weno_scheme_o6_reconstruction | Interpolation WENO Reconstruction Centered Schemes at order 4 |
►Mmod_interpolation_weno_schemes_o4_interpolation | Interpolation WENO Scheme at order 4,* |
Ct_int_point_weno_4_2_1d | WENO 4,2 scheme |
Ct_int_point_weno_4_2_2d | The 2D type |
Ct_int_point_weno_4_2_3d | The 3D type |
Ct_int_point_weno_4_2l_1d | WENO 4,2 scheme with level set SI |
Ct_int_point_weno_4_2p_1d | WENO 4,2 scheme with empty middle stencil |
Ct_int_point_weno_4_3_1d | The 1D type |
Ct_int_point_weno_4_3_2d | The 2D type |
Ct_int_point_weno_4_3_3d | The 3D type |
►Mmod_interpolation_weno_schemes_o6_interpolation | Interpolation WENO Scheme at order 6,* |
Ct_int_point_weno_6_3_1d | WENO 6 scheme with 4 stencils of 3 points |
Ct_int_point_weno_6_3_l_1d | WENO 6 scheme with 4 stencils of 3 points with LS smoothness_indicator |
Ct_int_point_weno_6_4_1d | WENO 6 scheme with 3 stencils of 4 points |
Ct_int_point_weno_6_5_1d | WENO 6 scheme with 2 stencils of 5 points |
Mmod_interpolation_weno_smoothness_indicator | Interpolation WENO Smoothness indicator computation |
Mmod_laplacian_operator_cell_to_cell | Laplacian operator from cells to cells |
Mmod_linearized_enthalpy_functions | Temperature-Enthalpy functions for the Linearized Enthalpy method |
Mmod_lsm_advect | Contains a wrapper for the various advection schemes for the Level Set representation |
Mmod_lsm_advect_eulerian | Contains a wrapper for the various advection schemes for the Level Set standard representation |
Mmod_lsm_advect_eulerian_euler | The Level Set advection module |
Mmod_lsm_compute_closest_points | Level set / Closest point wrappers |
Mmod_lsm_compute_ugradphi | Computation of the advection term |
Mmod_lsm_compute_ugradphi_conservative | Computation of the advection with a conservative approach |
Mmod_lsm_cp_diagnostics | Diagnostics for Closest Points |
Mmod_lsm_geometry_dirac | Dirac mass approximation |
Mmod_lsm_masscons_global | Mass conservation: global approach |
Mmod_lsm_normal | Normal computation |
Mmod_lsm_reinitialization_cp | Reinitialization method using the CP algorithm |
Mmod_lsm_reinitialization_hcr2 | Reinitialization method using the HCR2 algorithm |
Mmod_lsm_reinitialization_hj | Reinitialization method using the classic HJ algorithm |
Mmod_lsm_reinitialization_hj_first_order | Reinitialization method using the classic HJ algorithm |
Mmod_lsm_reinitialization_tools | Reinitialization common tools for algorithms |
Mmod_lsm_solve_mean_curvature_flow | Solve the mean curvature flow for LS |
Mmod_lsm_volume_fraction | Wrappers for volume fraction computation |
Mmod_lsm_volume_fraction_bc | Compute the volume fraction boundary conditions corresponding to the level set's bc |
Mmod_material_properties_boundary_conditions | Boundary conditions related routines for materials |
Mmod_math_algebra | Algebraic Functions |
Mmod_math_linalg | Linear algebra functions |
Mmod_memory_manager | Module containing all the memory manager routines |
Mmod_momentum_boundary_conditions | Boundary conditions related routines for momentum |
Mmod_mpi_broadcast_bc | MPI broadcast cell/face boundary conditions |
►Mmod_mpi_exchange | MPI Exchange modules between processors |
Cmpi_exchange | Exchange field |
Mmod_mpi_grid_info | Print grid and partitioning informatio, and some partitioning statistics |
Mmod_mpi_localization | Localization of the processor as regards physical boundaries |
Mmod_mpi_repartitioning | Manage the partitioning of the domain |
Mmod_mpi_send_receive | Send/receive an array from a MPI process to another Generic send/receive routines of an array from a MPI process to another. They encapsulate MPI call for sake of simplicity |
Mmod_multiphase_compute_contact_line_points | Compute |
Mmod_multiphase_front_tracking_advect_phase | Contains a wrapper for the various advection schemes for the Level Set representation |
Mmod_multiphase_front_tracking_compute_clp | Contains the wrapper the contact line point computation |
Mmod_multiphase_front_tracking_compute_curvature | Procedures to compute the curvature based on a FT representation |
Mmod_multiphase_front_tracking_frontier | Contains the wrappers for the FronTier library interface |
Mmod_navier_predict_density | Predict the density at the next time step |
Mmod_node_level_schemes_init | Initialization of declared node level schemes |
Mmod_notus_c_interface_interpolation | Contains the wrappers for interpolations This part of the interface can be used to furnish quick (wrapped) interpolation functions to a front tracking library |
Mmod_point_interpolation_coordinates | Functions to manipulate the coordinates |
►Mmod_point_interpolation_exec | Point interpolation execution module |
Cinterpolation_exec | Interpolate or differenciate |
►Mmod_point_interpolation_field | Point interpolation field module |
Cinterpolate_field | Interpolate various type of fields |
Creconstruct_field | Reconstruct various type of fields |
Mmod_point_interpolation_init | Initialization of declared extrapolation chemes |
Mmod_point_interpolation_prepare | Point interpolation preparation module |
►Mmod_point_interpolation_type | Point interpolation type |
Cinterpolation_init | Generic function for interpolation initialization |
Ct_interpolation_data | Store interpolation data |
Mmod_prepare_cut_cell | Cut cell routines |
Mmod_prepare_immersed_boundary_condition | Immersed Boundaries variable initializers |
Mmod_prepare_mpi_exchange | Prepare mpi_exchange |
Mmod_prepare_mpi_exchange_list | MPI Exchange preparation for communication of node-list-like arrays |
Mmod_random_number_tools | Random number tools |
Mmod_reallocate | Generic routines to reallocate arrays |
►Mmod_rec_d_point_lagrange_o1 | The first order Lagrange reconstruction's derivative |
Ct_rec_d_point_lagrange_o1_1d | The 1D type |
Ct_rec_d_point_lagrange_o1_2d | The 2D type |
Ct_rec_d_point_lagrange_o1_3d | The 3D type |
►Mmod_rec_d_point_lagrange_o2 | The second order Lagrange reconstruction's derivative |
Ct_rec_d_point_lagrange_o2_1d | The 1D type |
Ct_rec_d_point_lagrange_o2_2d | The 2D type |
Ct_rec_d_point_lagrange_o2_3d | The 3D type |
►Mmod_rec_d_point_lagrange_o3 | The third order Lagrange reconstruction's derivative |
Ct_rec_d_point_lagrange_o3_1d | The 1D type |
Ct_rec_d_point_lagrange_o3_2d | The 2D type |
Ct_rec_d_point_lagrange_o3_3d | The 3D type |
Mmod_rec_fast_scheme_houc3 | Reconstruction Schemes with houc at order 3 (at the fixed +1/2 position). This scheme is compatible with non uniform grids |
Mmod_rec_fast_scheme_houc5 | Reconstruction Schemes with houc at order 3 (at the fixed +1/2 position). This scheme is compatible with non uniform grids |
Mmod_rec_fast_scheme_o1_upwind | Reconstruction Schemes with upwind scheme at order 1 (at the fixed +1/2 position). This scheme is compatible with non uniform grids |
Mmod_rec_fast_scheme_o2_upwind | Reconstruction Schemes with upwind scheme at order 2 (at the fixed +1/2 position). This scheme is compatible with non uniform grids |
Mmod_rec_fast_scheme_o3d1_centered | Reconstruction Scheme: first derivative with a centered scheme at order 3 (at the fixed +1/2 position). This scheme is compatible with non uniform grids. This scheme is fourth order with a uniform grid |
Mmod_rec_fast_scheme_o4_centered | Reconstruction Schemes with a centered scheme at order 4 (at the fixed +1/2 position). This scheme is compatible with non uniform grids |
►Mmod_rec_point_lagrange_o3 | The third order Lagrange reconstruction |
Ct_rec_point_lagrange_o3_1d | The 1D type |
Ct_rec_point_lagrange_o3_2d | The 2D type |
Ct_rec_point_lagrange_o3_3d | The 3D type |
►Mmod_rec_point_lagrange_o4 | The fourth order Lagrange reconstruction |
Ct_rec_point_lagrange_o4_1d | The 1D type |
Ct_rec_point_lagrange_o4_2d | The 2D type |
Ct_rec_point_lagrange_o4_3d | The 3D type |
Mmod_rec_scheme_o1 | Reconstruction Schemes at order 1 The scheme is defined in the interval [0:0] |
Mmod_rec_scheme_o2 | Reconstruction Schemes at order 2 The scheme is defined in the interval [0:+1] |
Mmod_rec_scheme_o3 | Reconstruction Schemes at order 3 The scheme is defined in the interval [-1:+1] |
Mmod_rec_scheme_o4 | Reconstruction Schemes at order 4 The scheme is defined in the interval [-1:+2] |
Mmod_rec_scheme_o5 | Reconstruction Schemes at order 4 The scheme is defined in the interval [-1:+2] |
Mmod_rec_scheme_o6 | Reconstruction Schemes at order 4 The scheme is defined in the interval [-1:+2] |
Mmod_refined_grid_initialization | Functions to create grids Set a grid from parameters and create regular and refined (2^n) grids |
Mmod_scalar_advection_tvd_superbee | Explicit dimensional splitting Lax-Wendroff TVD SuperBee (LW-TVD-SB) scheme for the advection equation |
Mmod_set_grad_div_coef | User coefficient of Grad Div term of Navier-Stokes equations |
Mmod_set_ib_mask | Tools to manipulate immersed boundaries |
Mmod_setup_cell_ibm_saved_variables | Interface to prepare immersed boundary variables |
Mmod_solve_cell_allencahn_equation | Solve the Allen-Cahn equation (experimental module, not followed anymore) |
Mmod_solve_pressure | This module solves the correction step of the pressure correction method |
Mmod_synthetic_eddy_method | Synthetic Eddy Methods |
Mmod_tc_probe_fields | Probe fields for test cases |
Mmod_temperature_enthalpy_functions | Temperature-Enthalpy functions for the Apparent Heat Capacity method |
Mmod_turbulent_conductivity | Compute turbulent viscosity |
Mmod_update_variable_ib_b_ghost | Update fields on boundary and immersed boundary ghost cells |
Mmod_user_boundary_conditions | User boundary conditions |
Mmod_user_implicit_discretization_schemes | User schemes for the implicit discretization of the different terms of the cell scalar or face vector equations |
Mmod_user_initial_conditions | User initial conditions |
Mmod_user_linear_term | User linear terms |
Mmod_user_navier_grad_div_coef | User coefficient of Grad Div term of Navier-Stokes equations |
Mmod_user_prepare_energy | User energy equation preparation subroutine |
Mmod_user_prepare_navier | User Navier-Stokes equations preparation subroutine |
Mmod_user_prepare_phase_advection | User phase advection equations preparation subroutine |
Mmod_user_prepare_species_transport | User species transport equations preparation subroutine |
Mmod_user_pressure_update | User pressure update |
Mmod_user_solve_equations | Solve user equations. Called once per time iteration |
Mmod_user_source_term | User source terms |
Mmod_write_time | Write Time in a .vtk file |
Mtype_contact_line_point | The type for a contact line point To ease its use, it's always 3D |
►Mtype_cut_cell | Data types for cut cell |
Ct_cut_cell | Information to cut cells |
Ct_face_cut_cell | Gather metric-related information to immersed boundaries at face nodes |
Mtype_dd_matrix | Discrete derivatives Matrix |
►Mtype_dd_vector | Discrete derivatives vector |
Ct_discrete_derivative_vector | The discrete derivative vector type |
►Mtype_discrete_derivative | Discrete derivative type |
Ct_discrete_derivative | The discrete derivative type |
►Mtype_discrete_derivative_dictionnary | Discrete derivatives dictionnary |
Ct_dd_dict_steps | The discrete derivative dictionnary over steps It is a leaf and is made of an array of t_discrete_derivatives |
►Mtype_discrete_stencil | The Finite Difference Scheme type definition |
Ct_stencil_1d | The 1D stencil type |
Ct_stencil_2d | The 2D stencil type |
Ct_stencil_3d | The 3D stencil type |
Mtype_edge_field | Declaration of a type (and associated routines) for double precision variable defined on edges |
►Mtype_ext_neumann_scheme | Extrapolation Neumann Schemes type |
Ct_ext_neumann_scheme | The Neumann extrapolation scheme Those schemes simply derivate from the fd_scheme, as they are basicaly a simple alias to fd_schemes |
►Mtype_ext_scheme | Extrapolation Schemes type |
Ct_ext_scheme | The extrapolation scheme It simply derivates from the fd_scheme |
Mtype_face_field | Declaration of a type (and associated routines) for double precision variable defined on faces |
►Mtype_face_ls_map | Type decalaration associated to the mapping of a face vector linear system on the numerical grid |
Ct_face_ls_map | Face-based, vector field grid mapping for linear systems |
Ct_face_ls_map_component | Face-based, scalar field grid mapping for linear system |
Mtype_face_vector_gradient | Declaration of a type for double precision gradient of a face_field vector |
►Mtype_fd_scheme | The Finite Difference Scheme type definition |
Ct_fd_scheme | The Finite Difference type |
►Mtype_fd_weno_scheme | The Finite Difference Weno Scheme type definition |
Ct_fd_weno_scheme | The Finite Difference Weno type |
►Mtype_fv_flux | The Finite Volume flux type |
Cfv_flux_func | The abstract function for a numerical flux |
Cfv_flux_limiter_func | The abstract function for a flux limiter |
Ct_fv_flux | The Finite Volume flux type |
►Mtype_immersed_boundary_condition | Data types for immersed boundaries |
Ct_face_immersed_boundary_condition | Store ibc-related variable data |
Ct_immersed_boundary_condition | Field-related information to immersed boundary |
►Mtype_immersed_boundary_metrics | Immersed boundary metrics derived types |
Ct_face_immersed_boundary_metrics | Gather metric-related information to immersed boundaries at face nodes |
Ct_immersed_boundary_metrics | Metric-related information to immersed boundaries |
►Mtype_int_dscheme | Grid nodes Derivative Interpolation Schemes type |
Ct_int_dscheme | The derivative interpolation scheme to derivate from It simply derivates from the int_scheme and specialize the "compute stencil" function |
Mtype_int_fast_scheme | The fast Interpolation/Reconstruction scheme type definition. The efficiency is based on: |
►Mtype_int_grid_preweights | The precomputed weights type definition for fast interpolation schemes |
Ct_int_grid_preweights | The precomputed weights type associated to a positioned scheme |
Ct_int_grid_preweights_array_3d | The assembly of precomputed weights over a (x,y,z) grid |
►Mtype_int_point_1d | The type for generic 1D point interpolation that has to be derived |
Cint_point_1d_init | Abstract interfaces |
►Mtype_int_point_2d | The type for generic 2D point interpolation that has to be derived |
Cint_point_2d_init | Abstract interfaces |
►Mtype_int_point_3d | The type for generic 3D point interpolation that has to be derived |
Cint_point_3d_init | Abstract interfaces |
►Mtype_int_point_fast_2d | The type for generic 2D point interpolation that has to be derived |
Cint_point_fast_2d_init | Abstract interfaces |
►Mtype_int_point_fast_3d | The type for generic 3D point interpolation that has to be derived |
Cint_point_fast_3d_init | Abstract interfaces |
Mtype_int_point_fast_lagrange_1d | The type for generic 1D point Lagrange interpolation |
Mtype_int_point_lagrange_1d | The type for generic 1D point Lagrange interpolation |
►Mtype_int_point_weno_1d | The type for generic point WENO interpolation (1D) that has to be derived |
Cint_point_weno_1d_compute_coefficients | Abstract interfaces |
Mtype_int_point_weno_2d | The type for generic point WENO interpolation (2D) that has to be derived |
Mtype_int_point_weno_3d | The type for generic point WENO interpolation (3D) that has to be derived |
►Mtype_int_scheme | Grid nodes Interpolation Schemes type The difference with the t_int_point_1D resides in that the scheme is defined in a narrowed band between index_start and index_end . The stencil is centered around the index 0 , the step is relative to this node |
Ct_int_scheme | The interpolation scheme to derivate from It simply derivates from the fd_scheme |
Mtype_int_weno_fast_scheme | The fast Interpolation/Reconstruction WENO scheme type definition. The efficiency is based on: |
►Mtype_int_weno_grid_preweights | The precomputed weights type definition for fast WENO schemes |
Ct_int_weno_grid_preweights | The precomputed weights type associated to a positioned scheme |
Ct_int_weno_grid_preweights_array_3d | The assembly of precomputed weights over a (x,y,z) grid |
►Mtype_int_weno_scheme | The Interpolation/Reconstruction WENO Scheme type definition This definition of the WENO Scheme is based on a Finite Volume principle, and is thus a reconstuction, where the mean value of the data is known for a cell, contrary to interpolation based on node values. The difference is subtle and only happens in the associated weights |
Ct_int_weno_scheme | The WENO Interpolation type |
Mtype_integ_1d_scheme_gl | Integration Scheme: 1d Gauss |
Mtype_integ_1d_scheme_mp | Integration Scheme: 1D MidPoint |
Mtype_integ_1d_scheme_simpson | Integration Scheme: 1D Simpson |
Mtype_integ_2d_scheme_gl | Integration Scheme: 1d Gauss |
►Mtype_integ_scheme | Integration Schemes type |
Ct_integ_scheme | For simplicity, accordingly to most of the litterature, An integration scheme is defined between -1 and +1 Each scheme has a set of weights and associated positions |
Mtype_levelset | The level set type |
Mtype_levelset_cp_parameters | Level set CP parameters as a structureAlso define default values |
Mtype_levelset_parameters | Level set parameters as a structureAlso define default values |
►Mtype_levelset_reinit_cp_parameters | Level set CP parameters as a structureAlso define default values |
Ct_levelset_reinit_cp_parameters | The LS RCP parameters |
►Mtype_levelset_reinit_parameters | Level set reinitialization parameters as a structureAlso define default values |
Ct_levelset_reinit_parameters | The LS reinitialization parameters |
►Mtype_ls_map | Type declaration associated to the numerical grid mapping of a cell linear system |
Ct_ijk_triplet | Triplet of integers |
Ct_ls_map | Cell-based, scalar field grid mapping for linear systems |
►Mtype_mpi_exchange | Data types for MPI Exchange communications |
Ct_mpi_exchange | MPI Exchange data for 3D arrays |
Ct_mpi_exchange_base | Common MPI exchange datatype for any communication |
Ct_mpi_exchange_list | MPI Exchange data for node-list-shaped data |
►Mtype_nfi_contact_line_point | Contains NFI contact line point type |
Cnfi_contact_line_point | Local structure that may be passed to the nfi see type(t_contact_line_point) in type_contact_line_point |
►Mtype_node_list | Node subset stored in 1D arrays |
Ct_node_list | Pack a subset of node indexes |
Ct_point_list | Store point coordinates |
►Mtype_node_type | Node type handy tools |
Ct_node_type | Node type |
►Mtype_particle | The particle type |
Ct_particle | The generic particle tracer |
►Mtype_particle_list | The particle list type |
Ct_particle_list | The generic particle list |
►Mtype_phase_geometry | Definition of the type t_phase_geometry |
Ct_phase_geometry | This type contains information relative to the interface/phase geometry |
Mtype_rec_fast_scheme | The fast Reconstruction scheme type definition |
►Mtype_rec_point_2d | The type for generic 2D point reconstruction that has to be derived |
Ct_rec_point_2d | This is only used for strong typing |
►Mtype_rec_point_3d | The type for generic 3D point reconstruction that has to be derived |
Ct_rec_point_3d | This is only used for strong typing |
Mtype_rec_point_lagrange_1d | The type for generic 1D point reconstruction that has to be derived |
►Mtype_rec_scheme | Grid nodes Reconstruction Schemes type The difference with the t_int_point_1D resides in that the scheme is defined in a narrowed band between index_start and index_end . The stencil is centered around the index 0 , the step is relative to this node |
Ct_rec_scheme | The reconstruction scheme type to derivate from It simply derivates from the t_int_scheme |
►Mtype_solver_hypre | Type definition for all HYPRE's solvers |
Chypre_solver_precheck | Check is everything is well configured for Hypre |
Ct_hypre_precond_parcsr | Parent type for all ParCSR preconditioners |
Ct_hypre_precond_parcsr_boomeramg | ParCSR BoomerAMG precond |
Ct_hypre_precond_parcsr_euclid | ParCSR Euclid precond |
Ct_hypre_precond_parcsr_parasails | ParCSR ParaSails precond |
Ct_hypre_precond_parcsr_pilut | ParCSR Pilut precond |
Ct_hypre_precond_sstruct | Parent type for all SStruct preconditioners |
Ct_hypre_precond_sstruct_interface | Hypre preconditioners that follows the SStruct interface |
Ct_hypre_precond_sstruct_syspfmg | SStruct SysPFMG precond |
Ct_hypre_precond_struct | Parent type for all Struct preconditioners |
Ct_hypre_precond_struct_interface | Hypre preconditioners that follows the Struct interface |
Ct_hypre_precond_struct_jacobi | Struct Jacobi precond |
Ct_hypre_precond_struct_pfmg | Struct PFMG precond |
Ct_hypre_precond_struct_smg | Struct SMG precond |
Ct_hypre_preconditioner | Parent type for all Hypre preconditioners |
Ct_hypre_solver | Parent type for all Hypre solvers |
Ct_hypre_solver_interface | Parent type for all Hypre solvers and preconditioners |
Ct_hypre_solver_parcsr | Parent type for all ParCSR solvers |
Ct_hypre_solver_parcsr_bicgstab | ParCSR BiCGSTAB solver |
Ct_hypre_solver_parcsr_boomeramg | ParCSR BoomerAMG solver |
Ct_hypre_solver_parcsr_gmres | ParCSR GMRES solver |
Ct_hypre_solver_sstruct | Parent type for all SStruct solvers |
Ct_hypre_solver_sstruct_bicgstab | SStruct BiCGSTAB solver |
Ct_hypre_solver_sstruct_gmres | SStruct GMRES solver |
Ct_hypre_solver_sstruct_interface | Hypre solvers that follows the SStruct interface |
Ct_hypre_solver_sstruct_syspfmg | SStruct SysPFMG solver |
Ct_hypre_solver_struct | Parent type for all Struct solvers |
Ct_hypre_solver_struct_bicgstab | Struct BiCGSTAB solver |
Ct_hypre_solver_struct_gmres | Struct GMRES solver |
Ct_hypre_solver_struct_interface | Dummy type to indicate: "unpreconditionned" |
Ct_hypre_solver_struct_jacobi | Struct Jacobi solver |
Ct_hypre_solver_struct_pcg | Struct PCG solver |
Ct_hypre_solver_struct_pfmg | Struct PFMG solver |
Ct_hypre_solver_struct_smg | Struct SMG solver |
►Mtype_solver_lis | Type definition for all LIS solvers |
Ct_lis_preconditioner | Parent type for all Lis preconditioners |
Ct_lis_preconditioner_iluc | Lis ILUC preconditioner |
Ct_lis_preconditioner_iluk | Lis ILU(k) preconditioner |
Ct_lis_preconditioner_ilut | Lis ILUT preconditioner |
Ct_lis_solver | Parent type for all Lis solvers |
Ct_lis_solver_bicgsafe | Lis BiCGSAFE |
Ct_lis_solver_bicgstab | Lis BiCGSTAB |
Ct_lis_solver_bicgstab_l | Lis BiCGSTAB(l) |
Ct_lis_solver_bicrsafe | Lis BiCRSAFE |
Ct_lis_solver_bicrstab | Lis BiCRSTAB |
Ct_lis_solver_fgmres | Lis FGMRES |
Ct_lis_solver_gmres | Lis GMRES |
►Mtype_solver_mumps | Type definition for MUMPS solver |
Ct_mumps_solver | MUMPS solvers |
►Mtype_stencil | Enumeration modules associated to implicit discretization of PDE Declaration of types associated to different discretization stencils |
Ct_base_stencil | Stencil |
Ct_cell_stencil | Stencil for cell-based schemes |
Ct_face_stencil | Stencil for face-based schemes |
Ct_serialized_stencil | Container for the serialized stencil |
Ct_stencil_type | Stencil type |
Mtype_stress_tensor | Declaration of a type associated to the stress tensor |
►Mtype_subdomain | Description of a subdomain |
Ct_subdomain_geometry | Definition of the geometry of a subdomain |
Mut_check_schemes_second | Routines to check second derivatives |
Mut_ext_computer | Routines to compute the discrete approximations |
Mut_fd_computer | Routines to compute the discrete approximations |
Mut_int_computer | Routines to compute the discrete approximations |
Mut_integ_computer | Routines to compute the discrete approximations |
Mut_solution_tools | Tools to play with solutions |
Mut_solutions | Solution examples |
Mvariables_adios | Variables used for ADIOS output |
Mvariables_all_equations | Declaration of a variable module that encapsulates variable modules of each equation |
Mvariables_cell_coordinate | Cell node coordinates |
Mvariables_cell_spatial_steps | Cell spatial steps |
Mvariables_checkpoint_restart | Declaration variables associated to checkpoint/restart |
Mvariables_coordinates | Cell and face node coordinates |
Mvariables_core | Define variables of the core library |
Mvariables_cpu_time | Variables for CPU time measurement in different part of the code |
Mvariables_debugging_io | Variables to enable debugging I/O |
Mvariables_diagnostic_quantities | Diagnostic quantity switches |
Mvariables_domain | Variables describing the global domain |
Mvariables_energy | Declaration of scalar variables associated to the Energy equation |
Mvariables_explicit_weno_fd | Compile-time settings for immersed boundaries |
Mvariables_face_coordinate | Face node coordinates |
Mvariables_face_spatial_steps | Face spatial steps |
Mvariables_front_tracking | Module containing the parameters of the Front tracking method |
Mvariables_grid_cell | Cell nodes description variables |
Mvariables_grid_convergence | Declaration of variables useful to grid convergence tools |
Mvariables_grid_face | Face nodes description variables |
Mvariables_immersed_boundary_condition | Compile-time settings for immersed boundaries |
Mvariables_levelset | Variables associated to the level set representationMainly default values for LS parameters |
Mvariables_levelset_cp | Variables associated to the level set representationMainly default values for LS parameters |
Mvariables_material_properties | Declaration of local properties of the materials involved in the simulation (density, conductivity, viscosity, etc.) |
Mvariables_math | Declaration of math variables |
Mvariables_modeling | Declaration of variables relative to the equations and models used |
Mvariables_mof | Module containing the parameters of the Moment-of-Fluid method |
Mvariables_mpi | Variables associated with domain partitioning context |
Mvariables_mpi_exchange | Define variables associated to MPI communications on cells and faces |
Mvariables_multiphase | Module containing the list of the various phase representations |
Mvariables_navier | Define variables (time step, schemes, solvers, etc.) associated to the Navier-Stokes equations |
Mvariables_omp | Variables associated to OpenMP |
Mvariables_omp_lib | OpenMP library module |
Mvariables_output | Define variables associated to outputs |
Mvariables_particles | The particle fields |
Mvariables_phase_advection | Declaration of the variables associated to the phase advection equations |
Mvariables_probes | Define variables associated to probes |
Mvariables_random_number | Random number variables |
►Mvariables_reference_solution | Define the variables associated to the reference solutions |
Ct_reference_solution_species_initializer_set | Derived type to store individually the species concentration |
Mvariables_spatial_steps | Cell and face spatial steps |
Mvariables_species_transport | Declaration of scalar variables associated to species transport equations |
Mvariables_statistics | Defines variables associated to the statistics of instantaneous fields |
Mvariables_synthetic_eddy_method | Synthetic Eddy Method variables definition |
Mvariables_test_case | Define variables associated to test cases setup |
Mvariables_time_discretization | Declaration of variables associated to the time discretization |
Mvariables_turbulence | Define variables associated to the turbulence models |
Mvariables_turbulence_les | Define variables associated to the Large Eddy Simulation models |
Mvariables_turbulence_rans | Define variables associated to the turbulence models |
Mvariables_validation | Define variables associated to verification and validation |
Mvariables_vof_plic | Module containing the parameters of the Moment-of-Fluid method |
Mvariables_volume | Computation of volume |
Mvariables_weno_scheme | Interpolation WENO Reconstruction Schemes at order 3 |