ERF
Energy Research and Forecasting: An Atmospheric Modeling Code
SHOCInterface Class Reference

#include <ERF_ShocInterface.H>

Collaboration diagram for SHOCInterface:

Classes

struct  Buffer
 
struct  SHOCPostprocess
 
struct  SHOCPreprocess
 

Public Member Functions

 SHOCInterface (const int &lev, SolverChoice &sc)
 
void set_grids (int &level, const amrex::BoxArray &ba, amrex::Geometry &geom, amrex::MultiFab *cons, amrex::MultiFab *xvel, amrex::MultiFab *yvel, amrex::MultiFab *zvel, amrex::Real *w_subsid, amrex::MultiFab *tau13, amrex::MultiFab *tau23, amrex::MultiFab *hfx3, amrex::MultiFab *qfx3, amrex::MultiFab *eddyDiffs, amrex::MultiFab *z_phys)
 
void initialize_impl ()
 
void run_impl (const Real dt)
 
void finalize_impl (const Real dt)
 
void alloc_buffers ()
 
void dealloc_buffers ()
 
void mf_to_kokkos_buffers ()
 
void kokkos_buffers_to_mf (const Real dt)
 
std::string name () const
 
void set_eddy_diffs ()
 
void set_diff_stresses ()
 
void add_fast_tend (amrex::Vector< amrex::MultiFab > &S_rhs)
 
void add_slow_tend (const amrex::MFIter &mfi, const amrex::Box &tbx, const amrex::Array4< amrex::Real > &cc_rhs_arr)
 

Protected Member Functions

void check_flux_state_consistency (const double dt)
 
void apply_turbulent_mountain_stress ()
 
void set_computed_group_impl ()
 
size_t requested_buffer_size_in_bytes () const
 
void init_buffers ()
 

Protected Attributes

amrex::Vector< int > m_col_offsets
 
Int m_num_cols = 0
 
Int m_num_layers = 0
 
Int m_npbl
 
Int m_nadv
 
Int m_num_tracers = 3
 
Int m_num_vel_comp = 2
 
Int hdtime
 
int m_lev
 
int m_step
 
amrex::Geometry m_geom
 
amrex::BoxArray m_ba
 
amrex::MultiFab * m_cons = nullptr
 
amrex::MultiFab * m_xvel = nullptr
 
amrex::MultiFab * m_yvel = nullptr
 
amrex::MultiFab * m_zvel = nullptr
 
amrex::Realm_w_subsid = nullptr
 
amrex::MultiFab * m_tau13 = nullptr
 
amrex::MultiFab * m_tau23 = nullptr
 
amrex::MultiFab * m_hfx3 = nullptr
 
amrex::MultiFab * m_qfx3 = nullptr
 
amrex::MultiFab * m_mu = nullptr
 
amrex::MultiFab * m_z_phys = nullptr
 
amrex::MultiFab c_tend
 
amrex::MultiFab u_tend
 
amrex::MultiFab v_tend
 
bool m_first_step = true
 
Buffer m_buffer
 
SHF::SHOCInput input
 
SHF::SHOCInputOutput input_output
 
SHF::SHOCOutput output
 
SHF::SHOCHistoryOutput history_output
 
SHF::SHOCRuntime runtime_options
 
SHOCPreprocess shoc_preprocess
 
SHOCPostprocess shoc_postprocess
 
ekat::WorkspaceManager< Spack, KT::Device > workspace_mgr
 
view_1d tot_buff_view
 
bool apply_tms = true
 
bool check_flux_state = false
 
bool extra_shoc_diags = false
 
bool column_conservation_check = false
 
view_2d omega
 
view_1d surf_sens_flux
 
sview_2d surf_mom_flux
 
view_1d surf_evap
 
view_2d T_mid
 
view_2d qv
 
view_1d surf_drag_coeff_tms
 
view_2d p_mid
 
view_2d p_int
 
view_2d pseudo_dens
 
view_1d phis
 
view_3d horiz_wind
 
view_2d sgs_buoy_flux
 
view_2d tk
 
view_2d cldfrac_liq
 
view_2d tke
 
view_2d qc
 
view_1d pblh
 
view_2d inv_qc_relvar
 
view_2d tkh
 
view_2d w_sec
 
view_2d cldfrac_liq_prev
 
view_1d ustar
 
view_1d obklen
 
view_2d brunt
 
view_2d shoc_mix
 
view_2d isotropy
 
view_2d shoc_cond
 
view_2d shoc_evap
 
view_2d wthl_sec
 
view_2d thl_sec
 
view_2d wqw_sec
 
view_2d qw_sec
 
view_2d uw_sec
 
view_2d vw_sec
 
view_2d w3
 
view_3d_strided qtracers
 
view_1d vapor_flux
 
view_1d water_flux
 
view_1d ice_flux
 
view_1d heat_flux
 

Private Types

using SHF = scream::shoc::Functions< Real, KokkosDefaultDevice >
 
using PF = scream::PhysicsFunctions< KokkosDefaultDevice >
 
using C = scream::physics::Constants< Real >
 
using KT = ekat::KokkosTypes< KokkosDefaultDevice >
 
using SC = scream::shoc::Constants< Real >
 
using Spack = typename SHF::Spack
 
using IntSmallPack = typename SHF::IntSmallPack
 
using Smask = typename SHF::Smask
 
using view_1d_int = typename KT::template view_1d< Int >
 
using view_1d = typename SHF::view_1d< Real >
 
using view_1d_const = typename SHF::view_1d< const Real >
 
using view_2d = typename SHF::view_2d< SHF::Spack >
 
using view_2d_const = typename SHF::view_2d< const Spack >
 
using sview_2d = typename KT::template view_2d< Real >
 
using sview_2d_const = typename KT::template view_2d< const Real >
 
using view_3d = typename SHF::view_3d< Spack >
 
using view_3d_const = typename SHF::view_3d< const Spack >
 
using view_3d_strided = typename SHF::view_3d_strided< Spack >
 
using WSM = ekat::WorkspaceManager< Spack, KT::Device >
 
template<typename ScalarT >
using uview_1d = ekat::Unmanaged< typename KT::template view_1d< ScalarT > >
 
template<typename ScalarT >
using uview_2d = ekat::Unmanaged< typename KT::template view_2d< ScalarT > >
 

Member Typedef Documentation

◆ C

using SHOCInterface::C = scream::physics::Constants<Real>
private

◆ IntSmallPack

using SHOCInterface::IntSmallPack = typename SHF::IntSmallPack
private

◆ KT

using SHOCInterface::KT = ekat::KokkosTypes<KokkosDefaultDevice>
private

◆ PF

using SHOCInterface::PF = scream::PhysicsFunctions<KokkosDefaultDevice>
private

◆ SC

using SHOCInterface::SC = scream::shoc::Constants<Real>
private

◆ SHF

using SHOCInterface::SHF = scream::shoc::Functions<Real, KokkosDefaultDevice>
private

◆ Smask

using SHOCInterface::Smask = typename SHF::Smask
private

◆ Spack

using SHOCInterface::Spack = typename SHF::Spack
private

◆ sview_2d

using SHOCInterface::sview_2d = typename KT::template view_2d<Real>
private

◆ sview_2d_const

using SHOCInterface::sview_2d_const = typename KT::template view_2d<const Real>
private

◆ uview_1d

template<typename ScalarT >
using SHOCInterface::uview_1d = ekat::Unmanaged<typename KT::template view_1d<ScalarT> >
private

◆ uview_2d

template<typename ScalarT >
using SHOCInterface::uview_2d = ekat::Unmanaged<typename KT::template view_2d<ScalarT> >
private

◆ view_1d

using SHOCInterface::view_1d = typename SHF::view_1d<Real>
private

◆ view_1d_const

using SHOCInterface::view_1d_const = typename SHF::view_1d<const Real>
private

◆ view_1d_int

using SHOCInterface::view_1d_int = typename KT::template view_1d<Int>
private

◆ view_2d

using SHOCInterface::view_2d = typename SHF::view_2d<SHF::Spack>
private

◆ view_2d_const

using SHOCInterface::view_2d_const = typename SHF::view_2d<const Spack>
private

◆ view_3d

using SHOCInterface::view_3d = typename SHF::view_3d<Spack>
private

◆ view_3d_const

using SHOCInterface::view_3d_const = typename SHF::view_3d<const Spack>
private

◆ view_3d_strided

using SHOCInterface::view_3d_strided = typename SHF::view_3d_strided<Spack>
private

◆ WSM

using SHOCInterface::WSM = ekat::WorkspaceManager<Spack, KT::Device>
private

Constructor & Destructor Documentation

◆ SHOCInterface()

SHOCInterface::SHOCInterface ( const int &  lev,
SolverChoice sc 
)
8 {
9  //
10  // Defaults set from E3SM/components/eamxx/cime_config/namelist_defaults_eamxx.xml
11  //
12  // Turn off SGS variability in SHOC, effectively reducing it to a 1.5 TKE closure?
13  bool def_shoc_1p5tke = false;
14  // Minimum value of stability correction
15  Real def_lambda_low = 0.001;
16  // Maximum value of stability correction
17  Real def_lambda_high = 0.08;
18  // Slope of change from lambda_low to lambda_high
19  Real def_lambda_slope = 0.08;
20  // stability threshold for which to apply more stability correction
21  Real def_lambda_thresh = 0.02;
22  // Temperature variance tuning factor
23  Real def_thl2tune = 1.0;
24  // Moisture variance tuning factor
25  Real def_qw2tune = 1.0;
26  // Temperature moisture covariance
27  Real def_qwthl2tune = 1.0;
28  // Vertical velocity variance
29  Real def_w2tune = 1.0;
30  // Length scale factor
31  Real def_length_fac = 0.5;
32  // Third moment vertical velocity damping factor
33  Real def_c_diag_3rd_mom = 7.0;
34  // Eddy diffusivity coefficient for heat
35  Real def_coeff_kh = 0.1;
36  // Eddy diffusivity coefficient for momentum
37  Real def_coeff_km = 0.1;
38 
39  runtime_options.lambda_low = def_lambda_low;
40  runtime_options.lambda_high = def_lambda_high;
41  runtime_options.lambda_slope = def_lambda_slope;
42  runtime_options.lambda_thresh = def_lambda_thresh;
43 
44  runtime_options.thl2tune = def_thl2tune;
45  runtime_options.qwthl2tune = def_qwthl2tune;
46  runtime_options.qw2tune = def_qw2tune;
47  runtime_options.w2tune = def_w2tune;
48 
49  runtime_options.length_fac = def_length_fac;
50  runtime_options.c_diag_3rd_mom = def_c_diag_3rd_mom;
51  runtime_options.Ckh = def_coeff_kh;
52  runtime_options.Ckm = def_coeff_km;
53  runtime_options.shoc_1p5tke = def_shoc_1p5tke;
54  runtime_options.extra_diags = extra_shoc_diags;
55 
56  // Construct parser object for following reads
57  ParmParse pp("erf.shoc");
58 
59  // Parse runtime inputs at start up
60  pp.query("lambda_low" , runtime_options.lambda_low );
61  pp.query("lambda_high" , runtime_options.lambda_high );
62  pp.query("lambda_slope" , runtime_options.lambda_slope );
63  pp.query("lambda_thresh" , runtime_options.lambda_thresh );
64  pp.query("thl2tune" , runtime_options.thl2tune );
65  pp.query("qw2tune" , runtime_options.qw2tune );
66  pp.query("qwthl2tune" , runtime_options.qwthl2tune );
67  pp.query("w2tune" , runtime_options.w2tune );
68  pp.query("length_fac" , runtime_options.length_fac );
69  pp.query("c_diag_3rd_mom" , runtime_options.c_diag_3rd_mom);
70  pp.query("coeff_kh" , runtime_options.Ckh );
71  pp.query("coeff_km" , runtime_options.Ckm );
72  pp.query("shoc_1p5tke" , runtime_options.shoc_1p5tke );
73  pp.query("extra_shoc_diags", runtime_options.extra_diags );
74 
75  // Set to default but allow us to change it through the inputs file
76  pp.query("apply_tms", apply_tms);
77  pp.query("check_flux_state", check_flux_state);
78  pp.query("extra_shoc_diags", extra_shoc_diags);
79  pp.query("column_conservation_check", column_conservation_check);
80 }
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE amrex::Real pp(amrex::Real y)
Definition: ERF_MicrophysicsUtils.H:233
amrex::Real Real
Definition: ERF_ShocInterface.H:19
bool check_flux_state
Definition: ERF_ShocInterface.H:648
bool extra_shoc_diags
Definition: ERF_ShocInterface.H:649
bool apply_tms
Definition: ERF_ShocInterface.H:647
SHF::SHOCRuntime runtime_options
Definition: ERF_ShocInterface.H:629
bool column_conservation_check
Definition: ERF_ShocInterface.H:650
Here is the call graph for this function:

Member Function Documentation

◆ add_fast_tend()

void SHOCInterface::add_fast_tend ( amrex::Vector< amrex::MultiFab > &  S_rhs)
695 {
696  for (MFIter mfi(*m_cons); mfi.isValid(); ++mfi) {
697  const auto& vbx_cc = mfi.validbox();
698  const auto& vbx_x = convert(vbx_cc,IntVect(1,0,0));
699  const auto& vbx_y = convert(vbx_cc,IntVect(0,1,0));
700 
701  const Array4<const Real>& c_arr = m_cons->const_array(mfi);
702 
703  const Array4<Real>& cc_rhs_arr = S_rhs[IntVars::cons].array(mfi);
704  const Array4<Real>& ru_rhs_arr = S_rhs[IntVars::xmom].array(mfi);
705  const Array4<Real>& rv_rhs_arr = S_rhs[IntVars::ymom].array(mfi);
706 
707  const Array4<const Real>& c_tend_arr = c_tend.const_array(mfi);
708  const Array4<const Real>& u_tend_arr = u_tend.const_array(mfi);
709  const Array4<const Real>& v_tend_arr = v_tend.const_array(mfi);
710 
711  ParallelFor(vbx_cc, vbx_x, vbx_y,
712  [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
713  {
714  cc_rhs_arr(i,j,k,RhoTheta_comp) += c_arr(i,j,k,Rho_comp) * c_tend_arr(i,j,k,RhoTheta_comp);
715  },
716  [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
717  {
718  ru_rhs_arr(i,j,k) += c_arr(i,j,k,Rho_comp) * u_tend_arr(i,j,k);
719  },
720  [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
721  {
722  rv_rhs_arr(i,j,k) += c_arr(i,j,k,Rho_comp) * v_tend_arr(i,j,k);
723  });
724  }
725 }
#define Rho_comp
Definition: ERF_IndexDefines.H:36
#define RhoTheta_comp
Definition: ERF_IndexDefines.H:37
amrex::MultiFab c_tend
Definition: ERF_ShocInterface.H:614
amrex::MultiFab * m_cons
Definition: ERF_ShocInterface.H:591
amrex::MultiFab u_tend
Definition: ERF_ShocInterface.H:615
amrex::MultiFab v_tend
Definition: ERF_ShocInterface.H:616
@ ymom
Definition: ERF_IndexDefines.H:160
@ cons
Definition: ERF_IndexDefines.H:158
@ xmom
Definition: ERF_IndexDefines.H:159

◆ add_slow_tend()

void SHOCInterface::add_slow_tend ( const amrex::MFIter &  mfi,
const amrex::Box &  tbx,
const amrex::Array4< amrex::Real > &  cc_rhs_arr 
)
732 {
733  bool moist = (m_cons->nComp() > RhoQ1_comp);
734 
735  const Array4<const Real>& c_arr = m_cons->const_array(mfi);
736 
737  const Array4<const Real>& c_tend_arr = c_tend.const_array(mfi);
738 
739  ParallelFor(tbx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
740  {
741  cc_rhs_arr(i,j,k,RhoKE_comp) += c_arr(i,j,k,Rho_comp) * c_tend_arr(i,j,k,RhoKE_comp);
742  if (moist) {
743  cc_rhs_arr(i,j,k,RhoQ1_comp) += c_arr(i,j,k,Rho_comp) * c_tend_arr(i,j,k,RhoQ1_comp);
744  cc_rhs_arr(i,j,k,RhoQ2_comp) += c_arr(i,j,k,Rho_comp) * c_tend_arr(i,j,k,RhoQ2_comp);
745  }
746  });
747 }
#define RhoQ2_comp
Definition: ERF_IndexDefines.H:43
#define RhoQ1_comp
Definition: ERF_IndexDefines.H:42
#define RhoKE_comp
Definition: ERF_IndexDefines.H:38

◆ alloc_buffers()

void SHOCInterface::alloc_buffers ( )
192 {
193  // Interface data structures
194  //=======================================================
195  omega = view_2d("Omega" , m_num_cols, m_num_layers );
196  surf_sens_flux = view_1d("Sfc sens flux" , m_num_cols);
197  surf_mom_flux = sview_2d("Sfc mom flux" , m_num_cols, m_num_vel_comp);
198  surf_evap = view_1d("Sfc evap" , m_num_cols);
199  T_mid = view_2d("T_mid" , m_num_cols, m_num_layers );
200  qv = view_2d("Qv" , m_num_cols, m_num_layers );
201  surf_drag_coeff_tms = view_1d("surf_drag_coeff", m_num_cols);
202 
203  // Input data structures
204  //=======================================================
205  p_mid = view_2d("P_mid" , m_num_cols, m_num_layers );
206  p_int = view_2d("P_int" , m_num_cols, m_num_layers+1);
207  pseudo_dens = view_2d("Pseudo density" , m_num_cols, m_num_layers );
208  phis = view_1d("Phis" , m_num_cols);
209 
210  // Input/Output data structures
211  //=======================================================
213  cldfrac_liq = view_2d("Cld_frac_liq" , m_num_cols, m_num_layers );
214  tke = view_2d("Tke" , m_num_cols, m_num_layers );
215  qc = view_2d("Qc" , m_num_cols, m_num_layers );
216 
217  // Output data structures
218  //=======================================================
219  pblh = view_1d("pbl_height" , m_num_cols);
220  inv_qc_relvar = view_2d("inv_qc_relvar" , m_num_cols, m_num_layers);
221  tkh = view_2d("eddy_diff_heat" , m_num_cols, m_num_layers);
222  w_sec = view_2d("w_sec" , m_num_cols, m_num_layers);
223  cldfrac_liq_prev = view_2d("cld_frac_liq_prev" , m_num_cols, m_num_layers );
224  ustar = view_1d("ustar" , m_num_cols);
225  obklen = view_1d("obklen" , m_num_cols);
226 
227  // Extra diagnostic data structures
228  //=======================================================
229  if (extra_shoc_diags) {
230  brunt = view_2d("brunt" , m_num_cols, m_num_layers);
231  shoc_mix = view_2d("shoc_mix" , m_num_cols, m_num_layers);
232  isotropy = view_2d("isotropy" , m_num_cols, m_num_layers);
233  shoc_cond = view_2d("shoc_cond", m_num_cols, m_num_layers);
234  shoc_evap = view_2d("shoc_evap", m_num_cols, m_num_layers);
235 
236  wthl_sec = view_2d("wthl_sec" , m_num_cols, m_num_layers+1);
237  thl_sec = view_2d("thl_sec" , m_num_cols, m_num_layers+1);
238  wqw_sec = view_2d("wqw_sec" , m_num_cols, m_num_layers+1);
239  qw_sec = view_2d("qw_sec" , m_num_cols, m_num_layers+1);
240  uw_sec = view_2d("uw_sec" , m_num_cols, m_num_layers+1);
241  vw_sec = view_2d("vw_sec" , m_num_cols, m_num_layers+1);
242  w3 = view_2d("w3" , m_num_cols, m_num_layers+1);
243  }
244 
245  // Tracer data structures
246  //=======================================================
247  // NOTE: Use layoutright format
248  Kokkos::LayoutStride layout(m_num_cols , m_num_cols*m_num_layers, // stride for dim0
249  m_num_layers , m_num_layers, // stride for dim1
250  m_num_tracers, 1 // stride for dim2
251  );
252  qtracers = view_3d_strided("Qtracers" , layout);
253 
254  // Boundary flux data structures
255  //=======================================================
257  vapor_flux = view_1d("vapor_flux", m_num_cols);
258  water_flux = view_1d("water_flux", m_num_cols);
259  ice_flux = view_1d("ice_flux" , m_num_cols);
260  heat_flux = view_1d("heat_flux" , m_num_cols);
261  }
262 }
view_2d p_int
Definition: ERF_ShocInterface.H:665
view_2d wqw_sec
Definition: ERF_ShocInterface.H:698
view_1d surf_drag_coeff_tms
Definition: ERF_ShocInterface.H:660
view_2d thl_sec
Definition: ERF_ShocInterface.H:697
view_2d tkh
Definition: ERF_ShocInterface.H:682
view_2d cldfrac_liq
Definition: ERF_ShocInterface.H:674
typename KT::template view_2d< Real > sview_2d
Definition: ERF_ShocInterface.H:51
Int m_num_layers
Definition: ERF_ShocInterface.H:571
view_2d vw_sec
Definition: ERF_ShocInterface.H:701
view_1d ice_flux
Definition: ERF_ShocInterface.H:712
view_2d shoc_cond
Definition: ERF_ShocInterface.H:693
view_2d brunt
Definition: ERF_ShocInterface.H:690
view_1d heat_flux
Definition: ERF_ShocInterface.H:713
Int m_num_vel_comp
Definition: ERF_ShocInterface.H:575
view_1d surf_sens_flux
Definition: ERF_ShocInterface.H:655
view_1d pblh
Definition: ERF_ShocInterface.H:680
Int m_num_cols
Definition: ERF_ShocInterface.H:570
view_2d p_mid
Definition: ERF_ShocInterface.H:664
view_2d uw_sec
Definition: ERF_ShocInterface.H:700
view_2d qc
Definition: ERF_ShocInterface.H:676
view_2d shoc_mix
Definition: ERF_ShocInterface.H:691
view_2d qw_sec
Definition: ERF_ShocInterface.H:699
view_2d cldfrac_liq_prev
Definition: ERF_ShocInterface.H:684
view_2d omega
Definition: ERF_ShocInterface.H:654
typename SHF::view_3d_strided< Spack > view_3d_strided
Definition: ERF_ShocInterface.H:55
view_1d vapor_flux
Definition: ERF_ShocInterface.H:710
view_1d obklen
Definition: ERF_ShocInterface.H:686
view_2d pseudo_dens
Definition: ERF_ShocInterface.H:666
view_2d inv_qc_relvar
Definition: ERF_ShocInterface.H:681
view_1d surf_evap
Definition: ERF_ShocInterface.H:657
view_2d w_sec
Definition: ERF_ShocInterface.H:683
view_1d phis
Definition: ERF_ShocInterface.H:667
view_2d shoc_evap
Definition: ERF_ShocInterface.H:694
view_3d horiz_wind
Definition: ERF_ShocInterface.H:671
typename SHF::view_1d< Real > view_1d
Definition: ERF_ShocInterface.H:47
view_3d_strided qtracers
Definition: ERF_ShocInterface.H:706
view_1d ustar
Definition: ERF_ShocInterface.H:685
view_2d w3
Definition: ERF_ShocInterface.H:702
Int m_num_tracers
Definition: ERF_ShocInterface.H:574
sview_2d surf_mom_flux
Definition: ERF_ShocInterface.H:656
typename SHF::view_2d< SHF::Spack > view_2d
Definition: ERF_ShocInterface.H:49
view_2d qv
Definition: ERF_ShocInterface.H:659
view_2d wthl_sec
Definition: ERF_ShocInterface.H:696
view_2d tke
Definition: ERF_ShocInterface.H:675
view_1d water_flux
Definition: ERF_ShocInterface.H:711
view_2d T_mid
Definition: ERF_ShocInterface.H:658
typename SHF::view_3d< Spack > view_3d
Definition: ERF_ShocInterface.H:53
view_2d isotropy
Definition: ERF_ShocInterface.H:692

◆ apply_turbulent_mountain_stress()

void SHOCInterface::apply_turbulent_mountain_stress ( )
protected
1096 {
1097  auto rrho_i = m_buffer.rrho_i;
1098  auto upwp_sfc = m_buffer.upwp_sfc;
1099  auto vpwp_sfc = m_buffer.vpwp_sfc;
1100  auto surf_drag_coeff_tms_d = surf_drag_coeff_tms;
1101  auto horiz_wind_d = horiz_wind;
1102 
1103  const int nlev_v = (m_num_layers-1)/Spack::n;
1104  const int nlev_p = (m_num_layers-1)%Spack::n;
1105  const int nlevi_v = m_num_layers/Spack::n;
1106  const int nlevi_p = m_num_layers%Spack::n;
1107 
1108  Kokkos::parallel_for("apply_tms", KT::RangePolicy(0, m_num_cols), KOKKOS_LAMBDA (const int i)
1109  {
1110  upwp_sfc(i) -= surf_drag_coeff_tms_d(i)*horiz_wind_d(i,0,nlev_v)[nlev_p]/rrho_i(i,nlevi_v)[nlevi_p];
1111  vpwp_sfc(i) -= surf_drag_coeff_tms_d(i)*horiz_wind_d(i,1,nlev_v)[nlev_p]/rrho_i(i,nlevi_v)[nlevi_p];
1112  });
1113 }
Buffer m_buffer
Definition: ERF_ShocInterface.H:622
uview_1d< Real > upwp_sfc
Definition: ERF_ShocInterface.H:476
uview_1d< Real > vpwp_sfc
Definition: ERF_ShocInterface.H:477
uview_2d< Spack > rrho_i
Definition: ERF_ShocInterface.H:497

◆ check_flux_state_consistency()

void SHOCInterface::check_flux_state_consistency ( const double  dt)
protected
1118 {
1119  using PC = scream::physics::Constants<Real>;
1120  using RU = ekat::ReductionUtils<KT::ExeSpace>;
1121  using TPF = ekat::TeamPolicyFactory<KT::ExeSpace>;
1122 
1123  const Real gravit = PC::gravit;
1124  const Real qmin = 1e-12; // minimum permitted constituent concentration (kg/kg)
1125 
1126  const auto& pseudo_density = pseudo_dens;
1127  auto qv_d = qv;
1128  auto surf_evap_d = surf_evap;
1129 
1130  const auto nlevs = m_num_layers;
1131  const auto nlev_packs = ekat::npack<Spack>(nlevs);
1132  const auto last_pack_idx = (nlevs-1)/Spack::n;
1133  const auto last_pack_entry = (nlevs-1)%Spack::n;
1134  const auto policy = TPF::get_default_team_policy(m_num_cols, nlev_packs);
1135  Kokkos::parallel_for("check_flux_state_consistency",
1136  policy,
1137  KOKKOS_LAMBDA (const KT::MemberType& team)
1138  {
1139  const auto i = team.league_rank();
1140 
1141  const auto& pseudo_density_i = ekat::subview(pseudo_density, i);
1142  const auto& qv_i = ekat::subview(qv_d, i);
1143 
1144  // reciprocal of pseudo_density at the bottom layer
1145  const auto rpdel = 1.0/pseudo_density_i(last_pack_idx)[last_pack_entry];
1146 
1147  // Check if the negative surface latent heat flux can exhaust
1148  // the moisture in the lowest model level. If so, apply fixer.
1149  const auto condition = surf_evap_d(i) - (qmin - qv_i(last_pack_idx)[last_pack_entry])/(dt*gravit*rpdel);
1150  if (condition < 0) {
1151  const auto cc = std::fabs(surf_evap_d(i)*dt*gravit);
1152 
1153  auto tracer_mass = [&](const int k)
1154  {
1155  return qv_i(k)*pseudo_density_i(k);
1156  };
1157  Real mm = RU::view_reduction(team, 0, nlevs, tracer_mass);
1158 
1159  EKAT_KERNEL_ASSERT_MSG(mm >= cc, "Error! Total mass of column vapor should be greater than mass of surf_evap.\n");
1160 
1161  Kokkos::parallel_for(Kokkos::TeamVectorRange(team, nlev_packs), [&](const int& k)
1162  {
1163  const auto adjust = cc*qv_i(k)*pseudo_density_i(k)/mm;
1164  qv_i(k) = (qv_i(k)*pseudo_density_i(k) - adjust)/pseudo_density_i(k);
1165  });
1166 
1167  surf_evap_d(i) = 0;
1168  }
1169  });
1170 }
@ PC
Definition: ERF_IndexDefines.H:123

◆ dealloc_buffers()

void SHOCInterface::dealloc_buffers ( )
267 {
268  // Contiguous memory buffer view
269  //=======================================================
271 
272  // Interface data structures
273  //=======================================================
274  omega = view_2d();
277  surf_evap = view_1d();
278  T_mid = view_2d();
279  qv = view_2d();
281 
282  // Input data structures
283  //=======================================================
284  p_mid = view_2d();
285  p_int = view_2d();
286  pseudo_dens = view_2d();
287  phis = view_1d();
288 
289  // Input/Output data structures
290  //=======================================================
291  horiz_wind = view_3d();
292  cldfrac_liq = view_2d();
293  tke = view_2d();
294  qc = view_2d();
295 
296  // Output data structures
297  //=======================================================
298  pblh = view_1d();
300  tkh = view_2d();
301  w_sec = view_2d();
303  ustar = view_1d();
304  obklen = view_1d();
305 
306  // Extra diagnostic data structures
307  //=======================================================
308  if (extra_shoc_diags) {
309  brunt = view_2d();
310  shoc_mix = view_2d();
311  isotropy = view_2d();
312  shoc_cond = view_2d();
313  shoc_evap = view_2d();
314 
315  wthl_sec = view_2d();
316  thl_sec = view_2d();
317  wqw_sec = view_2d();
318  qw_sec = view_2d();
319  uw_sec = view_2d();
320  vw_sec = view_2d();
321  w3 = view_2d();
322  }
323 
324  // Tracer data structures
325  //=======================================================
327 
328  // Boundary flux data structures
329  //=======================================================
331  vapor_flux = view_1d();
332  water_flux = view_1d();
333  ice_flux = view_1d();
334  heat_flux = view_1d();
335  }
336 }
view_1d tot_buff_view
Definition: ERF_ShocInterface.H:643

◆ finalize_impl()

void SHOCInterface::finalize_impl ( const Real  dt)
1083 {
1084  // Do nothing (per SHOCMacrophysics::finalize_impl())
1085 
1086  // Fill the AMReX MFs from Kokkos Views
1088 
1089  // Deallocate the buffer arrays
1090  dealloc_buffers();
1091 }
void kokkos_buffers_to_mf(const Real dt)
Definition: ERF_ShocInterface.cpp:492
void dealloc_buffers()
Definition: ERF_ShocInterface.cpp:266

◆ init_buffers()

void SHOCInterface::init_buffers ( )
protected
778 {
779 
780  // Buffer of contiguous memory
781  auto buffer_size = requested_buffer_size_in_bytes();
782  tot_buff_view = view_1d("contiguous shoc_buffer",buffer_size);
783  Real* mem = reinterpret_cast<Real*>(tot_buff_view.data());
784 
785  // 1d scalar views
786  using scalar_view_t = decltype(m_buffer.wpthlp_sfc);
787  scalar_view_t* _1d_scalar_view_ptrs[Buffer::num_1d_scalar_ncol] =
789 #ifdef SCREAM_SHOC_SMALL_KERNELS
790  , &m_buffer.se_b, &m_buffer.ke_b, &m_buffer.wv_b, &m_buffer.wl_b
791  , &m_buffer.se_a, &m_buffer.ke_a, &m_buffer.wv_a, &m_buffer.wl_a
792  , &m_buffer.kbfs, &m_buffer.ustar2, &m_buffer.wstar
793 #endif
794  };
795  for (int i = 0; i < Buffer::num_1d_scalar_ncol; ++i) {
796  *_1d_scalar_view_ptrs[i] = scalar_view_t(mem, m_num_cols);
797  mem += _1d_scalar_view_ptrs[i]->size();
798  }
799 
800  Spack* s_mem = reinterpret_cast<Spack*>(mem);
801 
802  // 2d packed views
803  const int nlev_packs = ekat::npack<Spack>(m_num_layers);
804  const int nlevi_packs = ekat::npack<Spack>(m_num_layers+1);
805  const int num_tracer_packs = ekat::npack<Spack>(m_num_tracers);
806 
807  m_buffer.pref_mid = decltype(m_buffer.pref_mid)(s_mem, nlev_packs);
808  s_mem += m_buffer.pref_mid.size();
809 
810  using spack_2d_view_t = decltype(m_buffer.z_mid);
811  spack_2d_view_t* _2d_spack_mid_view_ptrs[Buffer::num_2d_vector_mid] =
815 #ifdef SCREAM_SHOC_SMALL_KERNELS
816  , &m_buffer.rho_zt, &m_buffer.shoc_qv, &m_buffer.tabs, &m_buffer.dz_zt
817 #endif
818  };
819 
820  spack_2d_view_t* _2d_spack_int_view_ptrs[Buffer::num_2d_vector_int] =
824 #ifdef SCREAM_SHOC_SMALL_KERNELS
825  , &m_buffer.dz_zi
826 #endif
827  };
828 
829  for (int i = 0; i < Buffer::num_2d_vector_mid; ++i) {
830  *_2d_spack_mid_view_ptrs[i] = spack_2d_view_t(s_mem, m_num_cols, nlev_packs);
831  s_mem += _2d_spack_mid_view_ptrs[i]->size();
832  }
833 
834  for (int i = 0; i < Buffer::num_2d_vector_int; ++i) {
835  *_2d_spack_int_view_ptrs[i] = spack_2d_view_t(s_mem, m_num_cols, nlevi_packs);
836  s_mem += _2d_spack_int_view_ptrs[i]->size();
837  }
838  m_buffer.wtracer_sfc = decltype(m_buffer.wtracer_sfc)(s_mem, m_num_cols, num_tracer_packs);
839  s_mem += m_buffer.wtracer_sfc.size();
840 
841  // WSM data
842  m_buffer.wsm_data = s_mem;
843 }
size_t requested_buffer_size_in_bytes() const
Definition: ERF_ShocInterface.cpp:751
typename SHF::Spack Spack
Definition: ERF_ShocInterface.H:43
uview_2d< Spack > w3
Definition: ERF_ShocInterface.H:522
uview_2d< Spack > qc_copy
Definition: ERF_ShocInterface.H:509
uview_2d< Spack > dse
Definition: ERF_ShocInterface.H:507
uview_2d< Spack > vw_sec
Definition: ERF_ShocInterface.H:521
uview_1d< Real > wpthlp_sfc
Definition: ERF_ShocInterface.H:474
uview_2d< Spack > thv
Definition: ERF_ShocInterface.H:498
uview_2d< Spack > wqls_sec
Definition: ERF_ShocInterface.H:523
uview_2d< Spack > wthl_sec
Definition: ERF_ShocInterface.H:517
uview_2d< Spack > thlm
Definition: ERF_ShocInterface.H:505
uview_2d< Spack > uw_sec
Definition: ERF_ShocInterface.H:520
uview_2d< Spack > z_mid
Definition: ERF_ShocInterface.H:494
uview_2d< Spack > rrho
Definition: ERF_ShocInterface.H:496
uview_2d< Spack > wtke_sec
Definition: ERF_ShocInterface.H:519
uview_2d< Spack > unused
Definition: ERF_ShocInterface.H:493
Spack * wsm_data
Definition: ERF_ShocInterface.H:534
static constexpr int num_2d_vector_int
Definition: ERF_ShocInterface.H:467
uview_2d< Spack > wtracer_sfc
Definition: ERF_ShocInterface.H:502
uview_2d< Spack > inv_exner
Definition: ERF_ShocInterface.H:504
uview_2d< Spack > qwthl_sec
Definition: ERF_ShocInterface.H:516
uview_2d< Spack > qw
Definition: ERF_ShocInterface.H:506
uview_2d< Spack > brunt
Definition: ERF_ShocInterface.H:524
uview_2d< Spack > shoc_mix
Definition: ERF_ShocInterface.H:511
uview_2d< Spack > tke_copy
Definition: ERF_ShocInterface.H:508
static constexpr int num_1d_scalar_ncol
Definition: ERF_ShocInterface.H:460
uview_2d< Spack > isotropy
Definition: ERF_ShocInterface.H:512
uview_2d< Spack > zt_grid
Definition: ERF_ShocInterface.H:500
uview_2d< Spack > w_sec
Definition: ERF_ShocInterface.H:513
uview_2d< Spack > thl_sec
Definition: ERF_ShocInterface.H:514
uview_2d< Spack > wm_zt
Definition: ERF_ShocInterface.H:503
uview_2d< Spack > qw_sec
Definition: ERF_ShocInterface.H:515
uview_2d< Spack > wqw_sec
Definition: ERF_ShocInterface.H:518
uview_2d< Spack > z_int
Definition: ERF_ShocInterface.H:495
uview_2d< Spack > shoc_ql2
Definition: ERF_ShocInterface.H:510
uview_1d< Real > wprtp_sfc
Definition: ERF_ShocInterface.H:475
uview_2d< Spack > zi_grid
Definition: ERF_ShocInterface.H:501
static constexpr int num_2d_vector_mid
Definition: ERF_ShocInterface.H:466
uview_1d< Spack > pref_mid
Definition: ERF_ShocInterface.H:491
uview_2d< Spack > dz
Definition: ERF_ShocInterface.H:499

◆ initialize_impl()

void SHOCInterface::initialize_impl ( )
848 {
849  // Alias local variables from temporary buffer
850  auto z_mid = m_buffer.z_mid;
851  auto z_int = m_buffer.z_int;
852  auto wpthlp_sfc = m_buffer.wpthlp_sfc;
853  auto wprtp_sfc = m_buffer.wprtp_sfc;
854  auto upwp_sfc = m_buffer.upwp_sfc;
855  auto vpwp_sfc = m_buffer.vpwp_sfc;
856  auto rrho = m_buffer.rrho;
857  auto rrho_i = m_buffer.rrho_i;
858  auto thv = m_buffer.thv;
859  auto dz = m_buffer.dz;
860  auto zt_grid = m_buffer.zt_grid;
861  auto zi_grid = m_buffer.zi_grid;
862  auto wtracer_sfc = m_buffer.wtracer_sfc;
863  auto wm_zt = m_buffer.wm_zt;
864  auto inv_exner = m_buffer.inv_exner;
865  auto thlm = m_buffer.thlm;
866  auto qw = m_buffer.qw;
867  auto dse = m_buffer.dse;
868  auto tke_copy = m_buffer.tke_copy;
869  auto qc_copy = m_buffer.qc_copy;
870  auto shoc_ql2 = m_buffer.shoc_ql2;
871 
872  // For now, set z_int(i,nlevs) = z_surf = 0
873  const Real z_surf = 0.0;
874 
875  // Set preprocess variables
878  surf_mom_flux, qtracers, qv, qc, qc_copy, tke, tke_copy, z_mid, z_int,
879  dse, rrho, rrho_i, thv, dz, zt_grid, zi_grid, wpthlp_sfc, wprtp_sfc, upwp_sfc,
880  vpwp_sfc, wtracer_sfc, wm_zt, inv_exner, thlm, qw, cldfrac_liq, cldfrac_liq_prev);
881 
882  // Input Variables:
883  input.zt_grid = shoc_preprocess.zt_grid;
884  input.zi_grid = shoc_preprocess.zi_grid;
885  input.pres = p_mid;
886  input.presi = p_int;
887  input.pdel = pseudo_dens;
888  input.thv = shoc_preprocess.thv;
889  input.w_field = shoc_preprocess.wm_zt;
890  input.wthl_sfc = shoc_preprocess.wpthlp_sfc;
891  input.wqw_sfc = shoc_preprocess.wprtp_sfc;
892  input.uw_sfc = shoc_preprocess.upwp_sfc;
893  input.vw_sfc = shoc_preprocess.vpwp_sfc;
894  input.wtracer_sfc = shoc_preprocess.wtracer_sfc;
895  input.inv_exner = shoc_preprocess.inv_exner;
896  input.phis = phis;
897 
898  // Input/Output Variables
903  input_output.horiz_wind = horiz_wind;
904  input_output.wthv_sec = sgs_buoy_flux;
906  input_output.tk = tk;
907  input_output.shoc_cldfrac = cldfrac_liq;
908  input_output.shoc_ql = qc_copy;
909 
910  // Output Variables
911  output.pblh = pblh;
912  output.shoc_ql2 = shoc_ql2;
913  output.tkh = tkh;
914  output.ustar = ustar;
915  output.obklen = obklen;
916 
917  // Output (diagnostic)
918  history_output.shoc_mix = m_buffer.shoc_mix;
919  history_output.isotropy = m_buffer.isotropy;
920  if (extra_shoc_diags) {
921  history_output.shoc_cond = shoc_cond;
922  history_output.shoc_evap = shoc_evap;
923  } else {
924  history_output.shoc_cond = m_buffer.unused;
925  history_output.shoc_evap = m_buffer.unused;
926  }
927  history_output.w_sec = w_sec;
928  history_output.thl_sec = m_buffer.thl_sec;
929  history_output.qw_sec = m_buffer.qw_sec;
930  history_output.qwthl_sec = m_buffer.qwthl_sec;
931  history_output.wthl_sec = m_buffer.wthl_sec;
932  history_output.wqw_sec = m_buffer.wqw_sec;
933  history_output.wtke_sec = m_buffer.wtke_sec;
934  history_output.uw_sec = m_buffer.uw_sec;
935  history_output.vw_sec = m_buffer.vw_sec;
937  history_output.wqls_sec = m_buffer.wqls_sec;
938  history_output.brunt = m_buffer.brunt;
939 
940 #ifdef SCREAM_SHOC_SMALL_KERNELS
941  temporaries.se_b = m_buffer.se_b;
942  temporaries.ke_b = m_buffer.ke_b;
943  temporaries.wv_b = m_buffer.wv_b;
944  temporaries.wl_b = m_buffer.wl_b;
945  temporaries.se_a = m_buffer.se_a;
946  temporaries.ke_a = m_buffer.ke_a;
947  temporaries.wv_a = m_buffer.wv_a;
948  temporaries.wl_a = m_buffer.wl_a;
949  temporaries.kbfs = m_buffer.kbfs;
950  temporaries.ustar2 = m_buffer.ustar2;
951  temporaries.wstar = m_buffer.wstar;
952 
953  temporaries.rho_zt = m_buffer.rho_zt;
954  temporaries.shoc_qv = m_buffer.shoc_qv;
955  temporaries.tabs = m_buffer.tabs;
956  temporaries.dz_zt = m_buffer.dz_zt;
957  temporaries.dz_zi = m_buffer.dz_zi;
958 #endif
959 
960  // Set postprocess variables
962  rrho, qv, qw, qc, qc_copy, tke,
963  tke_copy, qtracers, shoc_ql2,
965  T_mid, dse, z_mid, phis);
966 
967  // Setup WSM for internal local variables
968  using TPF = ekat::TeamPolicyFactory<KT::ExeSpace>;
969  const auto nlev_packs = ekat::npack<Spack>(m_num_layers);
970  const auto nlevi_packs = ekat::npack<Spack>(m_num_layers+1);
971  const int n_wind_slots = ekat::npack<Spack>(m_num_vel_comp)*Spack::n;
972  const int n_trac_slots = ekat::npack<Spack>(m_num_tracers)*Spack::n;
973  const auto default_policy = TPF::get_default_team_policy(m_num_cols, nlev_packs);
974  workspace_mgr.setup(m_buffer.wsm_data, nlevi_packs, 14+(n_wind_slots+n_trac_slots), default_policy);
975 
976  // NOTE: Vertical indices were permuted, so top and bottom are correct
977  // Maximum number of levels in pbl from surface
978  const int ntop_shoc = 0;
979  const int nbot_shoc = m_num_layers;
980  auto p_mid_d = p_mid;
981  view_1d pref_mid("pref_mid", m_num_layers);
982  Spack* s_mem = reinterpret_cast<Spack*>(pref_mid.data());
983  SHF::view_1d<Spack> pref_mid_um(s_mem, m_num_layers);
984  const auto policy = TPF::get_default_team_policy(m_num_cols, nlev_packs);
985  Kokkos::parallel_for("pref_mid",
986  policy,
987  KOKKOS_LAMBDA (const KT::MemberType& team)
988  {
989  const auto i = team.league_rank();
990  if (i==0) {
991  const auto& pmid_i = ekat::subview(p_mid_d, i);
992  Kokkos::parallel_for(Kokkos::TeamVectorRange(team, nlev_packs), [&](const int& k)
993  {
994  pref_mid_um(k) = pmid_i(k);
995  });
996  }
997  });
998  Kokkos::fence();
999  m_npbl = SHF::shoc_init(nbot_shoc,ntop_shoc,pref_mid_um);
1000 
1001  // Cell length for input dx and dy
1002  view_1d cell_length_x("cell_length_x", m_num_cols);
1003  view_1d cell_length_y("cell_length_y", m_num_cols);
1004  Kokkos::deep_copy(cell_length_x, m_geom.CellSize(0));
1005  Kokkos::deep_copy(cell_length_y, m_geom.CellSize(1));
1006  input.dx = cell_length_x;
1007  input.dy = cell_length_y;
1008 }
SHOCPreprocess shoc_preprocess
Definition: ERF_ShocInterface.H:635
amrex::Geometry m_geom
Definition: ERF_ShocInterface.H:585
view_2d sgs_buoy_flux
Definition: ERF_ShocInterface.H:672
SHF::SHOCOutput output
Definition: ERF_ShocInterface.H:627
ekat::WorkspaceManager< Spack, KT::Device > workspace_mgr
Definition: ERF_ShocInterface.H:639
Int m_npbl
Definition: ERF_ShocInterface.H:572
SHF::SHOCInput input
Definition: ERF_ShocInterface.H:625
SHOCPostprocess shoc_postprocess
Definition: ERF_ShocInterface.H:636
SHF::SHOCInputOutput input_output
Definition: ERF_ShocInterface.H:626
view_2d tk
Definition: ERF_ShocInterface.H:673
SHF::SHOCHistoryOutput history_output
Definition: ERF_ShocInterface.H:628
void set_variables(const int ncol_, const int nlev_, const view_2d_const &rrho_, const view_2d &qv_, const view_2d_const &qw_, const view_2d &qc_, const view_2d_const &qc_copy_, const view_2d &tke_, const view_2d_const &tke_copy_, const view_3d_strided &qtracers_, const view_2d_const &qc2_, const view_2d &cldfrac_liq_, const view_2d &inv_qc_relvar_, const view_2d &T_mid_, const view_2d_const &dse_, const view_2d_const &z_mid_, const view_1d_const phis_)
Definition: ERF_ShocInterface.H:416
view_3d_strided qtracers
Definition: ERF_ShocInterface.H:252
view_2d thlm
Definition: ERF_ShocInterface.H:274
view_2d zt_grid
Definition: ERF_ShocInterface.H:265
view_2d inv_exner
Definition: ERF_ShocInterface.H:273
view_2d wm_zt
Definition: ERF_ShocInterface.H:272
view_2d wtracer_sfc
Definition: ERF_ShocInterface.H:271
view_1d wprtp_sfc
Definition: ERF_ShocInterface.H:268
view_2d qw
Definition: ERF_ShocInterface.H:275
view_1d upwp_sfc
Definition: ERF_ShocInterface.H:269
view_1d wpthlp_sfc
Definition: ERF_ShocInterface.H:267
view_1d vpwp_sfc
Definition: ERF_ShocInterface.H:270
view_2d shoc_s
Definition: ERF_ShocInterface.H:258
view_2d tke_copy
Definition: ERF_ShocInterface.H:260
view_2d zi_grid
Definition: ERF_ShocInterface.H:266
view_2d thv
Definition: ERF_ShocInterface.H:263
void set_variables(const int ncol_, const int nlev_, const Real z_surf_, const view_2d_const &T_mid_, const view_2d_const &p_mid_, const view_2d_const &p_int_, const view_2d_const &pseudo_density_, const view_2d_const &omega_, const view_1d_const &phis_, const view_1d_const &surf_sens_flux_, const view_1d_const &surf_evap_, const sview_2d_const &surf_mom_flux_, const view_3d_strided &qtracers_, const view_2d &qv_, const view_2d_const &qc_, const view_2d &qc_copy_, const view_2d &tke_, const view_2d &tke_copy_, const view_2d &z_mid_, const view_2d &z_int_, const view_2d &dse_, const view_2d &rrho_, const view_2d &rrho_i_, const view_2d &thv_, const view_2d &dz_, const view_2d &zt_grid_, const view_2d &zi_grid_, const view_1d &wpthlp_sfc_, const view_1d &wprtp_sfc_, const view_1d &upwp_sfc_, const view_1d &vpwp_sfc_, const view_2d &wtracer_sfc_, const view_2d &wm_zt_, const view_2d &inv_exner_, const view_2d &thlm_, const view_2d &qw_, const view_2d &cldfrac_liq_, const view_2d &cldfrac_liq_prev_)
Definition: ERF_ShocInterface.H:281

◆ kokkos_buffers_to_mf()

void SHOCInterface::kokkos_buffers_to_mf ( const Real  dt)
493 {
494  //
495  // Expose for device capture
496  //
497 
498  // Buffer data structures
499  //=======================================================
500  auto thlm_d = m_buffer.thlm;
501 
502  // Interface data structures
503  //=======================================================
504  auto T_mid_d = T_mid;
505  auto qv_d = qv;
506 
507  // Input/Output data structures
508  //=======================================================
509  auto horiz_wind_d = horiz_wind;
510  auto tke_d = tke;
511  auto qc_d = qc;
512 
513  bool moist = (m_cons->nComp() > RhoQ1_comp);
514  for (MFIter mfi(*m_cons); mfi.isValid(); ++mfi) {
515  const auto& vbx_cc = mfi.validbox();
516  const auto& vbx_x = convert(vbx_cc,IntVect(1,0,0));
517  const auto& vbx_y = convert(vbx_cc,IntVect(0,1,0));
518 
519  const int nx = vbx_cc.length(0);
520  const int imin = vbx_cc.smallEnd(0);
521  const int jmin = vbx_cc.smallEnd(1);
522  const int kmax = vbx_cc.bigEnd(2);
523  const int offset = m_col_offsets[mfi.index()];
524 
525  int ilo = vbx_x.smallEnd(0);
526  int ihi = vbx_x.bigEnd(0);
527  int jlo = vbx_y.smallEnd(1);
528  int jhi = vbx_y.bigEnd(1);
529 
530  const Array4<const Real>& cons_arr = m_cons->const_array(mfi);
531  const Array4<const Real>& u_arr = m_xvel->const_array(mfi);
532  const Array4<const Real>& v_arr = m_yvel->const_array(mfi);
533 
534  const Array4<Real>& c_tend_arr = c_tend.array(mfi);
535  const Array4<Real>& u_tend_arr = u_tend.array(mfi);
536  const Array4<Real>& v_tend_arr = v_tend.array(mfi);
537 
538  ParallelFor(vbx_cc, vbx_x, vbx_y,
539  [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
540  {
541  // NOTE: k gets permuted with ilay
542  // map [i,j,k] 0-based to [icol, ilay] 0-based
543  const int icol = (j-jmin)*nx + (i-imin) + offset;
544  const int ilay = kmax - k;
545 
546  // Density at CC
547  Real r = cons_arr(i,j,k,Rho_comp);
548 
549  // Theta at CC (eamxx_common_physics_functions_impl.hpp L123)
550  Real Th = thlm_d(icol,ilay)[0] / (1.0 - (1.0 / T_mid_d(icol,ilay)[0]) * (C::LatVap/C::Cpair) * qc_d(icol,ilay)[0] );
551 
552  // Populate the tendencies
553  c_tend_arr(i,j,k,RhoTheta_comp) = ( Th - cons_arr(i,j,k,RhoTheta_comp)/r ) / dt;
554  c_tend_arr(i,j,k,RhoKE_comp) = ( tke_d(icol,ilay)[0] - cons_arr(i,j,k,RhoKE_comp )/r ) / dt;
555  if (moist) {
556  c_tend_arr(i,j,k,RhoQ1_comp) = ( qv_d(icol,ilay)[0] - cons_arr(i,j,k,RhoQ1_comp)/r ) / dt;
557  c_tend_arr(i,j,k,RhoQ2_comp) = ( qc_d(icol,ilay)[0] - cons_arr(i,j,k,RhoQ2_comp)/r ) / dt;
558  }
559  },
560  [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
561  {
562  // Limit i to CC box where views are valid
563  int ii = std::max(std::min(i,ihi-1),ilo);
564 
565  // NOTE: k gets permuted with ilay
566  // map [i,j,k] 0-based to [icol, ilay] 0-based
567  const int icol = (j-jmin)*nx + (ii-imin) + offset;
568  const int ilay = kmax - k;
569 
570  Real uvel;
571  int icolim = (j-jmin)*nx + (ii-1-imin) + offset;
572  if (i==ilo) {
573  int icolip = (j-jmin)*nx + (ii+1-imin) + offset;
574  uvel = 1.5 * horiz_wind_d(icol,0,ilay)[0] - 0.5 * horiz_wind_d(icolip,0,ilay)[0];
575  } else if (i==ihi) {
576  uvel = 1.5 * horiz_wind_d(icol,0,ilay)[0] - 0.5 * horiz_wind_d(icolim,0,ilay)[0];
577  } else {
578  uvel = 0.5 * (horiz_wind_d(icol,0,ilay)[0] + horiz_wind_d(icolim,0,ilay)[0]);
579  }
580  u_tend_arr(i,j,k) = ( uvel - u_arr(i,j,k) ) / dt;
581  },
582  [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
583  {
584  // Limit j to CC box where views are valid
585  int jj = std::max(std::min(j,jhi-1),jlo);
586 
587  // NOTE: k gets permuted with ilay
588  // map [i,j,k] 0-based to [icol, ilay] 0-based
589  const int icol = (jj-jmin)*nx + (i-imin) + offset;
590  const int ilay = kmax - k;
591 
592  Real vvel;
593  int icoljm = (jj-1-jmin)*nx + (i-imin) + offset;
594  if (j==jlo) {
595  int icoljp = (jj+1-jmin)*nx + (i-imin) + offset;
596  vvel = 1.5 * horiz_wind_d(icol,1,ilay)[0] - 0.5 * horiz_wind_d(icoljp,1,ilay)[0];
597  } else if (j==jhi) {
598  vvel = 1.5 * horiz_wind_d(icol,1,ilay)[0] - 0.5 * horiz_wind_d(icoljm,1,ilay)[0];
599  } else {
600  vvel = 0.5 * (horiz_wind_d(icol,1,ilay)[0] + horiz_wind_d(icoljm,1,ilay)[0]);
601  }
602  v_tend_arr(i,j,k) = ( vvel - v_arr(i,j,k) ) / dt;
603  });
604  }
605 }
AMREX_FORCE_INLINE IntVect offset(const int face_dir, const int normal)
Definition: ERF_ReadBndryPlanes.cpp:28
amrex::MultiFab * m_yvel
Definition: ERF_ShocInterface.H:595
amrex::MultiFab * m_xvel
Definition: ERF_ShocInterface.H:594
amrex::Vector< int > m_col_offsets
Definition: ERF_ShocInterface.H:566
Here is the call graph for this function:

◆ mf_to_kokkos_buffers()

void SHOCInterface::mf_to_kokkos_buffers ( )
341 {
342  //
343  // Expose for device capture
344  //
345 
346  // Interface data structures
347  //=======================================================
348  auto omega_d = omega;
349  auto surf_sens_flux_d = surf_sens_flux;
350  auto surf_mom_flux_d = surf_mom_flux;
351  auto surf_evap_d = surf_evap;
352  auto T_mid_d = T_mid;
353  auto qv_d = qv;
354  auto surf_drag_coeff_tms_d = surf_drag_coeff_tms;
355 
356  // Input data structures
357  //=======================================================
358  auto p_mid_d = p_mid;
359  auto p_int_d = p_int;
360  auto pseudo_dens_d = pseudo_dens;
361  auto phis_d = phis;
362 
363  // Input/Output data structures
364  //=======================================================
365  auto horiz_wind_d = horiz_wind;
366  auto cldfrac_liq_d = cldfrac_liq;
367  auto tke_d = tke;
368  auto qc_d = qc;
369 
370  // Enforce the correct grid heights and density
371  //=======================================================
372  auto dz_d = m_buffer.dz;
373 
374  // Subsidence pointer to device vector data
375  Real* w_sub = m_w_subsid;
376 
377  int nlay = m_num_layers;
378  Real dz = m_geom.CellSize(2);
379  bool moist = (m_cons->nComp() > RhoQ1_comp);
380  auto ProbLoArr = m_geom.ProbLoArray();
381  for (MFIter mfi(*m_cons); mfi.isValid(); ++mfi) {
382  const auto& vbx = mfi.validbox();
383  const int nx = vbx.length(0);
384  const int imin = vbx.smallEnd(0);
385  const int jmin = vbx.smallEnd(1);
386  const int kmax = vbx.bigEnd(2);
387  const int offset = m_col_offsets[mfi.index()];
388  const Array4<const Real>& cons_arr = m_cons->const_array(mfi);
389 
390  const Array4<const Real>& u_arr = m_xvel->const_array(mfi);
391  const Array4<const Real>& v_arr = m_yvel->const_array(mfi);
392  const Array4<const Real>& w_arr = m_zvel->const_array(mfi);
393 
394  const Array4<const Real>& t13_arr = m_tau13->const_array(mfi);
395  const Array4<const Real>& t23_arr = m_tau23->const_array(mfi);
396  const Array4<const Real>& hfx3_arr = m_hfx3->const_array(mfi);
397  const Array4<const Real>& qfx3_arr = m_qfx3->const_array(mfi);
398 
399  const Array4<const Real>& z_arr = (m_z_phys) ? m_z_phys->const_array(mfi) :
400  Array4<const Real>{};
401  ParallelFor(vbx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
402  {
403  // NOTE: k gets permuted with ilay
404  // map [i,j,k] 0-based to [icol, ilay] 0-based
405  const int icol = (j-jmin)*nx + (i-imin) + offset;
406  const int ilay = kmax - k;
407 
408  // EOS input (at CC)
409  Real r = cons_arr(i,j,k,Rho_comp);
410  Real rt = cons_arr(i,j,k,RhoTheta_comp);
411  Real qv = (moist) ? cons_arr(i,j,k,RhoQ1_comp)/r : 0.0;
412  Real qc = (moist) ? cons_arr(i,j,k,RhoQ2_comp)/r : 0.0;
413 
414  // EOS avg to z-face
415  Real r_lo = cons_arr(i,j,k-1,Rho_comp);
416  Real rt_lo = cons_arr(i,j,k-1,RhoTheta_comp);
417  Real qv_lo = (moist) ? cons_arr(i,j,k-1,RhoQ1_comp)/r_lo : 0.0;
418  Real rt_avg = 0.5 * (rt + rt_lo);
419  Real qv_avg = 0.5 * (qv + qv_lo);
420 
421  // Z height
422  Real z = (z_arr) ? 0.125 * ( (z_arr(i ,j ,k+1) + z_arr(i ,j ,k))
423  + (z_arr(i+1,j ,k+1) + z_arr(i+1,j ,k))
424  + (z_arr(i ,j+1,k+1) + z_arr(i ,j+1,k))
425  + (z_arr(i+1,j+1,k+1) + z_arr(i+1,j+1,k)) ) * CONST_GRAV :
426  ProbLoArr[2] + (k + 0.5) * dz;
427 
428  // Delta z
429  Real delz = (z_arr) ? 0.25 * ( (z_arr(i ,j ,k+1) - z_arr(i ,j ,k))
430  + (z_arr(i+1,j ,k+1) - z_arr(i+1,j ,k))
431  + (z_arr(i ,j+1,k+1) - z_arr(i ,j+1,k))
432  + (z_arr(i+1,j+1,k+1) - z_arr(i+1,j+1,k)) ) : dz;
433 
434  // W at cc (cannot be 0?; inspection of shoc code...)
435  Real w_cc = 0.5 * (w_arr(i,j,k) + w_arr(i,j,k+1));
436  w_cc += (w_sub) ? w_sub[k] : 0.0;
437  Real w_limited = std::copysign(std::max(std::fabs(w_cc),1.0e-6),w_cc);
438 
439 
440  // Input/Output data structures
441  //=======================================================
442  horiz_wind_d(icol,0,ilay) = 0.5 * (u_arr(i,j,k) + u_arr(i+1,j ,k));
443  horiz_wind_d(icol,1,ilay) = 0.5 * (v_arr(i,j,k) + v_arr(i ,j+1,k));
444  cldfrac_liq_d(icol,ilay) = (qc>0.0) ? 1. : 0.;
445  tke_d(icol,ilay) = std::max(cons_arr(i,j,k,RhoKE_comp)/r, 0.0);
446  qc_d(icol,ilay) = qc;
447 
448  // Interface data structures
449  //=======================================================
450  // eamxx_common_physics_functions_impl.hpp: calculate_vertical_velocity
451  omega_d(icol,ilay) = -w_limited * r * CONST_GRAV;
452  if (k==0) {
453  surf_mom_flux_d(icol,0) = 0.5 * (t13_arr(i,j,k) + t13_arr(i+1,j ,k));
454  surf_mom_flux_d(icol,1) = 0.5 * (t23_arr(i,j,k) + t23_arr(i ,j+1,k));
455  // No unit conversion to W/m^2 (ERF_ShocInterface.H L224)
456  surf_sens_flux_d(icol) = hfx3_arr(i,j,k);
457  surf_evap_d(icol) = (moist) ? qfx3_arr(i,j,k) : 0.0;
458  // Back out the drag coeff
459  Real wsp = sqrt( horiz_wind_d(icol,0,ilay)[0]*horiz_wind_d(icol,0,ilay)[0]
460  + horiz_wind_d(icol,1,ilay)[0]*horiz_wind_d(icol,1,ilay)[0] );
461  surf_drag_coeff_tms_d(icol) = surf_mom_flux_d(icol,0) /
462  (-r * wsp * horiz_wind_d(icol,0,ilay)[0]);
463  }
464  T_mid_d(icol,ilay) = getTgivenRandRTh(r, rt, qv);
465  qv_d(icol,ilay) = qv;
466 
467  // Input data structures
468  //=======================================================
469  p_mid_d(icol,ilay) = getPgivenRTh(rt, qv);
470  p_int_d(icol,ilay) = getPgivenRTh(rt_avg, qv_avg);
471  // eamxx_common_physics_functions_impl.hpp: calculate_density
472  pseudo_dens_d(icol,ilay) = r * CONST_GRAV * delz;
473  // Enforce the grid spacing
474  dz_d(icol,ilay) = delz;
475  // Geopotential
476  phis_d(icol) = CONST_GRAV * z;
477 
478  if (ilay==(nlay-1)) {
479  Real r_hi = cons_arr(i,j,k+1,Rho_comp);
480  Real rt_hi = cons_arr(i,j,k+1,RhoTheta_comp);
481  Real qv_hi = (moist) ? std::max(cons_arr(i,j,k+1,RhoQ1_comp)/r_hi,0.0) : 0.0;
482  rt_avg = 0.5 * (rt + rt_hi);
483  qv_avg = 0.5 * (qv + qv_hi);
484  p_int_d(icol,ilay+1) = getPgivenRTh(rt_avg, qv_avg);
485  }
486  });
487  }
488 }
constexpr amrex::Real CONST_GRAV
Definition: ERF_Constants.H:21
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE amrex::Real getPgivenRTh(const amrex::Real rhotheta, const amrex::Real qv=0.)
Definition: ERF_EOS.H:81
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE amrex::Real getTgivenRandRTh(const amrex::Real rho, const amrex::Real rhotheta, const amrex::Real qv=0.0)
Definition: ERF_EOS.H:46
amrex::MultiFab * m_z_phys
Definition: ERF_ShocInterface.H:611
amrex::MultiFab * m_qfx3
Definition: ERF_ShocInterface.H:605
amrex::MultiFab * m_zvel
Definition: ERF_ShocInterface.H:596
amrex::MultiFab * m_tau23
Definition: ERF_ShocInterface.H:603
amrex::MultiFab * m_tau13
Definition: ERF_ShocInterface.H:602
amrex::MultiFab * m_hfx3
Definition: ERF_ShocInterface.H:604
amrex::Real * m_w_subsid
Definition: ERF_ShocInterface.H:599
Here is the call graph for this function:

◆ name()

std::string SHOCInterface::name ( ) const
inline
117 { return "shoc"; }

◆ requested_buffer_size_in_bytes()

size_t SHOCInterface::requested_buffer_size_in_bytes ( ) const
protected
752 {
753  using TPF = ekat::TeamPolicyFactory<KT::ExeSpace>;
754 
755  const int nlev_packs = ekat::npack<Spack>(m_num_layers);
756  const int nlevi_packs = ekat::npack<Spack>(m_num_layers+1);
757  const int num_tracer_packs = ekat::npack<Spack>(m_num_tracers);
758 
759  // Number of Reals needed by local views in the interface
760  const size_t interface_request = Buffer::num_1d_scalar_ncol*m_num_cols*sizeof(Real) +
761  Buffer::num_1d_scalar_nlev*nlev_packs*sizeof(Spack) +
762  Buffer::num_2d_vector_mid*m_num_cols*nlev_packs*sizeof(Spack) +
763  Buffer::num_2d_vector_int*m_num_cols*nlevi_packs*sizeof(Spack) +
764  Buffer::num_2d_vector_tr*m_num_cols*num_tracer_packs*sizeof(Spack);
765 
766  // Number of Reals needed by the WorkspaceManager passed to shoc_main
767  const auto policy = TPF::get_default_team_policy(m_num_cols, nlev_packs);
768  const int n_wind_slots = ekat::npack<Spack>(m_num_vel_comp)*Spack::n;
769  const int n_trac_slots = ekat::npack<Spack>(m_num_tracers) *Spack::n;
770  const size_t wsm_request = WSM::get_total_bytes_needed(nlevi_packs, 14+(n_wind_slots+n_trac_slots), policy);
771 
772  return ( (interface_request + wsm_request)/sizeof(Real) );
773 }
static constexpr int num_2d_vector_tr
Definition: ERF_ShocInterface.H:472
static constexpr int num_1d_scalar_nlev
Definition: ERF_ShocInterface.H:464

◆ run_impl()

void SHOCInterface::run_impl ( const Real  dt)
1013 {
1014  using TPF = ekat::TeamPolicyFactory<KT::ExeSpace>;
1015 
1016  EKAT_REQUIRE_MSG (dt<=300,
1017  "Error! SHOC is intended to run with a timestep no longer than 5 minutes.\n"
1018  " Please, reduce timestep (perhaps increasing subcycling iterations).\n");
1019 
1020  const auto nlev_packs = ekat::npack<Spack>(m_num_layers);
1021  const auto scan_policy = TPF::get_thread_range_parallel_scan_team_policy(m_num_cols, nlev_packs);
1022  const auto default_policy = TPF::get_default_team_policy(m_num_cols, nlev_packs);
1023 
1024  // Preprocessing of SHOC inputs. Kernel contains a parallel_scan,
1025  // so a special TeamPolicy is required.
1026  Kokkos::parallel_for("shoc_preprocess",
1027  scan_policy,
1028  shoc_preprocess);
1029  Kokkos::fence();
1030 
1031  auto wtracer_sfc = shoc_preprocess.wtracer_sfc;
1032  Kokkos::deep_copy(wtracer_sfc, 0);
1033 
1034  if (apply_tms) {
1036  }
1037 
1038  if (check_flux_state) {
1040  }
1041 
1042  // For now set the host timestep to the shoc timestep. This forces
1043  // number of SHOC timesteps (nadv) to be 1.
1044  // TODO: input parameter?
1045  hdtime = dt;
1046  m_nadv = std::max(static_cast<int>(round(hdtime/dt)),1);
1047 
1048  // Reset internal WSM variables.
1049  workspace_mgr.reset_internals();
1050 
1051  // Run shoc main
1052  SHF::shoc_main(m_num_cols, m_num_layers, m_num_layers+1, m_npbl, m_nadv, m_num_tracers, dt,
1054 #ifdef SCREAM_SHOC_SMALL_KERNELS
1055  , temporaries
1056 #endif
1057  );
1058 
1059  // Postprocessing of SHOC outputs
1060  Kokkos::parallel_for("shoc_postprocess",
1061  default_policy,
1063  Kokkos::fence();
1064 
1065  // Extra SHOC output diagnostics
1066  if (runtime_options.extra_diags) {
1067  Kokkos::deep_copy(shoc_mix,history_output.shoc_mix);
1068  Kokkos::deep_copy(brunt,history_output.brunt);
1069  Kokkos::deep_copy(w3,history_output.w3);
1070  Kokkos::deep_copy(isotropy,history_output.isotropy);
1071  Kokkos::deep_copy(wthl_sec,history_output.wthl_sec);
1072  Kokkos::deep_copy(wqw_sec,history_output.wqw_sec);
1073  Kokkos::deep_copy(uw_sec,history_output.uw_sec);
1074  Kokkos::deep_copy(vw_sec,history_output.vw_sec);
1075  Kokkos::deep_copy(qw_sec,history_output.qw_sec);
1076  Kokkos::deep_copy(thl_sec,history_output.thl_sec);
1077  }
1078 }
Int m_nadv
Definition: ERF_ShocInterface.H:573
void check_flux_state_consistency(const double dt)
Definition: ERF_ShocInterface.cpp:1117
Int hdtime
Definition: ERF_ShocInterface.H:576
void apply_turbulent_mountain_stress()
Definition: ERF_ShocInterface.cpp:1095

◆ set_computed_group_impl()

void SHOCInterface::set_computed_group_impl ( )
protected

◆ set_diff_stresses()

void SHOCInterface::set_diff_stresses ( )
663 {
664  for (MFIter mfi(*m_hfx3); mfi.isValid(); ++mfi) {
665  const auto& vbx_cc = mfi.validbox();
666  const auto& vbx_xz = convert(vbx_cc,IntVect(1,0,1));
667  const auto& vbx_yz = convert(vbx_cc,IntVect(0,1,1));
668 
669  const Array4<Real>& hfx_arr = m_hfx3->array(mfi);
670  const Array4<Real>& qfx_arr = m_qfx3->array(mfi);
671 
672  const Array4<Real>& t13_arr = m_tau13->array(mfi);
673  const Array4<Real>& t23_arr = m_tau23->array(mfi);
674 
675  ParallelFor(vbx_cc, vbx_xz, vbx_yz,
676  [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
677  {
678  hfx_arr(i,j,k) = 0.;
679  qfx_arr(i,j,k) = 0.;
680  },
681  [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
682  {
683  t13_arr(i,j,k) = 0.;
684  },
685  [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
686  {
687  t23_arr(i,j,k) = 0.;
688  });
689  }
690 }

◆ set_eddy_diffs()

void SHOCInterface::set_eddy_diffs ( )
610 {
611  //
612  // Expose for device capture
613  //
614 
615  // Input/Output data structures
616  //=======================================================
617  auto tk_d = tk;
618 
619  // NOTE: Loop on grown box to fill ghost cells but limit
620  // to valid box where views are defined.
621  for (MFIter mfi(*m_mu); mfi.isValid(); ++mfi) {
622  const auto& gbx_cc = mfi.growntilebox();
623  const auto& vbx_cc = mfi.validbox();
624 
625  const int nx = vbx_cc.length(0);
626  const int imin = vbx_cc.smallEnd(0);
627  const int imax = vbx_cc.bigEnd(0);
628  const int jmin = vbx_cc.smallEnd(1);
629  const int jmax = vbx_cc.bigEnd(1);
630  const int kmin = vbx_cc.smallEnd(2);
631  const int kmax = vbx_cc.bigEnd(2);
632  const int offset = m_col_offsets[mfi.index()];
633 
634  const Array4<Real>& mu_arr = m_mu->array(mfi);
635 
636  ParallelFor(gbx_cc, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
637  {
638  // Limiting
639  int ii = std::min(std::max(i,imin),imax);
640  int jj = std::min(std::max(j,jmin),jmax);
641  int kk = std::min(std::max(k,kmin),kmax);
642 
643  // NOTE: k gets permuted with ilay
644  // map [i,j,k] 0-based to [icol, ilay] 0-based
645  const int icol = (jj-jmin)*nx + (ii-imin) + offset;
646  const int ilay = kmax - kk;
647 
648  // NOTE: Set mom_v for tau_33, all other vertical comps are 0
649  mu_arr(i,j,k,EddyDiff::Mom_v) = tk_d(icol,ilay)[0];
650  mu_arr(i,j,k,EddyDiff::Theta_v) = 0.0;
651  mu_arr(i,j,k,EddyDiff::KE_v) = 0.0;
652  mu_arr(i,j,k,EddyDiff::Q_v) = 0.0;
653  });
654  }
655 
656  // Correct the internal ghost cells that have foextrap
657  m_mu->FillBoundary(m_geom.periodicity());
658 }
amrex::MultiFab * m_mu
Definition: ERF_ShocInterface.H:608
@ Theta_v
Definition: ERF_IndexDefines.H:176
@ Q_v
Definition: ERF_IndexDefines.H:179
@ Mom_v
Definition: ERF_IndexDefines.H:175
@ KE_v
Definition: ERF_IndexDefines.H:177
Here is the call graph for this function:

◆ set_grids()

void SHOCInterface::set_grids ( int &  level,
const amrex::BoxArray &  ba,
amrex::Geometry &  geom,
amrex::MultiFab *  cons,
amrex::MultiFab *  xvel,
amrex::MultiFab *  yvel,
amrex::MultiFab *  zvel,
amrex::Real w_subsid,
amrex::MultiFab *  tau13,
amrex::MultiFab *  tau23,
amrex::MultiFab *  hfx3,
amrex::MultiFab *  qfx3,
amrex::MultiFab *  eddyDiffs,
amrex::MultiFab *  z_phys 
)
128 {
129  // Set data members that may change
130  m_lev = level;
131  m_geom = geom;
132  m_cons = cons;
133  m_xvel = xvel;
134  m_yvel = yvel;
135  m_zvel = zvel;
136  m_w_subsid = w_subsid;
137  m_tau13 = tau13;
138  m_tau23 = tau23;
139  m_hfx3 = hfx3;
140  m_qfx3 = qfx3;
141  m_mu = eddyDiffs;
142  m_z_phys = z_phys;
143 
144  // Ensure the boxes span klo -> khi
145  int klo = geom.Domain().smallEnd(2);
146  int khi = geom.Domain().bigEnd(2);
147 
148  // Reset vector of offsets for columnar data
149  m_num_layers = geom.Domain().length(2);
150 
151  int num_cols = 0;
152  m_col_offsets.clear();
153  m_col_offsets.resize(int(ba.size()));
154  for (MFIter mfi(*m_cons); mfi.isValid(); ++mfi) {
155  const auto& vbx = mfi.validbox();
156  AMREX_ALWAYS_ASSERT_WITH_MESSAGE((klo == vbx.smallEnd(2)) &&
157  (khi == vbx.bigEnd(2)),
158  "Vertical decomposition with shoc is not allowed.");
159  int nx = vbx.length(0);
160  int ny = vbx.length(1);
161  m_col_offsets[mfi.index()] = num_cols;
162  num_cols += nx * ny;
163  }
164 
165  // Resize the Kokkos variables that persist in memory
166  if (num_cols != m_num_cols) {
168  tk = view_2d();
169  sgs_buoy_flux = view_2d("sgs_buoy_flux", num_cols, m_num_layers);
170  tk = view_2d("eddy_diff_mom", num_cols, m_num_layers);
171  }
172  m_num_cols = num_cols;
173 
174  // Allocate the tendency MultiFabs
175  c_tend.define(m_cons->boxArray(), m_cons->DistributionMap(), m_cons->nComp(), 0);
176  u_tend.define(m_xvel->boxArray(), m_xvel->DistributionMap(), m_xvel->nComp(), 0);
177  v_tend.define(m_yvel->boxArray(), m_yvel->DistributionMap(), m_yvel->nComp(), 0);
178 
179  // Allocate the buffer arrays in ERF
180  alloc_buffers();
181 
182  // Allocate the m_buffer struct
183  init_buffers();
184 
185  // Fill the KOKKOS Views from AMReX MFs
187 }
@ tau23
Definition: ERF_DataStruct.H:30
@ tau13
Definition: ERF_DataStruct.H:30
void alloc_buffers()
Definition: ERF_ShocInterface.cpp:191
void init_buffers()
Definition: ERF_ShocInterface.cpp:777
int m_lev
Definition: ERF_ShocInterface.H:579
void mf_to_kokkos_buffers()
Definition: ERF_ShocInterface.cpp:340
@ xvel
Definition: ERF_IndexDefines.H:141
@ cons
Definition: ERF_IndexDefines.H:140
@ zvel
Definition: ERF_IndexDefines.H:143
@ yvel
Definition: ERF_IndexDefines.H:142

Member Data Documentation

◆ apply_tms

bool SHOCInterface::apply_tms = true
protected

◆ brunt

view_2d SHOCInterface::brunt
protected

◆ c_tend

amrex::MultiFab SHOCInterface::c_tend
protected

◆ check_flux_state

bool SHOCInterface::check_flux_state = false
protected

◆ cldfrac_liq

view_2d SHOCInterface::cldfrac_liq
protected

◆ cldfrac_liq_prev

view_2d SHOCInterface::cldfrac_liq_prev
protected

◆ column_conservation_check

bool SHOCInterface::column_conservation_check = false
protected

◆ extra_shoc_diags

bool SHOCInterface::extra_shoc_diags = false
protected

◆ hdtime

Int SHOCInterface::hdtime
protected

◆ heat_flux

view_1d SHOCInterface::heat_flux
protected

◆ history_output

SHF::SHOCHistoryOutput SHOCInterface::history_output
protected

◆ horiz_wind

view_3d SHOCInterface::horiz_wind
protected

◆ ice_flux

view_1d SHOCInterface::ice_flux
protected

◆ input

SHF::SHOCInput SHOCInterface::input
protected

◆ input_output

SHF::SHOCInputOutput SHOCInterface::input_output
protected

◆ inv_qc_relvar

view_2d SHOCInterface::inv_qc_relvar
protected

◆ isotropy

view_2d SHOCInterface::isotropy
protected

◆ m_ba

amrex::BoxArray SHOCInterface::m_ba
protected

◆ m_buffer

Buffer SHOCInterface::m_buffer
protected

◆ m_col_offsets

amrex::Vector<int> SHOCInterface::m_col_offsets
protected

◆ m_cons

amrex::MultiFab* SHOCInterface::m_cons = nullptr
protected

◆ m_first_step

bool SHOCInterface::m_first_step = true
protected

◆ m_geom

amrex::Geometry SHOCInterface::m_geom
protected

◆ m_hfx3

amrex::MultiFab* SHOCInterface::m_hfx3 = nullptr
protected

◆ m_lev

int SHOCInterface::m_lev
protected

◆ m_mu

amrex::MultiFab* SHOCInterface::m_mu = nullptr
protected

◆ m_nadv

Int SHOCInterface::m_nadv
protected

◆ m_npbl

Int SHOCInterface::m_npbl
protected

◆ m_num_cols

Int SHOCInterface::m_num_cols = 0
protected

◆ m_num_layers

Int SHOCInterface::m_num_layers = 0
protected

◆ m_num_tracers

Int SHOCInterface::m_num_tracers = 3
protected

◆ m_num_vel_comp

Int SHOCInterface::m_num_vel_comp = 2
protected

◆ m_qfx3

amrex::MultiFab* SHOCInterface::m_qfx3 = nullptr
protected

◆ m_step

int SHOCInterface::m_step
protected

◆ m_tau13

amrex::MultiFab* SHOCInterface::m_tau13 = nullptr
protected

◆ m_tau23

amrex::MultiFab* SHOCInterface::m_tau23 = nullptr
protected

◆ m_w_subsid

amrex::Real* SHOCInterface::m_w_subsid = nullptr
protected

◆ m_xvel

amrex::MultiFab* SHOCInterface::m_xvel = nullptr
protected

◆ m_yvel

amrex::MultiFab* SHOCInterface::m_yvel = nullptr
protected

◆ m_z_phys

amrex::MultiFab* SHOCInterface::m_z_phys = nullptr
protected

◆ m_zvel

amrex::MultiFab* SHOCInterface::m_zvel = nullptr
protected

◆ obklen

view_1d SHOCInterface::obklen
protected

◆ omega

view_2d SHOCInterface::omega
protected

◆ output

SHF::SHOCOutput SHOCInterface::output
protected

◆ p_int

view_2d SHOCInterface::p_int
protected

◆ p_mid

view_2d SHOCInterface::p_mid
protected

◆ pblh

view_1d SHOCInterface::pblh
protected

◆ phis

view_1d SHOCInterface::phis
protected

◆ pseudo_dens

view_2d SHOCInterface::pseudo_dens
protected

◆ qc

view_2d SHOCInterface::qc
protected

◆ qtracers

view_3d_strided SHOCInterface::qtracers
protected

◆ qv

view_2d SHOCInterface::qv
protected

◆ qw_sec

view_2d SHOCInterface::qw_sec
protected

◆ runtime_options

SHF::SHOCRuntime SHOCInterface::runtime_options
protected

◆ sgs_buoy_flux

view_2d SHOCInterface::sgs_buoy_flux
protected

◆ shoc_cond

view_2d SHOCInterface::shoc_cond
protected

◆ shoc_evap

view_2d SHOCInterface::shoc_evap
protected

◆ shoc_mix

view_2d SHOCInterface::shoc_mix
protected

◆ shoc_postprocess

SHOCPostprocess SHOCInterface::shoc_postprocess
protected

◆ shoc_preprocess

SHOCPreprocess SHOCInterface::shoc_preprocess
protected

◆ surf_drag_coeff_tms

view_1d SHOCInterface::surf_drag_coeff_tms
protected

◆ surf_evap

view_1d SHOCInterface::surf_evap
protected

◆ surf_mom_flux

sview_2d SHOCInterface::surf_mom_flux
protected

◆ surf_sens_flux

view_1d SHOCInterface::surf_sens_flux
protected

◆ T_mid

view_2d SHOCInterface::T_mid
protected

◆ thl_sec

view_2d SHOCInterface::thl_sec
protected

◆ tk

view_2d SHOCInterface::tk
protected

◆ tke

view_2d SHOCInterface::tke
protected

◆ tkh

view_2d SHOCInterface::tkh
protected

◆ tot_buff_view

view_1d SHOCInterface::tot_buff_view
protected

◆ u_tend

amrex::MultiFab SHOCInterface::u_tend
protected

◆ ustar

view_1d SHOCInterface::ustar
protected

◆ uw_sec

view_2d SHOCInterface::uw_sec
protected

◆ v_tend

amrex::MultiFab SHOCInterface::v_tend
protected

◆ vapor_flux

view_1d SHOCInterface::vapor_flux
protected

◆ vw_sec

view_2d SHOCInterface::vw_sec
protected

◆ w3

view_2d SHOCInterface::w3
protected

◆ w_sec

view_2d SHOCInterface::w_sec
protected

◆ water_flux

view_1d SHOCInterface::water_flux
protected

◆ workspace_mgr

ekat::WorkspaceManager<Spack, KT::Device> SHOCInterface::workspace_mgr
protected

◆ wqw_sec

view_2d SHOCInterface::wqw_sec
protected

◆ wthl_sec

view_2d SHOCInterface::wthl_sec
protected

The documentation for this class was generated from the following files: