ERF
Energy Research and Forecasting: An Atmospheric Modeling Code
ERF_TI_slow_rhs_post.H
Go to the documentation of this file.
1 #include "ERF_SrcHeaders.H"
2 
3  auto slow_rhs_fun_post = [&](Vector<MultiFab>& S_rhs,
4  Vector<MultiFab>& S_old,
5  Vector<MultiFab>& S_new,
6  Vector<MultiFab>& S_data,
7  const Real old_step_time,
8  const Real old_stage_time,
9  const Real new_stage_time,
10  const int nrk)
11  {
12  // Note that the "old" and "new" metric terms correspond to
13  // t^n and the RK stage (either t^*, t^** or t^{n+1} that this source
14  // will be used to advance to
15  Real slow_dt = new_stage_time - old_step_time;
16 
17  if (verbose) amrex::Print() << "Time integration of scalars at level " << level
18  << std::setprecision(timeprecision)
19  << " from " << old_step_time << " to " << new_stage_time
20  << " with dt = " << slow_dt
21  << " using RHS created at " << old_stage_time << std::endl;
22 
23 #if defined(ERF_USE_NETCDF)
24  bool moist_set_rhs = false;
25  if ( solverChoice.use_real_bcs && (level==0) && (real_set_width > 0) &&
26  (solverChoice.moisture_type != MoistureType::None) )
27  {
28  moist_set_rhs = true;
29  }
30 #endif
31 
32  // *************************************************************************
33  // Set up flux registers if using two_way coupling
34  // *************************************************************************
35  YAFluxRegister* fr_as_crse = nullptr;
36  YAFluxRegister* fr_as_fine = nullptr;
37  if (solverChoice.coupling_type == CouplingType::TwoWay && finest_level > 0)
38  {
39  if (level < finest_level) {
40  fr_as_crse = getAdvFluxReg(level+1);
41  }
42  if (level > 0) {
43  fr_as_fine = getAdvFluxReg(level);
44  }
45  }
46 
47  MultiFab* new_detJ =
48  (solverChoice.terrain_type == TerrainType::MovingFittedMesh) ? (detJ_cc_new[level].get()) : (detJ_cc[level].get());
49 
50  erf_slow_rhs_post(level, finest_level, nrk, slow_dt, micro->Get_Qstate_Moist_Size(),
51  S_rhs, S_old, S_new, S_data, S_prim, avg_xmom[level], avg_ymom[level], avg_zmom[level],
52  xvel_new, yvel_new, zvel_new, cc_src, SmnSmn, eddyDiffs,
53  Hfx1, Hfx2, Hfx3, Q1fx1, Q1fx2, Q1fx3, Q2fx3, Diss,
54  fine_geom, solverChoice, m_SurfaceLayer, domain_bcs_type_d, domain_bcs_type,
55  z_phys_nd[level], z_phys_cc[level], ax[level], ay[level], az[level],
56  detJ_cc[level], new_detJ, stretched_dz_d[level], mapfac[level], EBFactory(level),
57 #if defined(ERF_USE_NETCDF)
58  moist_set_rhs, bdy_time_interval, new_stage_time, stop_time-start_time,
59  real_width, real_set_width,
60  bdy_data_xlo, bdy_data_xhi, bdy_data_ylo, bdy_data_yhi,
61 #endif
62  fr_as_crse, fr_as_fine);
63 
64  // Apply state redistribution for cons states
65 
66  if (solverChoice.terrain_type == TerrainType::EB)
67  {
68  Vector<int> is_valid_slow_var; is_valid_slow_var.resize(RhoQ1_comp+1,0);
69  if (solverChoice.turbChoice[level].use_tke) {is_valid_slow_var[ RhoKE_comp] = 1;}
70  is_valid_slow_var[RhoScalar_comp] = 1;
71  if (solverChoice.moisture_type != MoistureType::None) {
72  is_valid_slow_var[RhoQ1_comp] = 1;
73  }
74  const int num_comp_total = S_rhs[IntVars::cons].nComp();
75  const int num_grow = S_rhs[IntVars::cons].nGrow();
76  const int nvars = S_data[IntVars::cons].nComp();
77 
78  MultiFab dUdt_tmp(ba, dm, num_comp_total, num_grow, MFInfo(), EBFactory(level));
79  dUdt_tmp.setVal(0.0, 0, num_comp_total, num_grow);
80 
81  int start_comp;
82  int num_comp;
83 
84  for (int ivar(RhoKE_comp); ivar<= RhoQ1_comp; ++ivar)
85  {
86  if (is_valid_slow_var[ivar])
87  {
88  start_comp = ivar;
89  num_comp = 1;
90  if (ivar == RhoQ1_comp) {
91  num_comp = nvars - RhoQ1_comp;
92  } else if (ivar == RhoScalar_comp) {
93  num_comp = NSCALARS;
94  }
95  MultiFab::Copy(dUdt_tmp, S_rhs[IntVars::cons], start_comp, start_comp, num_comp, 0);
96  }
97  }
98  dUdt_tmp.FillBoundary(fine_geom.periodicity());
99  dUdt_tmp.setDomainBndry(1.234e10, 0, num_comp_total, fine_geom);
100 
101  const BCRec* bc_ptr_d = domain_bcs_type_d.data();
102 
103  // Update S_rhs by Redistribution.
104  // To-do: Currently, redistributing all the scalar variables.
105  // This needs to be redistributed only for num_comp variables starting from ivar, for efficiency.
106  redistribute_term ( num_comp_total, fine_geom, S_rhs[IntVars::cons], dUdt_tmp,
107  S_old[IntVars::cons], EBFactory(level), bc_ptr_d, slow_dt);
108 
109  // Update state using the updated S_rhs. (NOTE: redistribute_term returns RHS not state variables.)
110  for ( MFIter mfi(S_new[IntVars::cons],TilingIfNotGPU()); mfi.isValid(); ++mfi)
111  {
112  Box tbx = mfi.tilebox();
113  const Array4<Real>& snew = S_new[IntVars::cons].array(mfi);
114  const Array4<Real>& sold = S_old[IntVars::cons].array(mfi);
115  const Array4<Real>& srhs = S_rhs[IntVars::cons].array(mfi);
116  Array4<const Real> detJ_arr = EBFactory(level).getVolFrac().const_array(mfi);
117 
118  for (int ivar(RhoKE_comp); ivar<= RhoQ1_comp; ++ivar)
119  {
120  if (is_valid_slow_var[ivar])
121  {
122  start_comp = ivar;
123  num_comp = 1;
124  if (ivar == RhoQ1_comp) {
125  num_comp = nvars - RhoQ1_comp;
126  } else if (ivar == RhoScalar_comp) {
127  num_comp = NSCALARS;
128  }
129  ParallelFor(tbx, num_comp, [=] AMREX_GPU_DEVICE (int i, int j, int k, int nn)
130  {
131  if (detJ_arr(i,j,k) > 0.0) {
132  const int n = start_comp + nn;
133  snew(i,j,k,n) = sold(i,j,k,n) + slow_dt * srhs(i,j,k,n);
134  }
135  });
136  }
137  }
138  }
139  } // EB
140 
141  // Apply boundary conditions on all the state variables that have been updated
142  // in both the fast and slow integrators
143  apply_bcs(S_new, new_stage_time, S_new[IntVars::cons].nGrow(), S_new[IntVars::xmom].nGrow(),
144  fast_only=false, vel_and_mom_synced=false);
145 
146  if (solverChoice.moisture_tight_coupling) {
147  // TODO: need iteration var for lagrangian microphysics
148  // call signature in ERF::Advance() is
149  //advance_microphysics(lev, S_new, dt_lev, iteration, time);
150  advance_microphysics(level, S_new[0], slow_dt, 123456789, old_step_time);
151  }
152  }; // end slow_rhs_fun_post
@ nvars
Definition: ERF_DataStruct.H:91
void redistribute_term(int ncomp, const Geometry &geom, MultiFab &result, MultiFab &result_tmp, MultiFab const &state, EBFArrayBoxFactory const &ebfact, BCRec const *bc, Real const local_dt)
Definition: ERF_EBRedistribute.cpp:13
#define RhoScalar_comp
Definition: ERF_IndexDefines.H:40
#define NSCALARS
Definition: ERF_IndexDefines.H:16
#define RhoQ1_comp
Definition: ERF_IndexDefines.H:42
#define RhoKE_comp
Definition: ERF_IndexDefines.H:38
amrex::Real Real
Definition: ERF_ShocInterface.H:19
void erf_slow_rhs_post(int level, int finest_level, int nrk, Real dt, int n_qstate, Vector< MultiFab > &S_rhs, Vector< MultiFab > &S_old, Vector< MultiFab > &S_new, Vector< MultiFab > &S_data, const MultiFab &S_prim, MultiFab &avg_xmom, MultiFab &avg_ymom, MultiFab &avg_zmom, const MultiFab &xvel, const MultiFab &yvel, const MultiFab &, const MultiFab &source, const MultiFab *SmnSmn, const MultiFab *eddyDiffs, MultiFab *Hfx1, MultiFab *Hfx2, MultiFab *Hfx3, MultiFab *Q1fx1, MultiFab *Q1fx2, MultiFab *Q1fx3, MultiFab *Q2fx3, MultiFab *Diss, const Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< SurfaceLayer > &SurfLayer, const Gpu::DeviceVector< BCRec > &domain_bcs_type_d, const Vector< BCRec > &domain_bcs_type_h, std::unique_ptr< MultiFab > &z_phys_nd, std::unique_ptr< MultiFab > &z_phys_cc, std::unique_ptr< MultiFab > &ax, std::unique_ptr< MultiFab > &ay, std::unique_ptr< MultiFab > &az, std::unique_ptr< MultiFab > &detJ, MultiFab *detJ_new, Gpu::DeviceVector< Real > &stretched_dz_d, Vector< std::unique_ptr< MultiFab >> &mapfac, amrex::EBFArrayBoxFactory const &ebfact, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine)
Definition: ERF_SlowRhsPost.cpp:47
auto slow_rhs_fun_post
Definition: ERF_TI_slow_rhs_post.H:3
auto apply_bcs
Definition: ERF_TI_utils.H:73
@ cons
Definition: ERF_IndexDefines.H:158
@ xmom
Definition: ERF_IndexDefines.H:159