ERF
Energy Research and Forecasting: An Atmospheric Modeling Code
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Macros Pages
ERF_ComputeDiffusivityMYNNEDMF.cpp File Reference
#include <algorithm>
#include <iostream>
#include <vector>
#include <cmath>
#include <functional>
#include <limits>
#include "ERF_ABLMost.H"
#include "ERF_DirectionSelector.H"
#include "ERF_Diffusion.H"
#include "ERF_Constants.H"
#include "ERF_TurbStruct.H"
#include "ERF_PBLModels.H"
Include dependency graph for ERF_ComputeDiffusivityMYNNEDMF.cpp:

Functions

void ComputeDiffusivityMYNNEDMF (const MultiFab &xvel, const MultiFab &yvel, const MultiFab &cons_in, MultiFab &eddyViscosity, const Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool use_terrain_fitted_coords, bool use_moisture, int level, const BCRec *bc_ptr, bool, const std::unique_ptr< MultiFab > &z_phys_nd, const int RhoQv_comp, const int RhoQc_comp, const int RhoQr_comp)
 

Function Documentation

◆ ComputeDiffusivityMYNNEDMF()

void ComputeDiffusivityMYNNEDMF ( const MultiFab &  xvel,
const MultiFab &  yvel,
const MultiFab &  cons_in,
MultiFab &  eddyViscosity,
const Geometry &  geom,
const TurbChoice turbChoice,
std::unique_ptr< ABLMost > &  most,
bool  use_terrain_fitted_coords,
bool  use_moisture,
int  level,
const BCRec *  bc_ptr,
bool  ,
const std::unique_ptr< MultiFab > &  z_phys_nd,
const int  RhoQv_comp,
const int  RhoQc_comp,
const int  RhoQr_comp 
)
4193 {
4194  Print()<<"reached mynnedmf"<<std::endl;
4195  {
4196  int n=1;
4197  Real a=1;
4198  Real b=1;
4199  Real c=1;
4200  Real d=1;
4201  Real x=0;
4202 #if 0
4203  tridiag2_cc(n,&a,&b,&c,&d,&x);
4204 #endif
4205  printf("ran tridiag2_cc with n=%d and got %g %g %g %g %g",n,a,b,c,d,x);
4206  }
4207  const bool use_most = (most != nullptr);
4208 
4209  auto mynn = turbChoice.pbl_mynn;
4210  auto level2 = turbChoice.pbl_mynn_level2;
4211 
4212  Real Lt_alpha = (mynn.config == MYNNConfigType::CHEN2021) ? 0.1 : 0.23;
4213 
4214  // Dirichlet flags to switch derivative stencil
4215  bool c_ext_dir_on_zlo = ( (bc_ptr[BCVars::cons_bc].lo(2) == ERFBCType::ext_dir) );
4216  bool c_ext_dir_on_zhi = ( (bc_ptr[BCVars::cons_bc].lo(5) == ERFBCType::ext_dir) );
4217  bool u_ext_dir_on_zlo = ( (bc_ptr[BCVars::xvel_bc].lo(2) == ERFBCType::ext_dir) );
4218  bool u_ext_dir_on_zhi = ( (bc_ptr[BCVars::xvel_bc].lo(5) == ERFBCType::ext_dir) );
4219  bool v_ext_dir_on_zlo = ( (bc_ptr[BCVars::yvel_bc].lo(2) == ERFBCType::ext_dir) );
4220  bool v_ext_dir_on_zhi = ( (bc_ptr[BCVars::yvel_bc].lo(5) == ERFBCType::ext_dir) );
4221 
4222  // Epsilon
4223  Real eps = std::numeric_limits<Real>::epsilon();
4224 
4225 #ifdef _OPENMP
4226 #pragma omp parallel if (Gpu::notInLaunchRegion())
4227 #endif
4228  for ( MFIter mfi(eddyViscosity,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
4229 
4230  const Box &bx = mfi.growntilebox(1);
4231  const Array4<Real const>& cell_data = cons_in.array(mfi);
4232  const Array4<Real >& K_turb = eddyViscosity.array(mfi);
4233  const Array4<Real const>& uvel = xvel.array(mfi);
4234  const Array4<Real const>& vvel = yvel.array(mfi);
4235 
4236  // Compute some quantities that are constant in each column
4237  // Sbox is shrunk to only include the interior of the domain in the vertical direction to compute integrals
4238  // Box includes one ghost cell in each direction
4239  const Box &dbx = geom.Domain();
4240  Box sbx(bx.smallEnd(), bx.bigEnd());
4241  sbx.grow(2,-1);
4242  AMREX_ALWAYS_ASSERT(sbx.smallEnd(2) == dbx.smallEnd(2) && sbx.bigEnd(2) == dbx.bigEnd(2));
4243 
4244  const GeometryData gdata = geom.data();
4245 
4246  const Box xybx = PerpendicularBox<ZDir>(bx, IntVect{0,0,0});
4247  FArrayBox qintegral(xybx,2);
4248  qintegral.setVal<RunOn::Device>(0.0);
4249  FArrayBox qturb(bx,1); FArrayBox qturb_old(bx,1);
4250  const Array4<Real> qint = qintegral.array();
4251  const Array4<Real> qvel = qturb.array();
4252 
4253  // vertical integrals to compute lengthscale
4254  if (use_terrain_fitted_coords) {
4255  const Array4<Real const> &z_nd_arr = z_phys_nd->array(mfi);
4256  const auto invCellSize = geom.InvCellSizeArray();
4257  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
4258  {
4259  qvel(i,j,k) = std::sqrt(2.0 * cell_data(i,j,k,RhoKE_comp) / cell_data(i,j,k,Rho_comp));
4260  AMREX_ASSERT_WITH_MESSAGE(qvel(i,j,k) > 0.0, "KE must have a positive value");
4261 
4262  Real fac = (sbx.contains(i,j,k)) ? 1.0 : 0.0;
4263  const Real Zval = Compute_Zrel_AtCellCenter(i,j,k,z_nd_arr);
4264  const Real dz = Compute_h_zeta_AtCellCenter(i,j,k,invCellSize,z_nd_arr);
4265  Gpu::Atomic::Add(&qint(i,j,0,0), Zval*qvel(i,j,k)*dz*fac);
4266  Gpu::Atomic::Add(&qint(i,j,0,1), qvel(i,j,k)*dz*fac);
4267  });
4268  } else {
4269  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
4270  {
4271  qvel(i,j,k) = std::sqrt(2.0 * cell_data(i,j,k,RhoKE_comp) / cell_data(i,j,k,Rho_comp));
4272  AMREX_ASSERT_WITH_MESSAGE(qvel(i,j,k) > 0.0, "KE must have a positive value");
4273 
4274  // Not multiplying by dz: its constant and would fall out when we divide qint0/qint1 anyway
4275 
4276  Real fac = (sbx.contains(i,j,k)) ? 1.0 : 0.0;
4277  const Real Zval = gdata.ProbLo(2) + (k + 0.5)*gdata.CellSize(2);
4278  Gpu::Atomic::Add(&qint(i,j,0,0), Zval*qvel(i,j,k)*fac);
4279  Gpu::Atomic::Add(&qint(i,j,0,1), qvel(i,j,k)*fac);
4280  });
4281  }
4282 
4283  Real dz_inv = geom.InvCellSize(2);
4284  const auto& dxInv = geom.InvCellSizeArray();
4285  int izmin = geom.Domain().smallEnd(2);
4286  int izmax = geom.Domain().bigEnd(2);
4287 
4288  // Spatially varying MOST
4289  Real d_kappa = KAPPA;
4290  Real d_gravity = CONST_GRAV;
4291 
4292  const auto& t_mean_mf = most->get_mac_avg(level,4); // theta_v
4293  const auto& q_mean_mf = most->get_mac_avg(level,3); // q_v
4294  const auto& u_star_mf = most->get_u_star(level);
4295  const auto& t_star_mf = most->get_t_star(level);
4296  const auto& q_star_mf = most->get_q_star(level);
4297 
4298  const auto& tm_arr = t_mean_mf->const_array(mfi);
4299  const auto& qm_arr = q_mean_mf->const_array(mfi);
4300  const auto& u_star_arr = u_star_mf->const_array(mfi);
4301  const auto& t_star_arr = t_star_mf->const_array(mfi);
4302  const auto& q_star_arr = (use_moisture) ? q_star_mf->const_array(mfi) : Array4<Real>{};
4303 
4304  const Array4<Real const> z_nd_arr = z_phys_nd->const_array(mfi);
4305 
4306  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
4307  {
4308  // NOTE: With MOST, the ghost cells are filled AFTER k_turb is computed
4309  // so that the non-explicit pathway works. Therefore, at this
4310  // point we do NOT have valid ghost cells from MOST. We need to
4311  // pass the MOST flag to use one-sided diffs here.
4312 
4313  // Compute some partial derivatives that we will need (second order)
4314  // U and V derivatives are interpolated to account for staggered grid
4315  const Real met_h_zeta = use_terrain_fitted_coords ? Compute_h_zeta_AtCellCenter(i,j,k,dxInv,z_nd_arr) : 1.0;
4316  Real dthetadz, dudz, dvdz;
4318  uvel, vvel, cell_data, izmin, izmax, dz_inv/met_h_zeta,
4319  c_ext_dir_on_zlo, c_ext_dir_on_zhi,
4320  u_ext_dir_on_zlo, u_ext_dir_on_zhi,
4321  v_ext_dir_on_zlo, v_ext_dir_on_zhi,
4322  dthetadz, dudz, dvdz,
4323  RhoQv_comp, RhoQc_comp, RhoQr_comp, use_most);
4324 
4325  // Spatially varying MOST
4326  Real theta0 = tm_arr(i,j,0);
4327  Real qv0 = qm_arr(i,j,0);
4328  Real surface_heat_flux = -u_star_arr(i,j,0) * t_star_arr(i,j,0);
4329  Real surface_latent_heat{0};
4330  if (use_moisture) {
4331  // Compute buoyancy flux (Stull Eqn. 4.4.5d)
4332  surface_latent_heat = -u_star_arr(i,j,0) * q_star_arr(i,j,0);
4333  surface_heat_flux *= (1.0 + 0.61*qv0);
4334  surface_heat_flux += 0.61 * theta0 * surface_latent_heat;
4335  }
4336 
4337  Real l_obukhov;
4338  if (std::abs(surface_heat_flux) > eps) {
4339  l_obukhov = -( theta0 * u_star_arr(i,j,0)*u_star_arr(i,j,0)*u_star_arr(i,j,0) )
4340  / ( d_kappa * d_gravity * surface_heat_flux );
4341  } else {
4342  l_obukhov = std::numeric_limits<Real>::max();
4343  }
4344 
4345  // Surface-layer length scale (NN09, Eqn. 53)
4346  AMREX_ASSERT(l_obukhov != 0);
4347  int lk = amrex::max(k,0);
4348  const Real zval = use_terrain_fitted_coords ? Compute_Zrel_AtCellCenter(i,j,lk,z_nd_arr)
4349  : gdata.ProbLo(2) + (lk + 0.5)*gdata.CellSize(2);
4350  const Real zeta = zval/l_obukhov;
4351  Real l_S;
4352  if (zeta >= 1.0) {
4353  l_S = KAPPA*zval/3.7;
4354  } else if (zeta >= 0) {
4355  l_S = KAPPA*zval/(1+2.7*zeta);
4356  } else {
4357  l_S = KAPPA*zval*std::pow(1.0 - 100.0 * zeta, 0.2);
4358  }
4359 
4360  // ABL-depth length scale (NN09, Eqn. 54)
4361  Real l_T;
4362  if (qint(i,j,0,1) > 0.0) {
4363  l_T = Lt_alpha*qint(i,j,0,0)/qint(i,j,0,1);
4364  } else {
4365  l_T = std::numeric_limits<Real>::max();
4366  }
4367 
4368  // Buoyancy length scale (NN09, Eqn. 55)
4369  Real l_B;
4370  if (dthetadz > 0) {
4371  Real N_brunt_vaisala = std::sqrt(CONST_GRAV/theta0 * dthetadz);
4372  if (zeta < 0) {
4373  Real qc = CONST_GRAV/theta0 * surface_heat_flux * l_T; // velocity scale
4374  qc = std::pow(qc,1.0/3.0);
4375  l_B = (1.0 + 5.0*std::sqrt(qc/(N_brunt_vaisala * l_T))) * qvel(i,j,k)/N_brunt_vaisala;
4376  } else {
4377  l_B = qvel(i,j,k) / N_brunt_vaisala;
4378  }
4379  } else {
4380  l_B = std::numeric_limits<Real>::max();
4381  }
4382 
4383  // Master length scale
4384  Real Lm;
4385  if (mynn.config == MYNNConfigType::CHEN2021) {
4386  Lm = std::pow(1.0/(l_S*l_S) + 1.0/(l_T*l_T) + 1.0/(l_B*l_B), -0.5);
4387  } else {
4388  // NN09, Eqn 52
4389  Lm = 1.0 / (1.0/l_S + 1.0/l_T + 1.0/l_B);
4390  }
4391 
4392  // Calculate nondimensional production terms
4393  Real shearProd = dudz*dudz + dvdz*dvdz;
4394  Real buoyProd = -(CONST_GRAV/theta0) * dthetadz;
4395  Real L2_over_q2 = Lm*Lm/(qvel(i,j,k)*qvel(i,j,k));
4396  Real GM = L2_over_q2 * shearProd;
4397  Real GH = L2_over_q2 * buoyProd;
4398 
4399  // Equilibrium (Level-2) q calculation follows NN09, Appendix 2
4400  Real Rf = level2.calc_Rf(GM, GH);
4401  Real SM2 = level2.calc_SM(Rf);
4402  Real qe2 = mynn.B1*Lm*Lm*SM2*(1.0-Rf)*shearProd;
4403  Real qe = (qe2 < 0.0) ? 0.0 : std::sqrt(qe2);
4404 
4405  // Level 2 limiting (Helfand and Labraga 1988)
4406  Real alphac = (qvel(i,j,k) > qe) ? 1.0 : qvel(i,j,k) / (qe + eps);
4407 
4408  // Level 2.5 stability functions
4409  Real SM, SH, SQ;
4410  mynn.calc_stability_funcs(SM,SH,SQ,GM,GH,alphac);
4411 
4412  // Clip SM, SH following WRF
4413  SM = amrex::min(amrex::max(SM,mynn.SMmin), mynn.SMmax);
4414  SH = amrex::min(amrex::max(SH,mynn.SHmin), mynn.SHmax);
4415 
4416  // Finally, compute the eddy viscosity/diffusivities
4417  const Real rho = cell_data(i,j,k,Rho_comp);
4418  K_turb(i,j,k,EddyDiff::Mom_v) = rho * Lm * qvel(i,j,k) * SM;
4419  K_turb(i,j,k,EddyDiff::Theta_v) = rho * Lm * qvel(i,j,k) * SH;
4420  K_turb(i,j,k,EddyDiff::KE_v) = rho * Lm * qvel(i,j,k) * SQ;
4421 
4422  // TODO: implement partial-condensation scheme?
4423  // Currently, implementation matches NN09 without rain (i.e.,
4424  // the liquid water potential temperature is equal to the
4425  // potential temperature.
4426 
4427  // NN09 gives the total water content flux; this assumes that
4428  // all the species have the same eddy diffusivity
4429  if (mynn.diffuse_moistvars) {
4430  K_turb(i,j,k,EddyDiff::Q_v) = rho * Lm * qvel(i,j,k) * SH;
4431  }
4432 
4433  K_turb(i,j,k,EddyDiff::Turb_lengthscale) = Lm;
4434  });
4435  }
4436 }
constexpr amrex::Real KAPPA
Definition: ERF_Constants.H:20
constexpr amrex::Real CONST_GRAV
Definition: ERF_Constants.H:21
#define Rho_comp
Definition: ERF_IndexDefines.H:36
#define RhoKE_comp
Definition: ERF_IndexDefines.H:38
AMREX_GPU_DEVICE AMREX_FORCE_INLINE void ComputeVerticalDerivativesPBL(int i, int j, int k, const amrex::Array4< const amrex::Real > &uvel, const amrex::Array4< const amrex::Real > &vvel, const amrex::Array4< const amrex::Real > &cell_data, const int izmin, const int izmax, const amrex::Real &dz_inv, const bool c_ext_dir_on_zlo, const bool c_ext_dir_on_zhi, const bool u_ext_dir_on_zlo, const bool u_ext_dir_on_zhi, const bool v_ext_dir_on_zlo, const bool v_ext_dir_on_zhi, amrex::Real &dthetadz, amrex::Real &dudz, amrex::Real &dvdz, const int RhoQv_comp, const int RhoQc_comp, const int RhoQr_comp, const bool use_most=true)
Definition: ERF_PBLModels.H:119
AMREX_FORCE_INLINE AMREX_GPU_DEVICE amrex::Real Compute_h_zeta_AtCellCenter(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:46
AMREX_GPU_DEVICE AMREX_FORCE_INLINE amrex::Real Compute_Zrel_AtCellCenter(const int &i, const int &j, const int &k, const amrex::Array4< const amrex::Real > &z_nd)
Definition: ERF_TerrainMetrics.H:359
@ yvel_bc
Definition: ERF_IndexDefines.H:88
@ cons_bc
Definition: ERF_IndexDefines.H:76
@ xvel_bc
Definition: ERF_IndexDefines.H:87
@ ext_dir
Definition: ERF_IndexDefines.H:191
@ Theta_v
Definition: ERF_IndexDefines.H:168
@ Turb_lengthscale
Definition: ERF_IndexDefines.H:172
@ Q_v
Definition: ERF_IndexDefines.H:171
@ Mom_v
Definition: ERF_IndexDefines.H:167
@ KE_v
Definition: ERF_IndexDefines.H:169
@ rho
Definition: ERF_Kessler.H:22
@ qc
Definition: ERF_SatAdj.H:36
@ xvel
Definition: ERF_IndexDefines.H:141
@ yvel
Definition: ERF_IndexDefines.H:142
MYNNLevel25 pbl_mynn
Definition: ERF_TurbStruct.H:242
MYNNLevel2 pbl_mynn_level2
Definition: ERF_TurbStruct.H:243

Referenced by ComputeTurbulentViscosity().

Here is the call graph for this function:
Here is the caller graph for this function: