Function for computing the slow RHS for the evolution equations for the density, potential temperature and momentum.
59 BL_PROFILE_REGION(
"erf_make_mom_sources()");
61 Box domain(geom.Domain());
62 const GpuArray<Real, AMREX_SPACEDIM> dxInv = geom.InvCellSizeArray();
92 if (solverChoice.
terrain_type == TerrainType::ImmersedForcing) {
94 amrex::Error(
" Currently forest canopy cannot be used with immersed forcing");
104 auto cosphi = solverChoice.
cosphi;
105 auto sinphi = solverChoice.
sinphi;
129 Table1D<Real> dptr_r_plane, dptr_u_plane, dptr_v_plane;
130 TableData<Real, 1> r_plane_tab, u_plane_tab, v_plane_tab;
139 IntVect ng_c = S_data[
IntVars::cons].nGrowVect(); ng_c[2] = 1;
141 r_ave.compute_averages(
ZDir(), r_ave.field());
143 int ncell = r_ave.ncell_line();
144 Gpu::HostVector< Real> r_plane_h(ncell);
145 Gpu::DeviceVector< Real> r_plane_d(ncell);
147 r_ave.line_average(
Rho_comp, r_plane_h);
149 Gpu::copyAsync(Gpu::hostToDevice, r_plane_h.begin(), r_plane_h.end(), r_plane_d.begin());
151 Real* dptr_r = r_plane_d.data();
153 Box tdomain = domain; tdomain.grow(2,ng_c[2]);
154 r_plane_tab.resize({tdomain.smallEnd(2)}, {tdomain.bigEnd(2)});
157 dptr_r_plane = r_plane_tab.table();
158 ParallelFor(ncell, [=] AMREX_GPU_DEVICE (
int k) noexcept
160 dptr_r_plane(k-
offset) = dptr_r[k];
164 IntVect ng_u = S_data[
IntVars::xmom].nGrowVect(); ng_u[2] = 1;
167 IntVect ng_v = S_data[
IntVars::ymom].nGrowVect(); ng_v[2] = 1;
170 u_ave.compute_averages(
ZDir(), u_ave.field());
171 v_ave.compute_averages(
ZDir(), v_ave.field());
173 int u_ncell = u_ave.ncell_line();
174 int v_ncell = v_ave.ncell_line();
175 Gpu::HostVector< Real> u_plane_h(u_ncell), v_plane_h(v_ncell);
176 Gpu::DeviceVector< Real> u_plane_d(u_ncell), v_plane_d(v_ncell);
178 u_ave.line_average(0, u_plane_h);
179 v_ave.line_average(0, v_plane_h);
181 Gpu::copyAsync(Gpu::hostToDevice, u_plane_h.begin(), u_plane_h.end(), u_plane_d.begin());
182 Gpu::copyAsync(Gpu::hostToDevice, v_plane_h.begin(), v_plane_h.end(), v_plane_d.begin());
184 Real* dptr_u = u_plane_d.data();
185 Real* dptr_v = v_plane_d.data();
187 Box udomain = domain; udomain.grow(2,ng_u[2]);
188 Box vdomain = domain; vdomain.grow(2,ng_v[2]);
189 u_plane_tab.resize({udomain.smallEnd(2)}, {udomain.bigEnd(2)});
190 v_plane_tab.resize({vdomain.smallEnd(2)}, {vdomain.bigEnd(2)});
192 int u_offset = ng_u[2];
193 dptr_u_plane = u_plane_tab.table();
194 ParallelFor(u_ncell, [=] AMREX_GPU_DEVICE (
int k) noexcept
196 dptr_u_plane(k-u_offset) = dptr_u[k];
199 int v_offset = ng_v[2];
200 dptr_v_plane = v_plane_tab.table();
201 ParallelFor(v_ncell, [=] AMREX_GPU_DEVICE (
int k) noexcept
203 dptr_v_plane(k-v_offset) = dptr_v[k];
210 for ( MFIter mfi(S_data[
IntVars::cons]); mfi.isValid(); ++mfi)
212 Box tbx = mfi.nodaltilebox(0);
213 Box tby = mfi.nodaltilebox(1);
214 Box tbz = mfi.nodaltilebox(2);
215 if (tbz.bigEnd(2) == domain.bigEnd(2)+1) tbz.growHi(2,-1);
217 const Array4<const Real>& cell_data = S_data[
IntVars::cons].array(mfi);
218 const Array4<const Real>& rho_u = S_data[
IntVars::xmom].array(mfi);
219 const Array4<const Real>& rho_v = S_data[
IntVars::ymom].array(mfi);
220 const Array4<const Real>& rho_w = S_data[
IntVars::zmom].array(mfi);
222 const Array4<const Real>& u =
xvel.array(mfi);
223 const Array4<const Real>& v =
yvel.array(mfi);
224 const Array4<const Real>& w = wvel.array(mfi);
226 const Array4< Real>& xmom_src_arr = xmom_src.array(mfi);
227 const Array4< Real>& ymom_src_arr = ymom_src.array(mfi);
228 const Array4< Real>& zmom_src_arr = zmom_src.array(mfi);
230 const Array4<const Real>& r0 = r_hse.const_array(mfi);
232 const Array4<const Real>& f_drag_arr = (forest_drag) ? forest_drag->const_array(mfi) :
233 Array4<const Real>{};
234 const Array4<const Real>& t_blank_arr = (terrain_blank) ? terrain_blank->const_array(mfi) :
235 Array4<const Real>{};
237 const Array4<const Real>& cphi_arr = (cosPhi_mf) ? cosPhi_mf->const_array(mfi) :
238 Array4<const Real>{};
239 const Array4<const Real>& sphi_arr = (sinPhi_mf) ? sinPhi_mf->const_array(mfi) :
240 Array4<const Real>{};
242 const Array4<const Real>& z_nd_arr = z_phys_nd.const_array(mfi);
243 const Array4<const Real>& z_cc_arr = z_phys_cc.const_array(mfi);
248 if (use_coriolis && is_slow_step) {
249 if (var_coriolis && has_lat_lon) {
250 ParallelFor(tbx, tby, tbz,
251 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
253 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));
254 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));
255 Real sphi_loc = 0.5 * (sphi_arr(i,j,0) + sphi_arr(i-1,j,0));
256 Real cphi_loc = 0.5 * (cphi_arr(i,j,0) + cphi_arr(i-1,j,0));
257 xmom_src_arr(i, j, k) += coriolis_factor * (rho_v_loc * sphi_loc - rho_w_loc * cphi_loc);
259 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) {
260 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));
261 Real sphi_loc = 0.5 * (sphi_arr(i,j,0) + sphi_arr(i,j-1,0));
262 ymom_src_arr(i, j, k) += -coriolis_factor * rho_u_loc * sphi_loc;
264 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) {
265 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));
266 zmom_src_arr(i, j, k) += coriolis_factor * rho_u_loc * cphi_arr(i,j,0);
269 ParallelFor(tbx, tby, tbz,
270 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
272 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));
273 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));
274 xmom_src_arr(i, j, k) += coriolis_factor * (rho_v_loc * sinphi - rho_w_loc * cosphi);
276 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) {
277 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));
278 ymom_src_arr(i, j, k) += -coriolis_factor * rho_u_loc * sinphi;
280 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) {
281 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));
282 zmom_src_arr(i, j, k) += coriolis_factor * rho_u_loc * cosphi;
290 Real zlo = geom.ProbLo(2);
291 Real dz = geom.CellSize(2);
296 if ((is_slow_step && !use_Rayleigh_fast) || (!is_slow_step && use_Rayleigh_fast)) {
297 if (rayleigh_damp_U) {
298 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
300 Real zcc = (z_cc_arr) ? z_cc_arr(i,j,k) : zlo + (k+0.5)*dz;
301 Real zfrac = 1 - (ztop - zcc) / zdamp;
303 Real rho_on_u_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i-1,j,k,
Rho_comp) );
304 Real uu = rho_u(i,j,k) / rho_on_u_face;
305 Real sinefac = std::sin(
PIoTwo*zfrac);
306 xmom_src_arr(i, j, k) -= dampcoef*sinefac*sinefac * (uu -
ubar[k]) * rho_on_u_face;
311 if (rayleigh_damp_V) {
312 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
314 Real zcc = (z_cc_arr) ? z_cc_arr(i,j,k) : zlo + (k+0.5)*dz;
315 Real zfrac = 1 - (ztop - zcc) / zdamp;
317 Real rho_on_v_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i,j-1,k,
Rho_comp) );
318 Real vv = rho_v(i,j,k) / rho_on_v_face;
319 Real sinefac = std::sin(
PIoTwo*zfrac);
320 ymom_src_arr(i, j, k) -= dampcoef*sinefac*sinefac * (vv -
vbar[k]) * rho_on_v_face;
325 if (rayleigh_damp_W) {
326 ParallelFor(tbz, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
328 Real zstag = (z_nd_arr) ? z_nd_arr(i,j,k) : zlo + k*dz;
329 Real zfrac = 1 - (ztop - zstag) / zdamp;
331 Real rho_on_w_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i,j,k-1,
Rho_comp) );
332 Real ww = rho_w(i,j,k) / rho_on_w_face;
333 Real sinefac = std::sin(
PIoTwo*zfrac);
334 zmom_src_arr(i, j, k) -= dampcoef*sinefac*sinefac * (ww -
wbar[k]) * rho_on_w_face;
344 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
346 Real rho_on_u_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i-1,j,k,
Rho_comp) );
347 xmom_src_arr(i, j, k) += rho_on_u_face * abl_geo_forcing[0];
349 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
351 Real rho_on_v_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i,j-1,k,
Rho_comp) );
352 ymom_src_arr(i, j, k) += rho_on_v_face * abl_geo_forcing[1];
354 ParallelFor(tbz, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
356 Real rho_on_w_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i,j,k-1,
Rho_comp) );
357 zmom_src_arr(i, j, k) += rho_on_w_face * abl_geo_forcing[2];
364 if (geo_wind_profile && is_slow_step) {
365 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
367 Real rho_on_u_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i-1,j,k,
Rho_comp) );
368 xmom_src_arr(i, j, k) -= coriolis_factor * rho_on_u_face * dptr_v_geos[k] * sinphi;
370 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k)
372 Real rho_on_v_face = 0.5 * ( cell_data(i,j,k,
Rho_comp) + cell_data(i,j-1,k,
Rho_comp) );
373 ymom_src_arr(i, j, k) += coriolis_factor * rho_on_v_face * dptr_u_geos[k] * sinphi;
383 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
385 Real dzInv = 0.5*dxInv[2];
387 Real z_xf_lo = 0.25 * ( z_nd_arr(i,j,k ) + z_nd_arr(i,j+1,k )
388 + z_nd_arr(i,j,k-1) + z_nd_arr(i,j+1,k-1) );
389 Real z_xf_hi = 0.25 * ( z_nd_arr(i,j,k+1) + z_nd_arr(i,j+1,k+1)
390 + z_nd_arr(i,j,k+2) + z_nd_arr(i,j+1,k+2) );
391 dzInv = 1.0 / (z_xf_hi - z_xf_lo);
393 Real rho_on_u_face = 0.5 * ( cell_data(i,j,k,
nr) + cell_data(i-1,j,k,
nr) );
394 Real U_hi = dptr_u_plane(k+1) / dptr_r_plane(k+1);
395 Real U_lo = dptr_u_plane(k-1) / dptr_r_plane(k-1);
396 Real wbar_xf = 0.5 * (dptr_wbar_sub[k] + dptr_wbar_sub[k+1]);
397 xmom_src_arr(i, j, k) -= rho_on_u_face * wbar_xf * (U_hi - U_lo) * dzInv;
399 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
401 Real dzInv = 0.5*dxInv[2];
403 Real z_yf_lo = 0.25 * ( z_nd_arr(i,j,k ) + z_nd_arr(i+1,j,k )
404 + z_nd_arr(i,j,k-1) + z_nd_arr(i+1,j,k-1) );
405 Real z_yf_hi = 0.25 * ( z_nd_arr(i,j,k+1) + z_nd_arr(i+1,j,k+1)
406 + z_nd_arr(i,j,k+2) + z_nd_arr(i+1,j,k+2) );
407 dzInv = 1.0 / (z_yf_hi - z_yf_lo);
409 Real rho_on_v_face = 0.5 * ( cell_data(i,j,k,
nr) + cell_data(i,j-1,k,
nr) );
410 Real V_hi = dptr_v_plane(k+1) / dptr_r_plane(k+1);
411 Real V_lo = dptr_v_plane(k-1) / dptr_r_plane(k-1);
412 Real wbar_yf = 0.5 * (dptr_wbar_sub[k] + dptr_wbar_sub[k+1]);
413 ymom_src_arr(i, j, k) -= rho_on_v_face * wbar_yf * (V_hi - V_lo) * dzInv;
416 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
418 Real dzInv = 0.5*dxInv[2];
420 Real z_xf_lo = 0.25 * ( z_nd_arr(i,j,k ) + z_nd_arr(i,j+1,k )
421 + z_nd_arr(i,j,k-1) + z_nd_arr(i,j+1,k-1) );
422 Real z_xf_hi = 0.25 * ( z_nd_arr(i,j,k+1) + z_nd_arr(i,j+1,k+1)
423 + z_nd_arr(i,j,k+2) + z_nd_arr(i,j+1,k+2) );
424 dzInv = 1.0 / (z_xf_hi - z_xf_lo);
426 Real U_hi = dptr_u_plane(k+1) / dptr_r_plane(k+1);
427 Real U_lo = dptr_u_plane(k-1) / dptr_r_plane(k-1);
428 Real wbar_xf = 0.5 * (dptr_wbar_sub[k] + dptr_wbar_sub[k+1]);
429 xmom_src_arr(i, j, k) -= wbar_xf * (U_hi - U_lo) * dzInv;
431 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
433 Real dzInv = 0.5*dxInv[2];
435 Real z_yf_lo = 0.25 * ( z_nd_arr(i,j,k ) + z_nd_arr(i+1,j,k )
436 + z_nd_arr(i,j,k-1) + z_nd_arr(i+1,j,k-1) );
437 Real z_yf_hi = 0.25 * ( z_nd_arr(i,j,k+1) + z_nd_arr(i+1,j,k+1)
438 + z_nd_arr(i,j,k+2) + z_nd_arr(i+1,j,k+2) );
439 dzInv = 1.0 / (z_yf_hi - z_yf_lo);
441 Real V_hi = dptr_v_plane(k+1) / dptr_r_plane(k+1);
442 Real V_lo = dptr_v_plane(k-1) / dptr_r_plane(k-1);
443 Real wbar_yf = 0.5 * (dptr_wbar_sub[k] + dptr_wbar_sub[k+1]);
444 ymom_src_arr(i, j, k) -= wbar_yf * (V_hi - V_lo) * dzInv;
456 Real coeff_n = Real(1.0);
457 Real coeff_np1 = Real(0.0);
459 Real tau_inv = Real(1.0) / input_sounding_data.
tau_nudging;
463 for (
int nt = 1; nt < n_sounding_times; nt++) {
466 if (itime_n == n_sounding_times-1) {
469 itime_np1 = itime_n+1;
472 coeff_n = Real(1.0) - coeff_np1;
477 const Real* u_inp_sound_n = input_sounding_data.
U_inp_sound_d[itime_n].dataPtr();
478 const Real* u_inp_sound_np1 = input_sounding_data.
U_inp_sound_d[itime_np1].dataPtr();
479 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
481 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));
483 xmom_src_arr(i, j, k) += cell_data(i, j, k,
nr) * nudge_u;
486 const Real* v_inp_sound_n = input_sounding_data.
V_inp_sound_d[itime_n].dataPtr();
487 const Real* v_inp_sound_np1 = input_sounding_data.
V_inp_sound_d[itime_np1].dataPtr();
488 ParallelFor(tby, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
490 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));
492 ymom_src_arr(i, j, k) += cell_data(i, j, k,
nr) * nudge_v;
501 const Array4<const Real>& mf_ux = mapfac[MapFac::ux]->const_array(mfi);
502 const Array4<const Real>& mf_uy = mapfac[MapFac::uy]->const_array(mfi);
503 const Array4<const Real>& mf_vx = mapfac[MapFac::vx]->const_array(mfi);
504 const Array4<const Real>& mf_vy = mapfac[MapFac::vy]->const_array(mfi);
506 u, cell_data, xmom_src_arr, mf_ux, mf_uy);
508 v, cell_data, ymom_src_arr, mf_vx, mf_vy);
519 z_cc_arr, xmom_src_arr, ymom_src_arr,
520 rho_u, rho_v, d_sponge_ptrs_at_lev);
525 xmom_src_arr, ymom_src_arr, zmom_src_arr, rho_u, rho_v, rho_w,
526 r0, z_nd_arr, z_cc_arr);
534 ((is_slow_step && !use_canopy_fast) || (!is_slow_step && use_canopy_fast))) {
535 ParallelFor(tbx, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
537 const Real ux = u(i, j, k);
538 const Real uy = 0.25 * ( v(i, j , k ) + v(i-1, j , k )
539 + v(i, j+1, k ) + v(i-1, j+1, k ) );
540 const Real uz = 0.25 * ( w(i, j , k ) + w(i-1, j , k )
541 + w(i, j , k+1) + w(i-1, j , k+1) );
542 const Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
543 const Real f_drag = 0.5 * (f_drag_arr(i, j, k) + f_drag_arr(i-1, j, k));
544 xmom_src_arr(i, j, k) -= f_drag * ux * windspeed;
546 ParallelFor(tby, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
548 const Real ux = 0.25 * ( u(i , j , k ) + u(i , j-1, k )
549 + u(i+1, j , k ) + u(i+1, j-1, k ) );
550 const Real uy = v(i, j, k);
551 const Real uz = 0.25 * ( w(i , j , k ) + w(i , j-1, k )
552 + w(i , j , k+1) + w(i , j-1, k+1) );
553 const amrex::Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
554 const Real f_drag = 0.5 * (f_drag_arr(i, j, k) + f_drag_arr(i, j-1, k));
555 ymom_src_arr(i, j, k) -= f_drag * uy * windspeed;
557 ParallelFor(tbz, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
559 const amrex::Real ux = 0.25 * ( u(i , j , k ) + u(i+1, j , k )
560 + u(i , j , k-1) + u(i+1, j , k-1) );
561 const amrex::Real uy = 0.25 * ( v(i , j , k ) + v(i , j+1, k )
562 + v(i , j , k-1) + v(i , j+1, k-1) );
563 const amrex::Real uz = w(i, j, k);
564 const amrex::Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
565 const Real f_drag = 0.5 * (f_drag_arr(i, j, k) + f_drag_arr(i, j, k-1));
566 zmom_src_arr(i, j, k) -= f_drag * uz * windspeed;
572 if (solverChoice.
terrain_type == TerrainType::ImmersedForcing &&
573 ((is_slow_step && !use_ImmersedForcing_fast) || (!is_slow_step && use_ImmersedForcing_fast))) {
574 const Real drag_coefficient=10.0/dz;
576 ParallelFor(tbx, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
578 const Real ux = u(i, j, k);
579 const Real uy = 0.25 * ( v(i, j , k ) + v(i-1, j , k )
580 + v(i, j+1, k ) + v(i-1, j+1, k ) );
581 const Real uz = 0.25 * ( w(i, j , k ) + w(i-1, j , k )
582 + w(i, j , k+1) + w(i-1, j , k+1) );
583 const Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
584 const Real t_blank = 0.5 * (t_blank_arr(i, j, k) + t_blank_arr(i-1, j, k));
585 const Real CdM = std::min(drag_coefficient / (windspeed + tiny), 1000.0);
586 xmom_src_arr(i, j, k) -= t_blank * CdM * ux * windspeed;
588 ParallelFor(tby, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
590 const Real ux = 0.25 * ( u(i , j , k ) + u(i , j-1, k )
591 + u(i+1, j , k ) + u(i+1, j-1, k ) );
592 const Real uy = v(i, j, k);
593 const Real uz = 0.25 * ( w(i , j , k ) + w(i , j-1, k )
594 + w(i , j , k+1) + w(i , j-1, k+1) );
595 const amrex::Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
596 const Real t_blank = 0.5 * (t_blank_arr(i, j, k) + t_blank_arr(i, j-1, k));
597 const Real CdM = std::min(drag_coefficient / (windspeed + tiny), 1000.0);
598 ymom_src_arr(i, j, k) -= t_blank * CdM * uy * windspeed;
600 ParallelFor(tbz, [=] AMREX_GPU_DEVICE(
int i,
int j,
int k) noexcept
602 const amrex::Real ux = 0.25 * ( u(i , j , k ) + u(i+1, j , k )
603 + u(i , j , k-1) + u(i+1, j , k-1) );
604 const amrex::Real uy = 0.25 * ( v(i , j , k ) + v(i , j+1, k )
605 + v(i , j , k-1) + v(i , j+1, k-1) );
606 const amrex::Real uz = w(i, j, k);
607 const amrex::Real windspeed = std::sqrt(ux * ux + uy * uy + uz * uz);
608 const Real t_blank = 0.5 * (t_blank_arr(i, j, k) + t_blank_arr(i, j, k-1));
609 const Real CdM = std::min(drag_coefficient / (windspeed + tiny), 1000.0);
610 zmom_src_arr(i, j, k) -= t_blank * CdM * uz * windspeed;
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:79
@ wbar
Definition: ERF_DataStruct.H:79
@ vbar
Definition: ERF_DataStruct.H:79
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:726
bool rayleigh_damp_V
Definition: ERF_DataStruct.H:698
bool rayleigh_damp_substep
Definition: ERF_DataStruct.H:704
amrex::Real rayleigh_zdamp
Definition: ERF_DataStruct.H:702
amrex::Real cosphi
Definition: ERF_DataStruct.H:727
amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > abl_geo_forcing
Definition: ERF_DataStruct.H:768
bool custom_w_subsidence
Definition: ERF_DataStruct.H:733
bool nudging_from_input_sounding
Definition: ERF_DataStruct.H:739
bool rayleigh_damp_U
Definition: ERF_DataStruct.H:697
amrex::Real rayleigh_ztop
Definition: ERF_DataStruct.H:703
bool immersed_forcing_substep
Definition: ERF_DataStruct.H:707
amrex::Real sinphi
Definition: ERF_DataStruct.H:728
bool have_geo_wind_profile
Definition: ERF_DataStruct.H:770
bool use_coriolis
Definition: ERF_DataStruct.H:694
amrex::Real num_diff_coeff
Definition: ERF_DataStruct.H:752
bool variable_coriolis
Definition: ERF_DataStruct.H:773
bool custom_forcing_prim_vars
Definition: ERF_DataStruct.H:735
static TerrainType terrain_type
Definition: ERF_DataStruct.H:659
bool rayleigh_damp_W
Definition: ERF_DataStruct.H:699
SpongeChoice spongeChoice
Definition: ERF_DataStruct.H:675
bool has_lat_lon
Definition: ERF_DataStruct.H:772
bool do_forest_drag
Definition: ERF_DataStruct.H:796
bool forest_substep
Definition: ERF_DataStruct.H:708
amrex::Real rayleigh_dampcoef
Definition: ERF_DataStruct.H:701
int ave_plane
Definition: ERF_DataStruct.H:775
std::string sponge_type
Definition: ERF_SpongeStruct.H:58