Procedures

ProcedureLocationProcedure TypeDescription
f_bpres_dotm_bubblesFunction

Function that computes the time derivative of the internal bubble pressure @param fvflux Vapour flux @param fR Current bubble radius @param fV Current bubble velocity @param fpb Current internal bubble pressure @param fmass_v Current mass of vapour @param iR0 Bubble size index

f_cgasm_bubblesFunction

Function that computes the sound speed for the bubble @param fCpinf Driving bubble pressure @param fntait Tait EOS parameter @param fBtait Tait EOS parameter @param fH Bubble enthalpy

f_cpbwm_bubblesFunction

Function that computes that bubble wall pressure for Gilmore bubbles

f_cpbw_KMm_bubblesFunction

Function that computes the bubble wall pressure for Keller--Miksis bubbles @param fR0 Equilibrium bubble radius @param fR Current bubble radius @param fV Current bubble velocity @param fpb Internal bubble pressure

f_cpinfdotm_bubblesFunction

Function that computes the time derivative of the driving pressure @param fRho Local liquid density @param fP Local pressure @param falf Local void fraction @param fntait Tait EOS parameter @param fBtait Tait EOS parameter @param advsrc Advection equation source term @param divu Divergence of velocity

f_Hm_bubblesFunction

Function that computes the bubble enthalpy @param fCpbw Bubble wall pressure @param fCpinf Driving bubble pressure @param fntait Tait EOS parameter @param fBtait Tait EOS parameter

f_Hdotm_bubblesFunction

Function that computes the time derivative of the enthalpy @param fCpbw Bubble wall pressure @param fCpinf Driving bubble pressure @param fCpinf_dot Time derivative of the driving pressure @param fntait Tait EOS parameter @param fBtait Tait EOS parameter @param fR0 Equilibrium bubble radius @param fR Current bubble radius @param fV Current bubble velocity @param fpbdot Time derivative of the internal bubble pressure

f_rddotm_bubblesFunction

Function that computes the bubble radial acceleration @param fCpbw Bubble wall pressure @param fR Current bubble radius @param fV Current bubble velocity @param fH Current enthalpy @param fHdot Current time derivative of the enthalpy @param fcgas Current gas sound speed @param fntait Tait EOS parameter @param fBtait Tait EOS parameter

f_rddot_KMm_bubblesFunction

Function that computes the bubble radial acceleration for Keller--Miksis bubbles @param fpbdot Time-derivative of internal bubble pressure @param fCp Driving pressure @param fCpbw Bubble wall pressure @param fRho Current density @param fR Current bubble radius @param fV Current bubble velocity @param fR0 Equilibrium bubble radius @param fC Current sound speed

f_rddot_RPm_bubblesFunction

Function that computes the bubble radial acceleration for Rayleigh-Plesset bubbles @param fCp Driving pressure @param fRho Current density @param fR Current bubble radius @param fV Current bubble velocity @param fR0 Equilibrium bubble radius @param fCpbw Boundary wall pressure

f_vfluxm_bubblesFunction

Function that computes the vapour flux @param fR Current bubble radius @param fV Current bubble velocity @param fmass_v Current mass of vapour @param iR0 Bubble size index

mpi_bcast_time_step_valuesm_mpi_proxySubroutine
nvtxEndRangenvtxSubroutine
nvtxRangePopnvtxInterface
nvtxRangePushnvtxInterface
nvtxStartRangenvtxSubroutine
s_1st_order_tvd_rkm_time_steppersSubroutine

1st order TVD RK time-stepping algorithm @param t_step Current time step

s_2nd_order_tvd_rkm_time_steppersSubroutine

2nd order TVD RK time-stepping algorithm @param t_step Current time-step

s_3rd_order_tvd_rkm_time_steppersSubroutine

3rd order TVD RK time-stepping algorithm @param t_step Current time-step

s_assign_default_values_to_user_inputsm_global_parametersSubroutine

Assigns default values to the user inputs before reading them in. This enables for an easier consistency check of these parameters once they are read from the input file.

s_bwpropertym_bubblesSubroutine

Subroutine that computes bubble wall properties for vapor bubbles @param pb Internal bubble pressure @param iR0 Current bubble size index

s_check_input_filem_start_upSubroutine

The goal of this procedure is to verify that each of the user provided inputs is valid and that their combination consitutes a meaningful configuration for the simulation.

s_coeffm_qbmmSubroutine
s_comp_n_from_consm_global_parametersSubroutine

Computes the bubble number density n from the conservative variables \f$ n = \sqrt{ \frac{4 \pi}{3} } \frac{ nR^3}{\alpha} \f$ @param vftmp is the void fraction @param nRtmp is the bubble number density times the bubble radii @param ntmp is the output number bubble density

s_comp_n_from_primm_global_parametersSubroutine

Computes the bubble number density n from the primitive variables \f$ n = \sqrt{ \frac{3}{4 \pi} } \frac{ \alpha }{ R^3} \f$ @param vftmp is the void fraction @param Rtmp is the bubble radii @param ntmp is the output number bubble density

s_compute_bubble_sourcem_bubblesSubroutine

The purpose of this procedure is to compute the source terms that are needed for the bubble modeling @param idir Dimension splitting index @param q_prim_vf Primitive variables @param q_cons_vf Conservative variables @param mydivu Divergence of velocity @param bub_adv_src Advection equation source due to bubble compression/expansion @param bub_r_src Bubble radius equation source @param bub_v_src Bubble velocity equation source @param bub_p_src Bubble pressure equation source @param bub_m_src Bubble mass equation source

s_compute_derived_variablesm_derived_variablesSubroutine

Writes coherent body information, communication files, and probes. @param t_step Current time-step

s_compute_rhsm_rhsSubroutine
s_convert_conservative_to_primitive_variablesm_variables_conversionSubroutine

The following procedure handles the conversion between the conservative variables and the primitive variables. @param qK_cons_vf Conservative variables @param qK_prim_vf Primitive variables @param gm_alphaK_vf Gradient magnitude of the volume fraction @param ix Index bounds in first coordinate direction @param iy Index bounds in second coordinate direction @param iz Index bounds in third coordinate direction

s_convert_mixture_to_mixture_variablesm_variables_conversionSubroutine

This procedure is used alongside with the gamma/pi_inf model to transfer the density, the specific heat ratio function and liquid stiffness function from the vector of conservative or primitive variables to their scalar counterparts. @param qK_vf conservative or primitive variables @param i cell index to transfer mixture variables @param j cell index to transfer mixture variables @param k cell index to transfer mixture variables @param rho_K density @param gamma_K specific heat ratio function @param pi_inf_K liquid stiffness @param Re_k Reynolds number

s_convert_primitive_to_conservative_variablesm_variables_conversionSubroutine

The following procedure handles the conversion between the primitive variables and the conservative variables. @param qK_prim_vf Primitive variables @param qK_cons_vf Conservative variables @param gm_alphaK_vf Gradient magnitude of the volume fractions @param ix Index bounds in the first coordinate direction @param iy Index bounds in the second coordinate direction @param iz Index bounds in the third coordinate direction

s_convert_primitive_to_flux_variablesm_variables_conversionSubroutine

The following subroutine handles the conversion between the primitive variables and the Eulerian flux variables. @param qK_prim_vf Primitive variables @param FK_vf Flux variables @param FK_src_vf Flux source variables @param ix Index bounds in the first coordinate direction @param iy Index bounds in the second coordinate direction @param iz Index bounds in the third coordinate direction

s_convert_species_to_mixture_variablesm_variables_conversionSubroutine

This subroutine is designed for the volume fraction model and provided a set of either conservative or primitive variables, computes the density, the specific heat ratio function and the liquid stiffness function from q_vf and stores the results into rho, gamma and pi_inf. @param qK_vf primitive variables @param rho_K density @param gamma_K specific heat ratio @param pi_inf_K liquid stiffness @param Re_K mixture Reynolds number @param k Cell index @param l Cell index @param r Cell index

s_convert_species_to_mixture_variables_accm_variables_conversionSubroutine
s_convert_species_to_mixture_variables_bubblesm_variables_conversionSubroutine

This procedure is used alongside with the gamma/pi_inf model to transfer the density, the specific heat ratio function and liquid stiffness function from the vector of conservative or primitive variables to their scalar counterparts. Specifially designed for when subgrid bubbles must be included. @param qK_vf primitive variables @param rho_K density @param gamma_K specific heat ratio @param pi_inf_K liquid stiffness @param Re_K mixture Reynolds number @param i Cell index @param j Cell index @param k Cell index

s_convert_species_to_mixture_variables_bubbles_accm_variables_conversionSubroutine
s_convert_species_to_mixture_variables_riemann_accm_riemann_solversSubroutine
s_finalize_derived_variables_modulem_derived_variablesSubroutine

Deallocation procedures for the module

s_finalize_global_parameters_modulem_global_parametersSubroutine

Module deallocation and/or disassociation procedures

s_finalize_mpi_proxy_modulem_mpi_proxySubroutine

Module deallocation and/or disassociation procedures

s_finalize_rhs_modulem_rhsSubroutine

Module deallocation and/or disassociation procedures

s_finalize_riemann_solvers_modulem_riemann_solversSubroutine

Module deallocation and/or disassociation procedures

s_finalize_start_up_modulem_start_upSubroutine
s_finalize_time_steppers_modulem_time_steppersSubroutine

Module deallocation and/or disassociation procedures

s_finalize_variables_conversion_modulem_variables_conversionSubroutine
s_get_viscousm_rhsSubroutine

This subroutine compute the TVD flux function @param q_cons_vf Cell-averaged conservative variables @param q_prim_vf Cell-averaged primitive variables @param rhs_vf Cell-averaged RHS variables @param i Dimensional splitting index Computes viscous terms @param q_cons_vf Cell-averaged conservative variables @param q_prim_vf Cell-averaged primitive variables @param rhs_vf Cell-averaged RHS variables

s_hll_riemann_solverm_riemann_solversSubroutine
s_hllc_riemann_solverm_riemann_solversSubroutine

This procedure is the implementation of the Harten, Lax, van Leer, and contact (HLLC) approximate Riemann solver, see Toro (1999) and Johnsen (2007). The viscous and the surface tension effects have been included by modifying the exact Riemann solver of Perigaud and Saurel (2005). @param qL_prim_vf The left WENO-reconstructed cell-boundary values of the cell-average primitive variables @param qR_prim_vf The right WENO-reconstructed cell-boundary values of the cell-average primitive variables @param dqL_prim_dx_vf The left WENO-reconstructed cell-boundary values of the first-order x-dir spatial derivatives @param dqL_prim_dy_vf The left WENO-reconstructed cell-boundary values of the first-order y-dir spatial derivatives @param dqL_prim_dz_vf The left WENO-reconstructed cell-boundary values of the first-order z-dir spatial derivatives @param dqR_prim_dx_vf The right WENO-reconstructed cell-boundary values of the first-order x-dir spatial derivatives @param dqR_prim_dy_vf The right WENO-reconstructed cell-boundary values of the first-order y-dir spatial derivatives @param dqR_prim_dz_vf The right WENO-reconstructed cell-boundary values of the first-order z-dir spatial derivatives @param gm_alphaL_vf Left averaged gradient magnitude @param gm_alphaR_vf Right averaged gradient magnitude @param flux_vf Intra-cell fluxes @param flux_src_vf Intra-cell fluxes sources @param flux_gsrc_vf Intra-cell geometric fluxes sources @param norm_dir Dir. splitting direction @param ix Index bounds in the x-dir @param iy Index bounds in the y-dir @param iz Index bounds in the z-dir @param q_prim_vf Cell-averaged primitive variables

s_initialize_derived_variablesm_derived_variablesSubroutine

Allocate and open derived variables. Computing FD coefficients.

s_initialize_derived_variables_modulem_derived_variablesSubroutine

Computation of parameters, allocation procedures, and/or any other tasks needed to properly setup the module

s_initialize_global_parameters_modulem_global_parametersSubroutine

The computation of parameters, the allocation of memory, the association of pointers and/or the execution of any other procedures that are necessary to setup the module.

s_initialize_internal_energy_equationsm_start_upSubroutine

The purpose of this procedure is to initialize the values of the internal-energy equations of each phase from the mass of each phase, the mixture momentum and mixture-total-energy equations. @param v_vf conservative variables

s_initialize_mpi_datam_mpi_proxySubroutine

The subroutine that initializes MPI data structures @param q_cons_vf Conservative variables

s_initialize_mpi_proxy_modulem_mpi_proxySubroutine

The computation of parameters, the allocation of memory, the association of pointers and/or the execution of any other procedures that are necessary to setup the module.

s_initialize_nonpolym_global_parametersSubroutine

Initializes non-polydisperse bubble modeling ! thermal properties !!!

s_initialize_parallel_iom_global_parametersSubroutine

Initializes parallel infrastructure

s_initialize_qbmm_modulem_qbmmSubroutine
s_initialize_rhs_modulem_rhsSubroutine

The computation of parameters, the allocation of memory, the association of pointers and/or the execution of any other procedures that are necessary to setup the module.

Read more…
s_initialize_riemann_solvers_modulem_riemann_solversSubroutine

The computation of parameters, the allocation of memory, the association of pointers and/or the execution of any other procedures that are necessary to setup the module.

s_initialize_start_up_modulem_start_upSubroutine
s_initialize_time_steppers_modulem_time_steppersSubroutine

The computation of parameters, the allocation of memory, the association of pointers and/or the execution of any other procedures that are necessary to setup the module.

s_initialize_variables_conversion_modulem_variables_conversionSubroutine

The computation of parameters, the allocation of memory, the association of pointers and/or the execution of any other procedures that are necessary to setup the module.

s_mom_invm_qbmmSubroutine

$acc loop seq

s_mpi_abortm_mpi_proxySubroutine

The subroutine terminates the MPI execution environment.

s_mpi_allreduce_maxm_mpi_proxySubroutine

The following subroutine takes the input local variable from all processors and reduces to the maximum of all values. The reduced variable is recorded back onto the original local variable on each processor. @param var_loc Some variable containing the local value which should be reduced amongst all the processors in the communicator. @param var_glb The globally reduced value

s_mpi_allreduce_minm_mpi_proxySubroutine

The following subroutine takes the input local variable from all processors and reduces to the minimum of all values. The reduced variable is recorded back onto the original local variable on each processor. @param var_loc Some variable containing the local value which should be reduced amongst all the processors in the communicator. @param var_glb The globally reduced value

s_mpi_allreduce_summ_mpi_proxySubroutine

The following subroutine takes the input local variable from all processors and reduces to the sum of all values. The reduced variable is recorded back onto the original local variable on each processor. @param var_loc Some variable containing the local value which should be reduced amongst all the processors in the communicator. @param var_glb The globally reduced value

s_mpi_barrierm_mpi_proxySubroutine

Halts all processes until all have reached barrier.

s_mpi_bcast_user_inputsm_mpi_proxySubroutine

Since only the processor with rank 0 reads and verifies the consistency of user inputs, these are initially not available to the other processors. Then, the purpose of this subroutine is to distribute the user inputs to the remaining processors in the communicator.

s_mpi_decompose_computational_domainm_mpi_proxySubroutine

The purpose of this procedure is to optimally decompose the computational domain among the available processors. This is performed by attempting to award each processor, in each of the coordinate directions, approximately the same number of cells, and then recomputing the affected global parameters.

s_mpi_finalizem_mpi_proxySubroutine

The subroutine finalizes the MPI execution environment.

s_mpi_initializem_mpi_proxySubroutine

The subroutine intializes the MPI execution environment and queries both the number of processors which will be available for the job and the local processor rank.

s_mpi_reduce_stability_criteria_extremam_mpi_proxySubroutine

The goal of this subroutine is to determine the global extrema of the stability criteria in the computational domain. This is performed by sifting through the local extrema of each stability criterion. Note that each of the local extrema is from a single process, within its assigned section of the computational domain. Finally, note that the global extrema values are only bookkeept on the rank 0 processor. @param icfl_max_loc Local maximum ICFL stability criterion @param vcfl_max_loc Local maximum VCFL stability criterion @param ccfl_max_loc Local maximum CCFL stability criterion @param Rc_min_loc Local minimum Rc stability criterion @param icfl_max_glb Global maximum ICFL stability criterion @param vcfl_max_glb Global maximum VCFL stability criterion @param ccfl_max_glb Global maximum CCFL stability criterion @param Rc_min_glb Global minimum Rc stability criterion

s_mpi_sendrecv_conservative_variables_buffersm_mpi_proxySubroutine

The goal of this procedure is to populate the buffers of the cell-average conservative variables by communicating with the neighboring processors. @param q_cons_vf Cell-average conservative variables @param mpi_dir MPI communication coordinate direction @param pbc_loc Processor boundary condition (PBC) location

s_mpi_sendrecv_grid_variables_buffersm_mpi_proxySubroutine

The goal of this procedure is to populate the buffers of the grid variables by communicating with the neighboring processors. Note that only the buffers of the cell-width distributions are handled in such a way. This is because the buffers of cell-boundary locations may be calculated directly from those of the cell-width distributions. @param mpi_dir MPI communication coordinate direction @param pbc_loc Processor boundary condition (PBC) location

s_populate_grid_variables_buffersm_start_upSubroutine

The purpose of this subroutine is to populate the buffers of the grid variables, which are constituted of the cell- boundary locations and cell-width distributions, based on the boundary conditions.

s_populate_variables_buffersm_rhsSubroutine

The purpose of this procedure is to populate the buffers of the conservative variables, depending on the selected boundary conditions. @param v_vf Scalar field for which buffers are populated

s_pressure_relaxation_procedurem_rhsSubroutine

The purpose of this procedure is to infinitely relax the pressures from the internal-energy equations to a unique pressure, from which the corresponding volume fraction of each phase are recomputed. For conservation purpose, this pressure is finally corrected using the mixture-total-energy equation. @param q_cons_vf Cell-average conservative variables

s_quadm_global_parametersSubroutine

Computes the quadrature for polydisperse bubble populations @param func is the bubble dynamic variables for each bin @param mom is the computed moment

s_read_input_filem_start_upSubroutine

The purpose of this procedure is to first verify that an input file has been made available by the user. Provided that this is so, the input file is then read in.

s_read_parallel_data_filesm_start_upSubroutine
s_read_serial_data_filesm_start_upSubroutine
s_simpsonm_global_parametersSubroutine

Computes the Simpson weights for quadrature

s_time_step_cyclingm_time_steppersSubroutine

This subroutine saves the temporary q_prim_vf vector into the q_prim_ts vector that is then used in p_main @param t_step current time-step

s_transcoeffm_global_parametersSubroutine

Computes transfer coefficient for non-polydisperse bubble modeling (Preston 2007) @param omega Frequency @param peclet Peclet number @param Re_trans Real part of transfer coefficient @param Im_trans Imaginary part of transfer coefficient

call~~graph~~CallGraph proc~f_cpbw_km f_cpbw_KM proc~s_compute_rhs s_compute_rhs proc~s_compute_rhs->proc~f_cpbw_km proc~f_rddot f_rddot proc~s_compute_rhs->proc~f_rddot proc~f_rddot_km f_rddot_KM proc~s_compute_rhs->proc~f_rddot_km proc~s_bwproperty s_bwproperty proc~s_compute_rhs->proc~s_bwproperty proc~s_get_viscous s_get_viscous proc~s_compute_rhs->proc~s_get_viscous proc~f_h f_H proc~s_compute_rhs->proc~f_h proc~f_cgas f_cgas proc~s_compute_rhs->proc~f_cgas proc~s_comp_n_from_prim s_comp_n_from_prim proc~s_compute_rhs->proc~s_comp_n_from_prim proc~f_vflux f_vflux proc~s_compute_rhs->proc~f_vflux proc~f_bpres_dot f_bpres_dot proc~s_compute_rhs->proc~f_bpres_dot proc~s_quad s_quad proc~s_compute_rhs->proc~s_quad proc~f_cpbw f_cpbw proc~s_compute_rhs->proc~f_cpbw proc~f_cpinfdot f_cpinfdot proc~s_compute_rhs->proc~f_cpinfdot proc~s_convert_conservative_to_primitive_variables s_convert_conservative_to_primitive_variables proc~s_compute_rhs->proc~s_convert_conservative_to_primitive_variables proc~f_hdot f_Hdot proc~s_compute_rhs->proc~f_hdot proc~f_rddot_rp f_rddot_RP proc~s_compute_rhs->proc~f_rddot_rp proc~s_mom_inv s_mom_inv proc~s_compute_rhs->proc~s_mom_inv proc~nvtxendrange nvtxEndRange proc~s_compute_rhs->proc~nvtxendrange proc~nvtxstartrange nvtxStartRange proc~s_compute_rhs->proc~nvtxstartrange s_cbc s_cbc proc~s_compute_rhs->s_cbc proc~s_pressure_relaxation_procedure s_pressure_relaxation_procedure proc~s_transcoeff s_transcoeff cexp cexp proc~s_transcoeff->cexp csqrt csqrt proc~s_transcoeff->csqrt proc~s_finalize_riemann_solvers_module s_finalize_riemann_solvers_module proc~s_hllc_riemann_solver s_hllc_riemann_solver proc~s_hllc_riemann_solver->proc~f_cpbw_km proc~s_initialize_parallel_io s_initialize_parallel_io mpi_info_set mpi_info_set proc~s_initialize_parallel_io->mpi_info_set mpi_info_create mpi_info_create proc~s_initialize_parallel_io->mpi_info_create proc~s_initialize_start_up_module s_initialize_start_up_module proc~s_initialize_global_parameters_module s_initialize_global_parameters_module proc~s_simpson s_simpson proc~s_initialize_global_parameters_module->proc~s_simpson proc~s_initialize_nonpoly s_initialize_nonpoly proc~s_initialize_global_parameters_module->proc~s_initialize_nonpoly proc~s_convert_species_to_mixture_variables_riemann_acc s_convert_species_to_mixture_variables_riemann_acc proc~s_2nd_order_tvd_rk s_2nd_order_tvd_rk proc~s_2nd_order_tvd_rk->proc~s_compute_rhs proc~s_2nd_order_tvd_rk->proc~s_pressure_relaxation_procedure proc~s_time_step_cycling s_time_step_cycling proc~s_2nd_order_tvd_rk->proc~s_time_step_cycling proc~s_2nd_order_tvd_rk->proc~nvtxendrange proc~s_2nd_order_tvd_rk->proc~nvtxstartrange s_apply_fourier_filter s_apply_fourier_filter proc~s_2nd_order_tvd_rk->s_apply_fourier_filter s_write_run_time_information s_write_run_time_information proc~s_2nd_order_tvd_rk->s_write_run_time_information proc~s_mpi_abort s_mpi_abort mpi_abort mpi_abort proc~s_mpi_abort->mpi_abort proc~s_populate_variables_buffers s_populate_variables_buffers proc~s_mpi_sendrecv_conservative_variables_buffers s_mpi_sendrecv_conservative_variables_buffers proc~s_populate_variables_buffers->proc~s_mpi_sendrecv_conservative_variables_buffers proc~s_convert_species_to_mixture_variables_bubbles_acc s_convert_species_to_mixture_variables_bubbles_acc proc~s_finalize_start_up_module s_finalize_start_up_module proc~s_mpi_initialize s_mpi_initialize mpi_comm_rank mpi_comm_rank proc~s_mpi_initialize->mpi_comm_rank mpi_init mpi_init proc~s_mpi_initialize->mpi_init proc~s_mpi_initialize->mpi_abort mpi_comm_size mpi_comm_size proc~s_mpi_initialize->mpi_comm_size proc~s_initialize_derived_variables_module s_initialize_derived_variables_module proc~s_initialize_variables_conversion_module s_initialize_variables_conversion_module proc~s_initialize_derived_variables s_initialize_derived_variables s_open_com_files s_open_com_files proc~s_initialize_derived_variables->s_open_com_files s_open_cb_files s_open_cb_files proc~s_initialize_derived_variables->s_open_cb_files s_open_probe_files s_open_probe_files proc~s_initialize_derived_variables->s_open_probe_files proc~s_convert_primitive_to_flux_variables s_convert_primitive_to_flux_variables proc~s_convert_primitive_to_flux_variables->proc~s_convert_species_to_mixture_variables_bubbles_acc proc~s_convert_species_to_mixture_variables_acc s_convert_species_to_mixture_variables_acc proc~s_convert_primitive_to_flux_variables->proc~s_convert_species_to_mixture_variables_acc proc~s_compute_derived_variables s_compute_derived_variables s_write_cb_files s_write_cb_files proc~s_compute_derived_variables->s_write_cb_files s_write_com_files s_write_com_files proc~s_compute_derived_variables->s_write_com_files x_accel x_accel proc~s_compute_derived_variables->x_accel y_accel y_accel proc~s_compute_derived_variables->y_accel accel_mag accel_mag proc~s_compute_derived_variables->accel_mag s_write_probe_files s_write_probe_files proc~s_compute_derived_variables->s_write_probe_files z_accel z_accel proc~s_compute_derived_variables->z_accel proc~s_finalize_global_parameters_module s_finalize_global_parameters_module proc~s_initialize_mpi_data s_initialize_mpi_data mpi_type_create_subarray mpi_type_create_subarray proc~s_initialize_mpi_data->mpi_type_create_subarray mpi_type_commit mpi_type_commit proc~s_initialize_mpi_data->mpi_type_commit proc~s_mpi_barrier s_mpi_barrier mpi_barrier mpi_barrier proc~s_mpi_barrier->mpi_barrier proc~s_initialize_mpi_proxy_module s_initialize_mpi_proxy_module proc~s_mpi_bcast_user_inputs s_mpi_bcast_user_inputs mpi_bcast mpi_bcast proc~s_mpi_bcast_user_inputs->mpi_bcast proc~mpi_bcast_time_step_values mpi_bcast_time_step_values mpi_gather mpi_gather proc~mpi_bcast_time_step_values->mpi_gather proc~s_comp_n_from_cons s_comp_n_from_cons proc~s_mpi_decompose_computational_domain s_mpi_decompose_computational_domain proc~s_mpi_decompose_computational_domain->proc~s_mpi_abort mpi_cart_rank mpi_cart_rank proc~s_mpi_decompose_computational_domain->mpi_cart_rank mpi_cart_coords mpi_cart_coords proc~s_mpi_decompose_computational_domain->mpi_cart_coords mpi_cart_create mpi_cart_create proc~s_mpi_decompose_computational_domain->mpi_cart_create proc~s_mpi_sendrecv_grid_variables_buffers s_mpi_sendrecv_grid_variables_buffers mpi_sendrecv mpi_sendrecv proc~s_mpi_sendrecv_grid_variables_buffers->mpi_sendrecv proc~s_finalize_time_steppers_module s_finalize_time_steppers_module s_close_run_time_information_file s_close_run_time_information_file proc~s_finalize_time_steppers_module->s_close_run_time_information_file proc~s_mpi_reduce_stability_criteria_extrema s_mpi_reduce_stability_criteria_extrema mpi_reduce mpi_reduce proc~s_mpi_reduce_stability_criteria_extrema->mpi_reduce proc~s_read_input_file s_read_input_file proc~s_read_input_file->proc~s_mpi_abort proc~s_3rd_order_tvd_rk s_3rd_order_tvd_rk proc~s_3rd_order_tvd_rk->proc~s_compute_rhs proc~s_3rd_order_tvd_rk->proc~s_pressure_relaxation_procedure proc~s_3rd_order_tvd_rk->proc~s_time_step_cycling proc~s_3rd_order_tvd_rk->proc~nvtxendrange proc~s_3rd_order_tvd_rk->proc~nvtxstartrange proc~s_3rd_order_tvd_rk->s_apply_fourier_filter proc~s_3rd_order_tvd_rk->s_write_run_time_information dexp dexp proc~s_simpson->dexp proc~s_check_input_file s_check_input_file proc~s_check_input_file->proc~s_mpi_abort my_inquire my_inquire proc~s_check_input_file->my_inquire proc~s_mpi_allreduce_sum s_mpi_allreduce_sum mpi_allreduce mpi_allreduce proc~s_mpi_allreduce_sum->mpi_allreduce proc~s_hll_riemann_solver s_hll_riemann_solver proc~s_mpi_allreduce_min s_mpi_allreduce_min proc~s_mpi_allreduce_min->mpi_allreduce proc~s_convert_conservative_to_primitive_variables->proc~s_convert_species_to_mixture_variables_bubbles_acc proc~s_convert_conservative_to_primitive_variables->proc~s_comp_n_from_cons proc~s_convert_conservative_to_primitive_variables->proc~s_convert_species_to_mixture_variables_acc proc~s_initialize_internal_energy_equations s_initialize_internal_energy_equations proc~s_read_serial_data_files s_read_serial_data_files proc~s_read_serial_data_files->proc~s_mpi_abort proc~s_read_serial_data_files->my_inquire proc~s_read_parallel_data_files s_read_parallel_data_files proc~s_read_parallel_data_files->proc~s_mpi_abort proc~s_read_parallel_data_files->proc~s_initialize_mpi_data proc~s_read_parallel_data_files->proc~s_mpi_barrier mpi_file_close mpi_file_close proc~s_read_parallel_data_files->mpi_file_close mpi_file_read mpi_file_read proc~s_read_parallel_data_files->mpi_file_read mpi_file_open mpi_file_open proc~s_read_parallel_data_files->mpi_file_open mpi_file_set_view mpi_file_set_view proc~s_read_parallel_data_files->mpi_file_set_view proc~s_finalize_variables_conversion_module s_finalize_variables_conversion_module proc~s_mpi_allreduce_max s_mpi_allreduce_max proc~s_mpi_allreduce_max->mpi_allreduce proc~s_populate_grid_variables_buffers s_populate_grid_variables_buffers proc~s_populate_grid_variables_buffers->proc~s_mpi_sendrecv_grid_variables_buffers proc~s_mpi_sendrecv_conservative_variables_buffers->mpi_barrier proc~s_mpi_sendrecv_conservative_variables_buffers->mpi_sendrecv proc~s_finalize_mpi_proxy_module s_finalize_mpi_proxy_module proc~s_finalize_derived_variables_module s_finalize_derived_variables_module s_close_com_files s_close_com_files proc~s_finalize_derived_variables_module->s_close_com_files s_close_cb_files s_close_cb_files proc~s_finalize_derived_variables_module->s_close_cb_files s_close_probe_files s_close_probe_files proc~s_finalize_derived_variables_module->s_close_probe_files proc~s_initialize_nonpoly->proc~s_transcoeff proc~s_mpi_finalize s_mpi_finalize mpi_finalize mpi_finalize proc~s_mpi_finalize->mpi_finalize proc~s_finalize_rhs_module s_finalize_rhs_module proc~s_initialize_riemann_solvers_module s_initialize_riemann_solvers_module proc~s_coeff s_coeff proc~s_initialize_qbmm_module s_initialize_qbmm_module proc~s_convert_species_to_mixture_variables s_convert_species_to_mixture_variables proc~s_compute_bubble_source s_compute_bubble_source proc~s_compute_bubble_source->proc~f_cpbw_km proc~s_compute_bubble_source->proc~f_rddot proc~s_compute_bubble_source->proc~f_rddot_km proc~s_compute_bubble_source->proc~s_bwproperty proc~s_compute_bubble_source->proc~f_h proc~s_compute_bubble_source->proc~f_cgas proc~s_compute_bubble_source->proc~s_comp_n_from_prim proc~s_compute_bubble_source->proc~f_vflux proc~s_compute_bubble_source->proc~f_bpres_dot proc~s_compute_bubble_source->proc~s_quad proc~s_compute_bubble_source->proc~f_cpbw proc~s_compute_bubble_source->proc~f_cpinfdot proc~s_compute_bubble_source->proc~f_hdot proc~s_compute_bubble_source->proc~f_rddot_rp proc~s_mom_inv->proc~s_comp_n_from_prim proc~s_mom_inv->proc~s_coeff proc~s_convert_species_to_mixture_variables_bubbles s_convert_species_to_mixture_variables_bubbles interface~nvtxrangepush nvtxRangePush proc~nvtxstartrange->interface~nvtxrangepush proc~s_initialize_time_steppers_module s_initialize_time_steppers_module s_open_run_time_information_file s_open_run_time_information_file proc~s_initialize_time_steppers_module->s_open_run_time_information_file proc~s_convert_primitive_to_conservative_variables s_convert_primitive_to_conservative_variables proc~s_convert_primitive_to_conservative_variables->proc~s_mpi_abort proc~s_1st_order_tvd_rk s_1st_order_tvd_rk proc~s_1st_order_tvd_rk->proc~s_compute_rhs proc~s_1st_order_tvd_rk->proc~s_pressure_relaxation_procedure proc~s_1st_order_tvd_rk->proc~s_time_step_cycling proc~s_1st_order_tvd_rk->proc~nvtxendrange proc~s_1st_order_tvd_rk->proc~nvtxstartrange proc~s_1st_order_tvd_rk->s_apply_fourier_filter proc~s_1st_order_tvd_rk->s_write_run_time_information proc~s_initialize_rhs_module s_initialize_rhs_module proc~s_assign_default_values_to_user_inputs s_assign_default_values_to_user_inputs interface~nvtxrangepop nvtxRangePop proc~s_convert_mixture_to_mixture_variables s_convert_mixture_to_mixture_variables program~p_main p_main program~p_main->proc~s_finalize_riemann_solvers_module program~p_main->proc~s_initialize_parallel_io program~p_main->proc~s_initialize_start_up_module program~p_main->proc~s_initialize_global_parameters_module program~p_main->proc~s_2nd_order_tvd_rk program~p_main->proc~s_finalize_start_up_module program~p_main->proc~s_mpi_initialize program~p_main->proc~s_initialize_derived_variables_module program~p_main->proc~s_initialize_variables_conversion_module program~p_main->proc~s_initialize_derived_variables program~p_main->proc~s_compute_derived_variables program~p_main->proc~s_finalize_global_parameters_module program~p_main->proc~s_mpi_barrier program~p_main->proc~s_initialize_mpi_proxy_module program~p_main->proc~s_mpi_bcast_user_inputs program~p_main->proc~mpi_bcast_time_step_values program~p_main->proc~s_mpi_decompose_computational_domain program~p_main->proc~s_finalize_time_steppers_module program~p_main->proc~s_read_input_file program~p_main->proc~s_3rd_order_tvd_rk program~p_main->proc~s_check_input_file program~p_main->proc~s_initialize_internal_energy_equations program~p_main->proc~s_finalize_variables_conversion_module program~p_main->proc~s_populate_grid_variables_buffers program~p_main->proc~s_finalize_mpi_proxy_module program~p_main->proc~s_finalize_derived_variables_module program~p_main->proc~s_mpi_finalize program~p_main->proc~s_finalize_rhs_module program~p_main->proc~s_initialize_riemann_solvers_module program~p_main->proc~s_initialize_qbmm_module program~p_main->proc~s_initialize_time_steppers_module program~p_main->proc~s_1st_order_tvd_rk program~p_main->proc~s_initialize_rhs_module program~p_main->proc~s_assign_default_values_to_user_inputs s_initialize_cbc_module s_initialize_cbc_module program~p_main->s_initialize_cbc_module acc_present_dump acc_present_dump program~p_main->acc_present_dump s_finalize_cbc_module s_finalize_cbc_module program~p_main->s_finalize_cbc_module s_finalize_weno_module s_finalize_weno_module program~p_main->s_finalize_weno_module s_initialize_data_output_module s_initialize_data_output_module program~p_main->s_initialize_data_output_module program~p_main->mpi_comm_rank s_finalize_fftw_module s_finalize_fftw_module program~p_main->s_finalize_fftw_module s_write_data_files s_write_data_files program~p_main->s_write_data_files s_initialize_weno_module s_initialize_weno_module program~p_main->s_initialize_weno_module s_finalize_data_output_module s_finalize_data_output_module program~p_main->s_finalize_data_output_module program~p_main->mpi_comm_size acc_set_device_num acc_set_device_num program~p_main->acc_set_device_num acc_get_device_type acc_get_device_type program~p_main->acc_get_device_type s_initialize_fftw_module s_initialize_fftw_module program~p_main->s_initialize_fftw_module acc_get_num_devices acc_get_num_devices program~p_main->acc_get_num_devices mpi_comm_split_type mpi_comm_split_type program~p_main->mpi_comm_split_type
Help