Loading [MathJax]/extensions/tex2jax.js
MFC: Simulation
High-fidelity multiphase flow simulation
All Classes Namespaces Files Functions Variables Pages
m_bubbles_EL.fpp.f90 File Reference

Functions/Subroutines

program __m_bubbles_el_fpp_f90__
 
subroutine s_initialize_bubbles_el_module (q_cons_vf)
 Initializes the lagrangian subgrid bubble solver.
 
subroutine s_start_lagrange_inputs ()
 The purpose of this procedure is to start lagrange bubble parameters applying nondimensionalization if needed.
 
subroutine s_read_input_bubbles (q_cons_vf)
 The purpose of this procedure is to obtain the initial bubbles' information.
 
subroutine s_add_bubbles (inputbubble, q_cons_vf, bub_id)
 The purpose of this procedure is to obtain the information of the bubbles when starting fresh.
 
subroutine s_restart_bubbles (bub_id, save_count)
 The purpose of this procedure is to obtain the information of the bubbles from a restart point.
 
subroutine s_compute_el_coupled_solver (q_cons_vf, q_prim_vf, rhs_vf, stage)
 Contains the two-way and one-way Euler-Lagrange coupled algorithm, including the bubble dynamics subroutines.
 
subroutine s_compute_cson_from_pinf (bub_id, q_prim_vf, pinf, cell, rhol, gamma, pi_inf, cson)
 This procedure computes the speed of sound from a given driving pressure.
 
subroutine s_smear_voidfraction ()
 The purpose of this subroutine is to smear the effect of the bubbles in the Eulerian framework.
 
subroutine s_add_rhs_sources (q_cons_vf, q_prim_vf, rhs_vf)
 The purpose of this subroutine is to obtain the bubble source terms based on Maeda and Colonius (2018) and add them to the RHS scalar field.
 
subroutine s_get_pinf (bub_id, q_prim_vf, ptype, f_pinfl, cell, preterm1, term2, romega)
 The purpose of this procedure is obtain the bubble driving pressure p_inf.
 
subroutine s_update_lagrange_tdv_rk (stage)
 This subroutine updates the Lagrange variables using the tvd RK time steppers. The time derivative of the bubble variables must be stored at every stage to avoid precision errors.
 
subroutine s_update_tmp_rkck (rkstep, q_cons_ts, rhs_ts, lag_largestep)
 This subroutine updates the Euler-Lagrange temporal variables before entering to the next time-stage in the RKCK stepper.
 
subroutine s_calculate_rkck_truncation_error (rkck_errmax)
 This subroutine calculates the maximum error between the 4th and 5th order Runge-Kutta-Cash-Karp solutions for the same time step size. If the errors are smaller than a tolerance, then the algorithm employs the 5th order solution, while if not, both eulerian/lagrangian variables are re-calculated with a smaller time step size.
 
subroutine s_update_rkck (q_cons_ts)
 This subroutine updates the conservative fields and the lagrangian variables after accepting the performed time step.
 
subroutine s_compute_rkck_dt (lag_largestep, restart_rkck_step, rkck_errmax)
 This subroutine computes the next time step in the adaptive RKCK stepper in the CPU.
 
subroutine s_locate_cell (pos, cell, scoord)
 This subroutine returns the computational coordinate of the cell for the given position.
 
subroutine s_transfer_data_to_tmp ()
 This subroutine transfer data into the temporal variables.
 
logical function particle_in_domain (pos_part)
 The purpose of this procedure is to determine if the global coordinates of the bubbles are present in the current MPI processor (including ghost cells).
 
logical function particle_in_domain_physical (pos_part)
 The purpose of this procedure is to determine if the lagrangian bubble is located in the physical domain. The ghost cells are not part of the physical domain.
 
subroutine s_gradient_dir (q, dq, dir)
 The purpose of this procedure is to calculate the gradient of a scalar field along the x, y and z directions following a second-order central difference considering uneven widths.
 
subroutine s_write_lag_particles (qtime)
 Subroutine that writes on each time step the changes of the lagrangian bubbles.
 
subroutine s_write_void_evol (qtime)
 Subroutine that writes some useful statistics related to the volume fraction of the particles (void fraction) in the computatioational domain on each time step.
 
subroutine s_write_restart_lag_bubbles (t_step)
 Subroutine that writes the restarting files for the particles in the lagrangian solver.
 
subroutine s_calculate_lag_bubble_stats ()
 This procedure calculates the maximum and minimum radius of each bubble.
 
subroutine s_write_lag_bubble_stats ()
 Subroutine that writes the maximum and minimum radius of each bubble.
 
subroutine s_remove_lag_bubble (bub_id)
 The purpose of this subroutine is to remove one specific particle if dt is too small.
 
subroutine s_finalize_lagrangian_solver ()
 The purpose of this subroutine is to deallocate variables.
 

Function/Subroutine Documentation

◆ __m_bubbles_el_fpp_f90__()

program __m_bubbles_el_fpp_f90__

◆ particle_in_domain()

logical function __m_bubbles_el_fpp_f90__::particle_in_domain ( real(wp), dimension(3), intent(in) pos_part)
private

The purpose of this procedure is to determine if the global coordinates of the bubbles are present in the current MPI processor (including ghost cells).

Parameters
pos_partSpatial coordinates of the bubble
Here is the call graph for this function:
Here is the caller graph for this function:

◆ particle_in_domain_physical()

logical function __m_bubbles_el_fpp_f90__::particle_in_domain_physical ( real(wp), dimension(3), intent(in) pos_part)
private

The purpose of this procedure is to determine if the lagrangian bubble is located in the physical domain. The ghost cells are not part of the physical domain.

Parameters
pos_partSpatial coordinates of the bubble
Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_add_bubbles()

subroutine __m_bubbles_el_fpp_f90__::s_add_bubbles ( real(wp), dimension(8), intent(in) inputbubble,
type(scalar_field), dimension(sys_size), intent(in) q_cons_vf,
integer, intent(in) bub_id )
private

The purpose of this procedure is to obtain the information of the bubbles when starting fresh.

Parameters
inputBubbleBubble information
q_cons_vfConservative variables
bub_idLocal id of the bubble
Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_add_rhs_sources()

subroutine __m_bubbles_el_fpp_f90__::s_add_rhs_sources ( type(scalar_field), dimension(sys_size), intent(inout) q_cons_vf,
type(scalar_field), dimension(sys_size), intent(inout) q_prim_vf,
type(scalar_field), dimension(sys_size), intent(inout) rhs_vf )
private

The purpose of this subroutine is to obtain the bubble source terms based on Maeda and Colonius (2018) and add them to the RHS scalar field.

Parameters
q_cons_vfConservative variables
q_prim_vfConservative variables
rhs_vfTime derivative of the conservative variables
Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_calculate_lag_bubble_stats()

subroutine __m_bubbles_el_fpp_f90__::s_calculate_lag_bubble_stats
private

This procedure calculates the maximum and minimum radius of each bubble.

Here is the caller graph for this function:

◆ s_calculate_rkck_truncation_error()

subroutine __m_bubbles_el_fpp_f90__::s_calculate_rkck_truncation_error ( real(wp), intent(out) rkck_errmax)
private

This subroutine calculates the maximum error between the 4th and 5th order Runge-Kutta-Cash-Karp solutions for the same time step size. If the errors are smaller than a tolerance, then the algorithm employs the 5th order solution, while if not, both eulerian/lagrangian variables are re-calculated with a smaller time step size.

Parameters
rkck_errmaxTruncation error
Here is the caller graph for this function:

◆ s_compute_cson_from_pinf()

subroutine __m_bubbles_el_fpp_f90__::s_compute_cson_from_pinf ( integer, intent(in) bub_id,
type(scalar_field), dimension(sys_size), intent(in) q_prim_vf,
real(wp), intent(in) pinf,
integer, dimension(3), intent(in) cell,
real(wp), intent(in) rhol,
real(wp), intent(in) gamma,
real(wp), intent(in) pi_inf,
real(wp), intent(out) cson )
private

This procedure computes the speed of sound from a given driving pressure.

Parameters
bub_idBubble id
q_prim_vfPrimitive variables
pinfDriving pressure
cellBubble cell
rholLiquid density
gammaLiquid specific heat ratio
pi_infLiquid stiffness
csonCalculated speed of sound
Here is the caller graph for this function:

◆ s_compute_el_coupled_solver()

subroutine __m_bubbles_el_fpp_f90__::s_compute_el_coupled_solver ( type(scalar_field), dimension(sys_size), intent(inout) q_cons_vf,
type(scalar_field), dimension(sys_size), intent(inout) q_prim_vf,
type(scalar_field), dimension(sys_size), intent(inout) rhs_vf,
integer, intent(in) stage )
private

Contains the two-way and one-way Euler-Lagrange coupled algorithm, including the bubble dynamics subroutines.

Parameters
q_cons_vfConservative variables
q_prim_vfPrimitive variables
rhs_vfCalculated change of conservative variables
stageCurrent stage in the time-stepper algorithm
Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_compute_rkck_dt()

subroutine __m_bubbles_el_fpp_f90__::s_compute_rkck_dt ( real(wp), intent(in) lag_largestep,
logical, intent(out) restart_rkck_step,
real(wp), intent(inout), optional rkck_errmax )
private

This subroutine computes the next time step in the adaptive RKCK stepper in the CPU.

Parameters
lag_largestepNegative radius flag
restart_rkck_stepRestart the current time step
rkck_errmaxTruncation error
Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_finalize_lagrangian_solver()

subroutine __m_bubbles_el_fpp_f90__::s_finalize_lagrangian_solver
private

The purpose of this subroutine is to deallocate variables.

Here is the caller graph for this function:

◆ s_get_pinf()

subroutine __m_bubbles_el_fpp_f90__::s_get_pinf ( integer, intent(in) bub_id,
type(scalar_field), dimension(sys_size), intent(in) q_prim_vf,
integer, intent(in) ptype,
real(wp), intent(out) f_pinfl,
integer, dimension(3), intent(out) cell,
real(wp), intent(out), optional preterm1,
real(wp), intent(out), optional term2,
real(wp), intent(out), optional romega )
private

The purpose of this procedure is obtain the bubble driving pressure p_inf.

Parameters
bub_idParticle identifier
q_prim_vfPrimitive variables
ptype1: p at infinity, 2: averaged P at the bubble location
f_pinflDriving pressure
cellBubble cell
RomegaControl volume radius
Here is the caller graph for this function:

◆ s_gradient_dir()

subroutine __m_bubbles_el_fpp_f90__::s_gradient_dir ( type(scalar_field), intent(inout) q,
type(scalar_field), intent(inout) dq,
integer, intent(in) dir )
private

The purpose of this procedure is to calculate the gradient of a scalar field along the x, y and z directions following a second-order central difference considering uneven widths.

Parameters
qInput scalar field
dqOutput gradient of q
dirGradient spatial direction
Here is the caller graph for this function:

◆ s_initialize_bubbles_el_module()

subroutine __m_bubbles_el_fpp_f90__::s_initialize_bubbles_el_module ( type(scalar_field), dimension(sys_size), intent(inout) q_cons_vf)

Initializes the lagrangian subgrid bubble solver.

Parameters
q_cons_vfInitial conservative variables
Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_locate_cell()

subroutine __m_bubbles_el_fpp_f90__::s_locate_cell ( real(wp), dimension(3), intent(in) pos,
integer, dimension(3), intent(inout) cell,
real(wp), dimension(3), intent(out) scoord )
private

This subroutine returns the computational coordinate of the cell for the given position.

Parameters
posInput coordinates
cellComputational coordinate of the cell
scoordCalculated particle coordinates
Here is the caller graph for this function:

◆ s_read_input_bubbles()

subroutine __m_bubbles_el_fpp_f90__::s_read_input_bubbles ( type(scalar_field), dimension(sys_size), intent(inout) q_cons_vf)
private

The purpose of this procedure is to obtain the initial bubbles' information.

Parameters
q_cons_vfConservative variables
Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_remove_lag_bubble()

subroutine __m_bubbles_el_fpp_f90__::s_remove_lag_bubble ( integer, intent(in) bub_id)
private

The purpose of this subroutine is to remove one specific particle if dt is too small.

Parameters
bub_idParticle id
Here is the caller graph for this function:

◆ s_restart_bubbles()

subroutine __m_bubbles_el_fpp_f90__::s_restart_bubbles ( integer, intent(inout) bub_id,
integer, intent(inout) save_count )
private

The purpose of this procedure is to obtain the information of the bubbles from a restart point.

Parameters
bub_idLocal ID of the particle
save_countFile identifier
Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_smear_voidfraction()

subroutine __m_bubbles_el_fpp_f90__::s_smear_voidfraction
private

The purpose of this subroutine is to smear the effect of the bubbles in the Eulerian framework.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_start_lagrange_inputs()

subroutine __m_bubbles_el_fpp_f90__::s_start_lagrange_inputs
private

The purpose of this procedure is to start lagrange bubble parameters applying nondimensionalization if needed.

Here is the caller graph for this function:

◆ s_transfer_data_to_tmp()

subroutine __m_bubbles_el_fpp_f90__::s_transfer_data_to_tmp
private

This subroutine transfer data into the temporal variables.

Here is the caller graph for this function:

◆ s_update_lagrange_tdv_rk()

subroutine __m_bubbles_el_fpp_f90__::s_update_lagrange_tdv_rk ( integer, intent(in) stage)
private

This subroutine updates the Lagrange variables using the tvd RK time steppers. The time derivative of the bubble variables must be stored at every stage to avoid precision errors.

Parameters
stageCurrent tvd RK stage
Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_update_rkck()

subroutine __m_bubbles_el_fpp_f90__::s_update_rkck ( type(vector_field), dimension(:), intent(inout) q_cons_ts)
private

This subroutine updates the conservative fields and the lagrangian variables after accepting the performed time step.

Parameters
q_cons_tsConservative variables
Here is the caller graph for this function:

◆ s_update_tmp_rkck()

subroutine __m_bubbles_el_fpp_f90__::s_update_tmp_rkck ( integer, intent(in) rkstep,
type(vector_field), dimension(:), intent(inout) q_cons_ts,
type(vector_field), dimension(:), intent(inout) rhs_ts,
real(wp), intent(out) lag_largestep )
private

This subroutine updates the Euler-Lagrange temporal variables before entering to the next time-stage in the RKCK stepper.

Parameters
RKstepCurrent time step in the RKCK adaptive stepper
q_cons_tsConservative variables
rhs_tsTime derivatives of the conservative variables
lag_largestepNegative radius flag
Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_write_lag_bubble_stats()

subroutine __m_bubbles_el_fpp_f90__::s_write_lag_bubble_stats
private

Subroutine that writes the maximum and minimum radius of each bubble.

Here is the caller graph for this function:

◆ s_write_lag_particles()

subroutine __m_bubbles_el_fpp_f90__::s_write_lag_particles ( real(wp), intent(in) qtime)
private

Subroutine that writes on each time step the changes of the lagrangian bubbles.

Parameters
q_timeCurrent time
Here is the caller graph for this function:

◆ s_write_restart_lag_bubbles()

subroutine __m_bubbles_el_fpp_f90__::s_write_restart_lag_bubbles ( integer, intent(in) t_step)
private

Subroutine that writes the restarting files for the particles in the lagrangian solver.

Parameters
t_stepCurrent time step
Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_write_void_evol()

subroutine __m_bubbles_el_fpp_f90__::s_write_void_evol ( real(wp), intent(in) qtime)
private

Subroutine that writes some useful statistics related to the volume fraction of the particles (void fraction) in the computatioational domain on each time step.

Parameters
q_timeCurrent time
Here is the call graph for this function:
Here is the caller graph for this function: