Neko 0.9.99
A portable framework for high-order spectral element flow simulations
Loading...
Searching...
No Matches
scalar_pnpn::scalar_pnpn_t Type Referenceabstract
Inheritance diagram for scalar_pnpn::scalar_pnpn_t:
Collaboration diagram for scalar_pnpn::scalar_pnpn_t:

Public Member Functions

procedure, pass(thisinit (this, msh, coef, gs, params, user, ulag, vlag, wlag, time_scheme, rho)
 Constructor.
 
procedure, pass(thisrestart (this, dtlag, tlag)
 To restart.
 
procedure, pass(thisfree (this)
 Destructor.
 
procedure, pass(thisstep (this, t, tstep, dt, ext_bdf, dt_controller)
 Solve for the current timestep.
 
procedure, pass(thisscheme_init (this, msh, c_xh, gs_xh, params, scheme, user, rho)
 Constructor for the base type.
 
procedure, pass(thisscheme_free (this)
 Destructor for the base type.
 
procedure, pass(thisvalidate (this)
 Validate successful initialization.
 
procedure, pass(thisset_user_bc (this, usr_eval)
 Assigns the evaluation function for user_bc.
 
procedure, pass(thisset_material_properties (this, params, user)
 Set lambda and cp.
 
procedure, pass(thisupdate_material_properties (this)
 Update variable material properties.
 
procedure(scalar_scheme_init_intrf), deferred, pass init (this, msh, coef, gs, params, user, ulag, vlag, wlag, time_scheme, rho)
 Constructor.
 
procedure(scalar_scheme_free_intrf), deferred, pass free (this)
 Destructor.
 
procedure(scalar_scheme_step_intrf), deferred, pass step (this, t, tstep, dt, ext_bdf, dt_controller)
 Solve for the current timestep.
 
procedure(scalar_scheme_restart_intrf), deferred, pass restart (this, dtlag, tlag)
 Restart from a checkpoint.
 

Public Attributes

type(field_ts_res
 The residual of the transport equation.
 
type(field_tds
 Solution increment.
 
class(ax_t), allocatable ax
 Helmholz operator.
 
type(projection_tproj_s
 Solution projection.
 
type(dirichlet_tbc_res
 Dirichlet conditions for the residual Collects all the Dirichlet condition facets into one bc and applies 0, Since the values never change there during the solve.
 
type(bc_list_tbclst_ds
 A bc list for the bc_res. Contains only that, essentially just to wrap the if statement determining whether to apply on the device or CPU.
 
class(advection_t), allocatable adv
 Advection operator.
 
logical oifs
 
type(field_tabx1
 
type(field_tabx2
 
type(field_tadvs
 
class(scalar_residual_t), allocatable res
 Computes the residual.
 
class(rhs_maker_ext_t), allocatable makeext
 Contributions to kth order extrapolation scheme.
 
class(rhs_maker_bdf_t), allocatable makebdf
 Contributions to the RHS from lagged BDF terms.
 
class(rhs_maker_oifs_t), allocatable makeoifs
 Contributions to the RHS from the OIFS method.
 
type(field_t), pointer u
 x-component of Velocity
 
type(field_t), pointer v
 y-component of Velocity
 
type(field_t), pointer w
 z-component of Velocity
 
type(field_t), pointer s
 The scalar.
 
type(field_series_tslag
 Lag arrays, i.e. solutions at previous timesteps.
 
type(space_t), pointer xh
 Function space \( X_h \).
 
type(dofmap_t), pointer dm_xh
 Dofmap associated with \( X_h \).
 
type(gs_t), pointer gs_xh
 Gather-scatter associated with \( X_h \).
 
type(coef_t), pointer c_xh
 Coefficients associated with \( X_h \).
 
type(field_t), pointer f_xh => null()
 Right-hand side.
 
type(scalar_source_term_t) source_term
 The source term for equation.
 
class(ksp_t), allocatable ksp
 Krylov solver.
 
integer ksp_maxiter
 Max iterations in the Krylov solver.
 
integer projection_dim
 Projection space size.
 
integer projection_activ_step
 
class(pc_t), allocatable pc
 Preconditioner.
 
type(dirichlet_t), dimension(neko_msh_max_zlbls) dir_bcs
 Dirichlet conditions.
 
type(field_dirichlet_t) field_dir_bc
 Field Dirichlet conditions.
 
type(bc_list_tfield_dirichlet_bcs
 List of BC objects to pass to user_dirichlet_update.
 
type(neumann_t), dimension(neko_msh_max_zlbls) neumann_bcs
 Neumann conditions.
 
type(usr_scalar_t) user_bc
 User Dirichlet conditions.
 
integer n_dir_bcs = 0
 Number of Dirichlet bcs.
 
integer n_neumann_bcs = 0
 Number of Neumann bcs.
 
type(bc_list_tbclst_dirichlet
 List of Dirichlet boundary conditions, including the user one.
 
type(bc_list_tbclst_neumann
 List of Neumann conditions list.
 
type(json_file), pointer params
 Case paramters.
 
type(mesh_t), pointer msh => null()
 Mesh.
 
type(chkp_tchkp
 Checkpoint for restarts.
 
real(kind=rp) lambda
 Thermal diffusivity.
 
type(field_tlambda_field
 The variable lambda field.
 
character(len=:), allocatable nut_field_name
 The turbulent kinematic viscosity field name.
 
real(kind=rp) rho
 Density.
 
real(kind=rp) cp
 Specific heat capacity.
 
real(kind=rp) pr_turb
 Turbulent Prandtl number.
 
logical variable_material_properties = .false.
 Is lambda varying in time? Currently only due to LES models.
 
character(len=neko_msh_max_zlbl_len), dimension(:), allocatable bc_labels
 Boundary condition labels (if any)
 
logical if_gradient_jump_penalty
 Gradient jump panelty.
 
type(gradient_jump_penalty_t) gradient_jump_penalty
 

Detailed Description

Definition at line 72 of file scalar_pnpn.f90.

Member Function/Subroutine Documentation

◆ free() [1/2]

procedure, pass(this) scalar_pnpn::scalar_pnpn_t::free ( class(scalar_pnpn_t), intent(inout this)

Definition at line 125 of file scalar_pnpn.f90.

◆ free() [2/2]

procedure(scalar_scheme_free_intrf), deferred, pass scalar_scheme::scalar_scheme_t::free ( class(scalar_scheme_t), intent(inout this)
pure virtualinherited

Definition at line 173 of file scalar_scheme.f90.

◆ init() [1/2]

procedure, pass(this) scalar_pnpn::scalar_pnpn_t::init ( class(scalar_pnpn_t), intent(inout), target  this,
type(mesh_t), intent(in), target  msh,
type(coef_t), intent(in), target  coef,
type(gs_t), intent(inout), target  gs,
type(json_file), intent(inout), target  params,
type(user_t), intent(in), target  user,
type(field_series_t), intent(in), target  ulag,
type(field_series_t), intent(in), target  vlag,
type(field_series_t), intent(in), target  wlag,
type(time_scheme_controller_t), intent(in), target  time_scheme,
real(kind=rp), intent(in rho 
)
Parameters
mshThe mesh.
coefThe coefficients.
gsThe gather-scatter.
paramsThe case parameter file in json.
userType with user-defined procedures.

Definition at line 121 of file scalar_pnpn.f90.

◆ init() [2/2]

procedure(scalar_scheme_init_intrf), deferred, pass scalar_scheme::scalar_scheme_t::init ( class(scalar_scheme_t), intent(inout), target  this,
type(mesh_t), intent(in), target  msh,
type(coef_t), intent(in), target  coef,
type(gs_t), intent(inout), target  gs,
type(json_file), intent(inout), target  params,
type(user_t), intent(in), target  user,
type(field_series_t), intent(in), target  ulag,
type(field_series_t), intent(in), target  vlag,
type(field_series_t), intent(in), target  wlag,
type(time_scheme_controller_t), intent(in), target  time_scheme,
real(kind=rp), intent(in rho 
)
pure virtualinherited

Definition at line 171 of file scalar_scheme.f90.

◆ restart() [1/2]

procedure, pass(this) scalar_pnpn::scalar_pnpn_t::restart ( class(scalar_pnpn_t), intent(inout), target  this,
real(kind=rp), dimension(10)  dtlag,
real(kind=rp), dimension(10)  tlag 
)

Definition at line 123 of file scalar_pnpn.f90.

◆ restart() [2/2]

procedure(scalar_scheme_restart_intrf), deferred, pass scalar_scheme::scalar_scheme_t::restart ( class(scalar_scheme_t), intent(inout), target  this,
real(kind=rp), dimension(10)  dtlag,
real(kind=rp), dimension(10)  tlag 
)
pure virtualinherited

Definition at line 177 of file scalar_scheme.f90.

◆ scheme_free()

procedure, pass(this) scalar_scheme::scalar_scheme_t::scheme_free ( class(scalar_scheme_t), intent(inout this)
inherited

Definition at line 159 of file scalar_scheme.f90.

◆ scheme_init()

procedure, pass(this) scalar_scheme::scalar_scheme_t::scheme_init ( class(scalar_scheme_t), intent(inout), target  this,
type(mesh_t), intent(in), target  msh,
type(coef_t), intent(in), target  c_xh,
type(gs_t), intent(inout), target  gs_xh,
type(json_file), intent(inout), target  params,
character(len=*), intent(in scheme,
type(user_t), intent(in), target  user,
real(kind=rp), intent(in rho 
)
inherited
Parameters
mshThe mesh.
c_XhThe coefficients.
gs_XhThe gather-scatter.
paramsThe case parameter file in json.
schemeThe name of the scalar scheme.
userType with user-defined procedures.
rhoThe density of the fluid.

Definition at line 157 of file scalar_scheme.f90.

◆ set_material_properties()

procedure, pass(this) scalar_scheme::scalar_scheme_t::set_material_properties ( class(scalar_scheme_t), intent(inout this,
type(json_file), intent(inout params,
type(user_t), intent(in), target  user 
)
inherited
Parameters
paramsThe case parameter file.
userThe user interface.

Definition at line 165 of file scalar_scheme.f90.

◆ set_user_bc()

procedure, pass(this) scalar_scheme::scalar_scheme_t::set_user_bc ( class(scalar_scheme_t), intent(inout this,
procedure(usr_scalar_bc_eval usr_eval 
)
inherited
Parameters
usr_evalUser specified boundary condition for scalar field

Definition at line 163 of file scalar_scheme.f90.

◆ step() [1/2]

procedure, pass(this) scalar_pnpn::scalar_pnpn_t::step ( class(scalar_pnpn_t), intent(inout this,
real(kind=rp), intent(in t,
integer, intent(in tstep,
real(kind=rp), intent(in dt,
type(time_scheme_controller_t), intent(in ext_bdf,
type(time_step_controller_t), intent(in dt_controller 
)

Definition at line 127 of file scalar_pnpn.f90.

◆ step() [2/2]

procedure(scalar_scheme_step_intrf), deferred, pass scalar_scheme::scalar_scheme_t::step ( class(scalar_scheme_t), intent(inout this,
real(kind=rp), intent(in t,
integer, intent(in tstep,
real(kind=rp), intent(in dt,
type(time_scheme_controller_t), intent(in ext_bdf,
type(time_step_controller_t), intent(in dt_controller 
)
pure virtualinherited

Definition at line 175 of file scalar_scheme.f90.

◆ update_material_properties()

procedure, pass(this) scalar_scheme::scalar_scheme_t::update_material_properties ( class(scalar_scheme_t), intent(inout this)
inherited

Definition at line 168 of file scalar_scheme.f90.

◆ validate()

procedure, pass(this) scalar_scheme::scalar_scheme_t::validate ( class(scalar_scheme_t), intent(inout), target  this)
inherited

Definition at line 161 of file scalar_scheme.f90.

Member Data Documentation

◆ abx1

type(field_t) scalar_pnpn::scalar_pnpn_t::abx1

Definition at line 102 of file scalar_pnpn.f90.

◆ abx2

type(field_t) scalar_pnpn::scalar_pnpn_t::abx2

Definition at line 102 of file scalar_pnpn.f90.

◆ adv

class(advection_t), allocatable scalar_pnpn::scalar_pnpn_t::adv

Definition at line 96 of file scalar_pnpn.f90.

◆ advs

type(field_t) scalar_pnpn::scalar_pnpn_t::advs

Definition at line 105 of file scalar_pnpn.f90.

◆ ax

class(ax_t), allocatable scalar_pnpn::scalar_pnpn_t::ax

Definition at line 81 of file scalar_pnpn.f90.

◆ bc_labels

character(len=neko_msh_max_zlbl_len), dimension(:), allocatable scalar_scheme::scalar_scheme_t::bc_labels
inherited

Definition at line 151 of file scalar_scheme.f90.

◆ bc_res

type(dirichlet_t) scalar_pnpn::scalar_pnpn_t::bc_res

Definition at line 89 of file scalar_pnpn.f90.

◆ bclst_dirichlet

type(bc_list_t) scalar_scheme::scalar_scheme_t::bclst_dirichlet
inherited

Definition at line 127 of file scalar_scheme.f90.

◆ bclst_ds

type(bc_list_t) scalar_pnpn::scalar_pnpn_t::bclst_ds

Definition at line 93 of file scalar_pnpn.f90.

◆ bclst_neumann

type(bc_list_t) scalar_scheme::scalar_scheme_t::bclst_neumann
inherited

Definition at line 129 of file scalar_scheme.f90.

◆ c_xh

type(coef_t), pointer scalar_scheme::scalar_scheme_t::c_xh
inherited

Definition at line 97 of file scalar_scheme.f90.

◆ chkp

type(chkp_t) scalar_scheme::scalar_scheme_t::chkp
inherited

Definition at line 135 of file scalar_scheme.f90.

◆ cp

real(kind=rp) scalar_scheme::scalar_scheme_t::cp
inherited

Definition at line 145 of file scalar_scheme.f90.

◆ dir_bcs

type(dirichlet_t), dimension(neko_msh_max_zlbls) scalar_scheme::scalar_scheme_t::dir_bcs
inherited

Definition at line 113 of file scalar_scheme.f90.

◆ dm_xh

type(dofmap_t), pointer scalar_scheme::scalar_scheme_t::dm_xh
inherited

Definition at line 93 of file scalar_scheme.f90.

◆ ds

type(field_t) scalar_pnpn::scalar_pnpn_t::ds

Definition at line 78 of file scalar_pnpn.f90.

◆ f_xh

type(field_t), pointer scalar_scheme::scalar_scheme_t::f_xh => null()
inherited

Definition at line 99 of file scalar_scheme.f90.

◆ field_dir_bc

type(field_dirichlet_t) scalar_scheme::scalar_scheme_t::field_dir_bc
inherited

Definition at line 115 of file scalar_scheme.f90.

◆ field_dirichlet_bcs

type(bc_list_t) scalar_scheme::scalar_scheme_t::field_dirichlet_bcs
inherited

Definition at line 117 of file scalar_scheme.f90.

◆ gradient_jump_penalty

type(gradient_jump_penalty_t) scalar_scheme::scalar_scheme_t::gradient_jump_penalty
inherited

Definition at line 154 of file scalar_scheme.f90.

◆ gs_xh

type(gs_t), pointer scalar_scheme::scalar_scheme_t::gs_xh
inherited

Definition at line 95 of file scalar_scheme.f90.

◆ if_gradient_jump_penalty

logical scalar_scheme::scalar_scheme_t::if_gradient_jump_penalty
inherited

Definition at line 153 of file scalar_scheme.f90.

◆ ksp

class(ksp_t), allocatable scalar_scheme::scalar_scheme_t::ksp
inherited

Definition at line 103 of file scalar_scheme.f90.

◆ ksp_maxiter

integer scalar_scheme::scalar_scheme_t::ksp_maxiter
inherited

Definition at line 105 of file scalar_scheme.f90.

◆ lambda

real(kind=rp) scalar_scheme::scalar_scheme_t::lambda
inherited

Definition at line 137 of file scalar_scheme.f90.

◆ lambda_field

type(field_t) scalar_scheme::scalar_scheme_t::lambda_field
inherited

Definition at line 139 of file scalar_scheme.f90.

◆ makebdf

class(rhs_maker_bdf_t), allocatable scalar_pnpn::scalar_pnpn_t::makebdf

Definition at line 114 of file scalar_pnpn.f90.

◆ makeext

class(rhs_maker_ext_t), allocatable scalar_pnpn::scalar_pnpn_t::makeext

Definition at line 111 of file scalar_pnpn.f90.

◆ makeoifs

class(rhs_maker_oifs_t), allocatable scalar_pnpn::scalar_pnpn_t::makeoifs

Definition at line 117 of file scalar_pnpn.f90.

◆ msh

type(mesh_t), pointer scalar_scheme::scalar_scheme_t::msh => null()
inherited

Definition at line 133 of file scalar_scheme.f90.

◆ n_dir_bcs

integer scalar_scheme::scalar_scheme_t::n_dir_bcs = 0
inherited

Definition at line 123 of file scalar_scheme.f90.

◆ n_neumann_bcs

integer scalar_scheme::scalar_scheme_t::n_neumann_bcs = 0
inherited

Definition at line 125 of file scalar_scheme.f90.

◆ neumann_bcs

type(neumann_t), dimension(neko_msh_max_zlbls) scalar_scheme::scalar_scheme_t::neumann_bcs
inherited

Definition at line 119 of file scalar_scheme.f90.

◆ nut_field_name

character(len=:), allocatable scalar_scheme::scalar_scheme_t::nut_field_name
inherited

Definition at line 141 of file scalar_scheme.f90.

◆ oifs

logical scalar_pnpn::scalar_pnpn_t::oifs

Definition at line 99 of file scalar_pnpn.f90.

◆ params

type(json_file), pointer scalar_scheme::scalar_scheme_t::params
inherited

Definition at line 131 of file scalar_scheme.f90.

◆ pc

class(pc_t), allocatable scalar_scheme::scalar_scheme_t::pc
inherited

Definition at line 111 of file scalar_scheme.f90.

◆ pr_turb

real(kind=rp) scalar_scheme::scalar_scheme_t::pr_turb
inherited

Definition at line 147 of file scalar_scheme.f90.

◆ proj_s

type(projection_t) scalar_pnpn::scalar_pnpn_t::proj_s

Definition at line 84 of file scalar_pnpn.f90.

◆ projection_activ_step

integer scalar_scheme::scalar_scheme_t::projection_activ_step
inherited

Definition at line 109 of file scalar_scheme.f90.

◆ projection_dim

integer scalar_scheme::scalar_scheme_t::projection_dim
inherited

Steps to activate projection for ksp

Definition at line 107 of file scalar_scheme.f90.

◆ res

class(scalar_residual_t), allocatable scalar_pnpn::scalar_pnpn_t::res

Definition at line 108 of file scalar_pnpn.f90.

◆ rho

real(kind=rp) scalar_scheme::scalar_scheme_t::rho
inherited

Definition at line 143 of file scalar_scheme.f90.

◆ s

type(field_t), pointer scalar_scheme::scalar_scheme_t::s
inherited

Definition at line 87 of file scalar_scheme.f90.

◆ s_res

type(field_t) scalar_pnpn::scalar_pnpn_t::s_res

Definition at line 75 of file scalar_pnpn.f90.

◆ slag

type(field_series_t) scalar_scheme::scalar_scheme_t::slag
inherited

Definition at line 89 of file scalar_scheme.f90.

◆ source_term

type(scalar_source_term_t) scalar_scheme::scalar_scheme_t::source_term
inherited

Definition at line 101 of file scalar_scheme.f90.

◆ u

type(field_t), pointer scalar_scheme::scalar_scheme_t::u
inherited

Definition at line 81 of file scalar_scheme.f90.

◆ user_bc

type(usr_scalar_t) scalar_scheme::scalar_scheme_t::user_bc
inherited

Definition at line 121 of file scalar_scheme.f90.

◆ v

type(field_t), pointer scalar_scheme::scalar_scheme_t::v
inherited

Definition at line 83 of file scalar_scheme.f90.

◆ variable_material_properties

logical scalar_scheme::scalar_scheme_t::variable_material_properties = .false.
inherited

Definition at line 149 of file scalar_scheme.f90.

◆ w

type(field_t), pointer scalar_scheme::scalar_scheme_t::w
inherited

Definition at line 85 of file scalar_scheme.f90.

◆ xh

type(space_t), pointer scalar_scheme::scalar_scheme_t::xh
inherited

Definition at line 91 of file scalar_scheme.f90.


The documentation for this type was generated from the following file: