30 BL_PROFILE_REGION(
"erf_make_tau_terms()");
32 const BCRec* bc_ptr_h = domain_bcs_type_h.data();
37 const bool l_use_terrain_fitted_coords = (solverChoice.
mesh_type != MeshType::ConstantDz);
38 const bool l_moving_terrain = (solverChoice.
terrain_type == TerrainType::MovingFittedMesh);
39 if (l_moving_terrain) AMREX_ALWAYS_ASSERT (l_use_terrain_fitted_coords);
44 const bool l_use_turb = ( tc.
les_type == LESType::Smagorinsky ||
53 const bool need_SmnSmn = (tc.
les_type == LESType::Deardorff ||
58 const Box& domain = geom.Domain();
59 const int domlo_z = domain.smallEnd(2);
60 const int domhi_z = domain.bigEnd(2);
62 const GpuArray<Real, AMREX_SPACEDIM> dxInv = geom.InvCellSizeArray();
68 const DistributionMapping& dm = S_data[
IntVars::cons].DistributionMap();
70 std::unique_ptr<MultiFab> expr;
73 expr = std::make_unique<MultiFab>(ba, dm, 1, IntVect(1,1,1));
81 auto dz_ptr = stretched_dz_d.data();
84 #pragma omp parallel if (Gpu::notInLaunchRegion())
88 const Box& valid_bx = mfi.validbox();
91 const Array4<const Real> & u =
xvel.array(mfi);
92 const Array4<const Real> & v =
yvel.array(mfi);
93 const Array4<const Real> & w =
zvel.array(mfi);
96 const Array4<const Real>& mf_mx = mapfac[
MapFacType::m_x]->const_array(mfi);
97 const Array4<const Real>& mf_ux = mapfac[
MapFacType::u_x]->const_array(mfi);
98 const Array4<const Real>& mf_vx = mapfac[
MapFacType::v_x]->const_array(mfi);
99 const Array4<const Real>& mf_my = mapfac[
MapFacType::m_y]->const_array(mfi);
100 const Array4<const Real>& mf_uy = mapfac[
MapFacType::u_y]->const_array(mfi);
101 const Array4<const Real>& mf_vy = mapfac[
MapFacType::v_y]->const_array(mfi);
104 const Array4<Real const>& mu_turb = l_use_turb ? eddyDiffs->const_array(mfi) :
105 Array4<const Real>{};
106 const Array4<Real const>& cell_data = l_use_constAlpha ? S_data[
IntVars::cons].const_array(mfi) :
107 Array4<const Real>{};
110 const Array4<const Real>& z_nd = z_phys_nd.const_array(mfi);
111 const Array4<const Real>& detJ_arr = detJ.const_array(mfi);
130 Box bx = mfi.tilebox();
131 Box bxcc = mfi.tilebox();
132 Box tbxxy = mfi.tilebox(IntVect(1,1,0));
133 Box tbxxz = mfi.tilebox(IntVect(1,0,1));
134 Box tbxyz = mfi.tilebox(IntVect(0,1,1));
137 bxcc.grow(IntVect(1,1,0));
138 tbxxy.grow(IntVect(1,1,0));
139 tbxxz.grow(IntVect(1,1,0));
140 tbxyz.grow(IntVect(1,1,0));
142 if (bxcc.smallEnd(2) != domain.smallEnd(2)) {
149 if (bxcc.bigEnd(2) != domain.bigEnd(2)) {
157 Array4<Real> er_arr = expr->array(mfi);
160 FArrayBox S11,S22,S33;
161 FArrayBox S12,S13,S23;
164 S11.resize( bxcc,1,The_Async_Arena()); S22.resize( bxcc,1,The_Async_Arena()); S33.resize( bxcc,1,The_Async_Arena());
165 S12.resize(tbxxy,1,The_Async_Arena()); S13.resize(tbxxz,1,The_Async_Arena()); S23.resize(tbxyz,1,The_Async_Arena());
166 Array4<Real> s11 = S11.array(); Array4<Real> s22 = S22.array(); Array4<Real> s33 = S33.array();
167 Array4<Real> s12 = S12.array(); Array4<Real> s13 = S13.array(); Array4<Real> s23 = S23.array();
177 FArrayBox S13_for_impl, S23_for_impl;
178 S13_for_impl.resize(tbxxz,1,The_Async_Arena());
179 S23_for_impl.resize(tbxyz,1,The_Async_Arena());
180 Array4<Real> s13_corr = (do_implicit) ? S13_for_impl.array() : Array4<Real>{};
181 Array4<Real> s23_corr = (do_implicit) ? S23_for_impl.array() : Array4<Real>{};
182 Array4<Real> tau13_corr = (do_implicit) ? Tau_corr_lev[0]->array(mfi) : Array4<Real>{};
183 Array4<Real> tau23_corr = (do_implicit) ? Tau_corr_lev[1]->array(mfi) : Array4<Real>{};
184 #ifdef ERF_IMPLICIT_W
185 FArrayBox S33_for_impl;
186 S33_for_impl.resize( bxcc,1,The_Async_Arena());
187 Array4<Real> s33_corr = (do_implicit) ? S33_for_impl.array() : Array4<Real>{};
188 Array4<Real> tau33_corr = (do_implicit) ? Tau_corr_lev[2]->array(mfi) : Array4<Real>{};
190 Array4<Real> s33_corr = Array4<Real>{};
191 Array4<Real> tau33_corr = Array4<Real>{};
198 Array4<Real> SmnSmn_a = ((nrk==0) && need_SmnSmn) ? SmnSmn->array(mfi) : Array4<Real>{};
226 if (solverChoice.
mesh_type == MeshType::StretchedDz) {
228 FArrayBox S21,S31,S32;
229 S21.resize(tbxxy,1,The_Async_Arena()); S31.resize(tbxxz,1,The_Async_Arena()); S32.resize(tbxyz,1,The_Async_Arena());
230 Array4<Real> s21 = S21.array(); Array4<Real> s31 = S31.array(); Array4<Real> s32 = S32.array();
239 BL_PROFILE(
"slow_rhs_making_er_S");
240 ParallelFor(bxcc, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
242 Real mfsq = mf_mx(i,j,0)*mf_my(i,j,0);
243 er_arr(i,j,k) = (u(i+1, j , k )/mf_uy(i+1,j,0) - u(i, j, k)/mf_uy(i,j,0))*dxInv[0] * mfsq +
244 (v(i , j+1, k )/mf_vx(i,j+1,0) - v(i, j, k)/mf_vx(i,j,0))*dxInv[1] * mfsq +
245 (w(i , j , k+1) - w(i, j, k) )/dz_ptr[k];
253 BL_PROFILE(
"slow_rhs_making_strain_S");
260 stretched_dz_d, dxInv,
262 mf_my, mf_uy, mf_vy, bc_ptr_h,
267 ParallelFor(bx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
279 BL_PROFILE(
"slow_rhs_making_stress_T");
282 tbxxy.grow(IntVect(-1,-1,0));
283 tbxxz.grow(IntVect(-1,-1,0));
284 tbxyz.grow(IntVect(-1,-1,0));
296 s13_corr, s23_corr, s33_corr);
307 s13_corr, s23_corr, s33_corr);
311 bxcc.grow(IntVect(-1,-1,0));
312 if (bxcc.smallEnd(0) == valid_bx.smallEnd(0)) bxcc.growLo(0, 1);
313 if (bxcc.bigEnd(0) == valid_bx.bigEnd(0)) bxcc.growHi(0, 1);
314 if (bxcc.smallEnd(1) == valid_bx.smallEnd(1)) bxcc.growLo(1, 1);
315 if (bxcc.bigEnd(1) == valid_bx.bigEnd(1)) bxcc.growHi(1, 1);
319 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
320 tau11(i,j,k) = s11(i,j,k);
321 tau22(i,j,k) = s22(i,j,k);
322 tau33(i,j,k) = s33(i,j,k);
323 if (tau33_corr) tau33_corr(i,j,k) = s33_corr(i,j,k);
326 ParallelFor(tbxxy, tbxxz, tbxyz,
327 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
328 tau12(i,j,k) = s12(i,j,k);
329 tau21(i,j,k) = s21(i,j,k);
331 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
332 tau13(i,j,k) = s13(i,j,k);
333 tau31(i,j,k) = s31(i,j,k);
334 if (tau13_corr) tau13_corr(i,j,k) = s13_corr(i,j,k);
336 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
337 tau23(i,j,k) = s23(i,j,k);
338 tau32(i,j,k) = s32(i,j,k);
339 if (tau23_corr) tau23_corr(i,j,k) = s23_corr(i,j,k);
343 }
else if (l_use_terrain_fitted_coords) {
346 FArrayBox S21,S31,S32;
347 S21.resize(tbxxy,1,The_Async_Arena()); S31.resize(tbxxz,1,The_Async_Arena()); S32.resize(tbxyz,1,The_Async_Arena());
348 Array4<Real> s21 = S21.array(); Array4<Real> s31 = S31.array(); Array4<Real> s32 = S32.array();
358 BL_PROFILE(
"slow_rhs_making_er_T");
359 Box gbxo = surroundingNodes(bxcc,2);
364 Omega.resize(gbxo,1,The_Async_Arena());
367 Array4<Real> omega_arr = Omega.array();
368 ParallelFor(gbxo, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
370 omega_arr(i,j,k) = (k == 0) ? 0. :
OmegaFromW(i,j,k,w(i,j,k),u,v,
371 mf_ux,mf_vy,z_nd,dxInv);
374 ParallelFor(bxcc, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
383 Real Omega_hi = omega_arr(i,j,k+1);
384 Real Omega_lo = omega_arr(i,j,k );
386 Real mfsq = mf_mx(i,j,0)*mf_my(i,j,0);
388 Real expansionRate = (u(i+1,j ,k)/mf_uy(i+1,j,0)*met_u_h_zeta_hi - u(i,j,k)/mf_uy(i,j,0)*met_u_h_zeta_lo)*dxInv[0]*mfsq +
389 (v(i ,j+1,k)/mf_vx(i,j+1,0)*met_v_h_zeta_hi - v(i,j,k)/mf_vx(i,j,0)*met_v_h_zeta_lo)*dxInv[1]*mfsq +
390 (Omega_hi - Omega_lo)*dxInv[2];
392 er_arr(i,j,k) = expansionRate / detJ_arr(i,j,k);
407 BL_PROFILE(
"slow_rhs_making_strain_T");
414 z_nd, detJ_arr, dxInv,
416 mf_my, mf_uy, mf_vy, bc_ptr_h,
421 ParallelFor(bx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
433 BL_PROFILE(
"slow_rhs_making_stress_T");
436 tbxxy.grow(IntVect(-1,-1,0));
437 tbxxz.grow(IntVect(-1,-1,0));
438 tbxyz.grow(IntVect(-1,-1,0));
447 er_arr, z_nd, detJ_arr, dxInv,
450 s13_corr, s23_corr, s33_corr);
458 er_arr, z_nd, detJ_arr, dxInv,
461 s13_corr, s23_corr, s33_corr);
465 bxcc.grow(IntVect(-1,-1,0));
466 if (bxcc.smallEnd(0) == valid_bx.smallEnd(0)) bxcc.growLo(0, 1);
467 if (bxcc.bigEnd(0) == valid_bx.bigEnd(0)) bxcc.growHi(0, 1);
468 if (bxcc.smallEnd(1) == valid_bx.smallEnd(1)) bxcc.growLo(1, 1);
469 if (bxcc.bigEnd(1) == valid_bx.bigEnd(1)) bxcc.growHi(1, 1);
473 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
474 tau11(i,j,k) = s11(i,j,k);
475 tau22(i,j,k) = s22(i,j,k);
476 tau33(i,j,k) = s33(i,j,k);
477 if (tau33_corr) tau33_corr(i,j,k) = s33_corr(i,j,k);
480 ParallelFor(tbxxy, tbxxz, tbxyz,
481 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
482 tau12(i,j,k) = s12(i,j,k);
483 tau21(i,j,k) = s21(i,j,k);
485 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
486 tau13(i,j,k) = s13(i,j,k);
487 tau31(i,j,k) = s31(i,j,k);
488 if(tau13_corr) tau13_corr(i,j,k) = s13_corr(i,j,k);
490 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
491 tau23(i,j,k) = s23(i,j,k);
492 tau32(i,j,k) = s32(i,j,k);
493 if(tau23_corr) tau23_corr(i,j,k) = s23_corr(i,j,k);
503 BL_PROFILE(
"slow_rhs_making_er_N");
504 ParallelFor(bxcc, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
505 Real mfsq = mf_mx(i,j,0)*mf_my(i,j,0);
506 er_arr(i,j,k) = (u(i+1, j , k )/mf_uy(i+1,j,0) - u(i, j, k)/mf_uy(i,j,0))*dxInv[0]*mfsq +
507 (v(i , j+1, k )/mf_vx(i,j+1,0) - v(i, j, k)/mf_vx(i,j,0))*dxInv[1]*mfsq +
508 (w(i , j , k+1) - w(i, j, k))*dxInv[2];
517 BL_PROFILE(
"slow_rhs_making_strain_N");
524 mf_my, mf_uy, mf_vy, bc_ptr_h,
529 ParallelFor(bx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
541 BL_PROFILE(
"slow_rhs_making_stress_N");
544 tbxxy.grow(IntVect(-1,-1,0));
545 tbxxz.grow(IntVect(-1,-1,0));
546 tbxyz.grow(IntVect(-1,-1,0));
547 if (tbxxy.smallEnd(2) > domlo_z) {
552 if (tbxxy.bigEnd(2) < domhi_z) {
564 s13_corr, s23_corr, s33_corr);
571 s13_corr, s23_corr, s33_corr);
575 bxcc.grow(IntVect(-1,-1,0));
576 if (bxcc.smallEnd(0) == valid_bx.smallEnd(0)) bxcc.growLo(0, 1);
577 if (bxcc.bigEnd(0) == valid_bx.bigEnd(0)) bxcc.growHi(0, 1);
578 if (bxcc.smallEnd(1) == valid_bx.smallEnd(1)) bxcc.growLo(1, 1);
579 if (bxcc.bigEnd(1) == valid_bx.bigEnd(1)) bxcc.growHi(1, 1);
583 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
584 tau11(i,j,k) = s11(i,j,k);
585 tau22(i,j,k) = s22(i,j,k);
586 tau33(i,j,k) = s33(i,j,k);
587 if (tau33_corr) tau33_corr(i,j,k) = s33_corr(i,j,k);
589 ParallelFor(tbxxy, tbxxz, tbxyz,
590 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
591 tau12(i,j,k) = s12(i,j,k);
593 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
594 tau13(i,j,k) = s13(i,j,k);
595 if (tau13_corr) tau13_corr(i,j,k) = s13_corr(i,j,k);
597 [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept {
598 tau23(i,j,k) = s23(i,j,k);
599 if (tau23_corr) tau23_corr(i,j,k) = s23_corr(i,j,k);
void ComputeStrain_N(Box bxcc, Box tbxxy, Box tbxxz, Box tbxyz, Box domain, const Array4< const Real > &u, const Array4< const Real > &v, const Array4< const Real > &w, Array4< Real > &tau11, Array4< Real > &tau22, Array4< Real > &tau33, Array4< Real > &tau12, Array4< Real > &tau13, Array4< Real > &tau23, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_mx, const Array4< const Real > &mf_ux, const Array4< const Real > &mf_vx, const Array4< const Real > &mf_my, const Array4< const Real > &mf_uy, const Array4< const Real > &mf_vy, const BCRec *bc_ptr, Array4< Real > &tau13i, Array4< Real > &tau23i)
Definition: ERF_ComputeStrain_N.cpp:31
void ComputeStrain_S(Box bxcc, Box tbxxy, Box tbxxz, Box tbxyz, Box domain, const Array4< const Real > &u, const Array4< const Real > &v, const Array4< const Real > &w, Array4< Real > &tau11, Array4< Real > &tau22, Array4< Real > &tau33, Array4< Real > &tau12, Array4< Real > &tau21, Array4< Real > &tau13, Array4< Real > &tau31, Array4< Real > &tau23, Array4< Real > &tau32, const Gpu::DeviceVector< Real > &stretched_dz_d, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_mx, const Array4< const Real > &mf_ux, const Array4< const Real > &mf_vx, const Array4< const Real > &mf_my, const Array4< const Real > &mf_uy, const Array4< const Real > &mf_vy, const BCRec *bc_ptr, Array4< Real > &tau13i, Array4< Real > &tau23i)
Definition: ERF_ComputeStrain_S.cpp:39
void ComputeStrain_T(Box bxcc, Box tbxxy, Box tbxxz, Box tbxyz, Box domain, const Array4< const Real > &u, const Array4< const Real > &v, const Array4< const Real > &w, Array4< Real > &tau11, Array4< Real > &tau22, Array4< Real > &tau33, Array4< Real > &tau12, Array4< Real > &tau21, Array4< Real > &tau13, Array4< Real > &tau31, Array4< Real > &tau23, Array4< Real > &tau32, const Array4< const Real > &z_nd, const Array4< const Real > &detJ, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_mx, const Array4< const Real > &mf_ux, const Array4< const Real > &mf_vx, const Array4< const Real > &mf_my, const Array4< const Real > &mf_uy, const Array4< const Real > &mf_vy, const BCRec *bc_ptr, Array4< Real > &tau13i, Array4< Real > &tau23i)
Definition: ERF_ComputeStrain_T.cpp:39
void ComputeStressConsVisc_N(Box bxcc, Box tbxxy, Box tbxxz, Box tbxyz, Real mu_eff, const Array4< const Real > &cell_data, Array4< Real > &tau11, Array4< Real > &tau22, Array4< Real > &tau33, Array4< Real > &tau12, Array4< Real > &tau13, Array4< Real > &tau23, const Array4< const Real > &er_arr, Array4< Real > &tau13i, Array4< Real > &tau23i, Array4< Real > &tau33i)
Definition: ERF_ComputeStress_N.cpp:26
void ComputeStressVarVisc_N(Box bxcc, Box tbxxy, Box tbxxz, Box tbxyz, Real mu_eff, const Array4< const Real > &mu_turb, const Array4< const Real > &cell_data, Array4< Real > &tau11, Array4< Real > &tau22, Array4< Real > &tau33, Array4< Real > &tau12, Array4< Real > &tau13, Array4< Real > &tau23, const Array4< const Real > &er_arr, Array4< Real > &tau13i, Array4< Real > &tau23i, Array4< Real > &tau33i)
Definition: ERF_ComputeStress_N.cpp:126
void ComputeStressVarVisc_S(Box bxcc, Box tbxxy, Box tbxxz, Box tbxyz, Real mu_eff, const Array4< const Real > &mu_turb, const Array4< const Real > &cell_data, Array4< Real > &tau11, Array4< Real > &tau22, Array4< Real > &tau33, Array4< Real > &tau12, Array4< Real > &tau21, Array4< Real > &tau13, Array4< Real > &tau31, Array4< Real > &tau23, Array4< Real > &tau32, const Array4< const Real > &er_arr, const Array4< const Real > &mf_mx, const Array4< const Real > &mf_ux, const Array4< const Real > &mf_vx, const Array4< const Real > &mf_my, const Array4< const Real > &mf_uy, const Array4< const Real > &mf_vy, Array4< Real > &tau13i, Array4< Real > &tau23i, Array4< Real > &tau33i)
Definition: ERF_ComputeStress_S.cpp:162
void ComputeStressConsVisc_S(Box bxcc, Box tbxxy, Box tbxxz, Box tbxyz, Real mu_eff, const Array4< const Real > &cell_data, Array4< Real > &tau11, Array4< Real > &tau22, Array4< Real > &tau33, Array4< Real > &tau12, Array4< Real > &tau21, Array4< Real > &tau13, Array4< Real > &tau31, Array4< Real > &tau23, Array4< Real > &tau32, const Array4< const Real > &er_arr, const Array4< const Real > &mf_mx, const Array4< const Real > &mf_ux, const Array4< const Real > &mf_vx, const Array4< const Real > &mf_my, const Array4< const Real > &mf_uy, const Array4< const Real > &mf_vy, Array4< Real > &tau13i, Array4< Real > &tau23i, Array4< Real > &tau33i)
Definition: ERF_ComputeStress_S.cpp:32
void ComputeStressVarVisc_T(Box bxcc, Box tbxxy, Box tbxxz, Box tbxyz, Real mu_eff, const Array4< const Real > &mu_turb, const Array4< const Real > &cell_data, Array4< Real > &tau11, Array4< Real > &tau22, Array4< Real > &tau33, Array4< Real > &tau12, Array4< Real > &tau21, Array4< Real > &tau13, Array4< Real > &tau31, Array4< Real > &tau23, Array4< Real > &tau32, const Array4< const Real > &er_arr, const Array4< const Real > &z_nd, const Array4< const Real > &detJ, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_mx, const Array4< const Real > &mf_ux, const Array4< const Real > &mf_vx, const Array4< const Real > &mf_my, const Array4< const Real > &mf_uy, const Array4< const Real > &mf_vy, Array4< Real > &tau13i, Array4< Real > &tau23i, Array4< Real > &tau33i)
Definition: ERF_ComputeStress_T.cpp:363
void ComputeStressConsVisc_T(Box bxcc, Box tbxxy, Box tbxxz, Box tbxyz, Real mu_eff, const Array4< const Real > &cell_data, Array4< Real > &tau11, Array4< Real > &tau22, Array4< Real > &tau33, Array4< Real > &tau12, Array4< Real > &tau21, Array4< Real > &tau13, Array4< Real > &tau31, Array4< Real > &tau23, Array4< Real > &tau32, const Array4< const Real > &er_arr, const Array4< const Real > &z_nd, const Array4< const Real > &detJ, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_mx, const Array4< const Real > &mf_ux, const Array4< const Real > &mf_vx, const Array4< const Real > &mf_my, const Array4< const Real > &mf_uy, const Array4< const Real > &mf_vy, Array4< Real > &tau13i, Array4< Real > &tau23i, Array4< Real > &tau33i)
Definition: ERF_ComputeStress_T.cpp:32
@ tau12
Definition: ERF_DataStruct.H:31
@ tau33
Definition: ERF_DataStruct.H:31
@ tau22
Definition: ERF_DataStruct.H:31
@ tau32
Definition: ERF_DataStruct.H:31
@ tau31
Definition: ERF_DataStruct.H:31
@ tau21
Definition: ERF_DataStruct.H:31
@ 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
AMREX_GPU_DEVICE AMREX_FORCE_INLINE amrex::Real ComputeSmnSmn(int &i, int &j, int &k, const amrex::Array4< amrex::Real const > &tau11, const amrex::Array4< amrex::Real const > &tau22, const amrex::Array4< amrex::Real const > &tau33, const amrex::Array4< amrex::Real const > &tau12, const amrex::Array4< amrex::Real const > &tau13, const amrex::Array4< amrex::Real const > &tau23)
Definition: ERF_EddyViscosity.H:63
amrex::Real Real
Definition: ERF_ShocInterface.H:19
AMREX_GPU_DEVICE AMREX_FORCE_INLINE amrex::Real OmegaFromW(int &i, int &j, int &k, amrex::Real w, const amrex::Array4< const amrex::Real > &u_arr, const amrex::Array4< const amrex::Real > &v_arr, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v, const amrex::Array4< const amrex::Real > &z_nd, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv)
Definition: ERF_TerrainMetrics.H:412
AMREX_GPU_DEVICE AMREX_FORCE_INLINE amrex::Real Compute_h_zeta_AtIface(const int &i, const int &j, const int &k, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &cellSizeInv, const amrex::Array4< const amrex::Real > &z_nd)
Definition: ERF_TerrainMetrics.H:102
AMREX_GPU_DEVICE AMREX_FORCE_INLINE amrex::Real Compute_h_zeta_AtJface(const int &i, const int &j, const int &k, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &cellSizeInv, const amrex::Array4< const amrex::Real > &z_nd)
Definition: ERF_TerrainMetrics.H:142
@ cons
Definition: ERF_IndexDefines.H:158
@ xvel
Definition: ERF_IndexDefines.H:141
@ zvel
Definition: ERF_IndexDefines.H:143
@ yvel
Definition: ERF_IndexDefines.H:142
Definition: ERF_DiffStruct.H:19
amrex::Real rho0_trans
Definition: ERF_DiffStruct.H:91
MolecDiffType molec_diff_type
Definition: ERF_DiffStruct.H:84
amrex::Real dynamic_viscosity
Definition: ERF_DiffStruct.H:96
static MeshType mesh_type
Definition: ERF_DataStruct.H:983
DiffChoice diffChoice
Definition: ERF_DataStruct.H:992
amrex::Vector< amrex::Real > vert_implicit_fac
Definition: ERF_DataStruct.H:1016
amrex::Vector< TurbChoice > turbChoice
Definition: ERF_DataStruct.H:995
static TerrainType terrain_type
Definition: ERF_DataStruct.H:971
bool implicit_momentum_diffusion
Definition: ERF_DataStruct.H:1019
Definition: ERF_TurbStruct.H:41
PBLType pbl_type
Definition: ERF_TurbStruct.H:390
RANSType rans_type
Definition: ERF_TurbStruct.H:387
LESType les_type
Definition: ERF_TurbStruct.H:345
bool use_kturb
Definition: ERF_TurbStruct.H:396