ERF
Energy Research and Forecasting: An Atmospheric Modeling Code
ERF_Substep_NS.cpp File Reference
Include dependency graph for ERF_Substep_NS.cpp:

Functions

void erf_substep_NS (int step, int nrk, int level, int finest_level, Vector< MultiFab > &S_slow_rhs, const Vector< MultiFab > &S_prev, Vector< MultiFab > &S_stage_data, const MultiFab &S_stage_prim, const MultiFab &qt, const MultiFab &pi_stage, const MultiFab &fast_coeffs, Vector< MultiFab > &S_data, MultiFab &lagged_delta_rt, MultiFab &avg_xmom, MultiFab &avg_ymom, MultiFab &avg_zmom, const MultiFab &cc_src, const MultiFab &xmom_src, const MultiFab &ymom_src, const MultiFab &zmom_src, const Geometry geom, const Real gravity, amrex::Gpu::DeviceVector< amrex::Real > &stretched_dz_d, const Real dtau, const Real beta_s, const Real facinv, Vector< std::unique_ptr< MultiFab >> &mapfac, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, const amrex::Real *sinesq_stag_d, const Real l_damp_coef)
 

Function Documentation

◆ erf_substep_NS()

void erf_substep_NS ( int  step,
int  nrk,
int  level,
int  finest_level,
Vector< MultiFab > &  S_slow_rhs,
const Vector< MultiFab > &  S_prev,
Vector< MultiFab > &  S_stage_data,
const MultiFab &  S_stage_prim,
const MultiFab &  qt,
const MultiFab &  pi_stage,
const MultiFab &  fast_coeffs,
Vector< MultiFab > &  S_data,
MultiFab &  lagged_delta_rt,
MultiFab &  avg_xmom,
MultiFab &  avg_ymom,
MultiFab &  avg_zmom,
const MultiFab &  cc_src,
const MultiFab &  xmom_src,
const MultiFab &  ymom_src,
const MultiFab &  zmom_src,
const Geometry  geom,
const Real  gravity,
amrex::Gpu::DeviceVector< amrex::Real > &  stretched_dz_d,
const Real  dtau,
const Real  beta_s,
const Real  facinv,
Vector< std::unique_ptr< MultiFab >> &  mapfac,
YAFluxRegister *  fr_as_crse,
YAFluxRegister *  fr_as_fine,
bool  l_use_moisture,
bool  l_reflux,
const amrex::Real sinesq_stag_d,
const Real  l_damp_coef 
)

Function for computing the fast RHS with no terrain and variable vertical spacing

Parameters
[in]stepwhich fast time step within each Runge-Kutta step
[in]nrkwhich Runge-Kutta step
[in]levellevel of resolution
[in]finest_levelfinest level of resolution
[in]S_slow_rhsslow RHS computed in erf_slow_rhs_pre
[in]S_previf step == 0, this is S_old, else the previous fast solution
[in]S_stage_datasolution at previous RK stage
[in]S_stage_primprimitive variables at previous RK stage
[in]pi_stageExner function at previous RK stage
[in]fast_coeffscoefficients for the tridiagonal solve used in the fast integrator
[out]S_datacurrent solution
[in,out]lagged_delta_rt
[in,out]avg_xmomtime-averaged x-momentum to be used for updating slow variables
[in,out]avg_ymomtime-averaged y-momentum to be used for updating slow variables
[in,out]avg_zmomtime-averaged z-momentum to be used for updating slow variables
[in]cc_srcsource terms for conserved variables
[in]xmom_srcsource terms for x-momentum
[in]ymom_srcsource terms for y-momentum
[in]zmom_srcsource terms for z-momentum
[in]geomcontainer for geometric information
[in]gravitymagnitude of gravity
[in]stretched_dz_d
[in]dtaufast time step
[in]beta_sCoefficient which determines how implicit vs explicit the solve is
[in]facinvinverse factor for time-averaging the momenta
[in]mapfacvector of map factors
[in,out]fr_as_crseYAFluxRegister at level l at level l / l+1 interface
[in,out]fr_as_fineYAFluxRegister at level l at level l-1 / l interface
[in]l_use_moisture
[in]l_refluxshould we add fluxes to the FluxRegisters?
72 {
73  //
74  // NOTE: for step > 0, S_data and S_prev point to the same MultiFab data!!
75  //
76 
77  BL_PROFILE_REGION("erf_substep_S()");
78 
79  Real beta_1 = 0.5 * (1.0 - beta_s); // multiplies explicit terms
80  Real beta_2 = 0.5 * (1.0 + beta_s); // multiplies implicit terms
81 
82  // How much do we project forward the (rho theta) that is used in the horizontal momentum equations
83  Real beta_d = 0.1;
84 
85  Real RvOverRd = R_v / R_d;
86 
87  bool l_rayleigh_impl_for_w = (sinesq_stag_d != nullptr);
88 
89  const Real* dx = geom.CellSize();
90  const GpuArray<Real, AMREX_SPACEDIM> dxInv = geom.InvCellSizeArray();
91 
92  Real dxi = dxInv[0];
93  Real dyi = dxInv[1];
94 
95  auto dz_ptr = stretched_dz_d.data();
96 
97  const auto& ba = S_stage_data[IntVars::cons].boxArray();
98  const auto& dm = S_stage_data[IntVars::cons].DistributionMap();
99 
100  MultiFab Delta_rho_theta( ba , dm, 1, 1);
101  MultiFab Delta_rho_w (convert(ba,IntVect(0,0,1)), dm, 1, IntVect(1,1,0));
102 
103  MultiFab coeff_A_mf(fast_coeffs, make_alias, 0, 1);
104  MultiFab inv_coeff_B_mf(fast_coeffs, make_alias, 1, 1);
105  MultiFab coeff_C_mf(fast_coeffs, make_alias, 2, 1);
106  MultiFab coeff_P_mf(fast_coeffs, make_alias, 3, 1);
107  MultiFab coeff_Q_mf(fast_coeffs, make_alias, 4, 1);
108 
109  // *************************************************************************
110  // Set gravity as a vector
111  const Array<Real,AMREX_SPACEDIM> grav{0.0, 0.0, -gravity};
112  const GpuArray<Real,AMREX_SPACEDIM> grav_gpu{grav[0], grav[1], grav[2]};
113 
114  // This will hold theta extrapolated forward in time
115  MultiFab extrap(S_data[IntVars::cons].boxArray(),S_data[IntVars::cons].DistributionMap(),1,1);
116 
117  // This will hold the update for (rho) and (rho theta)
118  MultiFab temp_rhs(S_stage_data[IntVars::zmom].boxArray(),S_stage_data[IntVars::zmom].DistributionMap(),2,0);
119 
120  // This will hold the new x- and y-momenta temporarily (so that we don't overwrite values we need when tiling)
121  MultiFab temp_cur_xmom(S_stage_data[IntVars::xmom].boxArray(),S_stage_data[IntVars::xmom].DistributionMap(),1,0);
122  MultiFab temp_cur_ymom(S_stage_data[IntVars::ymom].boxArray(),S_stage_data[IntVars::ymom].DistributionMap(),1,0);
123 
124  // We assume that in the first step (nrk == 0) we are only doing one substep.
125  AMREX_ALWAYS_ASSERT(nrk > 0 || step == 0);
126 
127  // *************************************************************************
128  // First set up some arrays we'll need
129  // *************************************************************************
130 
131 #ifdef _OPENMP
132 #pragma omp parallel if (Gpu::notInLaunchRegion())
133 #endif
134  for ( MFIter mfi(S_stage_data[IntVars::cons],TilingIfNotGPU()); mfi.isValid(); ++mfi)
135  {
136  const Array4<const Real>& prev_cons = S_prev[IntVars::cons].const_array(mfi);
137  const Array4<const Real>& prev_zmom = S_prev[IntVars::zmom].const_array(mfi);
138 
139  const Array4<const Real>& stage_cons = S_stage_data[IntVars::cons].const_array(mfi);
140  const Array4<const Real>& stage_zmom = S_stage_data[IntVars::zmom].const_array(mfi);
141 
142  const Array4<Real>& prev_drho_w = Delta_rho_w.array(mfi);
143  const Array4<Real>& prev_drho_theta = Delta_rho_theta.array(mfi);
144  const Array4<Real>& lagged_arr = lagged_delta_rt.array(mfi);
145  const Array4<Real>& theta_extrap = extrap.array(mfi);
146  const Array4<const Real>& prim = S_stage_prim.const_array(mfi);
147 
148  Box gbx = mfi.growntilebox(1);
149  ParallelFor(gbx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
150  {
151  prev_drho_theta(i,j,k) = prev_cons(i,j,k,RhoTheta_comp) - stage_cons(i,j,k,RhoTheta_comp);
152 
153  if (step == 0) {
154  theta_extrap(i,j,k) = prev_drho_theta(i,j,k);
155  } else {
156  theta_extrap(i,j,k) = prev_drho_theta(i,j,k) + beta_d *
157  ( prev_drho_theta(i,j,k) - lagged_arr(i,j,k) );
158  }
159 
160  // NOTE: qv is not changing over the fast steps so we use the stage data
161  Real qv = (l_use_moisture) ? prim(i,j,k,PrimQ1_comp) : 0.0;
162  theta_extrap(i,j,k) *= (1.0 + RvOverRd*qv);
163 
164  // We define lagged_delta_rt for our next step as the current delta_rt
165  // (after using it above to extrapolate theta for this step)
166  lagged_arr(i,j,k) = prev_drho_theta(i,j,k);
167  });
168 
169  // NOTE: We must do this here because for step > 0, prev_zmom and cur_zmom both point to the same data,
170  // so by the time we would use prev_zmom to define zflux, it would have already been over-written.
171  Box gtbz = mfi.nodaltilebox(2);
172  gtbz.grow(IntVect(1,1,0));
173  ParallelFor(gtbz, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
174  prev_drho_w(i,j,k) = prev_zmom(i,j,k) - stage_zmom(i,j,k);
175  });
176  } // mfi
177 
178  // *************************************************************************
179  // Define updates in the current RK stage
180  // *************************************************************************
181 
182 #ifdef _OPENMP
183 #pragma omp parallel if (Gpu::notInLaunchRegion())
184 #endif
185  for ( MFIter mfi(S_stage_data[IntVars::cons],TilingIfNotGPU()); mfi.isValid(); ++mfi)
186  {
187  Box tbx = mfi.nodaltilebox(0);
188  Box tby = mfi.nodaltilebox(1);
189 
190  const Array4<Real const>& xmom_src_arr = xmom_src.const_array(mfi);
191  const Array4<Real const>& ymom_src_arr = ymom_src.const_array(mfi);
192 
193  const Array4<const Real> & stage_xmom = S_stage_data[IntVars::xmom].const_array(mfi);
194  const Array4<const Real> & stage_ymom = S_stage_data[IntVars::ymom].const_array(mfi);
195  const Array4<const Real> & qt_arr = qt.const_array(mfi);
196 
197  const Array4<const Real>& slow_rhs_rho_u = S_slow_rhs[IntVars::xmom].const_array(mfi);
198  const Array4<const Real>& slow_rhs_rho_v = S_slow_rhs[IntVars::ymom].const_array(mfi);
199 
200  const Array4<Real>& temp_cur_xmom_arr = temp_cur_xmom.array(mfi);
201  const Array4<Real>& temp_cur_ymom_arr = temp_cur_ymom.array(mfi);
202 
203  const Array4<const Real>& prev_xmom = S_prev[IntVars::xmom].const_array(mfi);
204  const Array4<const Real>& prev_ymom = S_prev[IntVars::ymom].const_array(mfi);
205 
206  // These store the advection momenta which we will use to update the slow variables
207  const Array4< Real>& avg_xmom_arr = avg_xmom.array(mfi);
208  const Array4< Real>& avg_ymom_arr = avg_ymom.array(mfi);
209 
210  const Array4<const Real>& pi_stage_ca = pi_stage.const_array(mfi);
211 
212  const Array4<Real>& theta_extrap = extrap.array(mfi);
213 
214  // Map factors
215  const Array4<const Real>& mf_ux = mapfac[MapFacType::u_x]->const_array(mfi);
216  const Array4<const Real>& mf_vy = mapfac[MapFacType::v_y]->const_array(mfi);
217 
218  // *********************************************************************
219  // Define updates in the RHS of {x, y, z}-momentum equations
220  // *********************************************************************
221  if (nrk == 0 and step == 0) { // prev == stage
222  ParallelFor(tbx, tby,
223  [=] AMREX_GPU_DEVICE (int i, int j, int k)
224  {
225  Real new_drho_u = dtau * slow_rhs_rho_u(i,j,k) + dtau * xmom_src_arr(i,j,k);;
226  avg_xmom_arr(i,j,k) += facinv*new_drho_u;
227  temp_cur_xmom_arr(i,j,k) = stage_xmom(i,j,k) + new_drho_u;
228  },
229  [=] AMREX_GPU_DEVICE (int i, int j, int k)
230  {
231  Real new_drho_v = dtau * slow_rhs_rho_v(i,j,k) + dtau * ymom_src_arr(i,j,k);
232  avg_ymom_arr(i,j,k) += facinv*new_drho_v;
233  temp_cur_ymom_arr(i,j,k) = stage_ymom(i,j,k) + new_drho_v;
234  });
235  } else {
236  ParallelFor(tbx, tby,
237  [=] AMREX_GPU_DEVICE (int i, int j, int k)
238  {
239  // Add (negative) gradient of (rho theta) multiplied by lagged "pi"
240  Real gpx = (theta_extrap(i,j,k) - theta_extrap(i-1,j,k))*dxi;
241  gpx *= mf_ux(i,j,0);
242 
243  Real q = (l_use_moisture) ? 0.5 * (qt_arr(i,j,k) + qt_arr(i-1,j,k)) : 0.0;
244 
245  Real pi_c = 0.5 * (pi_stage_ca(i-1,j,k,0) + pi_stage_ca(i,j,k,0));
246  Real fast_rhs_rho_u = -Gamma * R_d * pi_c * gpx / (1.0 + q);
247 
248  Real new_drho_u = prev_xmom(i,j,k) - stage_xmom(i,j,k)
249  + dtau * fast_rhs_rho_u + dtau * slow_rhs_rho_u(i,j,k)
250  + dtau * xmom_src_arr(i,j,k);
251 
252  avg_xmom_arr(i,j,k) += facinv*new_drho_u;
253 
254  temp_cur_xmom_arr(i,j,k) = stage_xmom(i,j,k) + new_drho_u;
255  },
256  [=] AMREX_GPU_DEVICE (int i, int j, int k)
257  {
258  // Add (negative) gradient of (rho theta) multiplied by lagged "pi"
259  Real gpy = (theta_extrap(i,j,k) - theta_extrap(i,j-1,k))*dyi;
260  gpy *= mf_vy(i,j,0);
261 
262  Real q = (l_use_moisture) ? 0.5 * (qt_arr(i,j,k) + qt_arr(i,j-1,k)) : 0.0;
263 
264  Real pi_c = 0.5 * (pi_stage_ca(i,j-1,k,0) + pi_stage_ca(i,j,k,0));
265  Real fast_rhs_rho_v = -Gamma * R_d * pi_c * gpy / (1.0 + q);
266 
267  Real new_drho_v = prev_ymom(i,j,k) - stage_ymom(i,j,k)
268  + dtau * fast_rhs_rho_v + dtau * slow_rhs_rho_v(i,j,k)
269  + dtau * ymom_src_arr(i,j,k);
270 
271  avg_ymom_arr(i,j,k) += facinv*new_drho_v;
272 
273  temp_cur_ymom_arr(i,j,k) = stage_ymom(i,j,k) + new_drho_v;
274  });
275  } // nrk > 0 and/or step > 0
276  } //mfi
277 
278 #ifdef _OPENMP
279 #pragma omp parallel if (Gpu::notInLaunchRegion())
280 #endif
281  {
282  std::array<FArrayBox,AMREX_SPACEDIM> flux;
283  for ( MFIter mfi(S_stage_data[IntVars::cons],TileNoZ()); mfi.isValid(); ++mfi)
284  {
285  Box bx = mfi.tilebox();
286  Box tbz = surroundingNodes(bx,2);
287 
288  Box vbx = mfi.validbox();
289  const auto& vbx_hi = ubound(vbx);
290 
291  const Array4<Real const>& zmom_src_arr = zmom_src.const_array(mfi);
292 
293  const Array4<const Real>& stage_xmom = S_stage_data[IntVars::xmom].const_array(mfi);
294  const Array4<const Real>& stage_ymom = S_stage_data[IntVars::ymom].const_array(mfi);
295  const Array4<const Real>& stage_zmom = S_stage_data[IntVars::zmom].const_array(mfi);
296  const Array4<const Real> & prim = S_stage_prim.const_array(mfi);
297  const Array4<const Real> & qt_arr = qt.const_array(mfi);
298 
299  const Array4<const Real>& prev_drho_theta = Delta_rho_theta.array(mfi);
300 
301  const Array4<const Real>& prev_cons = S_prev[IntVars::cons].const_array(mfi);
302  const Array4<const Real>& stage_cons = S_stage_data[IntVars::cons].const_array(mfi);
303 
304  const Array4<const Real>& slow_rhs_cons = S_slow_rhs[IntVars::cons].const_array(mfi);
305  const Array4<const Real>& slow_rhs_rho_w = S_slow_rhs[IntVars::zmom].const_array(mfi);
306 
307  const Array4<const Real>& prev_zmom = S_prev[IntVars::zmom].const_array(mfi);
308  const Array4< Real>& cur_zmom = S_data[IntVars::zmom].array(mfi);
309 
310  const Array4<Real>& temp_cur_xmom_arr = temp_cur_xmom.array(mfi);
311  const Array4<Real>& temp_cur_ymom_arr = temp_cur_ymom.array(mfi);
312 
313  // These store the advection momenta which we will use to update the slow variables
314  const Array4< Real>& avg_zmom_arr = avg_zmom.array(mfi);
315 
316  // Map factors
317  const Array4<const Real>& mf_mx = mapfac[MapFacType::m_x]->const_array(mfi);
318  const Array4<const Real>& mf_my = mapfac[MapFacType::m_y]->const_array(mfi);
319  const Array4<const Real>& mf_uy = mapfac[MapFacType::u_y]->const_array(mfi);
320  const Array4<const Real>& mf_vx = mapfac[MapFacType::v_x]->const_array(mfi);
321 
322  FArrayBox RHS_fab;
323  RHS_fab.resize(tbz,1, The_Async_Arena());
324 
325  FArrayBox soln_fab;
326  soln_fab.resize(tbz,1, The_Async_Arena());
327 
328  auto const& RHS_a = RHS_fab.array();
329  auto const& soln_a = soln_fab.array();
330 
331  auto const& temp_rhs_arr = temp_rhs.array(mfi);
332 
333  auto const& coeffA_a = coeff_A_mf.array(mfi);
334  auto const& inv_coeffB_a = inv_coeff_B_mf.array(mfi);
335  auto const& coeffC_a = coeff_C_mf.array(mfi);
336  auto const& coeffP_a = coeff_P_mf.array(mfi);
337  auto const& coeffQ_a = coeff_Q_mf.array(mfi);
338 
339  // *************************************************************************
340  // Define flux arrays for use in advection
341  // *************************************************************************
342  for (int dir = 0; dir < AMREX_SPACEDIM; ++dir) {
343  flux[dir].resize(surroundingNodes(bx,dir),2,The_Async_Arena());
344  flux[dir].setVal<RunOn::Device>(0.);
345  }
346  const GpuArray<const Array4<Real>, AMREX_SPACEDIM>
347  flx_arr{{AMREX_D_DECL(flux[0].array(), flux[1].array(), flux[2].array())}};
348 
349  // *********************************************************************
350  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
351  Real xflux_lo = (temp_cur_xmom_arr(i ,j,k) - stage_xmom(i ,j,k)) / mf_uy(i ,j,0);
352  Real xflux_hi = (temp_cur_xmom_arr(i+1,j,k) - stage_xmom(i+1,j,k)) / mf_uy(i+1,j,0);
353  Real yflux_lo = (temp_cur_ymom_arr(i,j ,k) - stage_ymom(i,j ,k)) / mf_vx(i,j ,0);
354  Real yflux_hi = (temp_cur_ymom_arr(i,j+1,k) - stage_ymom(i,j+1,k)) / mf_vx(i,j+1,0);
355 
356  Real mfsq = mf_mx(i,j,0) * mf_my(i,j,0);
357 
358  temp_rhs_arr(i,j,k,Rho_comp ) = ( xflux_hi - xflux_lo ) * dxi * mfsq
359  + ( yflux_hi - yflux_lo ) * dyi * mfsq;
360  temp_rhs_arr(i,j,k,RhoTheta_comp) = (( xflux_hi * (prim(i,j,k,0) + prim(i+1,j,k,0)) -
361  xflux_lo * (prim(i,j,k,0) + prim(i-1,j,k,0)) ) * dxi * mfsq +
362  ( yflux_hi * (prim(i,j,k,0) + prim(i,j+1,k,0)) -
363  yflux_lo * (prim(i,j,k,0) + prim(i,j-1,k,0)) ) * dyi * mfsq) * 0.5;
364 
365  if (l_reflux) {
366  (flx_arr[0])(i,j,k,0) = xflux_lo;
367  (flx_arr[0])(i,j,k,1) = (flx_arr[0])(i ,j,k,0) * 0.5 * (prim(i,j,k,0) + prim(i-1,j,k,0));
368 
369  (flx_arr[1])(i,j,k,0) = yflux_lo;
370  (flx_arr[1])(i,j,k,1) = (flx_arr[1])(i,j ,k,0) * 0.5 * (prim(i,j,k,0) + prim(i,j-1,k,0));
371 
372  if (i == vbx_hi.x) {
373  (flx_arr[0])(i+1,j,k,0) = xflux_hi;
374  (flx_arr[0])(i+1,j,k,1) = (flx_arr[0])(i+1,j,k,0) * 0.5 * (prim(i,j,k,0) + prim(i+1,j,k,0));
375  }
376  if (j == vbx_hi.y) {
377  (flx_arr[1])(i,j+1,k,0) = yflux_hi;
378  (flx_arr[1])(i,j+1,k,1) = (flx_arr[1])(i,j+1,k,0) * 0.5 * (prim(i,j,k,0) + prim(i,j+1,k,0));
379  }
380  }
381  });
382 
383  Box bx_shrunk_in_k = bx;
384  int klo = tbz.smallEnd(2);
385  int khi = tbz.bigEnd(2);
386  bx_shrunk_in_k.setSmall(2,klo+1);
387  bx_shrunk_in_k.setBig(2,khi-1);
388 
389  // Note that the notes use "g" to mean the magnitude of gravity, so it is positive
390  // We set grav_gpu[2] to be the vector component which is negative
391  // We define halfg to match the notes (which is why we take the absolute value)
392  Real halfg = std::abs(0.5 * grav_gpu[2]);
393 
394  // *********************************************************************
395  // fast_loop_on_shrunk
396  // *********************************************************************
397  //Note we don't act on the bottom or top boundaries of the domain
398  ParallelFor(bx_shrunk_in_k, [=] AMREX_GPU_DEVICE (int i, int j, int k)
399  {
400  Real q = (l_use_moisture) ? 0.5 * (qt_arr(i,j,k) + qt_arr(i,j,k-1)) : 0.0;
401 
402  Real coeff_P = coeffP_a(i,j,k) / (1.0 + q);
403  Real coeff_Q = coeffQ_a(i,j,k) / (1.0 + q);
404 
405  Real theta_t_lo = 0.5 * ( prim(i,j,k-2,PrimTheta_comp) + prim(i,j,k-1,PrimTheta_comp) );
406  Real theta_t_mid = 0.5 * ( prim(i,j,k-1,PrimTheta_comp) + prim(i,j,k ,PrimTheta_comp) );
407  Real theta_t_hi = 0.5 * ( prim(i,j,k ,PrimTheta_comp) + prim(i,j,k+1,PrimTheta_comp) );
408 
409  Real Omega_kp1 = prev_zmom(i,j,k+1) - stage_zmom(i,j,k+1);
410  Real Omega_k = prev_zmom(i,j,k ) - stage_zmom(i,j,k );
411  Real Omega_km1 = prev_zmom(i,j,k-1) - stage_zmom(i,j,k-1);
412 
413  // line 2 last two terms (order dtau)
414  Real old_drho_k = prev_cons(i,j,k ,Rho_comp) - stage_cons(i,j,k ,Rho_comp);
415  Real old_drho_km1 = prev_cons(i,j,k-1,Rho_comp) - stage_cons(i,j,k-1,Rho_comp);
416  Real R0_tmp = coeff_P * prev_drho_theta(i,j,k) + coeff_Q * prev_drho_theta(i,j,k-1)
417  - halfg * ( old_drho_k + old_drho_km1 );
418 
419  // lines 3-5 residuals (order dtau^2) 1.0 <-> beta_2
420  Real R1_tmp = halfg * (-slow_rhs_cons(i,j,k ,Rho_comp)
421  -slow_rhs_cons(i,j,k-1,Rho_comp)
422  +temp_rhs_arr(i,j,k,0) + temp_rhs_arr(i,j,k-1) )
423  + ( coeff_P * (slow_rhs_cons(i,j,k ,RhoTheta_comp) - temp_rhs_arr(i,j,k ,RhoTheta_comp)) +
424  coeff_Q * (slow_rhs_cons(i,j,k-1,RhoTheta_comp) - temp_rhs_arr(i,j,k-1,RhoTheta_comp)) );
425 
426  // lines 6&7 consolidated (reuse Omega & metrics) (order dtau^2)
427  Real dz_inv = 1.0 / dz_ptr[k];
428  R1_tmp += beta_1 * dz_inv * ( (Omega_kp1 - Omega_km1) * halfg
429  -(Omega_kp1*theta_t_hi - Omega_k *theta_t_mid) * coeff_P
430  -(Omega_k *theta_t_mid - Omega_km1*theta_t_lo ) * coeff_Q );
431 
432  // line 1
433  RHS_a(i,j,k) = Omega_k + dtau * (slow_rhs_rho_w(i,j,k) + R0_tmp + dtau * beta_2 * R1_tmp + zmom_src_arr(i,j,k));
434 
435  }); // bx_shrunk_in_k
436 
437  Box b2d = tbz; // Copy constructor
438  b2d.setRange(2,0);
439 
440  auto const lo = lbound(bx);
441  auto const hi = ubound(bx);
442 
443  ParallelFor(b2d, [=] AMREX_GPU_DEVICE (int i, int j, int)
444  {
445  // w at bottom boundary of grid is 0 if at domain boundary, otherwise w = w_old + dtau * slow_rhs
446  RHS_a (i,j,lo.z) = prev_zmom(i,j,lo.z) - stage_zmom(i,j,lo.z)
447  + dtau * slow_rhs_rho_w(i,j,lo.z)
448  + dtau * zmom_src_arr(i,j,lo.z);
449 
450  // w at top boundary of grid is 0 if at domain boundary, otherwise w = w_old + dtau * slow_rhs
451  RHS_a (i,j,hi.z+1) = prev_zmom(i,j,hi.z+1) - stage_zmom(i,j,hi.z+1)
452  + dtau * slow_rhs_rho_w(i,j,hi.z+1)
453  + dtau * zmom_src_arr(i,j,hi.z+1);
454  }); // b2d
455 
456 #ifdef AMREX_USE_GPU
457  ParallelFor(b2d, [=] AMREX_GPU_DEVICE (int i, int j, int)
458  {
459  // w = specified Dirichlet value at k = lo.z
460  soln_a(i,j,lo.z) = RHS_a(i,j,lo.z) * inv_coeffB_a(i,j,lo.z);
461  cur_zmom(i,j,lo.z) = stage_zmom(i,j,lo.z) + soln_a(i,j,lo.z);
462 
463  for (int k = lo.z+1; k <= hi.z+1; k++) {
464  soln_a(i,j,k) = (RHS_a(i,j,k)-coeffA_a(i,j,k)*soln_a(i,j,k-1)) * inv_coeffB_a(i,j,k);
465  }
466 
467  cur_zmom(i,j,hi.z+1) = stage_zmom(i,j,hi.z+1) + soln_a(i,j,hi.z+1);
468 
469  for (int k = hi.z; k >= lo.z; k--) {
470  soln_a(i,j,k) -= ( coeffC_a(i,j,k) * inv_coeffB_a(i,j,k) ) *soln_a(i,j,k+1);
471  cur_zmom(i,j,k) = stage_zmom(i,j,k) + soln_a(i,j,k);
472  }
473  }); // b2d
474 #else
475  for (int j = lo.y; j <= hi.y; ++j) {
476  AMREX_PRAGMA_SIMD
477  for (int i = lo.x; i <= hi.x; ++i) {
478  soln_a(i,j,lo.z) = RHS_a(i,j,lo.z) * inv_coeffB_a(i,j,lo.z);
479  }
480  }
481  for (int k = lo.z+1; k <= hi.z+1; ++k) {
482  for (int j = lo.y; j <= hi.y; ++j) {
483  AMREX_PRAGMA_SIMD
484  for (int i = lo.x; i <= hi.x; ++i) {
485  soln_a(i,j,k) = (RHS_a(i,j,k)-coeffA_a(i,j,k)*soln_a(i,j,k-1)) * inv_coeffB_a(i,j,k);
486  }
487  }
488  }
489  for (int j = lo.y; j <= hi.y; ++j) {
490  AMREX_PRAGMA_SIMD
491  for (int i = lo.x; i <= hi.x; ++i) {
492  cur_zmom(i,j,hi.z+1) = stage_zmom(i,j,hi.z+1) + soln_a(i,j,hi.z+1);
493  }
494  }
495  for (int k = hi.z; k >= lo.z; --k) {
496  for (int j = lo.y; j <= hi.y; ++j) {
497  AMREX_PRAGMA_SIMD
498  for (int i = lo.x; i <= hi.x; ++i) {
499  soln_a(i,j,k) -= ( coeffC_a(i,j,k) * inv_coeffB_a(i,j,k) ) * soln_a(i,j,k+1);
500  cur_zmom(i,j,k) = stage_zmom(i,j,k) + soln_a(i,j,k);
501  }
502  }
503  }
504 #endif
505  if (l_rayleigh_impl_for_w) {
506  ParallelFor(bx_shrunk_in_k, [=] AMREX_GPU_DEVICE (int i, int j, int k)
507  {
508  Real damping_coeff = l_damp_coef * dtau * sinesq_stag_d[k];
509  cur_zmom(i,j,k) /= (1.0 + damping_coeff);
510  });
511  }
512 
513  // **************************************************************************
514  // Define updates in the RHS of rho and (rho theta)
515  // **************************************************************************
516  const Array4<Real>& prev_drho_w = Delta_rho_w.array(mfi);
517  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
518  {
519  Real zflux_lo = beta_2 * soln_a(i,j,k ) + beta_1 * prev_drho_w(i,j,k );
520  Real zflux_hi = beta_2 * soln_a(i,j,k+1) + beta_1 * prev_drho_w(i,j,k+1);
521 
522  avg_zmom_arr(i,j,k) += facinv*zflux_lo / (mf_mx(i,j,0) * mf_my(i,j,0));
523  if (l_reflux) {
524  (flx_arr[2])(i,j,k,0) = zflux_lo / (mf_mx(i,j,0) * mf_my(i,j,0));
525  (flx_arr[2])(i,j,k,1) = (flx_arr[2])(i,j,k,0) * 0.5 * (prim(i,j,k) + prim(i,j,k-1));
526  }
527 
528  if (k == vbx_hi.z) {
529  avg_zmom_arr(i,j,k+1) += facinv * zflux_hi / (mf_mx(i,j,0) * mf_my(i,j,0));
530  if (l_reflux) {
531  (flx_arr[2])(i,j,k+1,0) = zflux_hi / (mf_mx(i,j,0) * mf_my(i,j,0));
532  (flx_arr[2])(i,j,k+1,1) = (flx_arr[2])(i,j,k+1,0) * 0.5 * (prim(i,j,k) + prim(i,j,k+1));
533  }
534  }
535 
536  Real dz_inv = 1.0 / dz_ptr[k];
537  temp_rhs_arr(i,j,k,Rho_comp ) += dz_inv * ( zflux_hi - zflux_lo );
538  temp_rhs_arr(i,j,k,RhoTheta_comp) += 0.5 * dz_inv * ( zflux_hi * (prim(i,j,k) + prim(i,j,k+1))
539  - zflux_lo * (prim(i,j,k) + prim(i,j,k-1)) );
540  });
541 
542  // We only add to the flux registers in the final RK step
543  if (l_reflux) {
544  int strt_comp_reflux = 0;
545  // For now we don't reflux (rho theta) because it seems to create issues at c/f boundaries
546  int num_comp_reflux = 1;
547  if (level < finest_level) {
548  fr_as_crse->CrseAdd(mfi,
549  {{AMREX_D_DECL(&(flux[0]), &(flux[1]), &(flux[2]))}},
550  dx, dtau, strt_comp_reflux, strt_comp_reflux, num_comp_reflux, RunOn::Device);
551  }
552  if (level > 0) {
553  fr_as_fine->FineAdd(mfi,
554  {{AMREX_D_DECL(&(flux[0]), &(flux[1]), &(flux[2]))}},
555  dx, dtau, strt_comp_reflux, strt_comp_reflux, num_comp_reflux, RunOn::Device);
556  }
557 
558  // This is necessary here so we don't go on to the next FArrayBox without
559  // having finished copying the fluxes into the FluxRegisters (since the fluxes
560  // are stored in temporary FArrayBox's)
561  Gpu::streamSynchronize();
562 
563  } // two-way coupling
564  } // mfi
565  } // OMP
566 
567 #ifdef _OPENMP
568 #pragma omp parallel if (Gpu::notInLaunchRegion())
569 #endif
570  for ( MFIter mfi(S_stage_data[IntVars::cons],TilingIfNotGPU()); mfi.isValid(); ++mfi)
571  {
572  const Box& bx = mfi.tilebox();
573 
574  const Array4< Real>& cur_cons = S_data[IntVars::cons].array(mfi);
575  const Array4<const Real>& prev_cons = S_prev[IntVars::cons].const_array(mfi);
576  auto const& temp_rhs_arr = temp_rhs.const_array(mfi);
577  auto const& slow_rhs_cons = S_slow_rhs[IntVars::cons].const_array(mfi);
578  const Array4<Real const>& cc_src_arr = cc_src.const_array(mfi);
579 
580  if (step == 0) {
581  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
582  {
583  cur_cons(i,j,k,Rho_comp) = prev_cons(i,j,k,Rho_comp) +
584  dtau * (slow_rhs_cons(i,j,k,Rho_comp) - temp_rhs_arr(i,j,k,Rho_comp));
585  cur_cons(i,j,k,RhoTheta_comp) = prev_cons(i,j,k,RhoTheta_comp) +
586  dtau * (slow_rhs_cons(i,j,k,RhoTheta_comp) - temp_rhs_arr(i,j,k,RhoTheta_comp));
587 
588  // add in source terms for cell-centered conserved variables
589  cur_cons(i,j,k,Rho_comp) += dtau * cc_src_arr(i,j,k,Rho_comp);
590  cur_cons(i,j,k,RhoTheta_comp) += dtau * cc_src_arr(i,j,k,RhoTheta_comp);
591  });
592  } else {
593  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
594  {
595  //
596  // We didn't need to set cur_cons = prev_cons above because they point to the same data for step > 0
597  //
598  cur_cons(i,j,k,Rho_comp) += dtau * (slow_rhs_cons(i,j,k,Rho_comp) - temp_rhs_arr(i,j,k,Rho_comp));
599  cur_cons(i,j,k,RhoTheta_comp) += dtau * (slow_rhs_cons(i,j,k,RhoTheta_comp) - temp_rhs_arr(i,j,k,RhoTheta_comp));
600 
601  // add in source terms for cell-centered conserved variables
602  cur_cons(i,j,k,Rho_comp) += dtau * cc_src_arr(i,j,k,Rho_comp);
603  cur_cons(i,j,k,RhoTheta_comp) += dtau * cc_src_arr(i,j,k,RhoTheta_comp);
604  });
605  } // step = 0
606 
607  const Array4<Real>& cur_xmom = S_data[IntVars::xmom].array(mfi);
608  const Array4<Real>& cur_ymom = S_data[IntVars::ymom].array(mfi);
609 
610  const Array4<Real const>& temp_cur_xmom_arr = temp_cur_xmom.const_array(mfi);
611  const Array4<Real const>& temp_cur_ymom_arr = temp_cur_ymom.const_array(mfi);
612 
613  Box tbx = surroundingNodes(bx,0);
614  Box tby = surroundingNodes(bx,1);
615 
616  ParallelFor(tbx, tby,
617  [=] AMREX_GPU_DEVICE (int i, int j, int k)
618  {
619  cur_xmom(i,j,k) = temp_cur_xmom_arr(i,j,k);
620  },
621  [=] AMREX_GPU_DEVICE (int i, int j, int k)
622  {
623  cur_ymom(i,j,k) = temp_cur_ymom_arr(i,j,k);
624  });
625 
626  } // mfi
627 }
constexpr amrex::Real R_v
Definition: ERF_Constants.H:11
constexpr amrex::Real R_d
Definition: ERF_Constants.H:10
constexpr amrex::Real Gamma
Definition: ERF_Constants.H:19
@ v_x
Definition: ERF_DataStruct.H:23
@ u_y
Definition: ERF_DataStruct.H:24
@ v_y
Definition: ERF_DataStruct.H:24
@ m_y
Definition: ERF_DataStruct.H:24
@ u_x
Definition: ERF_DataStruct.H:23
@ m_x
Definition: ERF_DataStruct.H:23
#define PrimQ1_comp
Definition: ERF_IndexDefines.H:53
#define Rho_comp
Definition: ERF_IndexDefines.H:36
#define RhoTheta_comp
Definition: ERF_IndexDefines.H:37
#define PrimTheta_comp
Definition: ERF_IndexDefines.H:50
amrex::Real Real
Definition: ERF_ShocInterface.H:19
AMREX_FORCE_INLINE amrex::IntVect TileNoZ()
Definition: ERF_TileNoZ.H:11
@ gpy
Definition: ERF_IndexDefines.H:151
@ gpx
Definition: ERF_IndexDefines.H:150
@ ymom
Definition: ERF_IndexDefines.H:160
@ cons
Definition: ERF_IndexDefines.H:158
@ zmom
Definition: ERF_IndexDefines.H:161
@ xmom
Definition: ERF_IndexDefines.H:159
@ qt
Definition: ERF_Kessler.H:27
@ qv
Definition: ERF_Kessler.H:28
Here is the call graph for this function: