Function for computing the slow RHS for the evolution equations for the density, potential temperature and momentum.
60 BL_PROFILE_REGION(
"erf_make_mom_sources()");
62 Box domain(geom.Domain());
63 const GpuArray<Real, AMREX_SPACEDIM> dxInv = geom.InvCellSizeArray();
94 if (solverChoice.
terrain_type == TerrainType::ImmersedForcing) {
96 amrex::Error(
" Currently forest canopy cannot be used with immersed forcing");
106 auto cosphi = solverChoice.
cosphi;
107 auto sinphi = solverChoice.
sinphi;
139 Real rhoUA_target{0};
140 Real rhoVA_target{0};
147 Table1D<Real> dptr_r_plane, dptr_u_plane, dptr_v_plane;
148 TableData<Real, 1> r_plane_tab, u_plane_tab, v_plane_tab;
151 enforce_massflux_x || enforce_massflux_y))
154 const int u_offset = 1;
155 const int v_offset = 1;
164 r_ave.compute_averages(
ZDir(), r_ave.field());
166 int ncell = r_ave.ncell_line();
167 Gpu::HostVector< Real> r_plane_h(ncell);
168 Gpu::DeviceVector< Real> r_plane_d(ncell);
170 r_ave.line_average(
Rho_comp, r_plane_h);
172 Gpu::copyAsync(Gpu::hostToDevice, r_plane_h.begin(), r_plane_h.end(), r_plane_d.begin());
174 Real* dptr_r = r_plane_d.data();
176 Box tdomain = domain; tdomain.grow(2,ng_c[2]);
177 r_plane_tab.resize({tdomain.smallEnd(2)}, {tdomain.bigEnd(2)});
179 dptr_r_plane = r_plane_tab.table();
180 ParallelFor(ncell, [=] AMREX_GPU_DEVICE (
int k) noexcept
182 dptr_r_plane(k-
offset) = dptr_r[k];
186 IntVect ng_u = S_data[
IntVars::xmom].nGrowVect(); ng_u[2] = u_offset;
189 IntVect ng_v = S_data[
IntVars::ymom].nGrowVect(); ng_v[2] = v_offset;
192 u_ave.compute_averages(
ZDir(), u_ave.field());
193 v_ave.compute_averages(
ZDir(), v_ave.field());
195 int u_ncell = u_ave.ncell_line();
196 int v_ncell = v_ave.ncell_line();
197 Gpu::HostVector< Real> u_plane_h(u_ncell), v_plane_h(v_ncell);
198 Gpu::DeviceVector< Real> u_plane_d(u_ncell), v_plane_d(v_ncell);
200 u_ave.line_average(0, u_plane_h);
201 v_ave.line_average(0, v_plane_h);
203 Gpu::copyAsync(Gpu::hostToDevice, u_plane_h.begin(), u_plane_h.end(), u_plane_d.begin());
204 Gpu::copyAsync(Gpu::hostToDevice, v_plane_h.begin(), v_plane_h.end(), v_plane_d.begin());
206 Real* dptr_u = u_plane_d.data();
207 Real* dptr_v = v_plane_d.data();
209 Box udomain = domain; udomain.grow(2,ng_u[2]);
210 Box vdomain = domain; vdomain.grow(2,ng_v[2]);
211 u_plane_tab.resize({udomain.smallEnd(2)}, {udomain.bigEnd(2)});
212 v_plane_tab.resize({vdomain.smallEnd(2)}, {vdomain.bigEnd(2)});
214 dptr_u_plane = u_plane_tab.table();
215 ParallelFor(u_ncell, [=] AMREX_GPU_DEVICE (
int k) noexcept
217 dptr_u_plane(k-u_offset) = dptr_u[k];
220 dptr_v_plane = v_plane_tab.table();
221 ParallelFor(v_ncell, [=] AMREX_GPU_DEVICE (
int k) noexcept
223 dptr_v_plane(k-v_offset) = dptr_v[k];
227 if (enforce_massflux_x || enforce_massflux_y) {
228 Real Lx = geom.ProbHi(0) - geom.ProbLo(0);
229 Real Ly = geom.ProbHi(1) - geom.ProbLo(1);
231 if (solverChoice.
mesh_type == MeshType::ConstantDz) {
233 rhoUA = std::accumulate(u_plane_h.begin() + u_offset + massflux_klo,
234 u_plane_h.begin() + u_offset + massflux_khi+1, 0.0);
235 rhoVA = std::accumulate(v_plane_h.begin() + v_offset + massflux_klo,
236 v_plane_h.begin() + v_offset + massflux_khi+1, 0.0);
237 rhoUA_target = std::accumulate(r_plane_h.begin() +
offset + massflux_klo,
238 r_plane_h.begin() +
offset + massflux_khi+1, 0.0);
239 rhoVA_target = rhoUA_target;
241 rhoUA *= geom.CellSize(2) * Ly;
242 rhoVA *= geom.CellSize(2) * Lx;
243 rhoUA_target *= geom.CellSize(2) * Ly;
244 rhoVA_target *= geom.CellSize(2) * Lx;
246 }
else if (solverChoice.
mesh_type == MeshType::StretchedDz) {
248 for (
int k=massflux_klo; k < massflux_khi; ++k) {
249 rhoUA += u_plane_h[k + u_offset] * stretched_dz_h[k];
250 rhoVA += v_plane_h[k + v_offset] * stretched_dz_h[k];
251 rhoUA_target += r_plane_h[k +
offset] * stretched_dz_h[k];
253 rhoVA_target = rhoUA_target;
262 rhoUA_target *= U_target;
263 rhoVA_target *= V_target;
265 Print() <<
"Integrated mass flux : " << rhoUA <<
" " << rhoVA
266 <<
" (target: " << rhoUA_target <<
" " << rhoVA_target <<
")"
274 for ( MFIter mfi(S_data[
IntVars::cons]); mfi.isValid(); ++mfi)
276 Box tbx = mfi.nodaltilebox(0);
277 Box tby = mfi.nodaltilebox(1);
278 Box tbz = mfi.nodaltilebox(2);
279 if (tbz.bigEnd(2) == domain.bigEnd(2)+1) tbz.growHi(2,-1);
281 const Array4<const Real>& cell_data = S_data[
IntVars::cons].array(mfi);
282 const Array4<const Real>& rho_u = S_data[
IntVars::xmom].array(mfi);
283 const Array4<const Real>& rho_v = S_data[
IntVars::ymom].array(mfi);
284 const Array4<const Real>& rho_w = S_data[
IntVars::zmom].array(mfi);
286 const Array4<const Real>& u =
xvel.array(mfi);
287 const Array4<const Real>& v =
yvel.array(mfi);
288 const Array4<const Real>& w = wvel.array(mfi);
290 const Array4< Real>& xmom_src_arr = xmom_src.array(mfi);
291 const Array4< Real>& ymom_src_arr = ymom_src.array(mfi);
292 const Array4< Real>& zmom_src_arr = zmom_src.array(mfi);
294 const Array4<const Real>& r0 = r_hse.const_array(mfi);
296 const Array4<const Real>& f_drag_arr = (forest_drag) ? forest_drag->const_array(mfi) :
297 Array4<const Real>{};
298 const Array4<const Real>& t_blank_arr = (terrain_blank) ? terrain_blank->const_array(mfi) :
299 Array4<const Real>{};
301 const Array4<const Real>& cphi_arr = (cosPhi_mf) ? cosPhi_mf->const_array(mfi) :
302 Array4<const Real>{};
303 const Array4<const Real>& sphi_arr = (sinPhi_mf) ? sinPhi_mf->const_array(mfi) :
304 Array4<const Real>{};
306 const Array4<const Real>& z_nd_arr = z_phys_nd.const_array(mfi);
307 const Array4<const Real>& z_cc_arr = z_phys_cc.const_array(mfi);
312 if (use_coriolis && is_slow_step) {
313 if (var_coriolis && has_lat_lon) {
314 ParallelFor(tbx, tby, tbz,
315 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
317 Real rho_v_loc = 0.25 * (rho_v(i,j+1,k) + rho_v(i,j,k) + rho_v(i-1,j+1,k) + rho_v(i-1,j,k));
318 Real rho_w_loc = 0.25 * (rho_w(i,j,k+1) + rho_w(i,j,k) + rho_w(i,j-1,k+1) + rho_w(i,j-1,k));
319 Real sphi_loc = 0.5 * (sphi_arr(i,j,0) + sphi_arr(i-1,j,0));
320 Real cphi_loc = 0.5 * (cphi_arr(i,j,0) + cphi_arr(i-1,j,0));
321 xmom_src_arr(i, j, k) += coriolis_factor * (rho_v_loc * sphi_loc - rho_w_loc * cphi_loc);
323 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) {
324 Real rho_u_loc = 0.25 * (rho_u(i+1,j,k) + rho_u(i,j,k) + rho_u(i+1,j-1,k) + rho_u(i,j-1,k));
325 Real sphi_loc = 0.5 * (sphi_arr(i,j,0) + sphi_arr(i,j-1,0));
326 ymom_src_arr(i, j, k) += -coriolis_factor * rho_u_loc * sphi_loc;
328 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) {
329 Real rho_u_loc = 0.25 * (rho_u(i+1,j,k) + rho_u(i,j,k) + rho_u(i+1,j,k-1) + rho_u(i,j,k-1));
330 zmom_src_arr(i, j, k) += coriolis_factor * rho_u_loc * cphi_arr(i,j,0);
333 ParallelFor(tbx, tby, tbz,
334 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
336 Real rho_v_loc = 0.25 * (rho_v(i,j+1,k) + rho_v(i,j,k) + rho_v(i-1,j+1,k) + rho_v(i-1,j,k));
337 Real rho_w_loc = 0.25 * (rho_w(i,j,k+1) + rho_w(i,j,k) + rho_w(i,j-1,k+1) + rho_w(i,j-1,k));
338 xmom_src_arr(i, j, k) += coriolis_factor * (rho_v_loc * sinphi - rho_w_loc * cosphi);
340 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) {
341 Real rho_u_loc = 0.25 * (rho_u(i+1,j,k) + rho_u(i,j,k) + rho_u(i+1,j-1,k) + rho_u(i,j-1,k));
342 ymom_src_arr(i, j, k) += -coriolis_factor * rho_u_loc * sinphi;
344 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) {
345 Real rho_u_loc = 0.25 * (rho_u(i+1,j,k) + rho_u(i,j,k) + rho_u(i+1,j,k-1) + rho_u(i,j,k-1));
346 zmom_src_arr(i, j, k) += coriolis_factor * rho_u_loc * cosphi;
354 Real zlo = geom.ProbLo(2);
355 Real dz = geom.CellSize(2);
360 if ((is_slow_step && !use_Rayleigh_fast) || (!is_slow_step && use_Rayleigh_fast)) {
361 if (rayleigh_damp_U) {
362 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
364 Real zcc = (z_cc_arr) ? z_cc_arr(i,j,k) : zlo + (k+0.5)*dz;
365 Real zfrac = 1 - (ztop - zcc) / zdamp;
367 Real rho_on_u_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i-1,j,k,
Rho_comp) );
368 Real uu = rho_u(i,j,k) / rho_on_u_face;
369 Real sinefac = std::sin(
PIoTwo*zfrac);
370 xmom_src_arr(i, j, k) -= dampcoef*sinefac*sinefac * (uu -
ubar[k]) * rho_on_u_face;
375 if (rayleigh_damp_V) {
376 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
378 Real zcc = (z_cc_arr) ? z_cc_arr(i,j,k) : zlo + (k+0.5)*dz;
379 Real zfrac = 1 - (ztop - zcc) / zdamp;
381 Real rho_on_v_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i,j-1,k,
Rho_comp) );
382 Real vv = rho_v(i,j,k) / rho_on_v_face;
383 Real sinefac = std::sin(
PIoTwo*zfrac);
384 ymom_src_arr(i, j, k) -= dampcoef*sinefac*sinefac * (vv -
vbar[k]) * rho_on_v_face;
389 if (rayleigh_damp_W) {
390 ParallelFor(tbz, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
392 Real zstag = (z_nd_arr) ? z_nd_arr(i,j,k) : zlo + k*dz;
393 Real zfrac = 1 - (ztop - zstag) / zdamp;
395 Real rho_on_w_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i,j,k-1,
Rho_comp) );
396 Real ww = rho_w(i,j,k) / rho_on_w_face;
397 Real sinefac = std::sin(
PIoTwo*zfrac);
398 zmom_src_arr(i, j, k) -= dampcoef*sinefac*sinefac * (ww -
wbar[k]) * rho_on_w_face;
408 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
410 Real rho_on_u_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i-1,j,k,
Rho_comp) );
411 xmom_src_arr(i, j, k) += rho_on_u_face * abl_geo_forcing[0];
413 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
415 Real rho_on_v_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i,j-1,k,
Rho_comp) );
416 ymom_src_arr(i, j, k) += rho_on_v_face * abl_geo_forcing[1];
418 ParallelFor(tbz, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
420 Real rho_on_w_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i,j,k-1,
Rho_comp) );
421 zmom_src_arr(i, j, k) += rho_on_w_face * abl_geo_forcing[2];
428 if (geo_wind_profile && is_slow_step) {
429 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
431 Real rho_on_u_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i-1,j,k,
Rho_comp) );
432 xmom_src_arr(i, j, k) -= coriolis_factor * rho_on_u_face * dptr_v_geos[k] * sinphi;
434 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
436 Real rho_on_v_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i,j-1,k,
Rho_comp) );
437 ymom_src_arr(i, j, k) += coriolis_factor * rho_on_v_face * dptr_u_geos[k] * sinphi;
447 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
449 Real dzInv = 0.5*dxInv[2];
451 Real z_xf_lo = 0.25 * ( z_nd_arr(i,j,k ) + z_nd_arr(i,j+1,k )
452 + z_nd_arr(i,j,k-1) + z_nd_arr(i,j+1,k-1) );
453 Real z_xf_hi = 0.25 * ( z_nd_arr(i,j,k+1) + z_nd_arr(i,j+1,k+1)
454 + z_nd_arr(i,j,k+2) + z_nd_arr(i,j+1,k+2) );
455 dzInv = 1.0 / (z_xf_hi - z_xf_lo);
457 Real rho_on_u_face = 0.5 * ( cell_data(i,j,k,
nr) + cell_data(i-1,j,k,
nr) );
458 Real U_hi = dptr_u_plane(k+1) / dptr_r_plane(k+1);
459 Real U_lo = dptr_u_plane(k-1) / dptr_r_plane(k-1);
460 Real wbar_xf = 0.5 * (dptr_wbar_sub[k] + dptr_wbar_sub[k+1]);
461 xmom_src_arr(i, j, k) -= rho_on_u_face * wbar_xf * (U_hi - U_lo) * dzInv;
463 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
465 Real dzInv = 0.5*dxInv[2];
467 Real z_yf_lo = 0.25 * ( z_nd_arr(i,j,k ) + z_nd_arr(i+1,j,k )
468 + z_nd_arr(i,j,k-1) + z_nd_arr(i+1,j,k-1) );
469 Real z_yf_hi = 0.25 * ( z_nd_arr(i,j,k+1) + z_nd_arr(i+1,j,k+1)
470 + z_nd_arr(i,j,k+2) + z_nd_arr(i+1,j,k+2) );
471 dzInv = 1.0 / (z_yf_hi - z_yf_lo);
473 Real rho_on_v_face = 0.5 * ( cell_data(i,j,k,
nr) + cell_data(i,j-1,k,
nr) );
474 Real V_hi = dptr_v_plane(k+1) / dptr_r_plane(k+1);
475 Real V_lo = dptr_v_plane(k-1) / dptr_r_plane(k-1);
476 Real wbar_yf = 0.5 * (dptr_wbar_sub[k] + dptr_wbar_sub[k+1]);
477 ymom_src_arr(i, j, k) -= rho_on_v_face * wbar_yf * (V_hi - V_lo) * dzInv;
480 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
482 Real dzInv = 0.5*dxInv[2];
484 Real z_xf_lo = 0.25 * ( z_nd_arr(i,j,k ) + z_nd_arr(i,j+1,k )
485 + z_nd_arr(i,j,k-1) + z_nd_arr(i,j+1,k-1) );
486 Real z_xf_hi = 0.25 * ( z_nd_arr(i,j,k+1) + z_nd_arr(i,j+1,k+1)
487 + z_nd_arr(i,j,k+2) + z_nd_arr(i,j+1,k+2) );
488 dzInv = 1.0 / (z_xf_hi - z_xf_lo);
490 Real U_hi = dptr_u_plane(k+1) / dptr_r_plane(k+1);
491 Real U_lo = dptr_u_plane(k-1) / dptr_r_plane(k-1);
492 Real wbar_xf = 0.5 * (dptr_wbar_sub[k] + dptr_wbar_sub[k+1]);
493 xmom_src_arr(i, j, k) -= wbar_xf * (U_hi - U_lo) * dzInv;
495 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
497 Real dzInv = 0.5*dxInv[2];
499 Real z_yf_lo = 0.25 * ( z_nd_arr(i,j,k ) + z_nd_arr(i+1,j,k )
500 + z_nd_arr(i,j,k-1) + z_nd_arr(i+1,j,k-1) );
501 Real z_yf_hi = 0.25 * ( z_nd_arr(i,j,k+1) + z_nd_arr(i+1,j,k+1)
502 + z_nd_arr(i,j,k+2) + z_nd_arr(i+1,j,k+2) );
503 dzInv = 1.0 / (z_yf_hi - z_yf_lo);
505 Real V_hi = dptr_v_plane(k+1) / dptr_r_plane(k+1);
506 Real V_lo = dptr_v_plane(k-1) / dptr_r_plane(k-1);
507 Real wbar_yf = 0.5 * (dptr_wbar_sub[k] + dptr_wbar_sub[k+1]);
508 ymom_src_arr(i, j, k) -= wbar_yf * (V_hi - V_lo) * dzInv;
520 Real coeff_n = Real(1.0);
521 Real coeff_np1 = Real(0.0);
523 Real tau_inv = Real(1.0) / input_sounding_data.
tau_nudging;
527 for (
int nt = 1; nt < n_sounding_times; nt++) {
530 if (itime_n == n_sounding_times-1) {
533 itime_np1 = itime_n+1;
536 coeff_n = Real(1.0) - coeff_np1;
541 const Real* u_inp_sound_n = input_sounding_data.
U_inp_sound_d[itime_n].dataPtr();
542 const Real* u_inp_sound_np1 = input_sounding_data.
U_inp_sound_d[itime_np1].dataPtr();
543 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
545 Real nudge_u = (coeff_n*u_inp_sound_n[k] + coeff_np1*u_inp_sound_np1[k]) - (dptr_u_plane(k)/dptr_r_plane(k));
547 xmom_src_arr(i, j, k) += cell_data(i, j, k,
nr) * nudge_u;
550 const Real* v_inp_sound_n = input_sounding_data.
V_inp_sound_d[itime_n].dataPtr();
551 const Real* v_inp_sound_np1 = input_sounding_data.
V_inp_sound_d[itime_np1].dataPtr();
552 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
554 Real nudge_v = (coeff_n*v_inp_sound_n[k] + coeff_np1*v_inp_sound_np1[k]) - (dptr_v_plane(k)/dptr_r_plane(k));
556 ymom_src_arr(i, j, k) += cell_data(i, j, k,
nr) * nudge_v;
565 const Array4<const Real>& mf_ux = mapfac[MapFac::ux]->const_array(mfi);
566 const Array4<const Real>& mf_uy = mapfac[MapFac::uy]->const_array(mfi);
567 const Array4<const Real>& mf_vx = mapfac[MapFac::vx]->const_array(mfi);
568 const Array4<const Real>& mf_vy = mapfac[MapFac::vy]->const_array(mfi);
570 u, cell_data, xmom_src_arr, mf_ux, mf_uy);
572 v, cell_data, ymom_src_arr, mf_vx, mf_vy);
583 z_cc_arr, xmom_src_arr, ymom_src_arr,
584 rho_u, rho_v, d_sponge_ptrs_at_lev);
589 xmom_src_arr, ymom_src_arr, zmom_src_arr, rho_u, rho_v, rho_w,
590 r0, z_nd_arr, z_cc_arr);
598 ((is_slow_step && !use_canopy_fast) || (!is_slow_step && use_canopy_fast))) {
599 ParallelFor(tbx, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
601 const Real ux = u(i, j, k);
602 const Real uy = 0.25 * ( v(i, j , k ) + v(i-1, j , k )
603 + v(i, j+1, k ) + v(i-1, j+1, k ) );
604 const Real uz = 0.25 * ( w(i, j , k ) + w(i-1, j , k )
605 + w(i, j , k+1) + w(i-1, j , k+1) );
606 const Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
607 const Real f_drag = 0.5 * (f_drag_arr(i, j, k) + f_drag_arr(i-1, j, k));
608 xmom_src_arr(i, j, k) -= f_drag * ux * windspeed;
610 ParallelFor(tby, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
612 const Real ux = 0.25 * ( u(i , j , k ) + u(i , j-1, k )
613 + u(i+1, j , k ) + u(i+1, j-1, k ) );
614 const Real uy = v(i, j, k);
615 const Real uz = 0.25 * ( w(i , j , k ) + w(i , j-1, k )
616 + w(i , j , k+1) + w(i , j-1, k+1) );
617 const amrex::Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
618 const Real f_drag = 0.5 * (f_drag_arr(i, j, k) + f_drag_arr(i, j-1, k));
619 ymom_src_arr(i, j, k) -= f_drag * uy * windspeed;
621 ParallelFor(tbz, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
623 const amrex::Real ux = 0.25 * ( u(i , j , k ) + u(i+1, j , k )
624 + u(i , j , k-1) + u(i+1, j , k-1) );
625 const amrex::Real uy = 0.25 * ( v(i , j , k ) + v(i , j+1, k )
626 + v(i , j , k-1) + v(i , j+1, k-1) );
627 const amrex::Real uz = w(i, j, k);
628 const amrex::Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
629 const Real f_drag = 0.5 * (f_drag_arr(i, j, k) + f_drag_arr(i, j, k-1));
630 zmom_src_arr(i, j, k) -= f_drag * uz * windspeed;
636 if (solverChoice.
terrain_type == TerrainType::ImmersedForcing &&
637 ((is_slow_step && !use_ImmersedForcing_fast) || (!is_slow_step && use_ImmersedForcing_fast))) {
638 const Real drag_coefficient=10.0/dz;
640 ParallelFor(tbx, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
642 const Real ux = u(i, j, k);
643 const Real uy = 0.25 * ( v(i, j , k ) + v(i-1, j , k )
644 + v(i, j+1, k ) + v(i-1, j+1, k ) );
645 const Real uz = 0.25 * ( w(i, j , k ) + w(i-1, j , k )
646 + w(i, j , k+1) + w(i-1, j , k+1) );
647 const Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
648 const Real t_blank = 0.5 * (t_blank_arr(i, j, k) + t_blank_arr(i-1, j, k));
649 const Real CdM = std::min(drag_coefficient / (windspeed + tiny), 1000.0);
650 xmom_src_arr(i, j, k) -= t_blank * CdM * ux * windspeed;
652 ParallelFor(tby, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
654 const Real ux = 0.25 * ( u(i , j , k ) + u(i , j-1, k )
655 + u(i+1, j , k ) + u(i+1, j-1, k ) );
656 const Real uy = v(i, j, k);
657 const Real uz = 0.25 * ( w(i , j , k ) + w(i , j-1, k )
658 + w(i , j , k+1) + w(i , j-1, k+1) );
659 const amrex::Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
660 const Real t_blank = 0.5 * (t_blank_arr(i, j, k) + t_blank_arr(i, j-1, k));
661 const Real CdM = std::min(drag_coefficient / (windspeed + tiny), 1000.0);
662 ymom_src_arr(i, j, k) -= t_blank * CdM * uy * windspeed;
664 ParallelFor(tbz, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
666 const amrex::Real ux = 0.25 * ( u(i , j , k ) + u(i+1, j , k )
667 + u(i , j , k-1) + u(i+1, j , k-1) );
668 const amrex::Real uy = 0.25 * ( v(i , j , k ) + v(i , j+1, k )
669 + v(i , j , k-1) + v(i , j+1, k-1) );
670 const amrex::Real uz = w(i, j, k);
671 const amrex::Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
672 const Real t_blank = 0.5 * (t_blank_arr(i, j, k) + t_blank_arr(i, j, k-1));
673 const Real CdM = std::min(drag_coefficient / (windspeed + tiny), 1000.0);
674 zmom_src_arr(i, j, k) -= t_blank * CdM * uz * windspeed;
681 if (is_slow_step && (enforce_massflux_x || enforce_massflux_y)) {
684 ParallelFor(tbx, tby,
685 [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept {
686 xmom_src_arr(i, j, k) += tau_inv * (rhoUA_target - rhoUA);
688 [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept {
689 ymom_src_arr(i, j, k) += tau_inv * (rhoVA_target - rhoVA);
void ApplySpongeZoneBCsForMom(const SpongeChoice &spongeChoice, const Geometry geom, const Box &tbx, const Box &tby, const Box &tbz, const Array4< Real > &rho_u_rhs, const Array4< Real > &rho_v_rhs, const Array4< Real > &rho_w_rhs, const Array4< const Real > &rho_u, const Array4< const Real > &rho_v, const Array4< const Real > &rho_w, const Array4< const Real > &r0, const Array4< const Real > &z_phys_nd, const Array4< const Real > &z_phys_cc)
Definition: ERF_ApplySpongeZoneBCs.cpp:118
void ApplySpongeZoneBCsForMom_ReadFromFile(const SpongeChoice &spongeChoice, const Geometry geom, const Box &tbx, const Box &tby, const Array4< const Real > &cell_data, const Array4< const Real > &z_phys_cc, const Array4< Real > &rho_u_rhs, const Array4< Real > &rho_v_rhs, const Array4< const Real > &rho_u, const Array4< const Real > &rho_v, const Vector< Real * > d_sponge_ptrs_at_lev)
Definition: ERF_ApplySpongeZoneBCs_ReadFromFile.cpp:8
constexpr amrex::Real PIoTwo
Definition: ERF_Constants.H:7
@ ubar
Definition: ERF_DataStruct.H:87
@ wbar
Definition: ERF_DataStruct.H:87
@ vbar
Definition: ERF_DataStruct.H:87
DirectionSelector< 2 > ZDir
Definition: ERF_DirectionSelector.H:38
#define Rho_comp
Definition: ERF_IndexDefines.H:36
void NumericalDiffusion_Ymom(const Box &bx, const Real dt, const Real num_diff_coeff, const Array4< const Real > &prim_data, const Array4< const Real > &cell_data, const Array4< Real > &rhs, const Array4< const Real > &mfx_arr, const Array4< const Real > &mfy_arr)
Definition: ERF_NumericalDiffusion.cpp:151
void NumericalDiffusion_Xmom(const Box &bx, const Real dt, const Real num_diff_coeff, const Array4< const Real > &prim_data, const Array4< const Real > &cell_data, const Array4< Real > &rhs, const Array4< const Real > &mfx_arr, const Array4< const Real > &mfy_arr)
Definition: ERF_NumericalDiffusion.cpp:85
AMREX_FORCE_INLINE IntVect offset(const int face_dir, const int normal)
Definition: ERF_ReadBndryPlanes.cpp:28
Definition: ERF_PlaneAverage.H:14
@ r0_comp
Definition: ERF_IndexDefines.H:63
@ ymom
Definition: ERF_IndexDefines.H:160
@ cons
Definition: ERF_IndexDefines.H:158
@ zmom
Definition: ERF_IndexDefines.H:161
@ xmom
Definition: ERF_IndexDefines.H:159
@ nr
Definition: ERF_Morrison.H:45
@ xvel
Definition: ERF_IndexDefines.H:141
@ cons
Definition: ERF_IndexDefines.H:140
@ yvel
Definition: ERF_IndexDefines.H:142
real(c_double), parameter epsilon
Definition: ERF_module_model_constants.F90:12
amrex::Real coriolis_factor
Definition: ERF_DataStruct.H:769
static MeshType mesh_type
Definition: ERF_DataStruct.H:708
bool rayleigh_damp_V
Definition: ERF_DataStruct.H:741
bool rayleigh_damp_substep
Definition: ERF_DataStruct.H:747
amrex::Real rayleigh_zdamp
Definition: ERF_DataStruct.H:745
amrex::Real const_massflux_v
Definition: ERF_DataStruct.H:844
amrex::Real cosphi
Definition: ERF_DataStruct.H:770
amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > abl_geo_forcing
Definition: ERF_DataStruct.H:812
int massflux_klo
Definition: ERF_DataStruct.H:848
bool custom_w_subsidence
Definition: ERF_DataStruct.H:776
bool nudging_from_input_sounding
Definition: ERF_DataStruct.H:782
bool rayleigh_damp_U
Definition: ERF_DataStruct.H:740
amrex::Real rayleigh_ztop
Definition: ERF_DataStruct.H:746
bool immersed_forcing_substep
Definition: ERF_DataStruct.H:750
amrex::Real sinphi
Definition: ERF_DataStruct.H:771
bool have_geo_wind_profile
Definition: ERF_DataStruct.H:814
amrex::Real const_massflux_u
Definition: ERF_DataStruct.H:843
bool use_coriolis
Definition: ERF_DataStruct.H:737
amrex::Real num_diff_coeff
Definition: ERF_DataStruct.H:795
bool variable_coriolis
Definition: ERF_DataStruct.H:817
bool custom_forcing_prim_vars
Definition: ERF_DataStruct.H:778
static TerrainType terrain_type
Definition: ERF_DataStruct.H:702
bool rayleigh_damp_W
Definition: ERF_DataStruct.H:742
SpongeChoice spongeChoice
Definition: ERF_DataStruct.H:718
bool has_lat_lon
Definition: ERF_DataStruct.H:816
bool do_forest_drag
Definition: ERF_DataStruct.H:840
amrex::Real const_massflux_tau
Definition: ERF_DataStruct.H:845
int massflux_khi
Definition: ERF_DataStruct.H:849
bool forest_substep
Definition: ERF_DataStruct.H:751
amrex::Real rayleigh_dampcoef
Definition: ERF_DataStruct.H:744
int ave_plane
Definition: ERF_DataStruct.H:819
std::string sponge_type
Definition: ERF_SpongeStruct.H:58