Functions/Subroutines | Variables
module_parameters Module Reference

Functions/Subroutines

subroutine initiate_parameters
 
subroutine initiate_mpi
 
subroutine finalize_mpi
 
subroutine initiate_indices
 
subroutine get_mesh_param
 
subroutine calculate_ubar (u)
 
subroutine get_fft_plan
 
subroutine update_ri (stps)
 
subroutine update_dpx_drive
 
subroutine assign_rk_coeff (a_in, b_in, c_in)
 

Variables

real(mytype), parameter pi =3.1415926535897932_mytype
 
integer, save, protected p_row
 
integer, save, protected p_col
 
real(mytype), save, protected lx
 
real(mytype), save, protected ly
 
real(mytype), save, protected lz
 
integer, save, protected nx
 
integer, save, protected ny
 
integer, save, protected nz
 
real(mytype), save, protected zstretch
 
integer, save, protected ochannel
 
integer, save, protected dp_opt
 
integer, save, protected issk
 
integer, save, protected cds
 
integer, save, protected dts
 
real(mytype), save, protected dt
 
integer, save, protected imax
 
real(mytype), save, protected nu
 
real(mytype), save, protected alpha
 
real(mytype), save, protected got
 
real(mytype), save, protected fc
 
real(mytype), save, protected ug
 
real(mytype), save, protected vg
 
integer, save, protected isscalar
 
real(mytype), save, protected t_ref
 
real(mytype), save, protected tbot
 
real(mytype), save, protected ttop
 
integer, save, protected is_ri_var
 
real(mytype), save, protected ri_str
 
real(mytype), save, protected ri_end
 
integer, save, protected isnoise
 
real(mytype), save, protected noise_mag
 
integer, save, protected isdamp
 
integer, save, protected nzdamp
 
real(mytype), save, protected cdamp
 
real(mytype), save, protected u_mrf
 
integer, save, protected ibackup
 
integer, save, protected iinstfl
 
integer, save, protected imeanfl
 
integer, save, protected restart
 
integer, save, protected istmsr
 
integer, save, protected isxy2d
 
integer, dimension(50), save, protected xy2d_id
 
integer, save, protected isxz2d
 
integer, dimension(50), save, protected xz2d_id
 
integer, save, protected isyz2d
 
integer, dimension(50), save, protected yz2d_id
 
integer, save, protected intv_2d
 
integer, save, protected nprc
 
complex(mytype), parameter iii =cmplx(0.d0, 1.d0, kind=mytype)
 
real(mytype), save, protected dx
 
real(mytype), save, protected dy
 
real(mytype), save, protected dx2
 
real(mytype), save, protected dy2
 
integer, parameter ghst =2
 
integer, save, protected istr3
 
integer, save, protected iend3
 
integer, save, protected jstr3
 
integer, save, protected jend3
 
integer, save, protected kstr3
 
integer, save, protected kend3
 
integer, save, protected nia1
 
integer, save, protected nja1
 
integer, save, protected nka1
 
integer, save, protected nia2
 
integer, save, protected nja2
 
integer, save, protected nka2
 
integer, save, protected nia3
 
integer, save, protected nja3
 
integer, save, protected nka3
 
integer, save, protected i_offset
 
integer, save, protected j_offset
 
real(mytype), save div_hist_max =0.d0
 
real(mytype), save time_sim =0.d0
 
real(mytype), save cfl_max =0.d0
 
real(mytype), save, protected dpx_drive
 
real(mytype), save, protected dpx_coef
 
real(mytype), save, protected ubar
 
complex(mytype), save, protected wx1
 
complex(mytype), save, protected wy1
 
real(mytype), dimension(3), parameter rkc1 =(/8.d0/15.d0,5.d0/12.d0,3.d0/4.d0/)
 
real(mytype), dimension(3), parameter rkc2 =(/0.d0,-17.d0/60.d0,-5.d0/12.d0/)
 
real(mytype), dimension(3), parameter rkc3 =(/8.d0/15.d0,2.d0/15.d0,1.d0/3.d0/)
 
real(mytype), save, protected rk_a
 
real(mytype), save, protected rk_b
 
real(mytype), save, protected rk_c
 
real(mytype), dimension(:), allocatable, save, protected dz
 
real(mytype), dimension(:), allocatable, save, protected l_t
 
real(mytype), dimension(:), allocatable, save, protected l_b
 
real(mytype), dimension(:), allocatable, save, protected dz_t
 
real(mytype), dimension(:), allocatable, save, protected dz_b
 
integer, save, protected myid
 
integer, save, protected myid_rowindx
 
integer, save, protected myid_colindx
 
integer, save ierr
 
integer, dimension(:,:), allocatable, save, protected pij
 
type(c_ptr), save, protected fft_plan1
 
type(c_ptr), save, protected ifft_plan1
 
type(c_ptr), save, protected fft_plan2
 
type(c_ptr), save, protected ifft_plan2
 

Function/Subroutine Documentation

◆ initiate_parameters()

subroutine module_parameters::initiate_parameters ( )

Definition at line 243 of file module_parameters.f90.

References dp_opt, dpx_coef, dpx_drive, dx, dx2, dy, dy2, dz, dz_b, dz_t, ghst, iii, l_b, l_t, lx, ly, nu, nx, ny, nz, p_col, p_row, pi, pij, ubar, wx1, and wy1.

Referenced by main().

Here is the caller graph for this function:

◆ initiate_mpi()

subroutine module_parameters::initiate_mpi ( )

Definition at line 324 of file module_parameters.f90.

References ierr, myid, nprc, p_col, and p_row.

Referenced by main().

Here is the caller graph for this function:

◆ finalize_mpi()

subroutine module_parameters::finalize_mpi ( )

Definition at line 357 of file module_parameters.f90.

References ierr.

Referenced by main().

Here is the caller graph for this function:

◆ initiate_indices()

subroutine module_parameters::initiate_indices ( )

Definition at line 372 of file module_parameters.f90.

References ghst, i_offset, iend3, istr3, j_offset, jend3, jstr3, kend3, kstr3, myid, myid_colindx, myid_rowindx, nia1, nia2, nia3, nja1, nja2, nja3, nka1, nka2, nka3, nx, ny, p_col, p_row, and pij.

Referenced by main().

Here is the caller graph for this function:

◆ get_mesh_param()

subroutine module_parameters::get_mesh_param ( )

Definition at line 433 of file module_parameters.f90.

References dz, dz_b, dz_t, ghst, kend3, kstr3, l_b, l_t, lz, myid, nz, ochannel, and zstretch.

Referenced by module_navier_stokes::drive().

Here is the caller graph for this function:

◆ calculate_ubar()

subroutine module_parameters::calculate_ubar ( real(mytype), dimension(:,:,:), intent(in)  u)

Definition at line 514 of file module_parameters.f90.

References dz, iend3, ierr, istr3, jend3, jstr3, kend3, kstr3, lz, nprc, and ubar.

Referenced by module_navier_stokes::drive().

Here is the caller graph for this function:

◆ get_fft_plan()

subroutine module_parameters::get_fft_plan ( )

Definition at line 552 of file module_parameters.f90.

References fft_plan1, fft_plan2, ifft_plan1, ifft_plan2, nx, and ny.

Referenced by module_navier_stokes::drive().

Here is the caller graph for this function:

◆ update_ri()

subroutine module_parameters::update_ri ( integer, intent(in)  stps)

Definition at line 581 of file module_parameters.f90.

References got, imax, ri_end, and ri_str.

Referenced by module_navier_stokes::drive().

Here is the caller graph for this function:

◆ update_dpx_drive()

subroutine module_parameters::update_dpx_drive ( )

Definition at line 595 of file module_parameters.f90.

References dp_opt, dpx_coef, dpx_drive, u_mrf, and ubar.

Referenced by module_cnvdiff::get_momentum_cnvdiff(), and module_spectral::get_momentum_cnvdiff_spec().

Here is the caller graph for this function:

◆ assign_rk_coeff()

subroutine module_parameters::assign_rk_coeff ( real(mytype), intent(in)  a_in,
real(mytype), intent(in)  b_in,
real(mytype), intent(in)  c_in 
)

Definition at line 619 of file module_parameters.f90.

References dts, rk_a, rk_b, and rk_c.

Referenced by module_navier_stokes::time_advancement_fd(), and module_navier_stokes::time_advancement_sp().

Here is the caller graph for this function:

Variable Documentation

◆ pi

real(mytype), parameter pi =3.1415926535897932_mytype

◆ p_row

integer, save, protected p_row

◆ p_col

integer, save, protected p_col

◆ lx

real(mytype), save, protected lx

◆ ly

real(mytype), save, protected ly

◆ lz

real(mytype), save, protected lz

Definition at line 47 of file module_parameters.f90.

Referenced by calculate_ubar(), get_mesh_param(), and welcome_info().

◆ nx

integer, save, protected nx

◆ ny

integer, save, protected ny

◆ nz

integer, save, protected nz

◆ zstretch

real(mytype), save, protected zstretch

Definition at line 55 of file module_parameters.f90.

Referenced by get_mesh_param(), and welcome_info().

◆ ochannel

integer, save, protected ochannel

◆ dp_opt

integer, save, protected dp_opt

◆ issk

integer, save, protected issk

◆ cds

integer, save, protected cds

◆ dts

integer, save, protected dts

◆ dt

real(mytype), save, protected dt

◆ imax

integer, save, protected imax

Definition at line 81 of file module_parameters.f90.

Referenced by module_navier_stokes::drive(), update_ri(), and welcome_info().

◆ nu

real(mytype), save, protected nu

◆ alpha

real(mytype), save, protected alpha

◆ got

real(mytype), save, protected got

◆ fc

real(mytype), save, protected fc

◆ ug

real(mytype), save, protected ug

◆ vg

real(mytype), save, protected vg

◆ isscalar

integer, save, protected isscalar

◆ t_ref

real(mytype), save, protected t_ref

◆ tbot

real(mytype), save, protected tbot

◆ ttop

real(mytype), save, protected ttop

◆ is_ri_var

integer, save, protected is_ri_var

◆ ri_str

real(mytype), save, protected ri_str

Definition at line 103 of file module_parameters.f90.

Referenced by update_ri(), and welcome_info().

◆ ri_end

real(mytype), save, protected ri_end

Definition at line 104 of file module_parameters.f90.

Referenced by update_ri(), and welcome_info().

◆ isnoise

integer, save, protected isnoise

Definition at line 107 of file module_parameters.f90.

Referenced by module_tools::initiate_fields().

◆ noise_mag

real(mytype), save, protected noise_mag

Definition at line 108 of file module_parameters.f90.

Referenced by module_tools::add_noise2fields().

◆ isdamp

integer, save, protected isdamp

◆ nzdamp

integer, save, protected nzdamp

◆ cdamp

real(mytype), save, protected cdamp

◆ u_mrf

real(mytype), save, protected u_mrf

◆ ibackup

integer, save, protected ibackup

Definition at line 121 of file module_parameters.f90.

Referenced by module_navier_stokes::drive().

◆ iinstfl

integer, save, protected iinstfl

◆ imeanfl

integer, save, protected imeanfl

Definition at line 123 of file module_parameters.f90.

Referenced by module_navier_stokes::drive().

◆ restart

integer, save, protected restart

Definition at line 126 of file module_parameters.f90.

Referenced by module_tools::initiate_fields().

◆ istmsr

integer, save, protected istmsr

Definition at line 127 of file module_parameters.f90.

Referenced by module_navier_stokes::drive().

◆ isxy2d

integer, save, protected isxy2d

◆ xy2d_id

integer, dimension(50), save, protected xy2d_id

Definition at line 132 of file module_parameters.f90.

Referenced by module_io::output_2d_slices().

◆ isxz2d

integer, save, protected isxz2d

◆ xz2d_id

integer, dimension(50), save, protected xz2d_id

Definition at line 136 of file module_parameters.f90.

Referenced by module_io::output_2d_slices().

◆ isyz2d

integer, save, protected isyz2d

◆ yz2d_id

integer, dimension(50), save, protected yz2d_id

Definition at line 140 of file module_parameters.f90.

Referenced by module_io::output_2d_slices().

◆ intv_2d

integer, save, protected intv_2d

◆ nprc

integer, save, protected nprc

◆ iii

complex(mytype), parameter iii =cmplx(0.d0, 1.d0, kind=mytype)

◆ dx

real(mytype), save, protected dx

◆ dy

real(mytype), save, protected dy

◆ dx2

real(mytype), save, protected dx2

◆ dy2

real(mytype), save, protected dy2

◆ ghst

integer, parameter ghst =2

◆ istr3

integer, save, protected istr3

◆ iend3

integer, save, protected iend3

◆ jstr3

integer, save, protected jstr3

◆ jend3

integer, save, protected jend3

◆ kstr3

integer, save, protected kstr3

Definition at line 179 of file module_parameters.f90.

Referenced by module_tools::add_noise2fields(), module_tools::calculate_mean_fields(), module_spectral::calculate_mean_fields_spec(), module_navier_stokes::calculate_new_p(), module_spectral::calculate_new_p_spec(), calculate_ubar(), module_navier_stokes::calculate_uvw(), module_spectral::calculate_uvw_spec(), module_boundary::comm_bound(), module_spectral::get_div_spec(), module_tools::get_interp_fields_thxyz(), module_tools::get_interp_fields_uvwhxyz(), get_mesh_param(), module_cnvdiff::get_momentum_cnvdiff(), module_spectral::get_momentum_cnvdiff_spec(), module_poisson_solver::get_p_eqn_coeff(), module_poisson_solver::get_p_eqn_src(), module_poisson_solver::get_t_eqn_coeff(), module_cnvdiff::get_temperature_cnvdiff(), module_spectral::get_temperature_cnvdiff_spec(), module_poisson_solver::get_u_eqn_coeff(), module_poisson_solver::get_w_eqn_coeff(), initiate_indices(), module_io::output_2d_slices(), module_io::output_backup(), module_io::output_inst_fields(), module_io::output_mean_fields(), module_io::output_time_series(), module_poisson_solver::poisson_solver_fft(), module_spectral::poisson_solver_fft_spec(), module_tools::read_init_fields(), module_io::screen_cpu_time(), module_io::screen_div_error(), module_spectral::screen_div_error_spec(), module_boundary::update_boundary_p(), module_boundary::update_boundary_t(), module_boundary::update_boundary_thxyz(), module_boundary::update_boundary_uvw(), and module_boundary::update_boundary_uvwhxyz().

◆ kend3

integer, save, protected kend3

Definition at line 179 of file module_parameters.f90.

Referenced by module_tools::add_noise2fields(), module_tools::calculate_mean_fields(), module_spectral::calculate_mean_fields_spec(), module_navier_stokes::calculate_new_p(), module_spectral::calculate_new_p_spec(), calculate_ubar(), module_navier_stokes::calculate_uvw(), module_spectral::calculate_uvw_spec(), module_boundary::comm_bound(), module_spectral::get_div_spec(), module_tools::get_interp_fields_thxyz(), module_tools::get_interp_fields_uvwhxyz(), get_mesh_param(), module_cnvdiff::get_momentum_cnvdiff(), module_spectral::get_momentum_cnvdiff_spec(), module_poisson_solver::get_p_eqn_coeff(), module_poisson_solver::get_p_eqn_src(), module_poisson_solver::get_t_eqn_coeff(), module_cnvdiff::get_temperature_cnvdiff(), module_spectral::get_temperature_cnvdiff_spec(), module_poisson_solver::get_u_eqn_coeff(), module_poisson_solver::get_w_eqn_coeff(), initiate_indices(), module_io::output_2d_slices(), module_io::output_backup(), module_io::output_inst_fields(), module_io::output_mean_fields(), module_io::output_time_series(), module_poisson_solver::poisson_solver_fft(), module_spectral::poisson_solver_fft_spec(), module_tools::rayleigh_damping(), module_spectral::rayleigh_damping_spec(), module_tools::read_init_fields(), module_io::screen_cpu_time(), module_io::screen_div_error(), module_spectral::screen_div_error_spec(), module_boundary::update_boundary_p(), module_boundary::update_boundary_t(), module_boundary::update_boundary_thxyz(), module_boundary::update_boundary_uvw(), and module_boundary::update_boundary_uvwhxyz().

◆ nia1

integer, save, protected nia1

Definition at line 183 of file module_parameters.f90.

Referenced by initiate_indices().

◆ nja1

integer, save, protected nja1

Definition at line 183 of file module_parameters.f90.

Referenced by initiate_indices().

◆ nka1

integer, save, protected nka1

Definition at line 183 of file module_parameters.f90.

Referenced by initiate_indices().

◆ nia2

integer, save, protected nia2

Definition at line 184 of file module_parameters.f90.

Referenced by initiate_indices().

◆ nja2

integer, save, protected nja2

Definition at line 184 of file module_parameters.f90.

Referenced by initiate_indices().

◆ nka2

integer, save, protected nka2

Definition at line 184 of file module_parameters.f90.

Referenced by initiate_indices().

◆ nia3

integer, save, protected nia3

Definition at line 185 of file module_parameters.f90.

Referenced by module_tools::initiate_fields(), and initiate_indices().

◆ nja3

integer, save, protected nja3

Definition at line 185 of file module_parameters.f90.

Referenced by module_tools::initiate_fields(), and initiate_indices().

◆ nka3

integer, save, protected nka3

Definition at line 185 of file module_parameters.f90.

Referenced by module_tools::initiate_fields(), and initiate_indices().

◆ i_offset

integer, save, protected i_offset

◆ j_offset

integer, save, protected j_offset

◆ div_hist_max

real(mytype), save div_hist_max =0.d0

◆ time_sim

real(mytype), save time_sim =0.d0

◆ cfl_max

real(mytype), save cfl_max =0.d0

Definition at line 196 of file module_parameters.f90.

Referenced by module_io::screen_cpu_time().

◆ dpx_drive

real(mytype), save, protected dpx_drive

◆ dpx_coef

real(mytype), save, protected dpx_coef

Definition at line 203 of file module_parameters.f90.

Referenced by initiate_parameters(), and update_dpx_drive().

◆ ubar

real(mytype), save, protected ubar

◆ wx1

complex(mytype), save, protected wx1

◆ wy1

complex(mytype), save, protected wy1

◆ rkc1

real(mytype), dimension(3), parameter rkc1 =(/8.d0/15.d0,5.d0/12.d0,3.d0/4.d0/)

◆ rkc2

real(mytype), dimension(3), parameter rkc2 =(/0.d0,-17.d0/60.d0,-5.d0/12.d0/)

◆ rkc3

real(mytype), dimension(3), parameter rkc3 =(/8.d0/15.d0,2.d0/15.d0,1.d0/3.d0/)

◆ rk_a

real(mytype), save, protected rk_a

◆ rk_b

real(mytype), save, protected rk_b

◆ rk_c

real(mytype), save, protected rk_c

◆ dz

real(mytype), dimension(:), allocatable, save, protected dz

◆ l_t

real(mytype), dimension(:), allocatable, save, protected l_t

◆ l_b

real(mytype), dimension(:), allocatable, save, protected l_b

◆ dz_t

real(mytype), dimension(:), allocatable, save, protected dz_t

◆ dz_b

real(mytype), dimension(:), allocatable, save, protected dz_b

◆ myid

integer, save, protected myid

◆ myid_rowindx

integer, save, protected myid_rowindx

◆ myid_colindx

integer, save, protected myid_colindx

◆ ierr

integer, save ierr

◆ pij

integer, dimension(:,:), allocatable, save, protected pij

◆ fft_plan1

type(c_ptr), save, protected fft_plan1

◆ ifft_plan1

type(c_ptr), save, protected ifft_plan1

◆ fft_plan2

type(c_ptr), save, protected fft_plan2

◆ ifft_plan2

type(c_ptr), save, protected ifft_plan2