diff --git a/ERF_8H_source.html b/ERF_8H_source.html index 4e1de6d6a..118690678 100644 --- a/ERF_8H_source.html +++ b/ERF_8H_source.html @@ -1594,7 +1594,7 @@
ERF::regrid_int
int regrid_int
Definition: ERF.H:920
ERF::fixed_dt
amrex::Vector< amrex::Real > fixed_dt
Definition: ERF.H:914
ERF::write_1D_profiles_stag
void write_1D_profiles_stag(amrex::Real time)
Definition: ERF_Write1DProfiles_stag.cpp:23
-
ERF::WriteGenericPlotfileHeaderWithTerrain
void WriteGenericPlotfileHeaderWithTerrain(std::ostream &HeaderFile, int nlevels, const amrex::Vector< amrex::BoxArray > &bArray, const amrex::Vector< std::string > &varnames, const amrex::Vector< amrex::Geometry > &my_geom, amrex::Real time, const amrex::Vector< int > &level_steps, const amrex::Vector< amrex::IntVect > &my_ref_ratio, const std::string &versionName, const std::string &levelPrefix, const std::string &mfPrefix) const
Definition: ERF_Plotfile.cpp:1660
+
ERF::WriteGenericPlotfileHeaderWithTerrain
void WriteGenericPlotfileHeaderWithTerrain(std::ostream &HeaderFile, int nlevels, const amrex::Vector< amrex::BoxArray > &bArray, const amrex::Vector< std::string > &varnames, const amrex::Vector< amrex::Geometry > &my_geom, amrex::Real time, const amrex::Vector< int > &level_steps, const amrex::Vector< amrex::IntVect > &my_ref_ratio, const std::string &versionName, const std::string &levelPrefix, const std::string &mfPrefix) const
Definition: ERF_Plotfile.cpp:1661
ERF::d_sponge_ptrs
amrex::Vector< amrex::Vector< amrex::Gpu::DeviceVector< amrex::Real > > > d_sponge_ptrs
Definition: ERF.H:1109
ERF::h_rhoqt_src
amrex::Vector< amrex::Vector< amrex::Real > > h_rhoqt_src
Definition: ERF.H:1078
ERF::dt_mri_ratio
amrex::Vector< long > dt_mri_ratio
Definition: ERF.H:721
@@ -1651,7 +1651,7 @@
ERF::Tau33_lev
amrex::Vector< std::unique_ptr< amrex::MultiFab > > Tau33_lev
Definition: ERF.H:801
ERF::prob
std::unique_ptr< ProblemBase > prob
Definition: ERF.H:708
ERF::num_files_at_level
amrex::Vector< int > num_files_at_level
Definition: ERF.H:711
-
ERF::WriteMultiLevelPlotfileWithTerrain
void WriteMultiLevelPlotfileWithTerrain(const std::string &plotfilename, int nlevels, const amrex::Vector< const amrex::MultiFab * > &mf, const amrex::Vector< const amrex::MultiFab * > &mf_nd, const amrex::Vector< std::string > &varnames, const amrex::Vector< amrex::Geometry > &my_geom, amrex::Real time, const amrex::Vector< int > &level_steps, const amrex::Vector< amrex::IntVect > &my_ref_ratio, const std::string &versionName="HyperCLaw-V1.1", const std::string &levelPrefix="Level_", const std::string &mfPrefix="Cell", const amrex::Vector< std::string > &extra_dirs=amrex::Vector< std::string >()) const
Definition: ERF_Plotfile.cpp:1573
+
ERF::WriteMultiLevelPlotfileWithTerrain
void WriteMultiLevelPlotfileWithTerrain(const std::string &plotfilename, int nlevels, const amrex::Vector< const amrex::MultiFab * > &mf, const amrex::Vector< const amrex::MultiFab * > &mf_nd, const amrex::Vector< std::string > &varnames, const amrex::Vector< amrex::Geometry > &my_geom, amrex::Real time, const amrex::Vector< int > &level_steps, const amrex::Vector< amrex::IntVect > &my_ref_ratio, const std::string &versionName="HyperCLaw-V1.1", const std::string &levelPrefix="Level_", const std::string &mfPrefix="Cell", const amrex::Vector< std::string > &extra_dirs=amrex::Vector< std::string >()) const
Definition: ERF_Plotfile.cpp:1574
ERF::init_bcs
void init_bcs()
Definition: ERF_init_bcs.cpp:20
ERF::profile_int
int profile_int
Definition: ERF.H:935
ERF::init_immersed_body
void init_immersed_body(int lev, const amrex::BoxArray &ba, const amrex::DistributionMapping &dm)
Definition: ERF_make_new_level.cpp:496
diff --git a/ERF__AdvanceGeneralAD_8cpp.html b/ERF__AdvanceGeneralAD_8cpp.html index 2b41a84ff..314fd9c0d 100644 --- a/ERF__AdvanceGeneralAD_8cpp.html +++ b/ERF__AdvanceGeneralAD_8cpp.html @@ -231,99 +231,99 @@

-
191 {
-
192 
-
193  Real rpm = interpolate_1d(velocity, rotor_RPM, avg_vel, n_spec_extra);
-
194  Real pitch = interpolate_1d(velocity, blade_pitch, avg_vel, n_spec_extra);
-
195 
-
196  Real Omega = rpm/60.0*2.0*PI;
-
197  Real rho = 1.226;
-
198 
-
199  Real B = 3.0;
-
200  Real rhub = 2.0;
-
201  Real rtip = 63.5;
-
202 
-
203  Real twist = interpolate_1d(bld_rad_loc, bld_twist, rad, n_bld_sections);
-
204  Real c = interpolate_1d(bld_rad_loc, bld_chord, rad, n_bld_sections);
-
205 
-
206  // Iteration procedure
-
207 
-
208  Real s = 0.5*c*B/(PI*rad);
-
209 
-
210  Real at, an, V1, Vt, Vr, psi, L, D, Cn, Ct;
-
211  Real ftip, fhub, F, Cl, Cd, at_new, an_new;
-
212 
-
213  at = 0.1;
-
214  an = 0.1;
-
215 
-
216  bool is_converged = false;
-
217 
-
218  for(int i=0;i<100;i++) {
-
219  V1 = avg_vel*(1-an);
-
220  Vt = Omega*(1.0+at)*rad;
-
221  Vr = std::pow(V1*V1+Vt*Vt,0.5);
+
221 {
222 
-
223  psi = std::atan2(V1,Vt);
-
224 
-
225  Real aoa = psi*180.0/PI - twist + pitch;
-
226 
-
227  Cl = interpolate_1d(bld_airfoil_aoa, bld_airfoil_Cl, aoa, n_pts_airfoil);
-
228  Cd = interpolate_1d(bld_airfoil_aoa, bld_airfoil_Cd, aoa, n_pts_airfoil);
-
229 
-
230  //Cl = 1.37;
-
231  //Cd = 0.014;
+
223  Real rpm = interpolate_1d(velocity, rotor_RPM, avg_vel, n_spec_extra);
+
224  Real pitch = interpolate_1d(velocity, blade_pitch, avg_vel, n_spec_extra);
+
225 
+
226  Real Omega = rpm/60.0*2.0*PI;
+
227  Real rho = 1.226;
+
228 
+
229  Real B = 3.0;
+
230  Real rhub = 2.0;
+
231  Real rtip = 63.5;
232 
-
233  //printf("rad, aoa, Cl, Cd = %0.15g %0.15g %0.15g %0.15g\n", rad, aoa, Cl, Cd);
-
234 
-
235  Cn = Cl*std::cos(psi) + Cd*std::sin(psi);
-
236  Ct = Cl*std::sin(psi) - Cd*std::cos(psi);
+
233  Real twist = interpolate_1d(bld_rad_loc, bld_twist, rad, n_bld_sections);
+
234  Real c = interpolate_1d(bld_rad_loc, bld_chord, rad, n_bld_sections);
+
235 
+
236  // Iteration procedure
237 
-
238  ftip = B*(rtip-rad)/(2.0*rad*std::sin(psi)+1e-10);
-
239  fhub = B*(rad-rhub)/(2.0*rad*std::sin(psi)+1e-10);
-
240 
-
241  AMREX_ALWAYS_ASSERT(std::fabs(std::exp(-fhub))<=1.0);
-
242  AMREX_ALWAYS_ASSERT(std::fabs(std::exp(-ftip))<=1.0);
-
243 
-
244  F = 2.0/PI*(std::acos(std::exp(-ftip)) + std::acos(std::exp(-fhub)) );
+
238  Real s = 0.5*c*B/(PI*rad);
+
239 
+
240  Real at, an, V1, Vt, Vr, psi, L, D, Cn, Ct;
+
241  Real ftip, fhub, F, Cl, Cd, at_new, an_new;
+
242 
+
243  at = 0.1;
+
244  an = 0.1;
245 
-
246  at_new = 1.0/ ( 4.0*F*std::sin(psi)*std::cos(psi)/(s*Ct+1e-10) - 1.0 );
-
247  an_new = 1.0/ ( 1.0 + 4.0*F*std::pow(std::sin(psi),2)/(s*Cn + 1e-10) );
-
248  at_new = std::max(0.0, at_new);
-
249 
-
250  if(std::fabs(at_new-at) < 1e-5 and std::fabs(an_new-an) < 1e-5) {
-
251  //printf("Converged at, an = %d %0.15g %0.15g %0.15g\n",i, at, an, psi);
-
252  at = at_new;
-
253  an = an_new;
-
254  is_converged = true;
-
255  break;
-
256  }
-
257  at = at_new;
-
258  an = an_new;
-
259  //printf("Iteration, at, an = %0.15g %0.15g %0.15g\n",at, an, psi);
-
260  }
-
261 
-
262  if(!is_converged) {
-
263  Abort("The iteration procedure for the generalized actuator disk did not converge. Exiting...");
-
264  }
-
265 
-
266  // Iterations converged. Now compute Ft, Fn
+
246  bool is_converged = false;
+
247 
+
248  for(int i=0;i<100;i++) {
+
249  V1 = avg_vel*(1-an);
+
250  Vt = Omega*(1.0+at)*rad;
+
251  Vr = std::pow(V1*V1+Vt*Vt,0.5);
+
252 
+
253  psi = std::atan2(V1,Vt);
+
254 
+
255  Real aoa = psi*180.0/PI - twist + pitch;
+
256 
+
257  Cl = interpolate_1d(bld_airfoil_aoa, bld_airfoil_Cl, aoa, n_pts_airfoil);
+
258  Cd = interpolate_1d(bld_airfoil_aoa, bld_airfoil_Cd, aoa, n_pts_airfoil);
+
259 
+
260  //Cl = 1.37;
+
261  //Cd = 0.014;
+
262 
+
263  //printf("rad, aoa, Cl, Cd = %0.15g %0.15g %0.15g %0.15g\n", rad, aoa, Cl, Cd);
+
264 
+
265  Cn = Cl*std::cos(psi) + Cd*std::sin(psi);
+
266  Ct = Cl*std::sin(psi) - Cd*std::cos(psi);
267 
-
268  L = 0.5*rho*Vr*Vr*c*Cl;
-
269  D = 0.5*rho*Vr*Vr*c*Cd;
+
268  ftip = B*(rtip-rad)/(2.0*rad*std::sin(psi)+1e-10);
+
269  fhub = B*(rad-rhub)/(2.0*rad*std::sin(psi)+1e-10);
270 
-
271  Real Fn = L*std::cos(psi) + D*std::sin(psi);
-
272  Real Ft = L*std::sin(psi) - D*std::cos(psi);
+
271  AMREX_ALWAYS_ASSERT(std::fabs(std::exp(-fhub))<=1.0);
+
272  AMREX_ALWAYS_ASSERT(std::fabs(std::exp(-ftip))<=1.0);
273 
-
274  //printf("Fn and Ft %0.15g %0.15g %0.15g %0.15g\n", L, D, std::cos(psi), std::sin(psi));
+
274  F = 2.0/PI*(std::acos(std::exp(-ftip)) + std::acos(std::exp(-fhub)) );
275 
-
276  std::array<Real, 2> Fn_and_Ft;
-
277  Fn_and_Ft[0] = Fn;
-
278  Fn_and_Ft[1] = Ft;
+
276  at_new = 1.0/ ( 4.0*F*std::sin(psi)*std::cos(psi)/(s*Ct+1e-10) - 1.0 );
+
277  an_new = 1.0/ ( 1.0 + 4.0*F*std::pow(std::sin(psi),2)/(s*Cn + 1e-10) );
+
278  at_new = std::max(0.0, at_new);
279 
-
280  return Fn_and_Ft;
-
281 
-
282  //exit(0);
-
283 }
+
280  if(std::fabs(at_new-at) < 1e-5 and std::fabs(an_new-an) < 1e-5) {
+
281  //printf("Converged at, an = %d %0.15g %0.15g %0.15g\n",i, at, an, psi);
+
282  at = at_new;
+
283  an = an_new;
+
284  is_converged = true;
+
285  break;
+
286  }
+
287  at = at_new;
+
288  an = an_new;
+
289  //printf("Iteration, at, an = %0.15g %0.15g %0.15g\n",at, an, psi);
+
290  }
+
291 
+
292  if(!is_converged) {
+
293  Abort("The iteration procedure for the generalized actuator disk did not converge. Exiting...");
+
294  }
+
295 
+
296  // Iterations converged. Now compute Ft, Fn
+
297 
+
298  L = 0.5*rho*Vr*Vr*c*Cl;
+
299  D = 0.5*rho*Vr*Vr*c*Cd;
+
300 
+
301  Real Fn = L*std::cos(psi) + D*std::sin(psi);
+
302  Real Ft = L*std::sin(psi) - D*std::cos(psi);
+
303 
+
304  //printf("Fn and Ft %0.15g %0.15g %0.15g %0.15g\n", L, D, std::cos(psi), std::sin(psi));
+
305 
+
306  std::array<Real, 2> Fn_and_Ft;
+
307  Fn_and_Ft[0] = Fn;
+
308  Fn_and_Ft[1] = Ft;
+
309 
+
310  return Fn_and_Ft;
+
311 
+
312  //exit(0);
+
313 }
constexpr amrex::Real PI
Definition: ERF_Constants.H:6
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE amrex::Real interpolate_1d(const amrex::Real *alpha, const amrex::Real *beta, const amrex::Real alpha_interp, const int alpha_size)
Definition: ERF_Interpolation_1D.H:12
@@ -382,32 +382,32 @@

-
147 {
-
148  // Find the index of the radial location
-
149  int index=-1;
-
150  Real rhub = 2.0;
-
151  Real rad_from_hub = rad - rhub;
-
152  if(rad_from_hub < 0.0) {
-
153  index = 0;
-
154  }
-
155  else {
-
156  for(int i=0;i<n_bld_sections;i++){
-
157  if(bld_rad_loc[i] > rad) {
-
158  index = i;
-
159  break;
-
160  }
-
161  }
-
162  }
-
163  if(index == -1 and rad > bld_rad_loc[n_bld_sections-1]) {
-
164  index = n_bld_sections-1;
-
165  }
-
166  if(index == -1) {
-
167  //printf("The radial section is at %0.15g m\n",rad);
-
168  Abort("Could not find index of the radial section.");
-
169  }
-
170 
-
171  return index;
-
172 }
+
177 {
+
178  // Find the index of the radial location
+
179  int index=-1;
+
180  Real rhub = 2.0;
+
181  Real rad_from_hub = rad - rhub;
+
182  if(rad_from_hub < 0.0) {
+
183  index = 0;
+
184  }
+
185  else {
+
186  for(int i=0;i<n_bld_sections;i++){
+
187  if(bld_rad_loc[i] > rad) {
+
188  index = i;
+
189  break;
+
190  }
+
191  }
+
192  }
+
193  if(index == -1 and rad > bld_rad_loc[n_bld_sections-1]) {
+
194  index = n_bld_sections-1;
+
195  }
+
196  if(index == -1) {
+
197  //printf("The radial section is at %0.15g m\n",rad);
+
198  Abort("Could not find index of the radial section.");
+
199  }
+
200 
+
201  return index;
+
202 }

Referenced by GeneralAD::source_terms_cellcentered().

diff --git a/ERF__EWP_8H_source.html b/ERF__EWP_8H_source.html index 0b653b9de..028f5eb8a 100644 --- a/ERF__EWP_8H_source.html +++ b/ERF__EWP_8H_source.html @@ -123,33 +123,43 @@
35 
36  void update (const amrex::Real& dt_advance,
37  amrex::MultiFab& cons_in,
-
38  amrex::MultiFab& U_old, amrex::MultiFab& V_old,
-
39  const amrex::MultiFab& mf_vars_ewp);
-
40 
-
41 protected:
-
42  amrex::Vector<amrex::Real> xloc, yloc;
- -
44  amrex::Vector<amrex::Real> wind_speed, thrust_coeff, power;
-
45 };
-
46 
-
47 #endif
-
48 
+
38  amrex::MultiFab& U_old,
+
39  amrex::MultiFab& V_old,
+
40  const amrex::MultiFab& mf_vars_ewp);
+
41 
+
42  void compute_power_output (const amrex::MultiFab& cons_in,
+
43  const amrex::MultiFab& U_old,
+
44  const amrex::MultiFab& V_old,
+
45  const amrex::MultiFab& W_old,
+
46  const amrex::MultiFab& mf_SMark,
+
47  const amrex::MultiFab& mf_Nturb,
+
48  const amrex::Real& time);
+
49 
+
50 protected:
+
51  amrex::Vector<amrex::Real> xloc, yloc;
+ +
53  amrex::Vector<amrex::Real> wind_speed, thrust_coeff, power;
+
54 };
+
55 
+
56 #endif
+
57 
Definition: ERF_EWP.H:9
-
amrex::Real nominal_power
Definition: ERF_EWP.H:43
-
amrex::Real thrust_coeff_standing
Definition: ERF_EWP.H:43
-
amrex::Real hub_height
Definition: ERF_EWP.H:43
-
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_EWP.H:44
+
amrex::Real nominal_power
Definition: ERF_EWP.H:52
+
amrex::Real thrust_coeff_standing
Definition: ERF_EWP.H:52
+
amrex::Real hub_height
Definition: ERF_EWP.H:52
+
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_EWP.H:53
EWP()
Definition: ERF_EWP.H:13
-
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb)
Definition: ERF_AdvanceEWP.cpp:62
+
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb)
Definition: ERF_AdvanceEWP.cpp:128
void advance(const amrex::Geometry &geom, const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars_ewp, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb, const amrex::MultiFab &mf_SMark, const amrex::Real &time) override
Definition: ERF_AdvanceEWP.cpp:9
-
amrex::Vector< amrex::Real > xloc
Definition: ERF_EWP.H:42
-
void update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, const amrex::MultiFab &mf_vars_ewp)
Definition: ERF_AdvanceEWP.cpp:28
-
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_EWP.H:44
-
amrex::Vector< amrex::Real > power
Definition: ERF_EWP.H:44
-
amrex::Real rotor_rad
Definition: ERF_EWP.H:43
+
amrex::Vector< amrex::Real > xloc
Definition: ERF_EWP.H:51
+
void update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, const amrex::MultiFab &mf_vars_ewp)
Definition: ERF_AdvanceEWP.cpp:94
+
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_EWP.H:53
+
amrex::Vector< amrex::Real > power
Definition: ERF_EWP.H:53
+
amrex::Real rotor_rad
Definition: ERF_EWP.H:52
virtual ~EWP()=default
-
amrex::Vector< amrex::Real > yloc
Definition: ERF_EWP.H:42
+
amrex::Vector< amrex::Real > yloc
Definition: ERF_EWP.H:51
+
void compute_power_output(const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_SMark, const amrex::MultiFab &mf_Nturb, const amrex::Real &time)
Definition: ERF_AdvanceEWP.cpp:29
Definition: ERF_NullWindFarm.H:9

diff --git a/ERF__Fitch_8H_source.html b/ERF__Fitch_8H_source.html index bf8138ca7..96cad7d80 100644 --- a/ERF__Fitch_8H_source.html +++ b/ERF__Fitch_8H_source.html @@ -126,30 +126,40 @@
38  amrex::MultiFab& U_old, amrex::MultiFab& V_old,
39  const amrex::MultiFab& mf_vars_fitch);
40 
-
41 protected:
-
42  amrex::Vector<amrex::Real> xloc, yloc;
- -
44  amrex::Vector<amrex::Real> wind_speed, thrust_coeff, power;
-
45 };
-
46 
-
47 #endif
-
48 
+
41  void compute_power_output (const amrex::MultiFab& cons_in,
+
42  const amrex::MultiFab& U_old,
+
43  const amrex::MultiFab& V_old,
+
44  const amrex::MultiFab& mf_SMark,
+
45  const amrex::MultiFab& mf_Nturb,
+
46  const amrex::Real& time);
+
47 
+
48 protected:
+
49  amrex::Vector<amrex::Real> hub_height_velocity;
+
50  amrex::Vector<amrex::Real> xloc, yloc;
+ +
52  amrex::Vector<amrex::Real> wind_speed, thrust_coeff, power;
+
53 };
+
54 
+
55 #endif
+
56 
Definition: ERF_Fitch.H:9
void update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, const amrex::MultiFab &mf_vars_fitch)
Definition: ERF_AdvanceFitch.cpp:68
-
amrex::Vector< amrex::Real > yloc
Definition: ERF_Fitch.H:42
+
void compute_power_output(const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &mf_SMark, const amrex::MultiFab &mf_Nturb, const amrex::Real &time)
Definition: ERF_AdvanceFitch.cpp:102
+
amrex::Vector< amrex::Real > yloc
Definition: ERF_Fitch.H:50
Fitch()
Definition: ERF_Fitch.H:13
-
amrex::Vector< amrex::Real > xloc
Definition: ERF_Fitch.H:42
-
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_Fitch.H:44
-
amrex::Vector< amrex::Real > power
Definition: ERF_Fitch.H:44
+
amrex::Vector< amrex::Real > xloc
Definition: ERF_Fitch.H:50
+
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_Fitch.H:52
+
amrex::Vector< amrex::Real > power
Definition: ERF_Fitch.H:52
void advance(const amrex::Geometry &geom, const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars_fitch, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb, const amrex::MultiFab &mf_SMark, const amrex::Real &time) override
Definition: ERF_AdvanceFitch.cpp:48
-
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars_ewp, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb)
Definition: ERF_AdvanceFitch.cpp:102
-
amrex::Real rotor_rad
Definition: ERF_Fitch.H:43
-
amrex::Real thrust_coeff_standing
Definition: ERF_Fitch.H:43
-
amrex::Real hub_height
Definition: ERF_Fitch.H:43
-
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_Fitch.H:44
+
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars_ewp, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb)
Definition: ERF_AdvanceFitch.cpp:163
+
amrex::Real rotor_rad
Definition: ERF_Fitch.H:51
+
amrex::Real thrust_coeff_standing
Definition: ERF_Fitch.H:51
+
amrex::Real hub_height
Definition: ERF_Fitch.H:51
+
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_Fitch.H:52
+
amrex::Vector< amrex::Real > hub_height_velocity
Definition: ERF_Fitch.H:49
virtual ~Fitch()=default
-
amrex::Real nominal_power
Definition: ERF_Fitch.H:43
+
amrex::Real nominal_power
Definition: ERF_Fitch.H:51
Definition: ERF_NullWindFarm.H:9
diff --git a/ERF__GeneralAD_8H_source.html b/ERF__GeneralAD_8H_source.html index 69e92be72..a7af5b56b 100644 --- a/ERF__GeneralAD_8H_source.html +++ b/ERF__GeneralAD_8H_source.html @@ -129,51 +129,54 @@
41  amrex::MultiFab& W_old,
42  const amrex::MultiFab& mf_vars);
43 
-
44 protected:
-
45  amrex::Vector<amrex::Real> xloc, yloc;
-
46  amrex::Real turb_disk_angle;
- -
48  amrex::Vector<amrex::Real> wind_speed, thrust_coeff, power;
-
49  amrex::Vector<amrex::Real> freestream_velocity, freestream_phi, disk_cell_count;
-
50  amrex::Vector<amrex::Real> bld_rad_loc, bld_twist, bld_chord;
-
51  amrex::Vector<amrex::Vector<amrex::Real>> bld_airfoil_aoa, bld_airfoil_Cl, bld_airfoil_Cd;
-
52  amrex::Vector<amrex::Real> velocity, C_P, C_T, rotor_RPM, blade_pitch;
-
53 };
-
54 
-
55 #endif
+
44  void compute_power_output (const amrex::Real& time);
+
45 
+
46 protected:
+
47  amrex::Vector<amrex::Real> xloc, yloc;
+
48  amrex::Real turb_disk_angle;
+ +
50  amrex::Vector<amrex::Real> wind_speed, thrust_coeff, power;
+
51  amrex::Vector<amrex::Real> freestream_velocity, freestream_phi, disk_cell_count;
+
52  amrex::Vector<amrex::Real> bld_rad_loc, bld_twist, bld_chord;
+
53  amrex::Vector<amrex::Vector<amrex::Real>> bld_airfoil_aoa, bld_airfoil_Cl, bld_airfoil_Cd;
+
54  amrex::Vector<amrex::Real> velocity, C_P, C_T, rotor_RPM, blade_pitch;
+
55 };
56 
+
57 #endif
+
58 
Definition: ERF_GeneralAD.H:8
-
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_GeneralAD.H:48
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cl
Definition: ERF_GeneralAD.H:51
-
amrex::Vector< amrex::Real > power
Definition: ERF_GeneralAD.H:48
-
amrex::Vector< amrex::Real > freestream_velocity
Definition: ERF_GeneralAD.H:49
-
void update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_vars)
Definition: ERF_AdvanceGeneralAD.cpp:30
-
amrex::Vector< amrex::Real > xloc
Definition: ERF_GeneralAD.H:45
-
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_GeneralAD.H:48
-
amrex::Vector< amrex::Real > disk_cell_count
Definition: ERF_GeneralAD.H:49
-
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, const amrex::MultiFab &mf_Smark, amrex::MultiFab &mf_vars_generalAD)
Definition: ERF_AdvanceGeneralAD.cpp:287
-
amrex::Real rotor_rad
Definition: ERF_GeneralAD.H:47
-
amrex::Vector< amrex::Real > velocity
Definition: ERF_GeneralAD.H:52
-
amrex::Vector< amrex::Real > blade_pitch
Definition: ERF_GeneralAD.H:52
-
amrex::Vector< amrex::Real > C_P
Definition: ERF_GeneralAD.H:52
-
amrex::Vector< amrex::Real > bld_twist
Definition: ERF_GeneralAD.H:50
+
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_GeneralAD.H:50
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cl
Definition: ERF_GeneralAD.H:53
+
amrex::Vector< amrex::Real > power
Definition: ERF_GeneralAD.H:50
+
amrex::Vector< amrex::Real > freestream_velocity
Definition: ERF_GeneralAD.H:51
+
void update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_vars)
Definition: ERF_AdvanceGeneralAD.cpp:60
+
amrex::Vector< amrex::Real > xloc
Definition: ERF_GeneralAD.H:47
+
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_GeneralAD.H:50
+
amrex::Vector< amrex::Real > disk_cell_count
Definition: ERF_GeneralAD.H:51
+
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, const amrex::MultiFab &mf_Smark, amrex::MultiFab &mf_vars_generalAD)
Definition: ERF_AdvanceGeneralAD.cpp:317
+
amrex::Real rotor_rad
Definition: ERF_GeneralAD.H:49
+
amrex::Vector< amrex::Real > velocity
Definition: ERF_GeneralAD.H:54
+
amrex::Vector< amrex::Real > blade_pitch
Definition: ERF_GeneralAD.H:54
+
amrex::Vector< amrex::Real > C_P
Definition: ERF_GeneralAD.H:54
+
amrex::Vector< amrex::Real > bld_twist
Definition: ERF_GeneralAD.H:52
GeneralAD()
Definition: ERF_GeneralAD.H:12
void advance(const amrex::Geometry &geom, const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars_windfarm, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb, const amrex::MultiFab &mf_SMark, const amrex::Real &time) override
Definition: ERF_AdvanceGeneralAD.cpp:9
-
void compute_freestream_velocity(const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &mf_SMark)
Definition: ERF_AdvanceGeneralAD.cpp:66
-
amrex::Vector< amrex::Real > bld_chord
Definition: ERF_GeneralAD.H:50
-
amrex::Vector< amrex::Real > bld_rad_loc
Definition: ERF_GeneralAD.H:50
+
void compute_freestream_velocity(const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &mf_SMark)
Definition: ERF_AdvanceGeneralAD.cpp:96
+
amrex::Vector< amrex::Real > bld_chord
Definition: ERF_GeneralAD.H:52
+
amrex::Vector< amrex::Real > bld_rad_loc
Definition: ERF_GeneralAD.H:52
virtual ~GeneralAD()=default
-
amrex::Real hub_height
Definition: ERF_GeneralAD.H:47
-
amrex::Vector< amrex::Real > freestream_phi
Definition: ERF_GeneralAD.H:49
-
amrex::Real turb_disk_angle
Definition: ERF_GeneralAD.H:46
-
amrex::Vector< amrex::Real > yloc
Definition: ERF_GeneralAD.H:45
-
amrex::Real thrust_coeff_standing
Definition: ERF_GeneralAD.H:47
-
amrex::Vector< amrex::Real > C_T
Definition: ERF_GeneralAD.H:52
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_aoa
Definition: ERF_GeneralAD.H:51
-
amrex::Real nominal_power
Definition: ERF_GeneralAD.H:47
-
amrex::Vector< amrex::Real > rotor_RPM
Definition: ERF_GeneralAD.H:52
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cd
Definition: ERF_GeneralAD.H:51
+
amrex::Real hub_height
Definition: ERF_GeneralAD.H:49
+
amrex::Vector< amrex::Real > freestream_phi
Definition: ERF_GeneralAD.H:51
+
amrex::Real turb_disk_angle
Definition: ERF_GeneralAD.H:48
+
amrex::Vector< amrex::Real > yloc
Definition: ERF_GeneralAD.H:47
+
amrex::Real thrust_coeff_standing
Definition: ERF_GeneralAD.H:49
+
amrex::Vector< amrex::Real > C_T
Definition: ERF_GeneralAD.H:54
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_aoa
Definition: ERF_GeneralAD.H:53
+
amrex::Real nominal_power
Definition: ERF_GeneralAD.H:49
+
amrex::Vector< amrex::Real > rotor_RPM
Definition: ERF_GeneralAD.H:54
+
void compute_power_output(const amrex::Real &time)
Definition: ERF_AdvanceGeneralAD.cpp:31
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cd
Definition: ERF_GeneralAD.H:53
Definition: ERF_NullWindFarm.H:9
diff --git a/ERF__Interpolation__1D_8H.html b/ERF__Interpolation__1D_8H.html index dfd44fc30..be6d9dd00 100644 --- a/ERF__Interpolation__1D_8H.html +++ b/ERF__Interpolation__1D_8H.html @@ -345,29 +345,32 @@

70 } -

Referenced by SimpleAD::compute_power_output(), compute_source_terms_Fn_Ft(), init_bx_scalars_from_input_sounding(), init_bx_scalars_from_input_sounding_hse(), init_bx_velocities_from_input_sounding(), ERF::init_Dirichlet_bc_data(), ERF::init_geo_wind_profile(), InputSpongeData::read_from_file(), InputSoundingData::read_from_file(), ERF::setRayleighRefFromSounding(), ERF::setSpongeRefFromSounding(), EWP::source_terms_cellcentered(), Fitch::source_terms_cellcentered(), and SimpleAD::source_terms_cellcentered().

+

Referenced by Fitch::compute_power_output(), EWP::compute_power_output(), GeneralAD::compute_power_output(), SimpleAD::compute_power_output(), compute_source_terms_Fn_Ft(), init_bx_scalars_from_input_sounding(), init_bx_scalars_from_input_sounding_hse(), init_bx_velocities_from_input_sounding(), ERF::init_Dirichlet_bc_data(), ERF::init_geo_wind_profile(), InputSpongeData::read_from_file(), InputSoundingData::read_from_file(), ERF::setRayleighRefFromSounding(), ERF::setSpongeRefFromSounding(), EWP::source_terms_cellcentered(), Fitch::source_terms_cellcentered(), and SimpleAD::source_terms_cellcentered().

Here is the caller graph for this function:
- - - - - - - - - - - - - - - - - + + + + + + + + + + + + + + + + + + + +
diff --git a/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.map b/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.map index 2c3c605ae..0e51e6da9 100644 --- a/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.map +++ b/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.map @@ -1,19 +1,22 @@ - - - - - - - - - - - - - - - - - + + + + + + + + + + + + + + + + + + + + diff --git a/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.md5 b/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.md5 index 91cd0ea69..ecc5f4099 100644 --- a/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.md5 +++ b/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.md5 @@ -1 +1 @@ -514fa139c14378dbd5eb4a81421d89b7 \ No newline at end of file +110cd485be5629689ca1c03919eff27c \ No newline at end of file diff --git a/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.png b/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.png index 0a3b9e26c..a2b1865f8 100644 Binary files a/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.png and b/ERF__Interpolation__1D_8H_a803d0d35d4ca4791556cbe02bbf51cbb_icgraph.png differ diff --git a/ERF__WindFarm_8H_source.html b/ERF__WindFarm_8H_source.html index cc0759319..71383b274 100644 --- a/ERF__WindFarm_8H_source.html +++ b/ERF__WindFarm_8H_source.html @@ -158,9 +158,9 @@
70 
71  void read_windfarm_spec_table_extra (const std::string windfarm_spec_table_extra);
72 
-
73  void fill_Nturb_multifab (const amrex::Geometry& geom,
+
73  void fill_Nturb_multifab (const amrex::Geometry& geom,
74  amrex::MultiFab& mf_Nturb,
-
75  std::unique_ptr<amrex::MultiFab>& z_phys_cc);
+
75  std::unique_ptr<amrex::MultiFab>& z_phys_nd);
76 
77  void fill_SMark_multifab (const amrex::Geometry& geom,
78  amrex::MultiFab& mf_SMark,
@@ -168,99 +168,104 @@
80  const amrex::Real& turb_disk_angle,
81  std::unique_ptr<amrex::MultiFab>& z_phys_cc);
82 
- -
84 
-
85  void write_actuator_disks_vtk (const amrex::Geometry& geom,
-
86  const amrex::Real& sampling_distance_by_D);
+
83  void fill_SMark_multifab_mesoscale_models (const amrex::Geometry& geom,
+
84  amrex::MultiFab& mf_SMark,
+
85  const amrex::MultiFab& mf_Nturb,
+
86  std::unique_ptr<amrex::MultiFab>& z_phys_cc);
87 
-
88  void gatherKeyValuePairs(const std::vector<std::pair<int, double>>& localData,
-
89  std::vector<std::pair<int, double>>& globalData);
-
90 
-
91  void advance (const amrex::Geometry& a_geom,
-
92  const amrex::Real& dt_advance,
-
93  amrex::MultiFab& cons_in,
-
94  amrex::MultiFab& mf_vars_windfarm,
-
95  amrex::MultiFab& U_old,
-
96  amrex::MultiFab& V_old,
-
97  amrex::MultiFab& W_old,
-
98  const amrex::MultiFab& mf_Nturb,
-
99  const amrex::MultiFab& mf_SMark,
-
100  const amrex::Real& time) override
-
101  {
-
102  m_windfarm_model[0]->advance(a_geom, dt_advance, cons_in, mf_vars_windfarm,
-
103  U_old, V_old, W_old, mf_Nturb, mf_SMark, time);
-
104  }
-
105 
-
106  void set_turb_spec (const amrex::Real& a_rotor_rad, const amrex::Real& a_hub_height,
-
107  const amrex::Real& a_thrust_coeff_standing, const amrex::Vector<amrex::Real>& a_wind_speed,
-
108  const amrex::Vector<amrex::Real>& a_thrust_coeff,
-
109  const amrex::Vector<amrex::Real>& a_power) override
-
110  {
-
111  m_windfarm_model[0]->set_turb_spec(a_rotor_rad, a_hub_height, a_thrust_coeff_standing,
-
112  a_wind_speed, a_thrust_coeff, a_power);
-
113  }
-
114 
-
115  void set_turb_loc (const amrex::Vector<amrex::Real>& a_xloc,
-
116  const amrex::Vector<amrex::Real>& a_yloc) override
-
117  {
-
118  m_windfarm_model[0]->set_turb_loc(a_xloc, a_yloc);
-
119  }
-
120 
-
121  void set_turb_disk_angle (const amrex::Real& a_turb_disk_angle) override
+ +
89 
+
90  void write_actuator_disks_vtk (const amrex::Geometry& geom,
+
91  const amrex::Real& sampling_distance_by_D);
+
92 
+
93  void gatherKeyValuePairs(const std::vector<std::pair<int, double>>& localData,
+
94  std::vector<std::pair<int, double>>& globalData);
+
95 
+
96  void advance (const amrex::Geometry& a_geom,
+
97  const amrex::Real& dt_advance,
+
98  amrex::MultiFab& cons_in,
+
99  amrex::MultiFab& mf_vars_windfarm,
+
100  amrex::MultiFab& U_old,
+
101  amrex::MultiFab& V_old,
+
102  amrex::MultiFab& W_old,
+
103  const amrex::MultiFab& mf_Nturb,
+
104  const amrex::MultiFab& mf_SMark,
+
105  const amrex::Real& time) override
+
106  {
+
107  m_windfarm_model[0]->advance(a_geom, dt_advance, cons_in, mf_vars_windfarm,
+
108  U_old, V_old, W_old, mf_Nturb, mf_SMark, time);
+
109  }
+
110 
+
111  void set_turb_spec (const amrex::Real& a_rotor_rad, const amrex::Real& a_hub_height,
+
112  const amrex::Real& a_thrust_coeff_standing, const amrex::Vector<amrex::Real>& a_wind_speed,
+
113  const amrex::Vector<amrex::Real>& a_thrust_coeff,
+
114  const amrex::Vector<amrex::Real>& a_power) override
+
115  {
+
116  m_windfarm_model[0]->set_turb_spec(a_rotor_rad, a_hub_height, a_thrust_coeff_standing,
+
117  a_wind_speed, a_thrust_coeff, a_power);
+
118  }
+
119 
+
120  void set_turb_loc (const amrex::Vector<amrex::Real>& a_xloc,
+
121  const amrex::Vector<amrex::Real>& a_yloc) override
122  {
-
123  m_windfarm_model[0]->set_turb_disk_angle(a_turb_disk_angle);
+
123  m_windfarm_model[0]->set_turb_loc(a_xloc, a_yloc);
124  }
125 
-
126  void set_blade_spec (const amrex::Vector<amrex::Real>& a_bld_rad_loc,
-
127  const amrex::Vector<amrex::Real>& a_bld_twist,
-
128  const amrex::Vector<amrex::Real>& a_bld_chord) override
-
129  {
-
130  m_windfarm_model[0]->set_blade_spec(a_bld_rad_loc, a_bld_twist, a_bld_chord);
-
131  }
-
132 
-
133  void set_blade_airfoil_spec (const amrex::Vector<amrex::Vector<amrex::Real>>& a_bld_airfoil_aoa,
-
134  const amrex::Vector<amrex::Vector<amrex::Real>>& a_bld_airfoil_Cl,
-
135  const amrex::Vector<amrex::Vector<amrex::Real>>& a_bld_airfoil_Cd) override
-
136  {
-
137  m_windfarm_model[0]->set_blade_airfoil_spec(a_bld_airfoil_aoa, a_bld_airfoil_Cl, a_bld_airfoil_Cd);
-
138  }
-
139 
-
140  void set_turb_spec_extra (const amrex::Vector<amrex::Real>& a_velocity,
-
141  const amrex::Vector<amrex::Real>& a_C_P,
-
142  const amrex::Vector<amrex::Real>& a_C_T,
-
143  const amrex::Vector<amrex::Real>& a_rotor_RPM,
-
144  const amrex::Vector<amrex::Real>& a_blade_pitch) override
-
145  {
-
146  m_windfarm_model[0]->set_turb_spec_extra(a_velocity, a_C_P, a_C_T, a_rotor_RPM, a_blade_pitch);
-
147  }
-
148 
-
149 protected:
-
150 
-
151  amrex::Vector<amrex::Real> xloc, yloc, zloc;
-
152  amrex::Vector<int> turb_index;
-
153  amrex::Real my_turb_disk_angle;
- -
155  amrex::Vector<amrex::Real> wind_speed, thrust_coeff, power;
-
156  amrex::Vector<amrex::Real> bld_rad_loc, bld_twist, bld_chord;
-
157  amrex::Vector<amrex::Vector<amrex::Real>> bld_airfoil_aoa, bld_airfoil_Cl, bld_airfoil_Cd;
- -
159  amrex::Vector<amrex::Real> velocity, C_P, C_T, rotor_RPM, blade_pitch;
-
160 
-
161  /*! \brief Create and set the specified windfarm model */
-
162  template<class NewWindFarmModel>
-
163  void SetModel ()
-
164  {
-
165  for (int lev(0); lev<m_windfarm_model.size(); ++lev) {
-
166  m_windfarm_model[lev] = std::make_unique<NewWindFarmModel>();
-
167  }
-
168  }
-
169 
-
170 private:
-
171  amrex::Vector<std::unique_ptr<NullWindFarm>> m_windfarm_model; /*!< windfarm model */
-
172 };
-
173 
-
174 #endif
-
175 
+
126  void set_turb_disk_angle (const amrex::Real& a_turb_disk_angle) override
+
127  {
+
128  m_windfarm_model[0]->set_turb_disk_angle(a_turb_disk_angle);
+
129  }
+
130 
+
131  void set_blade_spec (const amrex::Vector<amrex::Real>& a_bld_rad_loc,
+
132  const amrex::Vector<amrex::Real>& a_bld_twist,
+
133  const amrex::Vector<amrex::Real>& a_bld_chord) override
+
134  {
+
135  m_windfarm_model[0]->set_blade_spec(a_bld_rad_loc, a_bld_twist, a_bld_chord);
+
136  }
+
137 
+
138  void set_blade_airfoil_spec (const amrex::Vector<amrex::Vector<amrex::Real>>& a_bld_airfoil_aoa,
+
139  const amrex::Vector<amrex::Vector<amrex::Real>>& a_bld_airfoil_Cl,
+
140  const amrex::Vector<amrex::Vector<amrex::Real>>& a_bld_airfoil_Cd) override
+
141  {
+
142  m_windfarm_model[0]->set_blade_airfoil_spec(a_bld_airfoil_aoa, a_bld_airfoil_Cl, a_bld_airfoil_Cd);
+
143  }
+
144 
+
145  void set_turb_spec_extra (const amrex::Vector<amrex::Real>& a_velocity,
+
146  const amrex::Vector<amrex::Real>& a_C_P,
+
147  const amrex::Vector<amrex::Real>& a_C_T,
+
148  const amrex::Vector<amrex::Real>& a_rotor_RPM,
+
149  const amrex::Vector<amrex::Real>& a_blade_pitch) override
+
150  {
+
151  m_windfarm_model[0]->set_turb_spec_extra(a_velocity, a_C_P, a_C_T, a_rotor_RPM, a_blade_pitch);
+
152  }
+
153 
+
154 protected:
+
155 
+
156  amrex::Vector<amrex::Real> xloc, yloc, zloc;
+
157  amrex::Vector<int> turb_index;
+
158  amrex::Real my_turb_disk_angle;
+ +
160  amrex::Vector<amrex::Real> wind_speed, thrust_coeff, power;
+
161  amrex::Vector<amrex::Real> bld_rad_loc, bld_twist, bld_chord;
+
162  amrex::Vector<amrex::Vector<amrex::Real>> bld_airfoil_aoa, bld_airfoil_Cl, bld_airfoil_Cd;
+ +
164  amrex::Vector<amrex::Real> velocity, C_P, C_T, rotor_RPM, blade_pitch;
+
165 
+
166  /*! \brief Create and set the specified windfarm model */
+
167  template<class NewWindFarmModel>
+
168  void SetModel ()
+
169  {
+
170  for (int lev(0); lev<m_windfarm_model.size(); ++lev) {
+
171  m_windfarm_model[lev] = std::make_unique<NewWindFarmModel>();
+
172  }
+
173  }
+
174 
+
175 private:
+
176  amrex::Vector<std::unique_ptr<NullWindFarm>> m_windfarm_model; /*!< windfarm model */
+
177 };
+
178 
+
179 #endif
+
180 
@@ -269,55 +274,56 @@
Definition: ERF_NullWindFarm.H:9
Definition: ERF_WindFarm.H:14
-
amrex::Real my_turb_disk_angle
Definition: ERF_WindFarm.H:153
-
amrex::Vector< amrex::Real > yloc
Definition: ERF_WindFarm.H:151
+
amrex::Real my_turb_disk_angle
Definition: ERF_WindFarm.H:158
+
amrex::Vector< amrex::Real > yloc
Definition: ERF_WindFarm.H:156
virtual ~WindFarm()=default
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cl
Definition: ERF_WindFarm.H:157
-
void advance(const amrex::Geometry &a_geom, const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars_windfarm, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb, const amrex::MultiFab &mf_SMark, const amrex::Real &time) override
Definition: ERF_WindFarm.H:91
-
amrex::Vector< amrex::Real > blade_pitch
Definition: ERF_WindFarm.H:159
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cl
Definition: ERF_WindFarm.H:162
+
void advance(const amrex::Geometry &a_geom, const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars_windfarm, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb, const amrex::MultiFab &mf_SMark, const amrex::Real &time) override
Definition: ERF_WindFarm.H:96
+
amrex::Vector< amrex::Real > blade_pitch
Definition: ERF_WindFarm.H:164
WindFarm()
Definition: ERF_WindFarm.H:18
void read_windfarm_locations_table(const std::string windfarm_loc_table, bool x_y, bool lat_lon, const amrex::Real windfarm_x_shift=0.0, const amrex::Real windfarm_y_shift=0.0)
Definition: ERF_InitWindFarm.cpp:35
-
void set_turb_spec_extra(const amrex::Vector< amrex::Real > &a_velocity, const amrex::Vector< amrex::Real > &a_C_P, const amrex::Vector< amrex::Real > &a_C_T, const amrex::Vector< amrex::Real > &a_rotor_RPM, const amrex::Vector< amrex::Real > &a_blade_pitch) override
Definition: ERF_WindFarm.H:140
+
void set_turb_spec_extra(const amrex::Vector< amrex::Real > &a_velocity, const amrex::Vector< amrex::Real > &a_C_P, const amrex::Vector< amrex::Real > &a_C_T, const amrex::Vector< amrex::Real > &a_rotor_RPM, const amrex::Vector< amrex::Real > &a_blade_pitch) override
Definition: ERF_WindFarm.H:145
void read_tables(std::string windfarm_loc_table, std::string windfarm_spec_table, bool x_y, bool lat_lon, const amrex::Real windfarm_x_shift=0.0, const amrex::Real windfarm_y_shift=0.0)
Definition: ERF_InitWindFarm.cpp:19
void read_windfarm_spec_table_extra(const std::string windfarm_spec_table_extra)
Definition: ERF_InitWindFarm.cpp:235
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_aoa
Definition: ERF_WindFarm.H:157
-
amrex::Vector< amrex::Real > velocity
Definition: ERF_WindFarm.H:159
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_aoa
Definition: ERF_WindFarm.H:162
+
amrex::Vector< amrex::Real > velocity
Definition: ERF_WindFarm.H:164
void read_windfarm_blade_table(const std::string windfarm_blade_table)
Definition: ERF_InitWindFarm.cpp:202
-
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_WindFarm.H:155
-
void set_turb_loc(const amrex::Vector< amrex::Real > &a_xloc, const amrex::Vector< amrex::Real > &a_yloc) override
Definition: ERF_WindFarm.H:115
-
void set_blade_spec(const amrex::Vector< amrex::Real > &a_bld_rad_loc, const amrex::Vector< amrex::Real > &a_bld_twist, const amrex::Vector< amrex::Real > &a_bld_chord) override
Definition: ERF_WindFarm.H:126
-
void SetModel()
Create and set the specified windfarm model.
Definition: ERF_WindFarm.H:163
-
amrex::Vector< amrex::Real > C_P
Definition: ERF_WindFarm.H:159
-
amrex::Real hub_height
Definition: ERF_WindFarm.H:154
-
amrex::Vector< amrex::Real > zloc
Definition: ERF_WindFarm.H:151
-
amrex::Vector< amrex::Real > bld_twist
Definition: ERF_WindFarm.H:156
-
void write_actuator_disks_vtk(const amrex::Geometry &geom, const amrex::Real &sampling_distance_by_D)
Definition: ERF_InitWindFarm.cpp:639
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cd
Definition: ERF_WindFarm.H:157
-
amrex::Vector< amrex::Real > C_T
Definition: ERF_WindFarm.H:159
-
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_WindFarm.H:155
+
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_WindFarm.H:160
+
void set_turb_loc(const amrex::Vector< amrex::Real > &a_xloc, const amrex::Vector< amrex::Real > &a_yloc) override
Definition: ERF_WindFarm.H:120
+
void set_blade_spec(const amrex::Vector< amrex::Real > &a_bld_rad_loc, const amrex::Vector< amrex::Real > &a_bld_twist, const amrex::Vector< amrex::Real > &a_bld_chord) override
Definition: ERF_WindFarm.H:131
+
void SetModel()
Create and set the specified windfarm model.
Definition: ERF_WindFarm.H:168
+
amrex::Vector< amrex::Real > C_P
Definition: ERF_WindFarm.H:164
+
amrex::Real hub_height
Definition: ERF_WindFarm.H:159
+
amrex::Vector< amrex::Real > zloc
Definition: ERF_WindFarm.H:156
+
amrex::Vector< amrex::Real > bld_twist
Definition: ERF_WindFarm.H:161
+
void fill_SMark_multifab_mesoscale_models(const amrex::Geometry &geom, amrex::MultiFab &mf_SMark, const amrex::MultiFab &mf_Nturb, std::unique_ptr< amrex::MultiFab > &z_phys_cc)
Definition: ERF_InitWindFarm.cpp:516
+
void write_actuator_disks_vtk(const amrex::Geometry &geom, const amrex::Real &sampling_distance_by_D)
Definition: ERF_InitWindFarm.cpp:691
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cd
Definition: ERF_WindFarm.H:162
+
amrex::Vector< amrex::Real > C_T
Definition: ERF_WindFarm.H:164
+
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_WindFarm.H:160
void read_windfarm_spec_table(const std::string windfarm_spec_table)
Definition: ERF_InitWindFarm.cpp:154
-
int n_bld_sections
Definition: ERF_WindFarm.H:158
+
int n_bld_sections
Definition: ERF_WindFarm.H:163
WindFarm(int nlev, const WindFarmType &a_windfarm_type)
Definition: ERF_WindFarm.H:22
-
amrex::Real nominal_power
Definition: ERF_WindFarm.H:154
-
void set_blade_airfoil_spec(const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_aoa, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cl, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cd) override
Definition: ERF_WindFarm.H:133
+
amrex::Real nominal_power
Definition: ERF_WindFarm.H:159
+
void set_blade_airfoil_spec(const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_aoa, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cl, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cd) override
Definition: ERF_WindFarm.H:138
void gatherKeyValuePairs(const std::vector< std::pair< int, double >> &localData, std::vector< std::pair< int, double >> &globalData)
Definition: ERF_InitWindFarm.cpp:354
void init_windfarm_x_y(const std::string windfarm_loc_table)
Definition: ERF_InitWindFarm.cpp:132
-
amrex::Vector< amrex::Real > bld_chord
Definition: ERF_WindFarm.H:156
+
amrex::Vector< amrex::Real > bld_chord
Definition: ERF_WindFarm.H:161
void init_windfarm_lat_lon(const std::string windfarm_loc_table, const amrex::Real windfarm_x_shift, const amrex::Real windfarm_y_shift)
Definition: ERF_InitWindFarm.cpp:55
-
void set_turb_spec(const amrex::Real &a_rotor_rad, const amrex::Real &a_hub_height, const amrex::Real &a_thrust_coeff_standing, const amrex::Vector< amrex::Real > &a_wind_speed, const amrex::Vector< amrex::Real > &a_thrust_coeff, const amrex::Vector< amrex::Real > &a_power) override
Definition: ERF_WindFarm.H:106
-
amrex::Real thrust_coeff_standing
Definition: ERF_WindFarm.H:154
-
amrex::Vector< amrex::Real > xloc
Definition: ERF_WindFarm.H:151
+
void set_turb_spec(const amrex::Real &a_rotor_rad, const amrex::Real &a_hub_height, const amrex::Real &a_thrust_coeff_standing, const amrex::Vector< amrex::Real > &a_wind_speed, const amrex::Vector< amrex::Real > &a_thrust_coeff, const amrex::Vector< amrex::Real > &a_power) override
Definition: ERF_WindFarm.H:111
+
amrex::Real thrust_coeff_standing
Definition: ERF_WindFarm.H:159
+
amrex::Vector< amrex::Real > xloc
Definition: ERF_WindFarm.H:156
+
void fill_Nturb_multifab(const amrex::Geometry &geom, amrex::MultiFab &mf_Nturb, std::unique_ptr< amrex::MultiFab > &z_phys_nd)
Definition: ERF_InitWindFarm.cpp:426
void read_windfarm_airfoil_tables(const std::string windfarm_airfoil_tables, const std::string windfarm_blade_table)
Definition: ERF_InitWindFarm.cpp:274
-
amrex::Real rotor_rad
Definition: ERF_WindFarm.H:154
-
void fill_SMark_multifab(const amrex::Geometry &geom, amrex::MultiFab &mf_SMark, const amrex::Real &sampling_distance_by_D, const amrex::Real &turb_disk_angle, std::unique_ptr< amrex::MultiFab > &z_phys_cc)
Definition: ERF_InitWindFarm.cpp:523
-
void write_turbine_locations_vtk()
Definition: ERF_InitWindFarm.cpp:620
-
amrex::Vector< amrex::Real > rotor_RPM
Definition: ERF_WindFarm.H:159
-
void fill_Nturb_multifab(const amrex::Geometry &geom, amrex::MultiFab &mf_Nturb, std::unique_ptr< amrex::MultiFab > &z_phys_cc)
Definition: ERF_InitWindFarm.cpp:430
-
amrex::Vector< amrex::Real > power
Definition: ERF_WindFarm.H:155
-
amrex::Vector< amrex::Real > bld_rad_loc
Definition: ERF_WindFarm.H:156
-
void set_turb_disk_angle(const amrex::Real &a_turb_disk_angle) override
Definition: ERF_WindFarm.H:121
-
amrex::Vector< int > turb_index
Definition: ERF_WindFarm.H:152
-
amrex::Vector< std::unique_ptr< NullWindFarm > > m_windfarm_model
Definition: ERF_WindFarm.H:171
+
amrex::Real rotor_rad
Definition: ERF_WindFarm.H:159
+
void fill_SMark_multifab(const amrex::Geometry &geom, amrex::MultiFab &mf_SMark, const amrex::Real &sampling_distance_by_D, const amrex::Real &turb_disk_angle, std::unique_ptr< amrex::MultiFab > &z_phys_cc)
Definition: ERF_InitWindFarm.cpp:572
+
void write_turbine_locations_vtk()
Definition: ERF_InitWindFarm.cpp:672
+
amrex::Vector< amrex::Real > rotor_RPM
Definition: ERF_WindFarm.H:164
+
amrex::Vector< amrex::Real > power
Definition: ERF_WindFarm.H:160
+
amrex::Vector< amrex::Real > bld_rad_loc
Definition: ERF_WindFarm.H:161
+
void set_turb_disk_angle(const amrex::Real &a_turb_disk_angle) override
Definition: ERF_WindFarm.H:126
+
amrex::Vector< int > turb_index
Definition: ERF_WindFarm.H:157
+
amrex::Vector< std::unique_ptr< NullWindFarm > > m_windfarm_model
Definition: ERF_WindFarm.H:176
diff --git a/classERF.html b/classERF.html index 43e2842ad..4ee3c9d16 100644 --- a/classERF.html +++ b/classERF.html @@ -5309,40 +5309,38 @@

201  if (fixed_dt[level] > 0. && fixed_fast_dt[level] > 0.) {
202  dt_fast_ratio = static_cast<long>( fixed_dt[level] / fixed_fast_dt[level] );
203  } else if (fixed_dt[level] > 0.) {
-
204  dt_fast_ratio = static_cast<long>( std::ceil((fixed_dt[level]/estdt_comp)) );
-
205  } else {
-
206  dt_fast_ratio = (estdt_lowM_inv > 0.0) ? static_cast<long>( std::ceil((estdt_lowM/estdt_comp)) ) : 1;
-
207  }
-
208 
-
209  // Force time step ratio to be an even value
- -
211  if ( dt_fast_ratio%2 != 0) dt_fast_ratio += 1;
-
212  } else {
-
213  if ( dt_fast_ratio%6 != 0) {
-
214  Print() << "mri_dt_ratio = " << dt_fast_ratio
-
215  << " not divisible by 6 for N/3 substeps in stage 1" << std::endl;
-
216  dt_fast_ratio = static_cast<int>(std::ceil(dt_fast_ratio/6.0) * 6);
-
217  }
-
218  }
-
219 
-
220  if (verbose) {
-
221  Print() << "smallest even ratio is: " << dt_fast_ratio << std::endl;
-
222  }
-
223  } // if substepping, either explicit or implicit
-
224 
-
225  if (fixed_dt[level] > 0.0) {
-
226  return fixed_dt[level];
-
227  } else {
-
228  // Anelastic (substepping is not allowed)
-
229  if (l_anelastic) {
-
230  return estdt_lowM;
-
231 
-
232  // Compressible with or without substepping
-
233  } else {
-
234  return estdt_comp;
-
235  }
-
236  }
-
237 }
+
204  dt_fast_ratio = static_cast<long>( 6 );
+
205  }
+
206 
+
207  // Force time step ratio to be an even value
+ +
209  if ( dt_fast_ratio%2 != 0) dt_fast_ratio += 1;
+
210  } else {
+
211  if ( dt_fast_ratio%6 != 0) {
+
212  Print() << "mri_dt_ratio = " << dt_fast_ratio
+
213  << " not divisible by 6 for N/3 substeps in stage 1" << std::endl;
+
214  dt_fast_ratio = static_cast<int>(std::ceil(dt_fast_ratio/6.0) * 6);
+
215  }
+
216  }
+
217 
+
218  if (verbose) {
+
219  Print() << "smallest even ratio is: " << dt_fast_ratio << std::endl;
+
220  }
+
221  } // if substepping, either explicit or implicit
+
222 
+
223  if (fixed_dt[level] > 0.0) {
+
224  return fixed_dt[level];
+
225  } else {
+
226  // Anelastic (substepping is not allowed)
+
227  if (l_anelastic) {
+
228  return estdt_lowM;
+
229 
+
230  // Compressible with or without substepping
+
231  } else {
+
232  return estdt_comp;
+
233  }
+
234  }
+
235 }
constexpr amrex::Real Gamma
Definition: ERF_Constants.H:19
amrex::Vector< amrex::Real > dz_min
Definition: ERF.H:1141
amrex::Vector< amrex::Real > fixed_dt
Definition: ERF.H:914
@@ -11692,206 +11690,208 @@

43  // Now convert the rho0w MultiFab to hold Omega rather than rhow
44  // ****************************************************************************
45  //
-
46  if (l_use_terrain && !SolverChoice::terrain_is_flat) {
-
47  for ( MFIter mfi(rhs[0],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
48  {
-
49  const Array4<Real const>& rho0u_arr = mom_mf[IntVars::xmom].const_array(mfi);
-
50  const Array4<Real const>& rho0v_arr = mom_mf[IntVars::ymom].const_array(mfi);
-
51  const Array4<Real >& rho0w_arr = mom_mf[IntVars::zmom].array(mfi);
-
52 
-
53  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
-
54  //
-
55  // Define Omega from (rho0 W) but store it in the same array
-
56  //
-
57  Box tbz = mfi.nodaltilebox(2);
-
58  ParallelFor(tbz, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
-
59  if (k > dom_lo.z && k <= dom_hi.z) {
-
60  Real rho0w = rho0w_arr(i,j,k);
-
61  rho0w_arr(i,j,k) = OmegaFromW(i,j,k,rho0w,rho0u_arr,rho0v_arr,z_nd,dxInv);
-
62  } else {
-
63  rho0w_arr(i,j,k) = Real(0.0);
-
64  }
-
65  });
-
66  } // mfi
-
67  }
-
68 
-
69  // ****************************************************************************
-
70  // Compute divergence which will form RHS
-
71  // Note that we replace "rho0w" with the contravariant momentum, Omega
-
72  // ****************************************************************************
-
73  compute_divergence(lev, rhs[0], mom_mf, geom_tmp[0]);
-
74 
-
75  Real rhsnorm = rhs[0].norm0();
+
46 #ifndef ERF_USE_EB
+
47  if (l_use_terrain && !SolverChoice::terrain_is_flat) {
+
48  for ( MFIter mfi(rhs[0],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
49  {
+
50  const Array4<Real const>& rho0u_arr = mom_mf[IntVars::xmom].const_array(mfi);
+
51  const Array4<Real const>& rho0v_arr = mom_mf[IntVars::ymom].const_array(mfi);
+
52  const Array4<Real >& rho0w_arr = mom_mf[IntVars::zmom].array(mfi);
+
53 
+
54  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
+
55  //
+
56  // Define Omega from (rho0 W) but store it in the same array
+
57  //
+
58  Box tbz = mfi.nodaltilebox(2);
+
59  ParallelFor(tbz, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
+
60  if (k > dom_lo.z && k <= dom_hi.z) {
+
61  Real rho0w = rho0w_arr(i,j,k);
+
62  rho0w_arr(i,j,k) = OmegaFromW(i,j,k,rho0w,rho0u_arr,rho0v_arr,z_nd,dxInv);
+
63  } else {
+
64  rho0w_arr(i,j,k) = Real(0.0);
+
65  }
+
66  });
+
67  } // mfi
+
68  }
+
69 #endif
+
70 
+
71  // ****************************************************************************
+
72  // Compute divergence which will form RHS
+
73  // Note that we replace "rho0w" with the contravariant momentum, Omega
+
74  // ****************************************************************************
+
75  compute_divergence(lev, rhs[0], mom_mf, geom_tmp[0]);
76 
-
77  if (mg_verbose > 0) {
-
78  Print() << "Max norm of divergence before solve at level " << lev << " : " << rhsnorm << std::endl;
-
79  }
-
80 
-
81  // ****************************************************************************
-
82  //
-
83  // No need to build the solver if RHS == 0
+
77  Real rhsnorm = rhs[0].norm0();
+
78 
+
79  if (mg_verbose > 0) {
+
80  Print() << "Max norm of divergence before solve at level " << lev << " : " << rhsnorm << std::endl;
+
81  }
+
82 
+
83  // ****************************************************************************
84  //
-
85  if (rhsnorm <= solverChoice.poisson_abstol) return;
-
86  // ****************************************************************************
-
87 
+
85  // No need to build the solver if RHS == 0
+
86  //
+
87  if (rhsnorm <= solverChoice.poisson_abstol) return;
88  // ****************************************************************************
-
89  // Initialize phi to 0
-
90  // (It is essential that we do this in order to fill the corners; these are never
-
91  // used but the Saxpy requires the values to be initialized.)
-
92  // ****************************************************************************
-
93  phi[0].setVal(0.0);
-
94 
-
95  Real start_step = static_cast<Real>(ParallelDescriptor::second());
+
89 
+
90  // ****************************************************************************
+
91  // Initialize phi to 0
+
92  // (It is essential that we do this in order to fill the corners; these are never
+
93  // used but the Saxpy requires the values to be initialized.)
+
94  // ****************************************************************************
+
95  phi[0].setVal(0.0);
96 
-
97  // ****************************************************************************
-
98  // Allocate fluxes
+
97  Real start_step = static_cast<Real>(ParallelDescriptor::second());
+
98 
99  // ****************************************************************************
-
100  Vector<Array<MultiFab,AMREX_SPACEDIM> > fluxes;
-
101  fluxes.resize(1);
-
102  for (int idim = 0; idim < AMREX_SPACEDIM; ++idim) {
-
103 #ifdef ERF_USE_EB
-
104  fluxes[0][idim].define(convert(ba_tmp[0], IntVect::TheDimensionVector(idim)), dm_tmp[0], 1, 0, MFInfo(), Factory(lev));
-
105 #else
-
106  fluxes[0][idim].define(convert(ba_tmp[0], IntVect::TheDimensionVector(idim)), dm_tmp[0], 1, 0);
-
107 #endif
-
108  }
-
109 
-
110  // ****************************************************************************
-
111  // Choose the solver and solve
+
100  // Allocate fluxes
+
101  // ****************************************************************************
+
102  Vector<Array<MultiFab,AMREX_SPACEDIM> > fluxes;
+
103  fluxes.resize(1);
+
104  for (int idim = 0; idim < AMREX_SPACEDIM; ++idim) {
+
105 #ifdef ERF_USE_EB
+
106  fluxes[0][idim].define(convert(ba_tmp[0], IntVect::TheDimensionVector(idim)), dm_tmp[0], 1, 0, MFInfo(), Factory(lev));
+
107 #else
+
108  fluxes[0][idim].define(convert(ba_tmp[0], IntVect::TheDimensionVector(idim)), dm_tmp[0], 1, 0);
+
109 #endif
+
110  }
+
111 
112  // ****************************************************************************
-
113 
+
113  // Choose the solver and solve
114  // ****************************************************************************
-
115  // EB
+
115 
116  // ****************************************************************************
-
117 #ifdef ERF_USE_EB
-
118  solve_with_EB_mlmg(lev, rhs, phi, fluxes);
-
119 #else
-
120 
-
121 #ifdef ERF_USE_FFT
-
122  bool boxes_make_rectangle = (geom_tmp[0].Domain().numPts() == ba_tmp[0].numPts());
-
123 #endif
-
124 
-
125  // ****************************************************************************
-
126  // No terrain or grid stretching
+
117  // EB
+
118  // ****************************************************************************
+
119 #ifdef ERF_USE_EB
+
120  solve_with_EB_mlmg(lev, rhs, phi, fluxes);
+
121 #else
+
122 
+
123 #ifdef ERF_USE_FFT
+
124  bool boxes_make_rectangle = (geom_tmp[0].Domain().numPts() == ba_tmp[0].numPts());
+
125 #endif
+
126 
127  // ****************************************************************************
-
128  if (!l_use_terrain) {
-
129 #ifdef ERF_USE_FFT
-
130  if (use_fft) {
-
131  if (boxes_make_rectangle) {
-
132  solve_with_fft(lev, rhs[0], phi[0], fluxes[0]);
-
133  } else {
-
134  amrex::Warning("FFT won't work unless the boxArray covers the domain: defaulting to MLMG");
-
135  solve_with_mlmg(lev, rhs, phi, fluxes);
-
136  }
-
137  } else {
-
138  solve_with_mlmg(lev, rhs, phi, fluxes);
-
139  }
-
140 #else
-
141  if (use_fft) {
-
142  amrex::Warning("use_fft can't be used unless you build with USE_FFT = TRUE; defaulting to MLMG");
-
143  }
-
144  solve_with_mlmg(lev, rhs, phi, fluxes);
-
145 #endif
-
146  } // No terrain or grid stretching
-
147 
-
148  // ****************************************************************************
-
149  // Grid stretching (flat terrain)
+
128  // No terrain or grid stretching
+
129  // ****************************************************************************
+
130  if (!l_use_terrain) {
+
131 #ifdef ERF_USE_FFT
+
132  if (use_fft) {
+
133  if (boxes_make_rectangle) {
+
134  solve_with_fft(lev, rhs[0], phi[0], fluxes[0]);
+
135  } else {
+
136  amrex::Warning("FFT won't work unless the boxArray covers the domain: defaulting to MLMG");
+
137  solve_with_mlmg(lev, rhs, phi, fluxes);
+
138  }
+
139  } else {
+
140  solve_with_mlmg(lev, rhs, phi, fluxes);
+
141  }
+
142 #else
+
143  if (use_fft) {
+
144  amrex::Warning("use_fft can't be used unless you build with USE_FFT = TRUE; defaulting to MLMG");
+
145  }
+
146  solve_with_mlmg(lev, rhs, phi, fluxes);
+
147 #endif
+
148  } // No terrain or grid stretching
+
149 
150  // ****************************************************************************
-
151  else if (l_use_terrain && SolverChoice::terrain_is_flat) {
-
152 #ifndef ERF_USE_FFT
-
153  amrex::Abort("Rebuild with USE_FFT = TRUE so you can use the FFT solver");
-
154 #else
-
155  if (!boxes_make_rectangle) {
-
156  amrex::Abort("FFT won't work unless the boxArray covers the domain");
-
157  } else {
-
158  if (!use_fft) {
-
159  amrex::Warning("Using FFT even though you didn't set use_fft = 0; it's the best choice");
-
160  }
-
161  solve_with_fft(lev, rhs[0], phi[0], fluxes[0]);
-
162  }
-
163 #endif
-
164  } // grid stretching
-
165 
-
166  // ****************************************************************************
-
167  // General terrain
+
151  // Grid stretching (flat terrain)
+
152  // ****************************************************************************
+
153  else if (l_use_terrain && SolverChoice::terrain_is_flat) {
+
154 #ifndef ERF_USE_FFT
+
155  amrex::Abort("Rebuild with USE_FFT = TRUE so you can use the FFT solver");
+
156 #else
+
157  if (!boxes_make_rectangle) {
+
158  amrex::Abort("FFT won't work unless the boxArray covers the domain");
+
159  } else {
+
160  if (!use_fft) {
+
161  amrex::Warning("Using FFT even though you didn't set use_fft = 0; it's the best choice");
+
162  }
+
163  solve_with_fft(lev, rhs[0], phi[0], fluxes[0]);
+
164  }
+
165 #endif
+
166  } // grid stretching
+
167 
168  // ****************************************************************************
-
169  else if (l_use_terrain && !SolverChoice::terrain_is_flat) {
-
170 #ifdef ERF_USE_FFT
-
171  if (use_fft)
-
172  {
-
173  amrex::Warning("FFT solver does not work for general terrain: switching to GMRES");
-
174  }
-
175  if (!boxes_make_rectangle) {
-
176  amrex::Abort("FFT preconditioner for GMRES won't work unless the boxArray covers the domain");
-
177  } else {
-
178  solve_with_gmres(lev, rhs, phi, fluxes[0]);
-
179  }
-
180 #else
-
181  amrex::Abort("Rebuild with USE_FFT = TRUE so you can use the FFT preconditioner for GMRES");
-
182 #endif
-
183  } // general terrain
-
184 
-
185 #endif // not EB
+
169  // General terrain
+
170  // ****************************************************************************
+
171  else if (l_use_terrain && !SolverChoice::terrain_is_flat) {
+
172 #ifdef ERF_USE_FFT
+
173  if (use_fft)
+
174  {
+
175  amrex::Warning("FFT solver does not work for general terrain: switching to GMRES");
+
176  }
+
177  if (!boxes_make_rectangle) {
+
178  amrex::Abort("FFT preconditioner for GMRES won't work unless the boxArray covers the domain");
+
179  } else {
+
180  solve_with_gmres(lev, rhs, phi, fluxes[0]);
+
181  }
+
182 #else
+
183  amrex::Abort("Rebuild with USE_FFT = TRUE so you can use the FFT preconditioner for GMRES");
+
184 #endif
+
185  } // general terrain
186 
-
187  // ****************************************************************************
-
188  // Print time in solve
+
187 #endif // not EB
+
188 
189  // ****************************************************************************
-
190  Real end_step = static_cast<Real>(ParallelDescriptor::second());
-
191  if (mg_verbose > 0) {
-
192  amrex::Print() << "Time in solve " << end_step - start_step << std::endl;
-
193  }
-
194 
-
195  // ****************************************************************************
-
196  // Subtract dt grad(phi) from the momenta (rho0u, rho0v, Omega)
+
190  // Print time in solve
+
191  // ****************************************************************************
+
192  Real end_step = static_cast<Real>(ParallelDescriptor::second());
+
193  if (mg_verbose > 0) {
+
194  amrex::Print() << "Time in solve " << end_step - start_step << std::endl;
+
195  }
+
196 
197  // ****************************************************************************
-
198  MultiFab::Add(mom_mf[IntVars::xmom],fluxes[0][0],0,0,1,0);
-
199  MultiFab::Add(mom_mf[IntVars::ymom],fluxes[0][1],0,0,1,0);
-
200  MultiFab::Add(mom_mf[IntVars::zmom],fluxes[0][2],0,0,1,0);
-
201 
-
202  //
-
203  // This call is only to verify the divergence after the solve
-
204  // It is important we do this before computing the rho0w_arr from Omega back to rho0w
-
205  //
-
206  // ****************************************************************************
-
207  // THIS IS SIMPLY VERIFYING THE DIVERGENCE AFTER THE SOLVE
+
198  // Subtract dt grad(phi) from the momenta (rho0u, rho0v, Omega)
+
199  // ****************************************************************************
+
200  MultiFab::Add(mom_mf[IntVars::xmom],fluxes[0][0],0,0,1,0);
+
201  MultiFab::Add(mom_mf[IntVars::ymom],fluxes[0][1],0,0,1,0);
+
202  MultiFab::Add(mom_mf[IntVars::zmom],fluxes[0][2],0,0,1,0);
+
203 
+
204  //
+
205  // This call is only to verify the divergence after the solve
+
206  // It is important we do this before computing the rho0w_arr from Omega back to rho0w
+
207  //
208  // ****************************************************************************
-
209  //
-
210  if (mg_verbose > 0)
-
211  {
-
212  compute_divergence(lev, rhs[0], mom_mf, geom_tmp[0]);
-
213 
-
214  amrex::Print() << "Max norm of divergence after solve at level " << lev << " : " << rhs[0].norm0() << std::endl;
+
209  // THIS IS SIMPLY VERIFYING THE DIVERGENCE AFTER THE SOLVE
+
210  // ****************************************************************************
+
211  //
+
212  if (mg_verbose > 0)
+
213  {
+
214  compute_divergence(lev, rhs[0], mom_mf, geom_tmp[0]);
215 
-
216  } // mg_verbose
+
216  amrex::Print() << "Max norm of divergence after solve at level " << lev << " : " << rhs[0].norm0() << std::endl;
217 
-
218 
-
219  //
-
220  // ****************************************************************************
-
221  // Now convert the rho0w MultiFab back to holding (rho0w) rather than Omega
+
218  } // mg_verbose
+
219 
+
220 
+
221  //
222  // ****************************************************************************
-
223  //
-
224  if (l_use_terrain && !solverChoice.terrain_is_flat)
-
225  {
-
226  for (MFIter mfi(mom_mf[Vars::cons],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
227  {
-
228  Box tbz = mfi.nodaltilebox(2);
-
229  const Array4<Real >& rho0u_arr = mom_mf[IntVars::xmom].array(mfi);
-
230  const Array4<Real >& rho0v_arr = mom_mf[IntVars::ymom].array(mfi);
-
231  const Array4<Real >& rho0w_arr = mom_mf[IntVars::zmom].array(mfi);
-
232  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
-
233  ParallelFor(tbz, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
-
234  Real omega = rho0w_arr(i,j,k);
-
235  rho0w_arr(i,j,k) = WFromOmega(i,j,k,omega,rho0u_arr,rho0v_arr,z_nd,dxInv);
-
236  });
-
237  } // mfi
-
238  }
-
239 
-
240  // ****************************************************************************
-
241  // Update pressure variable with phi -- note that phi is dt * change in pressure
+
223  // Now convert the rho0w MultiFab back to holding (rho0w) rather than Omega
+
224  // ****************************************************************************
+
225  //
+
226  if (l_use_terrain && !solverChoice.terrain_is_flat)
+
227  {
+
228  for (MFIter mfi(mom_mf[Vars::cons],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
229  {
+
230  Box tbz = mfi.nodaltilebox(2);
+
231  const Array4<Real >& rho0u_arr = mom_mf[IntVars::xmom].array(mfi);
+
232  const Array4<Real >& rho0v_arr = mom_mf[IntVars::ymom].array(mfi);
+
233  const Array4<Real >& rho0w_arr = mom_mf[IntVars::zmom].array(mfi);
+
234  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
+
235  ParallelFor(tbz, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
+
236  Real omega = rho0w_arr(i,j,k);
+
237  rho0w_arr(i,j,k) = WFromOmega(i,j,k,omega,rho0u_arr,rho0v_arr,z_nd,dxInv);
+
238  });
+
239  } // mfi
+
240  }
+
241 
242  // ****************************************************************************
-
243  MultiFab::Saxpy(pmf, 1.0/l_dt, phi[0],0,0,1,1);
-
244  pmf.FillBoundary(geom[lev].periodicity());
-
245 }
+
243  // Update pressure variable with phi -- note that phi is dt * change in pressure
+
244  // ****************************************************************************
+
245  MultiFab::Saxpy(pmf, 1.0/l_dt, phi[0],0,0,1,1);
+
246  pmf.FillBoundary(geom[lev].periodicity());
+
247 }
AMREX_GPU_DEVICE AMREX_FORCE_INLINE amrex::Real WFromOmega(int i, int j, int k, amrex::Real omega, amrex::Real u, amrex::Real v, const amrex::Array4< const amrex::Real > &z_nd, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv)
Definition: ERF_TerrainMetrics.H:407
static int mg_verbose
Definition: ERF.H:1020
static bool use_fft
Definition: ERF.H:1021
@@ -14001,7 +14001,7 @@

97  for (int i = 0; i < derived_names.size(); ++i) {
98  if ( containerHasElement(plot_var_names, derived_names[i]) ) {
99  if(solverChoice.windfarm_type == WindFarmType::Fitch or solverChoice.windfarm_type == WindFarmType::EWP) {
-
100  if(derived_names[i] == "num_turb") {
+
100  if(derived_names[i] == "num_turb" or derived_names[i] == "SMark0") {
101  tmp_plot_names.push_back(derived_names[i]);
102  }
103  }
@@ -16337,82 +16337,82 @@

-
1671 {
-
1672  AMREX_ALWAYS_ASSERT(nlevels <= bArray.size());
-
1673  AMREX_ALWAYS_ASSERT(nlevels <= my_ref_ratio.size()+1);
-
1674  AMREX_ALWAYS_ASSERT(nlevels <= level_steps.size());
-
1675 
-
1676  HeaderFile.precision(17);
-
1677 
-
1678  // ---- this is the generic plot file type name
-
1679  HeaderFile << versionName << '\n';
-
1680 
-
1681  HeaderFile << varnames.size() << '\n';
-
1682 
-
1683  for (int ivar = 0; ivar < varnames.size(); ++ivar) {
-
1684  HeaderFile << varnames[ivar] << "\n";
-
1685  }
-
1686  HeaderFile << AMREX_SPACEDIM << '\n';
-
1687  HeaderFile << my_time << '\n';
-
1688  HeaderFile << finest_level << '\n';
-
1689  for (int i = 0; i < AMREX_SPACEDIM; ++i) {
-
1690  HeaderFile << my_geom[0].ProbLo(i) << ' ';
-
1691  }
-
1692  HeaderFile << '\n';
-
1693  for (int i = 0; i < AMREX_SPACEDIM; ++i) {
-
1694  HeaderFile << my_geom[0].ProbHi(i) << ' ';
-
1695  }
-
1696  HeaderFile << '\n';
-
1697  for (int i = 0; i < finest_level; ++i) {
-
1698  HeaderFile << my_ref_ratio[i][0] << ' ';
-
1699  }
-
1700  HeaderFile << '\n';
-
1701  for (int i = 0; i <= finest_level; ++i) {
-
1702  HeaderFile << my_geom[i].Domain() << ' ';
-
1703  }
-
1704  HeaderFile << '\n';
-
1705  for (int i = 0; i <= finest_level; ++i) {
-
1706  HeaderFile << level_steps[i] << ' ';
-
1707  }
-
1708  HeaderFile << '\n';
-
1709  for (int i = 0; i <= finest_level; ++i) {
-
1710  for (int k = 0; k < AMREX_SPACEDIM; ++k) {
-
1711  HeaderFile << my_geom[i].CellSize()[k] << ' ';
-
1712  }
-
1713  HeaderFile << '\n';
-
1714  }
-
1715  HeaderFile << (int) my_geom[0].Coord() << '\n';
-
1716  HeaderFile << "0\n";
-
1717 
-
1718  for (int level = 0; level <= finest_level; ++level) {
-
1719  HeaderFile << level << ' ' << bArray[level].size() << ' ' << my_time << '\n';
-
1720  HeaderFile << level_steps[level] << '\n';
-
1721 
-
1722  const IntVect& domain_lo = my_geom[level].Domain().smallEnd();
-
1723  for (int i = 0; i < bArray[level].size(); ++i)
-
1724  {
-
1725  // Need to shift because the RealBox ctor we call takes the
-
1726  // physical location of index (0,0,0). This does not affect
-
1727  // the usual cases where the domain index starts with 0.
-
1728  const Box& b = shift(bArray[level][i], -domain_lo);
-
1729  RealBox loc = RealBox(b, my_geom[level].CellSize(), my_geom[level].ProbLo());
-
1730  for (int n = 0; n < AMREX_SPACEDIM; ++n) {
-
1731  HeaderFile << loc.lo(n) << ' ' << loc.hi(n) << '\n';
-
1732  }
-
1733  }
-
1734 
-
1735  HeaderFile << MultiFabHeaderPath(level, levelPrefix, mfPrefix) << '\n';
-
1736  }
-
1737  HeaderFile << "1" << "\n";
-
1738  HeaderFile << "3" << "\n";
-
1739  HeaderFile << "amrexvec_nu_x" << "\n";
-
1740  HeaderFile << "amrexvec_nu_y" << "\n";
-
1741  HeaderFile << "amrexvec_nu_z" << "\n";
-
1742  std::string mf_nodal_prefix = "Nu_nd";
-
1743  for (int level = 0; level <= finest_level; ++level) {
-
1744  HeaderFile << MultiFabHeaderPath(level, levelPrefix, mf_nodal_prefix) << '\n';
-
1745  }
-
1746 }
+
1672 {
+
1673  AMREX_ALWAYS_ASSERT(nlevels <= bArray.size());
+
1674  AMREX_ALWAYS_ASSERT(nlevels <= my_ref_ratio.size()+1);
+
1675  AMREX_ALWAYS_ASSERT(nlevels <= level_steps.size());
+
1676 
+
1677  HeaderFile.precision(17);
+
1678 
+
1679  // ---- this is the generic plot file type name
+
1680  HeaderFile << versionName << '\n';
+
1681 
+
1682  HeaderFile << varnames.size() << '\n';
+
1683 
+
1684  for (int ivar = 0; ivar < varnames.size(); ++ivar) {
+
1685  HeaderFile << varnames[ivar] << "\n";
+
1686  }
+
1687  HeaderFile << AMREX_SPACEDIM << '\n';
+
1688  HeaderFile << my_time << '\n';
+
1689  HeaderFile << finest_level << '\n';
+
1690  for (int i = 0; i < AMREX_SPACEDIM; ++i) {
+
1691  HeaderFile << my_geom[0].ProbLo(i) << ' ';
+
1692  }
+
1693  HeaderFile << '\n';
+
1694  for (int i = 0; i < AMREX_SPACEDIM; ++i) {
+
1695  HeaderFile << my_geom[0].ProbHi(i) << ' ';
+
1696  }
+
1697  HeaderFile << '\n';
+
1698  for (int i = 0; i < finest_level; ++i) {
+
1699  HeaderFile << my_ref_ratio[i][0] << ' ';
+
1700  }
+
1701  HeaderFile << '\n';
+
1702  for (int i = 0; i <= finest_level; ++i) {
+
1703  HeaderFile << my_geom[i].Domain() << ' ';
+
1704  }
+
1705  HeaderFile << '\n';
+
1706  for (int i = 0; i <= finest_level; ++i) {
+
1707  HeaderFile << level_steps[i] << ' ';
+
1708  }
+
1709  HeaderFile << '\n';
+
1710  for (int i = 0; i <= finest_level; ++i) {
+
1711  for (int k = 0; k < AMREX_SPACEDIM; ++k) {
+
1712  HeaderFile << my_geom[i].CellSize()[k] << ' ';
+
1713  }
+
1714  HeaderFile << '\n';
+
1715  }
+
1716  HeaderFile << (int) my_geom[0].Coord() << '\n';
+
1717  HeaderFile << "0\n";
+
1718 
+
1719  for (int level = 0; level <= finest_level; ++level) {
+
1720  HeaderFile << level << ' ' << bArray[level].size() << ' ' << my_time << '\n';
+
1721  HeaderFile << level_steps[level] << '\n';
+
1722 
+
1723  const IntVect& domain_lo = my_geom[level].Domain().smallEnd();
+
1724  for (int i = 0; i < bArray[level].size(); ++i)
+
1725  {
+
1726  // Need to shift because the RealBox ctor we call takes the
+
1727  // physical location of index (0,0,0). This does not affect
+
1728  // the usual cases where the domain index starts with 0.
+
1729  const Box& b = shift(bArray[level][i], -domain_lo);
+
1730  RealBox loc = RealBox(b, my_geom[level].CellSize(), my_geom[level].ProbLo());
+
1731  for (int n = 0; n < AMREX_SPACEDIM; ++n) {
+
1732  HeaderFile << loc.lo(n) << ' ' << loc.hi(n) << '\n';
+
1733  }
+
1734  }
+
1735 
+
1736  HeaderFile << MultiFabHeaderPath(level, levelPrefix, mfPrefix) << '\n';
+
1737  }
+
1738  HeaderFile << "1" << "\n";
+
1739  HeaderFile << "3" << "\n";
+
1740  HeaderFile << "amrexvec_nu_x" << "\n";
+
1741  HeaderFile << "amrexvec_nu_y" << "\n";
+
1742  HeaderFile << "amrexvec_nu_z" << "\n";
+
1743  std::string mf_nodal_prefix = "Nu_nd";
+
1744  for (int level = 0; level <= finest_level; ++level) {
+
1745  HeaderFile << MultiFabHeaderPath(level, levelPrefix, mf_nodal_prefix) << '\n';
+
1746  }
+
1747 }
Coord
Definition: ERF_DataStruct.H:60
@@ -16665,80 +16665,80 @@

-
1585 {
-
1586  BL_PROFILE("WriteMultiLevelPlotfileWithTerrain()");
-
1587 
-
1588  AMREX_ALWAYS_ASSERT(nlevels <= mf.size());
-
1589  AMREX_ALWAYS_ASSERT(nlevels <= rr.size()+1);
-
1590  AMREX_ALWAYS_ASSERT(nlevels <= level_steps.size());
-
1591  AMREX_ALWAYS_ASSERT(mf[0]->nComp() == varnames.size());
-
1592 
-
1593  bool callBarrier(false);
-
1594  PreBuildDirectorHierarchy(plotfilename, levelPrefix, nlevels, callBarrier);
-
1595  if (!extra_dirs.empty()) {
-
1596  for (const auto& d : extra_dirs) {
-
1597  const std::string ed = plotfilename+"/"+d;
-
1598  PreBuildDirectorHierarchy(ed, levelPrefix, nlevels, callBarrier);
-
1599  }
-
1600  }
-
1601  ParallelDescriptor::Barrier();
-
1602 
-
1603  if (ParallelDescriptor::MyProc() == ParallelDescriptor::NProcs()-1) {
-
1604  Vector<BoxArray> boxArrays(nlevels);
-
1605  for(int level(0); level < boxArrays.size(); ++level) {
-
1606  boxArrays[level] = mf[level]->boxArray();
-
1607  }
-
1608 
-
1609  auto f = [=]() {
-
1610  VisMF::IO_Buffer io_buffer(VisMF::IO_Buffer_Size);
-
1611  std::string HeaderFileName(plotfilename + "/Header");
-
1612  std::ofstream HeaderFile;
-
1613  HeaderFile.rdbuf()->pubsetbuf(io_buffer.dataPtr(), io_buffer.size());
-
1614  HeaderFile.open(HeaderFileName.c_str(), std::ofstream::out |
-
1615  std::ofstream::trunc |
-
1616  std::ofstream::binary);
-
1617  if( ! HeaderFile.good()) FileOpenFailed(HeaderFileName);
-
1618  WriteGenericPlotfileHeaderWithTerrain(HeaderFile, nlevels, boxArrays, varnames,
-
1619  my_geom, time, level_steps, rr, versionName,
-
1620  levelPrefix, mfPrefix);
-
1621  };
-
1622 
-
1623  if (AsyncOut::UseAsyncOut()) {
-
1624  AsyncOut::Submit(std::move(f));
-
1625  } else {
-
1626  f();
-
1627  }
-
1628  }
-
1629 
-
1630  std::string mf_nodal_prefix = "Nu_nd";
-
1631  for (int level = 0; level <= finest_level; ++level)
-
1632  {
-
1633  if (AsyncOut::UseAsyncOut()) {
-
1634  VisMF::AsyncWrite(*mf[level],
-
1635  MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mfPrefix),
-
1636  true);
-
1637  VisMF::AsyncWrite(*mf_nd[level],
-
1638  MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_nodal_prefix),
-
1639  true);
-
1640  } else {
-
1641  const MultiFab* data;
-
1642  std::unique_ptr<MultiFab> mf_tmp;
-
1643  if (mf[level]->nGrowVect() != 0) {
-
1644  mf_tmp = std::make_unique<MultiFab>(mf[level]->boxArray(),
-
1645  mf[level]->DistributionMap(),
-
1646  mf[level]->nComp(), 0, MFInfo(),
-
1647  mf[level]->Factory());
-
1648  MultiFab::Copy(*mf_tmp, *mf[level], 0, 0, mf[level]->nComp(), 0);
-
1649  data = mf_tmp.get();
-
1650  } else {
-
1651  data = mf[level];
-
1652  }
-
1653  VisMF::Write(*data , MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mfPrefix));
-
1654  VisMF::Write(*mf_nd[level], MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_nodal_prefix));
-
1655  }
-
1656  }
-
1657 }
-
void WriteGenericPlotfileHeaderWithTerrain(std::ostream &HeaderFile, int nlevels, const amrex::Vector< amrex::BoxArray > &bArray, const amrex::Vector< std::string > &varnames, const amrex::Vector< amrex::Geometry > &my_geom, amrex::Real time, const amrex::Vector< int > &level_steps, const amrex::Vector< amrex::IntVect > &my_ref_ratio, const std::string &versionName, const std::string &levelPrefix, const std::string &mfPrefix) const
Definition: ERF_Plotfile.cpp:1660
+
1586 {
+
1587  BL_PROFILE("WriteMultiLevelPlotfileWithTerrain()");
+
1588 
+
1589  AMREX_ALWAYS_ASSERT(nlevels <= mf.size());
+
1590  AMREX_ALWAYS_ASSERT(nlevels <= rr.size()+1);
+
1591  AMREX_ALWAYS_ASSERT(nlevels <= level_steps.size());
+
1592  AMREX_ALWAYS_ASSERT(mf[0]->nComp() == varnames.size());
+
1593 
+
1594  bool callBarrier(false);
+
1595  PreBuildDirectorHierarchy(plotfilename, levelPrefix, nlevels, callBarrier);
+
1596  if (!extra_dirs.empty()) {
+
1597  for (const auto& d : extra_dirs) {
+
1598  const std::string ed = plotfilename+"/"+d;
+
1599  PreBuildDirectorHierarchy(ed, levelPrefix, nlevels, callBarrier);
+
1600  }
+
1601  }
+
1602  ParallelDescriptor::Barrier();
+
1603 
+
1604  if (ParallelDescriptor::MyProc() == ParallelDescriptor::NProcs()-1) {
+
1605  Vector<BoxArray> boxArrays(nlevels);
+
1606  for(int level(0); level < boxArrays.size(); ++level) {
+
1607  boxArrays[level] = mf[level]->boxArray();
+
1608  }
+
1609 
+
1610  auto f = [=]() {
+
1611  VisMF::IO_Buffer io_buffer(VisMF::IO_Buffer_Size);
+
1612  std::string HeaderFileName(plotfilename + "/Header");
+
1613  std::ofstream HeaderFile;
+
1614  HeaderFile.rdbuf()->pubsetbuf(io_buffer.dataPtr(), io_buffer.size());
+
1615  HeaderFile.open(HeaderFileName.c_str(), std::ofstream::out |
+
1616  std::ofstream::trunc |
+
1617  std::ofstream::binary);
+
1618  if( ! HeaderFile.good()) FileOpenFailed(HeaderFileName);
+
1619  WriteGenericPlotfileHeaderWithTerrain(HeaderFile, nlevels, boxArrays, varnames,
+
1620  my_geom, time, level_steps, rr, versionName,
+
1621  levelPrefix, mfPrefix);
+
1622  };
+
1623 
+
1624  if (AsyncOut::UseAsyncOut()) {
+
1625  AsyncOut::Submit(std::move(f));
+
1626  } else {
+
1627  f();
+
1628  }
+
1629  }
+
1630 
+
1631  std::string mf_nodal_prefix = "Nu_nd";
+
1632  for (int level = 0; level <= finest_level; ++level)
+
1633  {
+
1634  if (AsyncOut::UseAsyncOut()) {
+
1635  VisMF::AsyncWrite(*mf[level],
+
1636  MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mfPrefix),
+
1637  true);
+
1638  VisMF::AsyncWrite(*mf_nd[level],
+
1639  MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_nodal_prefix),
+
1640  true);
+
1641  } else {
+
1642  const MultiFab* data;
+
1643  std::unique_ptr<MultiFab> mf_tmp;
+
1644  if (mf[level]->nGrowVect() != 0) {
+
1645  mf_tmp = std::make_unique<MultiFab>(mf[level]->boxArray(),
+
1646  mf[level]->DistributionMap(),
+
1647  mf[level]->nComp(), 0, MFInfo(),
+
1648  mf[level]->Factory());
+
1649  MultiFab::Copy(*mf_tmp, *mf[level], 0, 0, mf[level]->nComp(), 0);
+
1650  data = mf_tmp.get();
+
1651  } else {
+
1652  data = mf[level];
+
1653  }
+
1654  VisMF::Write(*data , MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mfPrefix));
+
1655  VisMF::Write(*mf_nd[level], MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_nodal_prefix));
+
1656  }
+
1657  }
+
1658 }
+
void WriteGenericPlotfileHeaderWithTerrain(std::ostream &HeaderFile, int nlevels, const amrex::Vector< amrex::BoxArray > &bArray, const amrex::Vector< std::string > &varnames, const amrex::Vector< amrex::Geometry > &my_geom, amrex::Real time, const amrex::Vector< int > &level_steps, const amrex::Vector< amrex::IntVect > &my_ref_ratio, const std::string &versionName, const std::string &levelPrefix, const std::string &mfPrefix) const
Definition: ERF_Plotfile.cpp:1661
@@ -17186,1064 +17186,1065 @@

510  }
511 
512  if( containerHasElement(plot_var_names, "SMark0") and
-
513  (solverChoice.windfarm_type == WindFarmType::SimpleAD or solverChoice.windfarm_type == WindFarmType::GeneralAD) ) {
-
514  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
515  {
-
516  const Box& bx = mfi.tilebox();
-
517  const Array4<Real>& derdat = mf[lev].array(mfi);
-
518  const Array4<Real const>& SMark_array = SMark[lev].const_array(mfi);
-
519  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
520  derdat(i, j, k, mf_comp) = SMark_array(i,j,k,0);
-
521  });
-
522  }
-
523  mf_comp ++;
-
524  }
-
525 
-
526  if(containerHasElement(plot_var_names, "SMark1") and
-
527  (solverChoice.windfarm_type == WindFarmType::SimpleAD or solverChoice.windfarm_type == WindFarmType::GeneralAD)) {
-
528  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
529  {
-
530  const Box& bx = mfi.tilebox();
-
531  const Array4<Real>& derdat = mf[lev].array(mfi);
-
532  const Array4<Real const>& SMark_array = SMark[lev].const_array(mfi);
-
533  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
534  derdat(i, j, k, mf_comp) = SMark_array(i,j,k,1);
-
535  });
-
536  }
-
537  mf_comp ++;
-
538  }
-
539 
-
540 #endif
-
541 
-
542  int klo = geom[lev].Domain().smallEnd(2);
-
543  int khi = geom[lev].Domain().bigEnd(2);
-
544 
-
545  if (containerHasElement(plot_var_names, "dpdx"))
-
546  {
-
547  auto dxInv = geom[lev].InvCellSizeArray();
-
548  MultiFab pres(vars_new[lev][Vars::cons].boxArray(), vars_new[lev][Vars::cons].DistributionMap(), 1, 1);
-
549 #ifdef _OPENMP
-
550 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
551 #endif
-
552  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
553  {
-
554  // First define pressure on grown box
-
555  const Box& gbx = mfi.growntilebox(1);
-
556  const Array4<Real > & p_arr = pres.array(mfi);
-
557  const Array4<Real const> & hse_arr = base_state[lev].const_array(mfi);
-
558  const Array4<Real const>& S_arr = vars_new[lev][Vars::cons].const_array(mfi);
-
559  if (solverChoice.anelastic[lev] == 1) {
-
560  ParallelFor(gbx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
-
561  p_arr(i,j,k) = hse_arr(i,j,k,1);
-
562  });
-
563  } else {
-
564  ParallelFor(gbx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
-
565  p_arr(i,j,k) = getPgivenRTh(S_arr(i,j,k,RhoTheta_comp));
-
566  });
-
567  }
-
568  }
-
569  pres.FillBoundary(geom[lev].periodicity());
-
570 
-
571 #ifdef _OPENMP
-
572 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
573 #endif
-
574  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
575  {
-
576  // Now compute pressure gradient on valid box
-
577  const Box& bx = mfi.tilebox();
-
578  const Array4<Real>& derdat = mf[lev].array(mfi);
-
579  const Array4<Real> & p_arr = pres.array(mfi);
-
580 
-
581  if (SolverChoice::terrain_type != TerrainType::None) {
-
582  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
-
583 
-
584  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
585 
-
586  // Pgrad at lower I face
-
587  Real met_h_xi_lo = Compute_h_xi_AtIface (i, j, k, dxInv, z_nd);
-
588  Real met_h_zeta_lo = Compute_h_zeta_AtIface(i, j, k, dxInv, z_nd);
-
589  Real gp_xi_lo = dxInv[0] * (p_arr(i,j,k) - p_arr(i-1,j,k));
-
590  Real gp_zeta_on_iface_lo;
-
591  if(k == klo) {
-
592  gp_zeta_on_iface_lo = 0.5 * dxInv[2] * (
-
593  p_arr(i-1,j,k+1) + p_arr(i,j,k+1)
-
594  - p_arr(i-1,j,k ) - p_arr(i,j,k ) );
-
595  } else if (k == khi) {
-
596  gp_zeta_on_iface_lo = 0.5 * dxInv[2] * (
-
597  p_arr(i-1,j,k ) + p_arr(i,j,k )
-
598  - p_arr(i-1,j,k-1) - p_arr(i,j,k-1) );
-
599  } else {
-
600  gp_zeta_on_iface_lo = 0.25 * dxInv[2] * (
-
601  p_arr(i-1,j,k+1) + p_arr(i,j,k+1)
-
602  - p_arr(i-1,j,k-1) - p_arr(i,j,k-1) );
-
603  }
-
604  Real gpx_lo = gp_xi_lo - (met_h_xi_lo/ met_h_zeta_lo) * gp_zeta_on_iface_lo;
-
605 
-
606  // Pgrad at higher I face
-
607  Real met_h_xi_hi = Compute_h_xi_AtIface (i+1, j, k, dxInv, z_nd);
-
608  Real met_h_zeta_hi = Compute_h_zeta_AtIface(i+1, j, k, dxInv, z_nd);
-
609  Real gp_xi_hi = dxInv[0] * (p_arr(i+1,j,k) - p_arr(i,j,k));
-
610  Real gp_zeta_on_iface_hi;
-
611  if(k == klo) {
-
612  gp_zeta_on_iface_hi = 0.5 * dxInv[2] * (
-
613  p_arr(i+1,j,k+1) + p_arr(i,j,k+1)
-
614  - p_arr(i+1,j,k ) - p_arr(i,j,k ) );
-
615  } else if (k == khi) {
-
616  gp_zeta_on_iface_hi = 0.5 * dxInv[2] * (
-
617  p_arr(i+1,j,k ) + p_arr(i,j,k )
-
618  - p_arr(i+1,j,k-1) - p_arr(i,j,k-1) );
-
619  } else {
-
620  gp_zeta_on_iface_hi = 0.25 * dxInv[2] * (
-
621  p_arr(i+1,j,k+1) + p_arr(i,j,k+1)
-
622  - p_arr(i+1,j,k-1) - p_arr(i,j,k-1) );
-
623  }
-
624  Real gpx_hi = gp_xi_hi - (met_h_xi_hi/ met_h_zeta_hi) * gp_zeta_on_iface_hi;
-
625 
-
626  // Average P grad to CC
-
627  derdat(i ,j ,k, mf_comp) = 0.5 * (gpx_lo + gpx_hi);
-
628  });
-
629  } else {
-
630  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
631  derdat(i ,j ,k, mf_comp) = 0.5 * (p_arr(i+1,j,k) - p_arr(i-1,j,k)) * dxInv[0];
-
632  });
-
633  }
-
634  } // mfi
-
635  mf_comp ++;
-
636  } // dpdx
-
637 
-
638  if (containerHasElement(plot_var_names, "dpdy"))
-
639  {
-
640  auto dxInv = geom[lev].InvCellSizeArray();
-
641 
-
642  MultiFab pres(vars_new[lev][Vars::cons].boxArray(), vars_new[lev][Vars::cons].DistributionMap(), 1, 1);
-
643 #ifdef _OPENMP
-
644 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
645 #endif
-
646  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
647  {
-
648  // First define pressure on grown box
-
649  const Box& gbx = mfi.growntilebox(1);
-
650  const Array4<Real > & p_arr = pres.array(mfi);
-
651  const Array4<Real const> & hse_arr = base_state[lev].const_array(mfi);
-
652  const Array4<Real const>& S_arr = vars_new[lev][Vars::cons].const_array(mfi);
-
653  if (solverChoice.anelastic[lev] == 1) {
-
654  ParallelFor(gbx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
-
655  p_arr(i,j,k) = hse_arr(i,j,k,1);
-
656  });
-
657  } else {
-
658  ParallelFor(gbx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
-
659  p_arr(i,j,k) = getPgivenRTh(S_arr(i,j,k,RhoTheta_comp));
-
660  });
-
661  }
-
662  }
-
663  pres.FillBoundary(geom[lev].periodicity());
-
664 
-
665 #ifdef _OPENMP
-
666 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
667 #endif
-
668  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
669  {
-
670  // Now compute pressure gradient on valid box
-
671  const Box& bx = mfi.tilebox();
-
672  const Array4<Real>& derdat = mf[lev].array(mfi);
-
673  const Array4<Real> & p_arr = pres.array(mfi);
-
674 
-
675  if (SolverChoice::terrain_type != TerrainType::None) {
-
676  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
-
677 
-
678  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
679 
-
680  Real met_h_eta_lo = Compute_h_eta_AtJface (i, j, k, dxInv, z_nd);
-
681  Real met_h_zeta_lo = Compute_h_zeta_AtJface(i, j, k, dxInv, z_nd);
-
682  Real gp_eta_lo = dxInv[1] * (p_arr(i,j,k) - p_arr(i,j-1,k));
-
683  Real gp_zeta_on_jface_lo;
-
684  if (k == klo) {
-
685  gp_zeta_on_jface_lo = 0.5 * dxInv[2] * (
-
686  p_arr(i,j,k+1) + p_arr(i,j-1,k+1)
-
687  - p_arr(i,j,k ) - p_arr(i,j-1,k ) );
-
688  } else if (k == khi) {
-
689  gp_zeta_on_jface_lo = 0.5 * dxInv[2] * (
-
690  p_arr(i,j,k ) + p_arr(i,j-1,k )
-
691  - p_arr(i,j,k-1) - p_arr(i,j-1,k-1) );
-
692  } else {
-
693  gp_zeta_on_jface_lo = 0.25 * dxInv[2] * (
-
694  p_arr(i,j,k+1) + p_arr(i,j-1,k+1)
-
695  - p_arr(i,j,k-1) - p_arr(i,j-1,k-1) );
-
696  }
-
697  Real gpy_lo = gp_eta_lo - (met_h_eta_lo / met_h_zeta_lo) * gp_zeta_on_jface_lo;
-
698 
-
699  Real met_h_eta_hi = Compute_h_eta_AtJface (i, j+1, k, dxInv, z_nd);
-
700  Real met_h_zeta_hi = Compute_h_zeta_AtJface(i, j+1, k, dxInv, z_nd);
-
701  Real gp_eta_hi = dxInv[1] * (p_arr(i,j+1,k) - p_arr(i,j,k));
-
702  Real gp_zeta_on_jface_hi;
-
703  if (k == klo) {
-
704  gp_zeta_on_jface_hi = 0.5 * dxInv[2] * (
-
705  p_arr(i,j+1,k+1) + p_arr(i,j,k+1)
-
706  - p_arr(i,j+1,k ) - p_arr(i,j,k ) );
-
707  } else if (k == khi) {
-
708  gp_zeta_on_jface_hi = 0.5 * dxInv[2] * (
-
709  p_arr(i,j+1,k ) + p_arr(i,j,k )
-
710  - p_arr(i,j+1,k-1) - p_arr(i,j,k-1) );
-
711  } else {
-
712  gp_zeta_on_jface_hi = 0.25 * dxInv[2] * (
-
713  p_arr(i,j+1,k+1) + p_arr(i,j,k+1)
-
714  - p_arr(i,j+1,k-1) - p_arr(i,j,k-1) );
-
715  }
-
716  Real gpy_hi = gp_eta_hi - (met_h_eta_hi / met_h_zeta_hi) * gp_zeta_on_jface_hi;
-
717 
-
718  derdat(i ,j ,k, mf_comp) = 0.5 * (gpy_lo + gpy_hi);
-
719  });
-
720  } else {
-
721  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
722  derdat(i ,j ,k, mf_comp) = 0.5 * (p_arr(i,j+1,k) - p_arr(i,j-1,k)) * dxInv[1];
-
723  });
-
724  }
-
725  } // mf
-
726  mf_comp ++;
-
727  } // dpdy
-
728 
-
729  if (containerHasElement(plot_var_names, "pres_hse_x"))
-
730  {
-
731  auto dxInv = geom[lev].InvCellSizeArray();
-
732 #ifdef _OPENMP
-
733 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
734 #endif
-
735  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
736  {
-
737  const Box& bx = mfi.tilebox();
-
738  const Array4<Real >& derdat = mf[lev].array(mfi);
-
739  const Array4<Real const>& p_arr = p_hse.const_array(mfi);
-
740 
-
741  //USE_TERRAIN POSSIBLE ISSUE HERE
-
742  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
-
743 
-
744  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
745  Real met_h_xi_lo = Compute_h_xi_AtIface (i, j, k, dxInv, z_nd);
-
746  Real met_h_zeta_lo = Compute_h_zeta_AtIface(i, j, k, dxInv, z_nd);
-
747  Real gp_xi_lo = dxInv[0] * (p_arr(i,j,k) - p_arr(i-1,j,k));
-
748  Real gp_zeta_on_iface_lo;
-
749  if (k == klo) {
-
750  gp_zeta_on_iface_lo = 0.5 * dxInv[2] * (
-
751  p_arr(i-1,j,k+1) + p_arr(i,j,k+1)
-
752  - p_arr(i-1,j,k ) - p_arr(i,j,k ) );
-
753  } else if (k == khi) {
-
754  gp_zeta_on_iface_lo = 0.5 * dxInv[2] * (
-
755  p_arr(i-1,j,k ) + p_arr(i,j,k )
-
756  - p_arr(i-1,j,k-1) - p_arr(i,j,k-1) );
-
757  } else {
-
758  gp_zeta_on_iface_lo = 0.25 * dxInv[2] * (
-
759  p_arr(i-1,j,k+1) + p_arr(i,j,k+1)
-
760  - p_arr(i-1,j,k-1) - p_arr(i,j,k-1) );
-
761  }
-
762  Real gpx_lo = gp_xi_lo - (met_h_xi_lo/ met_h_zeta_lo) * gp_zeta_on_iface_lo;
-
763 
-
764  Real met_h_xi_hi = Compute_h_xi_AtIface (i+1, j, k, dxInv, z_nd);
-
765  Real met_h_zeta_hi = Compute_h_zeta_AtIface(i+1, j, k, dxInv, z_nd);
-
766  Real gp_xi_hi = dxInv[0] * (p_arr(i+1,j,k) - p_arr(i,j,k));
-
767  Real gp_zeta_on_iface_hi;
-
768  if (k == klo) {
-
769  gp_zeta_on_iface_hi = 0.5 * dxInv[2] * (
-
770  p_arr(i+1,j,k+1) + p_arr(i,j,k+1)
-
771  - p_arr(i+1,j,k ) - p_arr(i,j,k ) );
-
772  } else if (k == khi) {
-
773  gp_zeta_on_iface_hi = 0.5 * dxInv[2] * (
-
774  p_arr(i+1,j,k ) + p_arr(i,j,k )
-
775  - p_arr(i+1,j,k-1) - p_arr(i,j,k-1) );
-
776  } else {
-
777  gp_zeta_on_iface_hi = 0.25 * dxInv[2] * (
-
778  p_arr(i+1,j,k+1) + p_arr(i,j,k+1)
-
779  - p_arr(i+1,j,k-1) - p_arr(i,j,k-1) );
-
780  }
-
781  Real gpx_hi = gp_xi_hi - (met_h_xi_hi/ met_h_zeta_hi) * gp_zeta_on_iface_hi;
-
782 
-
783  derdat(i ,j ,k, mf_comp) = 0.5 * (gpx_lo + gpx_hi);
-
784  });
-
785  }
-
786  mf_comp += 1;
-
787  } // pres_hse_x
-
788 
-
789  if (containerHasElement(plot_var_names, "pres_hse_y"))
-
790  {
-
791  auto dxInv = geom[lev].InvCellSizeArray();
-
792 #ifdef _OPENMP
-
793 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
794 #endif
-
795  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
796  {
-
797  const Box& bx = mfi.tilebox();
-
798  const Array4<Real >& derdat = mf[lev].array(mfi);
-
799  const Array4<Real const>& p_arr = p_hse.const_array(mfi);
-
800  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
-
801  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
802  Real met_h_eta_lo = Compute_h_eta_AtJface (i, j, k, dxInv, z_nd);
-
803  Real met_h_zeta_lo = Compute_h_zeta_AtJface(i, j, k, dxInv, z_nd);
-
804  Real gp_eta_lo = dxInv[1] * (p_arr(i,j,k) - p_arr(i,j-1,k));
-
805  Real gp_zeta_on_jface_lo;
-
806  if (k == klo) {
-
807  gp_zeta_on_jface_lo = 0.5 * dxInv[2] * (
-
808  p_arr(i,j,k+1) + p_arr(i,j-1,k+1)
-
809  - p_arr(i,j,k ) - p_arr(i,j-1,k ) );
-
810  } else if (k == khi) {
-
811  gp_zeta_on_jface_lo = 0.5 * dxInv[2] * (
-
812  p_arr(i,j,k ) + p_arr(i,j-1,k )
-
813  - p_arr(i,j,k-1) - p_arr(i,j-1,k-1) );
-
814  } else {
-
815  gp_zeta_on_jface_lo = 0.25 * dxInv[2] * (
-
816  p_arr(i,j,k+1) + p_arr(i,j-1,k+1)
-
817  - p_arr(i,j,k-1) - p_arr(i,j-1,k-1) );
-
818  }
-
819  Real gpy_lo = gp_eta_lo - (met_h_eta_lo / met_h_zeta_lo) * gp_zeta_on_jface_lo;
-
820 
-
821  Real met_h_eta_hi = Compute_h_eta_AtJface (i, j+1, k, dxInv, z_nd);
-
822  Real met_h_zeta_hi = Compute_h_zeta_AtJface(i, j+1, k, dxInv, z_nd);
-
823  Real gp_eta_hi = dxInv[1] * (p_arr(i,j+1,k) - p_arr(i,j,k));
-
824  Real gp_zeta_on_jface_hi;
-
825  if (k == klo) {
-
826  gp_zeta_on_jface_hi = 0.5 * dxInv[2] * (
-
827  p_arr(i,j+1,k+1) + p_arr(i,j,k+1)
-
828  - p_arr(i,j+1,k ) - p_arr(i,j,k ) );
-
829  } else if (k == khi) {
-
830  gp_zeta_on_jface_hi = 0.5 * dxInv[2] * (
-
831  p_arr(i,j+1,k ) + p_arr(i,j,k )
-
832  - p_arr(i,j+1,k-1) - p_arr(i,j,k-1) );
-
833  } else {
-
834  gp_zeta_on_jface_hi = 0.25 * dxInv[2] * (
-
835  p_arr(i,j+1,k+1) + p_arr(i,j,k+1)
-
836  - p_arr(i,j+1,k-1) - p_arr(i,j,k-1) );
-
837  }
-
838  Real gpy_hi = gp_eta_hi - (met_h_eta_hi / met_h_zeta_hi) * gp_zeta_on_jface_hi;
-
839 
-
840  derdat(i ,j ,k, mf_comp) = 0.5 * (gpy_lo + gpy_hi);
-
841  });
-
842  }
-
843  mf_comp += 1;
-
844  } // pres_hse_y
-
845 
-
846  if (SolverChoice::terrain_type != TerrainType::None) {
-
847  if (containerHasElement(plot_var_names, "z_phys"))
-
848  {
-
849  MultiFab::Copy(mf[lev],*z_phys_cc[lev],0,mf_comp,1,0);
-
850  mf_comp ++;
-
851  }
-
852 
-
853  if (containerHasElement(plot_var_names, "detJ"))
-
854  {
-
855  MultiFab::Copy(mf[lev],*detJ_cc[lev],0,mf_comp,1,0);
-
856  mf_comp ++;
-
857  }
-
858  } // use_terrain
-
859 
-
860  if (containerHasElement(plot_var_names, "mapfac")) {
-
861 #ifdef _OPENMP
-
862 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
863 #endif
-
864  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
865  {
-
866  const Box& bx = mfi.tilebox();
-
867  const Array4<Real>& derdat = mf[lev].array(mfi);
-
868  const Array4<Real>& mf_m = mapfac_m[lev]->array(mfi);
-
869  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
870  derdat(i ,j ,k, mf_comp) = mf_m(i,j,0);
-
871  });
-
872  }
-
873  mf_comp ++;
-
874  }
-
875 
-
876 #ifdef ERF_USE_NETCDF
-
877  if (use_real_bcs) {
-
878  if (containerHasElement(plot_var_names, "lat_m")) {
-
879 #ifdef _OPENMP
-
880 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
881 #endif
-
882  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
883  {
-
884  const Box& bx = mfi.tilebox();
-
885  const Array4<Real>& derdat = mf[lev].array(mfi);
-
886  const Array4<Real>& data = lat_m[lev]->array(mfi);
-
887  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
888  derdat(i, j, k, mf_comp) = data(i,j,0);
-
889  });
-
890  }
-
891  mf_comp ++;
-
892  } // lat_m
-
893  if (containerHasElement(plot_var_names, "lon_m")) {
-
894 #ifdef _OPENMP
-
895 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
896 #endif
-
897  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
898  {
-
899  const Box& bx = mfi.tilebox();
-
900  const Array4<Real>& derdat = mf[lev].array(mfi);
-
901  const Array4<Real>& data = lon_m[lev]->array(mfi);
-
902  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
903  derdat(i, j, k, mf_comp) = data(i,j,0);
-
904  });
-
905  }
-
906  mf_comp ++;
-
907  } // lon_m
-
908  } // use_real_bcs
-
909 #endif
-
910 
+
513  (solverChoice.windfarm_type == WindFarmType::Fitch or solverChoice.windfarm_type == WindFarmType::EWP or
+
514  solverChoice.windfarm_type == WindFarmType::SimpleAD or solverChoice.windfarm_type == WindFarmType::GeneralAD) ) {
+
515  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
516  {
+
517  const Box& bx = mfi.tilebox();
+
518  const Array4<Real>& derdat = mf[lev].array(mfi);
+
519  const Array4<Real const>& SMark_array = SMark[lev].const_array(mfi);
+
520  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
521  derdat(i, j, k, mf_comp) = SMark_array(i,j,k,0);
+
522  });
+
523  }
+
524  mf_comp ++;
+
525  }
+
526 
+
527  if(containerHasElement(plot_var_names, "SMark1") and
+
528  (solverChoice.windfarm_type == WindFarmType::SimpleAD or solverChoice.windfarm_type == WindFarmType::GeneralAD)) {
+
529  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
530  {
+
531  const Box& bx = mfi.tilebox();
+
532  const Array4<Real>& derdat = mf[lev].array(mfi);
+
533  const Array4<Real const>& SMark_array = SMark[lev].const_array(mfi);
+
534  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
535  derdat(i, j, k, mf_comp) = SMark_array(i,j,k,1);
+
536  });
+
537  }
+
538  mf_comp ++;
+
539  }
+
540 
+
541 #endif
+
542 
+
543  int klo = geom[lev].Domain().smallEnd(2);
+
544  int khi = geom[lev].Domain().bigEnd(2);
+
545 
+
546  if (containerHasElement(plot_var_names, "dpdx"))
+
547  {
+
548  auto dxInv = geom[lev].InvCellSizeArray();
+
549  MultiFab pres(vars_new[lev][Vars::cons].boxArray(), vars_new[lev][Vars::cons].DistributionMap(), 1, 1);
+
550 #ifdef _OPENMP
+
551 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
552 #endif
+
553  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
554  {
+
555  // First define pressure on grown box
+
556  const Box& gbx = mfi.growntilebox(1);
+
557  const Array4<Real > & p_arr = pres.array(mfi);
+
558  const Array4<Real const> & hse_arr = base_state[lev].const_array(mfi);
+
559  const Array4<Real const>& S_arr = vars_new[lev][Vars::cons].const_array(mfi);
+
560  if (solverChoice.anelastic[lev] == 1) {
+
561  ParallelFor(gbx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
+
562  p_arr(i,j,k) = hse_arr(i,j,k,1);
+
563  });
+
564  } else {
+
565  ParallelFor(gbx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
+
566  p_arr(i,j,k) = getPgivenRTh(S_arr(i,j,k,RhoTheta_comp));
+
567  });
+
568  }
+
569  }
+
570  pres.FillBoundary(geom[lev].periodicity());
+
571 
+
572 #ifdef _OPENMP
+
573 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
574 #endif
+
575  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
576  {
+
577  // Now compute pressure gradient on valid box
+
578  const Box& bx = mfi.tilebox();
+
579  const Array4<Real>& derdat = mf[lev].array(mfi);
+
580  const Array4<Real> & p_arr = pres.array(mfi);
+
581 
+
582  if (SolverChoice::terrain_type != TerrainType::None) {
+
583  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
+
584 
+
585  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
586 
+
587  // Pgrad at lower I face
+
588  Real met_h_xi_lo = Compute_h_xi_AtIface (i, j, k, dxInv, z_nd);
+
589  Real met_h_zeta_lo = Compute_h_zeta_AtIface(i, j, k, dxInv, z_nd);
+
590  Real gp_xi_lo = dxInv[0] * (p_arr(i,j,k) - p_arr(i-1,j,k));
+
591  Real gp_zeta_on_iface_lo;
+
592  if(k == klo) {
+
593  gp_zeta_on_iface_lo = 0.5 * dxInv[2] * (
+
594  p_arr(i-1,j,k+1) + p_arr(i,j,k+1)
+
595  - p_arr(i-1,j,k ) - p_arr(i,j,k ) );
+
596  } else if (k == khi) {
+
597  gp_zeta_on_iface_lo = 0.5 * dxInv[2] * (
+
598  p_arr(i-1,j,k ) + p_arr(i,j,k )
+
599  - p_arr(i-1,j,k-1) - p_arr(i,j,k-1) );
+
600  } else {
+
601  gp_zeta_on_iface_lo = 0.25 * dxInv[2] * (
+
602  p_arr(i-1,j,k+1) + p_arr(i,j,k+1)
+
603  - p_arr(i-1,j,k-1) - p_arr(i,j,k-1) );
+
604  }
+
605  Real gpx_lo = gp_xi_lo - (met_h_xi_lo/ met_h_zeta_lo) * gp_zeta_on_iface_lo;
+
606 
+
607  // Pgrad at higher I face
+
608  Real met_h_xi_hi = Compute_h_xi_AtIface (i+1, j, k, dxInv, z_nd);
+
609  Real met_h_zeta_hi = Compute_h_zeta_AtIface(i+1, j, k, dxInv, z_nd);
+
610  Real gp_xi_hi = dxInv[0] * (p_arr(i+1,j,k) - p_arr(i,j,k));
+
611  Real gp_zeta_on_iface_hi;
+
612  if(k == klo) {
+
613  gp_zeta_on_iface_hi = 0.5 * dxInv[2] * (
+
614  p_arr(i+1,j,k+1) + p_arr(i,j,k+1)
+
615  - p_arr(i+1,j,k ) - p_arr(i,j,k ) );
+
616  } else if (k == khi) {
+
617  gp_zeta_on_iface_hi = 0.5 * dxInv[2] * (
+
618  p_arr(i+1,j,k ) + p_arr(i,j,k )
+
619  - p_arr(i+1,j,k-1) - p_arr(i,j,k-1) );
+
620  } else {
+
621  gp_zeta_on_iface_hi = 0.25 * dxInv[2] * (
+
622  p_arr(i+1,j,k+1) + p_arr(i,j,k+1)
+
623  - p_arr(i+1,j,k-1) - p_arr(i,j,k-1) );
+
624  }
+
625  Real gpx_hi = gp_xi_hi - (met_h_xi_hi/ met_h_zeta_hi) * gp_zeta_on_iface_hi;
+
626 
+
627  // Average P grad to CC
+
628  derdat(i ,j ,k, mf_comp) = 0.5 * (gpx_lo + gpx_hi);
+
629  });
+
630  } else {
+
631  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
632  derdat(i ,j ,k, mf_comp) = 0.5 * (p_arr(i+1,j,k) - p_arr(i-1,j,k)) * dxInv[0];
+
633  });
+
634  }
+
635  } // mfi
+
636  mf_comp ++;
+
637  } // dpdx
+
638 
+
639  if (containerHasElement(plot_var_names, "dpdy"))
+
640  {
+
641  auto dxInv = geom[lev].InvCellSizeArray();
+
642 
+
643  MultiFab pres(vars_new[lev][Vars::cons].boxArray(), vars_new[lev][Vars::cons].DistributionMap(), 1, 1);
+
644 #ifdef _OPENMP
+
645 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
646 #endif
+
647  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
648  {
+
649  // First define pressure on grown box
+
650  const Box& gbx = mfi.growntilebox(1);
+
651  const Array4<Real > & p_arr = pres.array(mfi);
+
652  const Array4<Real const> & hse_arr = base_state[lev].const_array(mfi);
+
653  const Array4<Real const>& S_arr = vars_new[lev][Vars::cons].const_array(mfi);
+
654  if (solverChoice.anelastic[lev] == 1) {
+
655  ParallelFor(gbx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
+
656  p_arr(i,j,k) = hse_arr(i,j,k,1);
+
657  });
+
658  } else {
+
659  ParallelFor(gbx, [=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept {
+
660  p_arr(i,j,k) = getPgivenRTh(S_arr(i,j,k,RhoTheta_comp));
+
661  });
+
662  }
+
663  }
+
664  pres.FillBoundary(geom[lev].periodicity());
+
665 
+
666 #ifdef _OPENMP
+
667 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
668 #endif
+
669  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
670  {
+
671  // Now compute pressure gradient on valid box
+
672  const Box& bx = mfi.tilebox();
+
673  const Array4<Real>& derdat = mf[lev].array(mfi);
+
674  const Array4<Real> & p_arr = pres.array(mfi);
+
675 
+
676  if (SolverChoice::terrain_type != TerrainType::None) {
+
677  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
+
678 
+
679  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
680 
+
681  Real met_h_eta_lo = Compute_h_eta_AtJface (i, j, k, dxInv, z_nd);
+
682  Real met_h_zeta_lo = Compute_h_zeta_AtJface(i, j, k, dxInv, z_nd);
+
683  Real gp_eta_lo = dxInv[1] * (p_arr(i,j,k) - p_arr(i,j-1,k));
+
684  Real gp_zeta_on_jface_lo;
+
685  if (k == klo) {
+
686  gp_zeta_on_jface_lo = 0.5 * dxInv[2] * (
+
687  p_arr(i,j,k+1) + p_arr(i,j-1,k+1)
+
688  - p_arr(i,j,k ) - p_arr(i,j-1,k ) );
+
689  } else if (k == khi) {
+
690  gp_zeta_on_jface_lo = 0.5 * dxInv[2] * (
+
691  p_arr(i,j,k ) + p_arr(i,j-1,k )
+
692  - p_arr(i,j,k-1) - p_arr(i,j-1,k-1) );
+
693  } else {
+
694  gp_zeta_on_jface_lo = 0.25 * dxInv[2] * (
+
695  p_arr(i,j,k+1) + p_arr(i,j-1,k+1)
+
696  - p_arr(i,j,k-1) - p_arr(i,j-1,k-1) );
+
697  }
+
698  Real gpy_lo = gp_eta_lo - (met_h_eta_lo / met_h_zeta_lo) * gp_zeta_on_jface_lo;
+
699 
+
700  Real met_h_eta_hi = Compute_h_eta_AtJface (i, j+1, k, dxInv, z_nd);
+
701  Real met_h_zeta_hi = Compute_h_zeta_AtJface(i, j+1, k, dxInv, z_nd);
+
702  Real gp_eta_hi = dxInv[1] * (p_arr(i,j+1,k) - p_arr(i,j,k));
+
703  Real gp_zeta_on_jface_hi;
+
704  if (k == klo) {
+
705  gp_zeta_on_jface_hi = 0.5 * dxInv[2] * (
+
706  p_arr(i,j+1,k+1) + p_arr(i,j,k+1)
+
707  - p_arr(i,j+1,k ) - p_arr(i,j,k ) );
+
708  } else if (k == khi) {
+
709  gp_zeta_on_jface_hi = 0.5 * dxInv[2] * (
+
710  p_arr(i,j+1,k ) + p_arr(i,j,k )
+
711  - p_arr(i,j+1,k-1) - p_arr(i,j,k-1) );
+
712  } else {
+
713  gp_zeta_on_jface_hi = 0.25 * dxInv[2] * (
+
714  p_arr(i,j+1,k+1) + p_arr(i,j,k+1)
+
715  - p_arr(i,j+1,k-1) - p_arr(i,j,k-1) );
+
716  }
+
717  Real gpy_hi = gp_eta_hi - (met_h_eta_hi / met_h_zeta_hi) * gp_zeta_on_jface_hi;
+
718 
+
719  derdat(i ,j ,k, mf_comp) = 0.5 * (gpy_lo + gpy_hi);
+
720  });
+
721  } else {
+
722  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
723  derdat(i ,j ,k, mf_comp) = 0.5 * (p_arr(i,j+1,k) - p_arr(i,j-1,k)) * dxInv[1];
+
724  });
+
725  }
+
726  } // mf
+
727  mf_comp ++;
+
728  } // dpdy
+
729 
+
730  if (containerHasElement(plot_var_names, "pres_hse_x"))
+
731  {
+
732  auto dxInv = geom[lev].InvCellSizeArray();
+
733 #ifdef _OPENMP
+
734 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
735 #endif
+
736  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
737  {
+
738  const Box& bx = mfi.tilebox();
+
739  const Array4<Real >& derdat = mf[lev].array(mfi);
+
740  const Array4<Real const>& p_arr = p_hse.const_array(mfi);
+
741 
+
742  //USE_TERRAIN POSSIBLE ISSUE HERE
+
743  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
+
744 
+
745  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
746  Real met_h_xi_lo = Compute_h_xi_AtIface (i, j, k, dxInv, z_nd);
+
747  Real met_h_zeta_lo = Compute_h_zeta_AtIface(i, j, k, dxInv, z_nd);
+
748  Real gp_xi_lo = dxInv[0] * (p_arr(i,j,k) - p_arr(i-1,j,k));
+
749  Real gp_zeta_on_iface_lo;
+
750  if (k == klo) {
+
751  gp_zeta_on_iface_lo = 0.5 * dxInv[2] * (
+
752  p_arr(i-1,j,k+1) + p_arr(i,j,k+1)
+
753  - p_arr(i-1,j,k ) - p_arr(i,j,k ) );
+
754  } else if (k == khi) {
+
755  gp_zeta_on_iface_lo = 0.5 * dxInv[2] * (
+
756  p_arr(i-1,j,k ) + p_arr(i,j,k )
+
757  - p_arr(i-1,j,k-1) - p_arr(i,j,k-1) );
+
758  } else {
+
759  gp_zeta_on_iface_lo = 0.25 * dxInv[2] * (
+
760  p_arr(i-1,j,k+1) + p_arr(i,j,k+1)
+
761  - p_arr(i-1,j,k-1) - p_arr(i,j,k-1) );
+
762  }
+
763  Real gpx_lo = gp_xi_lo - (met_h_xi_lo/ met_h_zeta_lo) * gp_zeta_on_iface_lo;
+
764 
+
765  Real met_h_xi_hi = Compute_h_xi_AtIface (i+1, j, k, dxInv, z_nd);
+
766  Real met_h_zeta_hi = Compute_h_zeta_AtIface(i+1, j, k, dxInv, z_nd);
+
767  Real gp_xi_hi = dxInv[0] * (p_arr(i+1,j,k) - p_arr(i,j,k));
+
768  Real gp_zeta_on_iface_hi;
+
769  if (k == klo) {
+
770  gp_zeta_on_iface_hi = 0.5 * dxInv[2] * (
+
771  p_arr(i+1,j,k+1) + p_arr(i,j,k+1)
+
772  - p_arr(i+1,j,k ) - p_arr(i,j,k ) );
+
773  } else if (k == khi) {
+
774  gp_zeta_on_iface_hi = 0.5 * dxInv[2] * (
+
775  p_arr(i+1,j,k ) + p_arr(i,j,k )
+
776  - p_arr(i+1,j,k-1) - p_arr(i,j,k-1) );
+
777  } else {
+
778  gp_zeta_on_iface_hi = 0.25 * dxInv[2] * (
+
779  p_arr(i+1,j,k+1) + p_arr(i,j,k+1)
+
780  - p_arr(i+1,j,k-1) - p_arr(i,j,k-1) );
+
781  }
+
782  Real gpx_hi = gp_xi_hi - (met_h_xi_hi/ met_h_zeta_hi) * gp_zeta_on_iface_hi;
+
783 
+
784  derdat(i ,j ,k, mf_comp) = 0.5 * (gpx_lo + gpx_hi);
+
785  });
+
786  }
+
787  mf_comp += 1;
+
788  } // pres_hse_x
+
789 
+
790  if (containerHasElement(plot_var_names, "pres_hse_y"))
+
791  {
+
792  auto dxInv = geom[lev].InvCellSizeArray();
+
793 #ifdef _OPENMP
+
794 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
795 #endif
+
796  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
797  {
+
798  const Box& bx = mfi.tilebox();
+
799  const Array4<Real >& derdat = mf[lev].array(mfi);
+
800  const Array4<Real const>& p_arr = p_hse.const_array(mfi);
+
801  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
+
802  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
803  Real met_h_eta_lo = Compute_h_eta_AtJface (i, j, k, dxInv, z_nd);
+
804  Real met_h_zeta_lo = Compute_h_zeta_AtJface(i, j, k, dxInv, z_nd);
+
805  Real gp_eta_lo = dxInv[1] * (p_arr(i,j,k) - p_arr(i,j-1,k));
+
806  Real gp_zeta_on_jface_lo;
+
807  if (k == klo) {
+
808  gp_zeta_on_jface_lo = 0.5 * dxInv[2] * (
+
809  p_arr(i,j,k+1) + p_arr(i,j-1,k+1)
+
810  - p_arr(i,j,k ) - p_arr(i,j-1,k ) );
+
811  } else if (k == khi) {
+
812  gp_zeta_on_jface_lo = 0.5 * dxInv[2] * (
+
813  p_arr(i,j,k ) + p_arr(i,j-1,k )
+
814  - p_arr(i,j,k-1) - p_arr(i,j-1,k-1) );
+
815  } else {
+
816  gp_zeta_on_jface_lo = 0.25 * dxInv[2] * (
+
817  p_arr(i,j,k+1) + p_arr(i,j-1,k+1)
+
818  - p_arr(i,j,k-1) - p_arr(i,j-1,k-1) );
+
819  }
+
820  Real gpy_lo = gp_eta_lo - (met_h_eta_lo / met_h_zeta_lo) * gp_zeta_on_jface_lo;
+
821 
+
822  Real met_h_eta_hi = Compute_h_eta_AtJface (i, j+1, k, dxInv, z_nd);
+
823  Real met_h_zeta_hi = Compute_h_zeta_AtJface(i, j+1, k, dxInv, z_nd);
+
824  Real gp_eta_hi = dxInv[1] * (p_arr(i,j+1,k) - p_arr(i,j,k));
+
825  Real gp_zeta_on_jface_hi;
+
826  if (k == klo) {
+
827  gp_zeta_on_jface_hi = 0.5 * dxInv[2] * (
+
828  p_arr(i,j+1,k+1) + p_arr(i,j,k+1)
+
829  - p_arr(i,j+1,k ) - p_arr(i,j,k ) );
+
830  } else if (k == khi) {
+
831  gp_zeta_on_jface_hi = 0.5 * dxInv[2] * (
+
832  p_arr(i,j+1,k ) + p_arr(i,j,k )
+
833  - p_arr(i,j+1,k-1) - p_arr(i,j,k-1) );
+
834  } else {
+
835  gp_zeta_on_jface_hi = 0.25 * dxInv[2] * (
+
836  p_arr(i,j+1,k+1) + p_arr(i,j,k+1)
+
837  - p_arr(i,j+1,k-1) - p_arr(i,j,k-1) );
+
838  }
+
839  Real gpy_hi = gp_eta_hi - (met_h_eta_hi / met_h_zeta_hi) * gp_zeta_on_jface_hi;
+
840 
+
841  derdat(i ,j ,k, mf_comp) = 0.5 * (gpy_lo + gpy_hi);
+
842  });
+
843  }
+
844  mf_comp += 1;
+
845  } // pres_hse_y
+
846 
+
847  if (SolverChoice::terrain_type != TerrainType::None) {
+
848  if (containerHasElement(plot_var_names, "z_phys"))
+
849  {
+
850  MultiFab::Copy(mf[lev],*z_phys_cc[lev],0,mf_comp,1,0);
+
851  mf_comp ++;
+
852  }
+
853 
+
854  if (containerHasElement(plot_var_names, "detJ"))
+
855  {
+
856  MultiFab::Copy(mf[lev],*detJ_cc[lev],0,mf_comp,1,0);
+
857  mf_comp ++;
+
858  }
+
859  } // use_terrain
+
860 
+
861  if (containerHasElement(plot_var_names, "mapfac")) {
+
862 #ifdef _OPENMP
+
863 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
864 #endif
+
865  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
866  {
+
867  const Box& bx = mfi.tilebox();
+
868  const Array4<Real>& derdat = mf[lev].array(mfi);
+
869  const Array4<Real>& mf_m = mapfac_m[lev]->array(mfi);
+
870  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
871  derdat(i ,j ,k, mf_comp) = mf_m(i,j,0);
+
872  });
+
873  }
+
874  mf_comp ++;
+
875  }
+
876 
+
877 #ifdef ERF_USE_NETCDF
+
878  if (use_real_bcs) {
+
879  if (containerHasElement(plot_var_names, "lat_m")) {
+
880 #ifdef _OPENMP
+
881 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
882 #endif
+
883  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
884  {
+
885  const Box& bx = mfi.tilebox();
+
886  const Array4<Real>& derdat = mf[lev].array(mfi);
+
887  const Array4<Real>& data = lat_m[lev]->array(mfi);
+
888  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
889  derdat(i, j, k, mf_comp) = data(i,j,0);
+
890  });
+
891  }
+
892  mf_comp ++;
+
893  } // lat_m
+
894  if (containerHasElement(plot_var_names, "lon_m")) {
+
895 #ifdef _OPENMP
+
896 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
897 #endif
+
898  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
899  {
+
900  const Box& bx = mfi.tilebox();
+
901  const Array4<Real>& derdat = mf[lev].array(mfi);
+
902  const Array4<Real>& data = lon_m[lev]->array(mfi);
+
903  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
904  derdat(i, j, k, mf_comp) = data(i,j,0);
+
905  });
+
906  }
+
907  mf_comp ++;
+
908  } // lon_m
+
909  } // use_real_bcs
+
910 #endif
911 
- -
913  if (containerHasElement(plot_var_names, "u_t_avg")) {
-
914 #ifdef _OPENMP
-
915 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
916 #endif
-
917  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
918  {
-
919  const Box& bx = mfi.tilebox();
-
920  const Array4<Real>& derdat = mf[lev].array(mfi);
-
921  const Array4<Real>& data = vel_t_avg[lev]->array(mfi);
-
922  const Real norm = t_avg_cnt[lev];
-
923  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
924  {
-
925  derdat(i ,j ,k, mf_comp) = data(i,j,k,0) / norm;
-
926  });
-
927  }
-
928  mf_comp ++;
-
929  }
-
930 
-
931  if (containerHasElement(plot_var_names, "v_t_avg")) {
-
932 #ifdef _OPENMP
-
933 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
934 #endif
-
935  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
936  {
-
937  const Box& bx = mfi.tilebox();
-
938  const Array4<Real>& derdat = mf[lev].array(mfi);
-
939  const Array4<Real>& data = vel_t_avg[lev]->array(mfi);
-
940  const Real norm = t_avg_cnt[lev];
-
941  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
942  {
-
943  derdat(i ,j ,k, mf_comp) = data(i,j,k,1) / norm;
-
944  });
-
945  }
-
946  mf_comp ++;
-
947  }
-
948 
-
949  if (containerHasElement(plot_var_names, "w_t_avg")) {
-
950 #ifdef _OPENMP
-
951 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
952 #endif
-
953  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
954  {
-
955  const Box& bx = mfi.tilebox();
-
956  const Array4<Real>& derdat = mf[lev].array(mfi);
-
957  const Array4<Real>& data = vel_t_avg[lev]->array(mfi);
-
958  const Real norm = t_avg_cnt[lev];
-
959  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
960  {
-
961  derdat(i ,j ,k, mf_comp) = data(i,j,k,2) / norm;
-
962  });
-
963  }
-
964  mf_comp ++;
-
965  }
-
966 
-
967  if (containerHasElement(plot_var_names, "umag_t_avg")) {
-
968 #ifdef _OPENMP
-
969 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
970 #endif
-
971  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
972  {
-
973  const Box& bx = mfi.tilebox();
-
974  const Array4<Real>& derdat = mf[lev].array(mfi);
-
975  const Array4<Real>& data = vel_t_avg[lev]->array(mfi);
-
976  const Real norm = t_avg_cnt[lev];
-
977  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
978  {
-
979  derdat(i ,j ,k, mf_comp) = data(i,j,k,3) / norm;
-
980  });
-
981  }
-
982  mf_comp ++;
-
983  }
-
984  }
-
985 
-
986  if (containerHasElement(plot_var_names, "Kmv")) {
-
987  MultiFab::Copy(mf[lev],*eddyDiffs_lev[lev],EddyDiff::Mom_v,mf_comp,1,0);
-
988  mf_comp ++;
-
989  }
-
990  if (containerHasElement(plot_var_names, "Kmh")) {
-
991  MultiFab::Copy(mf[lev],*eddyDiffs_lev[lev],EddyDiff::Mom_h,mf_comp,1,0);
-
992  mf_comp ++;
-
993  }
-
994  if (containerHasElement(plot_var_names, "Khv")) {
-
995  MultiFab::Copy(mf[lev],*eddyDiffs_lev[lev],EddyDiff::Theta_v,mf_comp,1,0);
-
996  mf_comp ++;
-
997  }
-
998  if (containerHasElement(plot_var_names, "Khh")) {
-
999  MultiFab::Copy(mf[lev],*eddyDiffs_lev[lev],EddyDiff::Theta_h,mf_comp,1,0);
-
1000  mf_comp ++;
-
1001  }
-
1002  if (containerHasElement(plot_var_names, "Lturb")) {
-
1003  MultiFab::Copy(mf[lev],*eddyDiffs_lev[lev],EddyDiff::Turb_lengthscale,mf_comp,1,0);
-
1004  mf_comp ++;
-
1005  }
-
1006 
-
1007  // TODO: The size of the q variables can vary with different
-
1008  // moisture models. Therefore, certain components may
-
1009  // reside at different indices. For example, Kessler is
-
1010  // warm but precipitating. This puts qp at index 3.
-
1011  // However, SAM is cold and precipitating so qp is index 4.
-
1012  // Need to built an external enum struct or a better pathway.
-
1013 
-
1014  // NOTE: Protect against accessing non-existent data
-
1015  if (use_moisture) {
-
1016  int n_qstate = micro->Get_Qstate_Size();
-
1017 
-
1018  // Non-precipitating components
-
1019  //--------------------------------------------------------------------------
-
1020  if(containerHasElement(plot_var_names, "qt"))
-
1021  {
-
1022  int n_start = RhoQ1_comp; // qv
-
1023  int n_end = RhoQ2_comp; // qc
-
1024  if (n_qstate > 3) n_end = RhoQ3_comp; // qi
-
1025  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], n_start, mf_comp, 1, 0);
-
1026  for (int n_comp(n_start+1); n_comp <= n_end; ++n_comp) {
-
1027  MultiFab::Add(mf[lev], vars_new[lev][Vars::cons], n_comp, mf_comp, 1, 0);
-
1028  }
-
1029  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp , mf_comp, 1, 0);
-
1030  mf_comp += 1;
-
1031  }
-
1032 
-
1033  if(containerHasElement(plot_var_names, "qv") && (n_qstate >= 1))
-
1034  {
-
1035  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], RhoQ1_comp, mf_comp, 1, 0);
-
1036  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp , mf_comp, 1, 0);
-
1037  mf_comp += 1;
-
1038  }
-
1039 
-
1040  if(containerHasElement(plot_var_names, "qc") && (n_qstate >= 2))
-
1041  {
-
1042  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], RhoQ2_comp, mf_comp, 1, 0);
-
1043  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp , mf_comp, 1, 0);
-
1044  mf_comp += 1;
-
1045  }
-
1046 
-
1047  if(containerHasElement(plot_var_names, "qi") && (n_qstate >= 4))
-
1048  {
-
1049  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], RhoQ3_comp, mf_comp, 1, 0);
-
1050  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp , mf_comp, 1, 0);
-
1051  mf_comp += 1;
-
1052  }
-
1053 
-
1054  // Precipitating components
-
1055  //--------------------------------------------------------------------------
-
1056  if(containerHasElement(plot_var_names, "qp"))
-
1057  {
-
1058  int n_start = (n_qstate > 3) ? RhoQ4_comp : RhoQ3_comp;
-
1059  int n_end = ncomp_cons - 1;
-
1060  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], n_start, mf_comp, 1, 0);
-
1061  for (int n_comp(n_start+1); n_comp <= n_end; ++n_comp) {
-
1062  MultiFab::Add( mf[lev], vars_new[lev][Vars::cons], n_comp, mf_comp, 1, 0);
-
1063  }
-
1064  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp , mf_comp, 1, 0);
-
1065  mf_comp += 1;
-
1066  }
-
1067 
-
1068  if(containerHasElement(plot_var_names, "qrain") && (n_qstate >= 3))
-
1069  {
-
1070  int n_start = (n_qstate > 3) ? RhoQ4_comp : RhoQ3_comp;
-
1071  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], n_start , mf_comp, 1, 0);
-
1072  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp, mf_comp, 1, 0);
-
1073  mf_comp += 1;
-
1074  }
-
1075 
-
1076  if(containerHasElement(plot_var_names, "qsnow") && (n_qstate >= 5))
-
1077  {
-
1078  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], RhoQ5_comp, mf_comp, 1, 0);
-
1079  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp, mf_comp, 1, 0);
-
1080  mf_comp += 1;
-
1081  }
-
1082 
-
1083  if(containerHasElement(plot_var_names, "qgraup") && (n_qstate >= 6))
-
1084  {
-
1085  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], RhoQ6_comp, mf_comp, 1, 0);
-
1086  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp, mf_comp, 1, 0);
-
1087  mf_comp += 1;
-
1088  }
-
1089 
-
1090  if (containerHasElement(plot_var_names, "qsat"))
-
1091  {
-
1092 #ifdef _OPENMP
-
1093 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
1094 #endif
-
1095  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
1096  {
-
1097  const Box& bx = mfi.tilebox();
-
1098  const Array4<Real>& derdat = mf[lev].array(mfi);
-
1099  const Array4<Real const>& S_arr = vars_new[lev][Vars::cons].const_array(mfi);
-
1100  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
1101  {
-
1102  Real qv = S_arr(i,j,k,RhoQ1_comp) / S_arr(i,j,k,Rho_comp);
-
1103  Real T = getTgivenRandRTh(S_arr(i,j,k,Rho_comp), S_arr(i,j,k,RhoTheta_comp), qv);
-
1104  Real pressure = getPgivenRTh(S_arr(i,j,k,RhoTheta_comp), qv) * Real(0.01);
-
1105  erf_qsatw(T, pressure, derdat(i,j,k,mf_comp));
-
1106  });
-
1107  }
-
1108  mf_comp ++;
-
1109  }
-
1110 
-
1111  if(solverChoice.moisture_type == MoistureType::Kessler){
-
1112  if (containerHasElement(plot_var_names, "rain_accum"))
-
1113  {
-
1114  MultiFab::Copy(mf[lev],*(qmoist[lev][4]),0,mf_comp,1,0);
-
1115  mf_comp += 1;
-
1116  }
-
1117  }
-
1118  else if(solverChoice.moisture_type == MoistureType::SAM)
-
1119  {
-
1120  if (containerHasElement(plot_var_names, "rain_accum"))
-
1121  {
-
1122  MultiFab::Copy(mf[lev],*(qmoist[lev][8]),0,mf_comp,1,0);
-
1123  mf_comp += 1;
-
1124  }
-
1125  if (containerHasElement(plot_var_names, "snow_accum"))
-
1126  {
-
1127  MultiFab::Copy(mf[lev],*(qmoist[lev][9]),0,mf_comp,1,0);
-
1128  mf_comp += 1;
-
1129  }
-
1130  if (containerHasElement(plot_var_names, "graup_accum"))
-
1131  {
-
1132  MultiFab::Copy(mf[lev],*(qmoist[lev][10]),0,mf_comp,1,0);
-
1133  mf_comp += 1;
-
1134  }
-
1135  }
+
912 
+ +
914  if (containerHasElement(plot_var_names, "u_t_avg")) {
+
915 #ifdef _OPENMP
+
916 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
917 #endif
+
918  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
919  {
+
920  const Box& bx = mfi.tilebox();
+
921  const Array4<Real>& derdat = mf[lev].array(mfi);
+
922  const Array4<Real>& data = vel_t_avg[lev]->array(mfi);
+
923  const Real norm = t_avg_cnt[lev];
+
924  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
925  {
+
926  derdat(i ,j ,k, mf_comp) = data(i,j,k,0) / norm;
+
927  });
+
928  }
+
929  mf_comp ++;
+
930  }
+
931 
+
932  if (containerHasElement(plot_var_names, "v_t_avg")) {
+
933 #ifdef _OPENMP
+
934 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
935 #endif
+
936  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
937  {
+
938  const Box& bx = mfi.tilebox();
+
939  const Array4<Real>& derdat = mf[lev].array(mfi);
+
940  const Array4<Real>& data = vel_t_avg[lev]->array(mfi);
+
941  const Real norm = t_avg_cnt[lev];
+
942  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
943  {
+
944  derdat(i ,j ,k, mf_comp) = data(i,j,k,1) / norm;
+
945  });
+
946  }
+
947  mf_comp ++;
+
948  }
+
949 
+
950  if (containerHasElement(plot_var_names, "w_t_avg")) {
+
951 #ifdef _OPENMP
+
952 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
953 #endif
+
954  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
955  {
+
956  const Box& bx = mfi.tilebox();
+
957  const Array4<Real>& derdat = mf[lev].array(mfi);
+
958  const Array4<Real>& data = vel_t_avg[lev]->array(mfi);
+
959  const Real norm = t_avg_cnt[lev];
+
960  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
961  {
+
962  derdat(i ,j ,k, mf_comp) = data(i,j,k,2) / norm;
+
963  });
+
964  }
+
965  mf_comp ++;
+
966  }
+
967 
+
968  if (containerHasElement(plot_var_names, "umag_t_avg")) {
+
969 #ifdef _OPENMP
+
970 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
971 #endif
+
972  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
973  {
+
974  const Box& bx = mfi.tilebox();
+
975  const Array4<Real>& derdat = mf[lev].array(mfi);
+
976  const Array4<Real>& data = vel_t_avg[lev]->array(mfi);
+
977  const Real norm = t_avg_cnt[lev];
+
978  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
979  {
+
980  derdat(i ,j ,k, mf_comp) = data(i,j,k,3) / norm;
+
981  });
+
982  }
+
983  mf_comp ++;
+
984  }
+
985  }
+
986 
+
987  if (containerHasElement(plot_var_names, "Kmv")) {
+
988  MultiFab::Copy(mf[lev],*eddyDiffs_lev[lev],EddyDiff::Mom_v,mf_comp,1,0);
+
989  mf_comp ++;
+
990  }
+
991  if (containerHasElement(plot_var_names, "Kmh")) {
+
992  MultiFab::Copy(mf[lev],*eddyDiffs_lev[lev],EddyDiff::Mom_h,mf_comp,1,0);
+
993  mf_comp ++;
+
994  }
+
995  if (containerHasElement(plot_var_names, "Khv")) {
+
996  MultiFab::Copy(mf[lev],*eddyDiffs_lev[lev],EddyDiff::Theta_v,mf_comp,1,0);
+
997  mf_comp ++;
+
998  }
+
999  if (containerHasElement(plot_var_names, "Khh")) {
+
1000  MultiFab::Copy(mf[lev],*eddyDiffs_lev[lev],EddyDiff::Theta_h,mf_comp,1,0);
+
1001  mf_comp ++;
+
1002  }
+
1003  if (containerHasElement(plot_var_names, "Lturb")) {
+
1004  MultiFab::Copy(mf[lev],*eddyDiffs_lev[lev],EddyDiff::Turb_lengthscale,mf_comp,1,0);
+
1005  mf_comp ++;
+
1006  }
+
1007 
+
1008  // TODO: The size of the q variables can vary with different
+
1009  // moisture models. Therefore, certain components may
+
1010  // reside at different indices. For example, Kessler is
+
1011  // warm but precipitating. This puts qp at index 3.
+
1012  // However, SAM is cold and precipitating so qp is index 4.
+
1013  // Need to built an external enum struct or a better pathway.
+
1014 
+
1015  // NOTE: Protect against accessing non-existent data
+
1016  if (use_moisture) {
+
1017  int n_qstate = micro->Get_Qstate_Size();
+
1018 
+
1019  // Non-precipitating components
+
1020  //--------------------------------------------------------------------------
+
1021  if(containerHasElement(plot_var_names, "qt"))
+
1022  {
+
1023  int n_start = RhoQ1_comp; // qv
+
1024  int n_end = RhoQ2_comp; // qc
+
1025  if (n_qstate > 3) n_end = RhoQ3_comp; // qi
+
1026  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], n_start, mf_comp, 1, 0);
+
1027  for (int n_comp(n_start+1); n_comp <= n_end; ++n_comp) {
+
1028  MultiFab::Add(mf[lev], vars_new[lev][Vars::cons], n_comp, mf_comp, 1, 0);
+
1029  }
+
1030  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp , mf_comp, 1, 0);
+
1031  mf_comp += 1;
+
1032  }
+
1033 
+
1034  if(containerHasElement(plot_var_names, "qv") && (n_qstate >= 1))
+
1035  {
+
1036  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], RhoQ1_comp, mf_comp, 1, 0);
+
1037  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp , mf_comp, 1, 0);
+
1038  mf_comp += 1;
+
1039  }
+
1040 
+
1041  if(containerHasElement(plot_var_names, "qc") && (n_qstate >= 2))
+
1042  {
+
1043  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], RhoQ2_comp, mf_comp, 1, 0);
+
1044  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp , mf_comp, 1, 0);
+
1045  mf_comp += 1;
+
1046  }
+
1047 
+
1048  if(containerHasElement(plot_var_names, "qi") && (n_qstate >= 4))
+
1049  {
+
1050  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], RhoQ3_comp, mf_comp, 1, 0);
+
1051  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp , mf_comp, 1, 0);
+
1052  mf_comp += 1;
+
1053  }
+
1054 
+
1055  // Precipitating components
+
1056  //--------------------------------------------------------------------------
+
1057  if(containerHasElement(plot_var_names, "qp"))
+
1058  {
+
1059  int n_start = (n_qstate > 3) ? RhoQ4_comp : RhoQ3_comp;
+
1060  int n_end = ncomp_cons - 1;
+
1061  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], n_start, mf_comp, 1, 0);
+
1062  for (int n_comp(n_start+1); n_comp <= n_end; ++n_comp) {
+
1063  MultiFab::Add( mf[lev], vars_new[lev][Vars::cons], n_comp, mf_comp, 1, 0);
+
1064  }
+
1065  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp , mf_comp, 1, 0);
+
1066  mf_comp += 1;
+
1067  }
+
1068 
+
1069  if(containerHasElement(plot_var_names, "qrain") && (n_qstate >= 3))
+
1070  {
+
1071  int n_start = (n_qstate > 3) ? RhoQ4_comp : RhoQ3_comp;
+
1072  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], n_start , mf_comp, 1, 0);
+
1073  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp, mf_comp, 1, 0);
+
1074  mf_comp += 1;
+
1075  }
+
1076 
+
1077  if(containerHasElement(plot_var_names, "qsnow") && (n_qstate >= 5))
+
1078  {
+
1079  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], RhoQ5_comp, mf_comp, 1, 0);
+
1080  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp, mf_comp, 1, 0);
+
1081  mf_comp += 1;
+
1082  }
+
1083 
+
1084  if(containerHasElement(plot_var_names, "qgraup") && (n_qstate >= 6))
+
1085  {
+
1086  MultiFab::Copy( mf[lev], vars_new[lev][Vars::cons], RhoQ6_comp, mf_comp, 1, 0);
+
1087  MultiFab::Divide(mf[lev], vars_new[lev][Vars::cons], Rho_comp, mf_comp, 1, 0);
+
1088  mf_comp += 1;
+
1089  }
+
1090 
+
1091  if (containerHasElement(plot_var_names, "qsat"))
+
1092  {
+
1093 #ifdef _OPENMP
+
1094 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
1095 #endif
+
1096  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
1097  {
+
1098  const Box& bx = mfi.tilebox();
+
1099  const Array4<Real>& derdat = mf[lev].array(mfi);
+
1100  const Array4<Real const>& S_arr = vars_new[lev][Vars::cons].const_array(mfi);
+
1101  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
1102  {
+
1103  Real qv = S_arr(i,j,k,RhoQ1_comp) / S_arr(i,j,k,Rho_comp);
+
1104  Real T = getTgivenRandRTh(S_arr(i,j,k,Rho_comp), S_arr(i,j,k,RhoTheta_comp), qv);
+
1105  Real pressure = getPgivenRTh(S_arr(i,j,k,RhoTheta_comp), qv) * Real(0.01);
+
1106  erf_qsatw(T, pressure, derdat(i,j,k,mf_comp));
+
1107  });
+
1108  }
+
1109  mf_comp ++;
+
1110  }
+
1111 
+
1112  if(solverChoice.moisture_type == MoistureType::Kessler){
+
1113  if (containerHasElement(plot_var_names, "rain_accum"))
+
1114  {
+
1115  MultiFab::Copy(mf[lev],*(qmoist[lev][4]),0,mf_comp,1,0);
+
1116  mf_comp += 1;
+
1117  }
+
1118  }
+
1119  else if(solverChoice.moisture_type == MoistureType::SAM)
+
1120  {
+
1121  if (containerHasElement(plot_var_names, "rain_accum"))
+
1122  {
+
1123  MultiFab::Copy(mf[lev],*(qmoist[lev][8]),0,mf_comp,1,0);
+
1124  mf_comp += 1;
+
1125  }
+
1126  if (containerHasElement(plot_var_names, "snow_accum"))
+
1127  {
+
1128  MultiFab::Copy(mf[lev],*(qmoist[lev][9]),0,mf_comp,1,0);
+
1129  mf_comp += 1;
+
1130  }
+
1131  if (containerHasElement(plot_var_names, "graup_accum"))
+
1132  {
+
1133  MultiFab::Copy(mf[lev],*(qmoist[lev][10]),0,mf_comp,1,0);
+
1134  mf_comp += 1;
+
1135  }
1136  }
-
1137 
-
1138 #ifdef ERF_USE_PARTICLES
-
1139  const auto& particles_namelist( particleData.getNames() );
-
1140  for (ParticlesNamesVector::size_type i = 0; i < particles_namelist.size(); i++) {
-
1141  if (containerHasElement(plot_var_names, std::string(particles_namelist[i]+"_count"))) {
-
1142  MultiFab temp_dat(mf[lev].boxArray(), mf[lev].DistributionMap(), 1, 0);
-
1143  temp_dat.setVal(0);
-
1144  particleData[particles_namelist[i]]->Increment(temp_dat, lev);
-
1145  MultiFab::Copy(mf[lev], temp_dat, 0, mf_comp, 1, 0);
-
1146  mf_comp += 1;
-
1147  }
-
1148  }
-
1149 
-
1150  Vector<std::string> particle_mesh_plot_names(0);
-
1151  particleData.GetMeshPlotVarNames( particle_mesh_plot_names );
-
1152  for (int i = 0; i < particle_mesh_plot_names.size(); i++) {
-
1153  std::string plot_var_name(particle_mesh_plot_names[i]);
-
1154  if (containerHasElement(plot_var_names, plot_var_name) ) {
-
1155  MultiFab temp_dat(mf[lev].boxArray(), mf[lev].DistributionMap(), 1, 1);
-
1156  temp_dat.setVal(0);
-
1157  particleData.GetMeshPlotVar(plot_var_name, temp_dat, lev);
-
1158  MultiFab::Copy(mf[lev], temp_dat, 0, mf_comp, 1, 0);
-
1159  mf_comp += 1;
-
1160  }
-
1161  }
-
1162 #endif
-
1163 
-
1164 #ifdef ERF_USE_EB
-
1165  if (containerHasElement(plot_var_names, "volfrac")) {
-
1166  MultiFab::Copy(mf[lev], EBFactory(lev).getVolFrac(), 0, mf_comp, 1, 0);
-
1167  mf_comp += 1;
-
1168  }
-
1169 #endif
-
1170 
-
1171 #ifdef ERF_COMPUTE_ERROR
-
1172  // Next, check for error in velocities and if desired, output them -- note we output none or all, not just some
-
1173  if (containerHasElement(plot_var_names, "xvel_err") ||
-
1174  containerHasElement(plot_var_names, "yvel_err") ||
-
1175  containerHasElement(plot_var_names, "zvel_err"))
-
1176  {
-
1177  //
-
1178  // Moving terrain ANALYTICAL
-
1179  //
-
1180  Real H = geom[lev].ProbHi()[2];
-
1181  Real Ampl = 0.16;
-
1182  Real wavelength = 100.;
-
1183  Real kp = 2. * PI / wavelength;
-
1184  Real g = CONST_GRAV;
-
1185  Real omega = std::sqrt(g * kp);
-
1186  Real omega_t = omega * t_new[lev];
-
1187 
-
1188  const auto dx = geom[lev].CellSizeArray();
-
1189 
-
1190 #ifdef _OPENMP
-
1191 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
1192 #endif
-
1193  for (MFIter mfi(mf[lev], TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
1194  {
-
1195  const Box& bx = mfi.validbox();
-
1196  Box xbx(bx); xbx.surroundingNodes(0);
-
1197  const Array4<Real> xvel_arr = vars_new[lev][Vars::xvel].array(mfi);
-
1198  const Array4<Real> zvel_arr = vars_new[lev][Vars::zvel].array(mfi);
-
1199 
-
1200  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
-
1201 
-
1202  ParallelFor(xbx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
-
1203  {
-
1204  Real x = i * dx[0];
-
1205  Real z = 0.25 * (z_nd(i,j,k) + z_nd(i,j+1,k) + z_nd(i,j,k+1) + z_nd(i,j+1,k+1));
-
1206 
-
1207  Real z_base = Ampl * std::sin(kp * x - omega_t);
-
1208  z -= z_base;
-
1209 
-
1210  Real fac = std::cosh( kp * (z - H) ) / std::sinh(kp * H);
-
1211 
-
1212  xvel_arr(i,j,k) -= -Ampl * omega * fac * std::sin(kp * x - omega_t);
-
1213  });
-
1214 
-
1215  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
-
1216  {
-
1217  Real x = (i + 0.5) * dx[0];
-
1218  Real z = 0.25 * ( z_nd(i,j,k) + z_nd(i+1,j,k) + z_nd(i,j+1,k) + z_nd(i+1,j+1,k));
-
1219 
-
1220  Real z_base = Ampl * std::sin(kp * x - omega_t);
-
1221  z -= z_base;
-
1222 
-
1223  Real fac = std::sinh( kp * (z - H) ) / std::sinh(kp * H);
-
1224 
-
1225  zvel_arr(i,j,k) -= Ampl * omega * fac * std::cos(kp * x - omega_t);
-
1226  });
-
1227  }
-
1228 
-
1229  MultiFab temp_mf(mf[lev].boxArray(), mf[lev].DistributionMap(), AMREX_SPACEDIM, 0);
-
1230  average_face_to_cellcenter(temp_mf,0,
-
1231  Array<const MultiFab*,3>{&vars_new[lev][Vars::xvel],&vars_new[lev][Vars::yvel],&vars_new[lev][Vars::zvel]});
-
1232 
-
1233  if (containerHasElement(plot_var_names, "xvel_err")) {
-
1234  MultiFab::Copy(mf[lev],temp_mf,0,mf_comp,1,0);
-
1235  mf_comp += 1;
-
1236  }
-
1237  if (containerHasElement(plot_var_names, "yvel_err")) {
-
1238  MultiFab::Copy(mf[lev],temp_mf,1,mf_comp,1,0);
-
1239  mf_comp += 1;
-
1240  }
-
1241  if (containerHasElement(plot_var_names, "zvel_err")) {
-
1242  MultiFab::Copy(mf[lev],temp_mf,2,mf_comp,1,0);
-
1243  mf_comp += 1;
-
1244  }
-
1245 
-
1246  // Now restore the velocities to what they were
-
1247 #ifdef _OPENMP
-
1248 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
1249 #endif
-
1250  for (MFIter mfi(mf[lev], TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
1251  {
-
1252  const Box& bx = mfi.validbox();
-
1253  Box xbx(bx); xbx.surroundingNodes(0);
-
1254 
-
1255  const Array4<Real> xvel_arr = vars_new[lev][Vars::xvel].array(mfi);
-
1256  const Array4<Real> zvel_arr = vars_new[lev][Vars::zvel].array(mfi);
-
1257 
-
1258  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
-
1259 
-
1260  ParallelFor(xbx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
-
1261  {
-
1262  Real x = i * dx[0];
-
1263  Real z = 0.25 * (z_nd(i,j,k) + z_nd(i,j+1,k) + z_nd(i,j,k+1) + z_nd(i,j+1,k+1));
-
1264  Real z_base = Ampl * std::sin(kp * x - omega_t);
-
1265 
-
1266  z -= z_base;
-
1267 
-
1268  Real fac = std::cosh( kp * (z - H) ) / std::sinh(kp * H);
-
1269  xvel_arr(i,j,k) += -Ampl * omega * fac * std::sin(kp * x - omega_t);
-
1270  });
-
1271  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
-
1272  {
-
1273  Real x = (i + 0.5) * dx[0];
-
1274  Real z = 0.25 * ( z_nd(i,j,k) + z_nd(i+1,j,k) + z_nd(i,j+1,k) + z_nd(i+1,j+1,k));
-
1275  Real z_base = Ampl * std::sin(kp * x - omega_t);
-
1276 
-
1277  z -= z_base;
-
1278  Real fac = std::sinh( kp * (z - H) ) / std::sinh(kp * H);
-
1279 
-
1280  zvel_arr(i,j,k) += Ampl * omega * fac * std::cos(kp * x - omega_t);
-
1281  });
-
1282  }
-
1283  } // end xvel_err, yvel_err, zvel_err
-
1284 
-
1285  if (containerHasElement(plot_var_names, "pp_err"))
-
1286  {
-
1287  // Moving terrain ANALYTICAL
-
1288 #ifdef _OPENMP
-
1289 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
-
1290 #endif
-
1291  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
-
1292  {
-
1293  const Box& bx = mfi.tilebox();
-
1294  const Array4<Real>& derdat = mf[lev].array(mfi);
-
1295  const Array4<Real const>& p0_arr = p_hse.const_array(mfi);
-
1296  const Array4<Real const>& S_arr = vars_new[lev][Vars::cons].const_array(mfi);
-
1297 
-
1298  const auto dx = geom[lev].CellSizeArray();
-
1299  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
-
1300  const Array4<Real const>& r0_arr = r_hse.const_array(mfi);
-
1301 
-
1302  Real H = geom[lev].ProbHi()[2];
-
1303  Real Ampl = 0.16;
-
1304  Real wavelength = 100.;
-
1305  Real kp = 2. * PI / wavelength;
-
1306  Real g = CONST_GRAV;
-
1307  Real omega = std::sqrt(g * kp);
-
1308  Real omega_t = omega * t_new[lev];
-
1309 
-
1310  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
1311  {
-
1312  const Real rhotheta = S_arr(i,j,k,RhoTheta_comp);
-
1313  derdat(i, j, k, mf_comp) = getPgivenRTh(rhotheta) - p0_arr(i,j,k);
-
1314 
-
1315  Real rho_hse = r0_arr(i,j,k);
-
1316 
-
1317  Real x = (i + 0.5) * dx[0];
-
1318  Real z = 0.125 * ( z_nd(i,j,k ) + z_nd(i+1,j,k ) + z_nd(i,j+1,k ) + z_nd(i+1,j+1,k )
-
1319  +z_nd(i,j,k+1) + z_nd(i+1,j,k+1) + z_nd(i,j+1,k+1) + z_nd(i+1,j+1,k+1) );
-
1320  Real z_base = Ampl * std::sin(kp * x - omega_t);
-
1321 
-
1322  z -= z_base;
-
1323  Real fac = std::cosh( kp * (z - H) ) / std::sinh(kp * H);
-
1324  Real pprime_exact = -(Ampl * omega * omega / kp) * fac *
-
1325  std::sin(kp * x - omega_t) * r0_arr(i,j,k);
-
1326 
-
1327  derdat(i,j,k,mf_comp) -= pprime_exact;
-
1328  });
-
1329  }
-
1330  mf_comp += 1;
-
1331  }
-
1332 #endif
-
1333 
-
1334 #ifdef ERF_USE_RRTMGP
-
1335  if (containerHasElement(plot_var_names, "qsrc_sw")) {
-
1336  MultiFab::Copy(mf[lev], *(qheating_rates[lev]), 0, mf_comp, 1, 0);
-
1337  mf_comp += 1;
-
1338  }
-
1339  if (containerHasElement(plot_var_names, "qsrc_lw")) {
-
1340  MultiFab::Copy(mf[lev], *(qheating_rates[lev]), 1, mf_comp, 1, 0);
-
1341  mf_comp += 1;
-
1342  }
-
1343 #endif
-
1344  }
-
1345 
-
1346 #ifdef ERF_USE_EB
-
1347  for (int lev = 0; lev <= finest_level; ++lev) {
-
1348  EB_set_covered(mf[lev], 0.0);
-
1349  }
-
1350 #endif
-
1351 
-
1352  // Fill terrain distortion MF
-
1353  if (SolverChoice::terrain_type != TerrainType::None) {
-
1354  for (int lev(0); lev <= finest_level; ++lev) {
-
1355  MultiFab::Copy(mf_nd[lev],*z_phys_nd[lev],0,2,1,0);
-
1356  Real dz = Geom()[lev].CellSizeArray()[2];
-
1357  for (MFIter mfi(mf_nd[lev], TilingIfNotGPU()); mfi.isValid(); ++mfi) {
-
1358  const Box& bx = mfi.tilebox();
-
1359  Array4< Real> mf_arr = mf_nd[lev].array(mfi);
-
1360  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) {
-
1361  mf_arr(i,j,k,2) -= k * dz;
-
1362  });
-
1363  }
-
1364  }
-
1365  }
-
1366 
-
1367  std::string plotfilename;
-
1368  std::string plotfilenameU;
-
1369  std::string plotfilenameV;
-
1370  std::string plotfilenameW;
-
1371  if (which == 1) {
-
1372  plotfilename = Concatenate(plot_file_1, istep[0], 5);
-
1373  plotfilenameU = Concatenate(plot_file_1+"U", istep[0], 5);
-
1374  plotfilenameV = Concatenate(plot_file_1+"V", istep[0], 5);
-
1375  plotfilenameW = Concatenate(plot_file_1+"W", istep[0], 5);
-
1376  } else if (which == 2) {
-
1377  plotfilename = Concatenate(plot_file_2, istep[0], 5);
-
1378  plotfilenameU = Concatenate(plot_file_2+"U", istep[0], 5);
-
1379  plotfilenameV = Concatenate(plot_file_2+"V", istep[0], 5);
-
1380  plotfilenameW = Concatenate(plot_file_2+"W", istep[0], 5);
-
1381  }
-
1382 
-
1383  // LSM writes it's own data
-
1384  if (which==1 && plot_lsm) {
-
1385  lsm.Plot_Lsm_Data(t_new[0], istep, refRatio());
-
1386  }
-
1387 
-
1388 #ifdef ERF_USE_RRTMGP
-
1389  // write additional RRTMGP data
-
1390  // TODO: currently single level only
-
1391  if (which==1 && plot_rad) {
-
1392  rad.writePlotfile(plot_file_1, t_new[0], istep[0]);
-
1393  }
-
1394 #endif
-
1395 
-
1396  // Single level
-
1397  if (finest_level == 0)
-
1398  {
-
1399  if (plotfile_type == PlotFileType::Amrex)
-
1400  {
-
1401  Print() << "Writing native plotfile " << plotfilename << "\n";
-
1402  if (SolverChoice::terrain_type != TerrainType::None) {
-
1403  WriteMultiLevelPlotfileWithTerrain(plotfilename, finest_level+1,
-
1404  GetVecOfConstPtrs(mf),
-
1405  GetVecOfConstPtrs(mf_nd),
-
1406  varnames,
-
1407  Geom(), t_new[0], istep, refRatio());
-
1408  } else {
-
1409  WriteMultiLevelPlotfile(plotfilename, finest_level+1,
-
1410  GetVecOfConstPtrs(mf),
-
1411  varnames,
-
1412  Geom(), t_new[0], istep, refRatio());
-
1413  }
-
1414  writeJobInfo(plotfilename);
-
1415 
-
1416  if (m_plot_face_vels) {
-
1417  Print() << "Writing face velocities" << std::endl;
-
1418  WriteMultiLevelPlotfile(plotfilenameU, finest_level+1,
-
1419  GetVecOfConstPtrs(mf_u),
-
1420  {"x_velocity_stag"},
-
1421  Geom(), t_new[0], istep, refRatio());
-
1422  WriteMultiLevelPlotfile(plotfilenameV, finest_level+1,
-
1423  GetVecOfConstPtrs(mf_v),
-
1424  {"y_velocity_stag"},
-
1425  Geom(), t_new[0], istep, refRatio());
-
1426  WriteMultiLevelPlotfile(plotfilenameW, finest_level+1,
-
1427  GetVecOfConstPtrs(mf_w),
-
1428  {"z_velocity_stag"},
-
1429  Geom(), t_new[0], istep, refRatio());
-
1430  }
-
1431 
-
1432 #ifdef ERF_USE_PARTICLES
-
1433  particleData.writePlotFile(plotfilename);
-
1434 #endif
-
1435 #ifdef ERF_USE_NETCDF
-
1436  } else if (plotfile_type == PlotFileType::Netcdf) {
-
1437  int lev = 0;
-
1438  int l_which = 0;
-
1439  writeNCPlotFile(lev, l_which, plotfilename, GetVecOfConstPtrs(mf), varnames, istep, t_new[0]);
-
1440 #endif
-
1441  } else {
-
1442  // Here we assume the plotfile_type is PlotFileType::None
-
1443  Print() << "Writing no plotfile since plotfile_type is none" << std::endl;
-
1444  }
-
1445 
-
1446  } else { // Multilevel
-
1447 
-
1448  if (plotfile_type == PlotFileType::Amrex) {
-
1449 
-
1450  int lev0 = 0;
-
1451  int desired_ratio = std::max(std::max(ref_ratio[lev0][0],ref_ratio[lev0][1]),ref_ratio[lev0][2]);
-
1452  bool any_ratio_one = ( ( (ref_ratio[lev0][0] == 1) || (ref_ratio[lev0][1] == 1) ) ||
-
1453  (ref_ratio[lev0][2] == 1) );
-
1454  for (int lev = 1; lev < finest_level; lev++) {
-
1455  any_ratio_one = any_ratio_one ||
-
1456  ( ( (ref_ratio[lev][0] == 1) || (ref_ratio[lev][1] == 1) ) ||
-
1457  (ref_ratio[lev][2] == 1) );
-
1458  }
-
1459 
-
1460  if (any_ratio_one && m_expand_plotvars_to_unif_rr)
-
1461  {
-
1462  Vector<IntVect> r2(finest_level);
-
1463  Vector<Geometry> g2(finest_level+1);
-
1464  Vector<MultiFab> mf2(finest_level+1);
-
1465 
-
1466  mf2[0].define(grids[0], dmap[0], ncomp_mf, 0);
-
1467 
-
1468  // Copy level 0 as is
-
1469  MultiFab::Copy(mf2[0],mf[0],0,0,mf[0].nComp(),0);
-
1470 
-
1471  // Define a new multi-level array of Geometry's so that we pass the new "domain" at lev > 0
-
1472  Array<int,AMREX_SPACEDIM> periodicity =
-
1473  {Geom()[lev0].isPeriodic(0),Geom()[lev0].isPeriodic(1),Geom()[lev0].isPeriodic(2)};
-
1474  g2[lev0].define(Geom()[lev0].Domain(),&(Geom()[lev0].ProbDomain()),0,periodicity.data());
-
1475 
-
1476  r2[0] = IntVect(desired_ratio/ref_ratio[lev0][0],
-
1477  desired_ratio/ref_ratio[lev0][1],
-
1478  desired_ratio/ref_ratio[lev0][2]);
-
1479 
-
1480  for (int lev = 1; lev <= finest_level; ++lev) {
-
1481  if (lev > 1) {
-
1482  r2[lev-1][0] = r2[lev-2][0] * desired_ratio / ref_ratio[lev-1][0];
-
1483  r2[lev-1][1] = r2[lev-2][1] * desired_ratio / ref_ratio[lev-1][1];
-
1484  r2[lev-1][2] = r2[lev-2][2] * desired_ratio / ref_ratio[lev-1][2];
-
1485  }
-
1486 
-
1487  mf2[lev].define(refine(grids[lev],r2[lev-1]), dmap[lev], ncomp_mf, 0);
-
1488 
-
1489  // Set the new problem domain
-
1490  Box d2(Geom()[lev].Domain());
-
1491  d2.refine(r2[lev-1]);
-
1492 
-
1493  g2[lev].define(d2,&(Geom()[lev].ProbDomain()),0,periodicity.data());
-
1494  }
-
1495 
-
1496  // Do piecewise interpolation of mf into mf2
-
1497  for (int lev = 1; lev <= finest_level; ++lev) {
-
1498  Interpolater* mapper_c = &pc_interp;
-
1499  InterpFromCoarseLevel(mf2[lev], t_new[lev], mf[lev],
-
1500  0, 0, ncomp_mf,
-
1501  geom[lev], g2[lev],
- -
1503  r2[lev-1], mapper_c, domain_bcs_type, 0);
-
1504  }
-
1505 
-
1506  // Define an effective ref_ratio which is isotropic to be passed into WriteMultiLevelPlotfile
-
1507  Vector<IntVect> rr(finest_level);
-
1508  for (int lev = 0; lev < finest_level; ++lev) {
-
1509  rr[lev] = IntVect(desired_ratio);
-
1510  }
-
1511 
-
1512  Print() << "Writing plotfile " << plotfilename << "\n";
-
1513  if (SolverChoice::terrain_type != TerrainType::None) {
-
1514  WriteMultiLevelPlotfileWithTerrain(plotfilename, finest_level+1,
-
1515  GetVecOfConstPtrs(mf2),
-
1516  GetVecOfConstPtrs(mf_nd),
-
1517  varnames,
-
1518  g2, t_new[0], istep, rr);
-
1519  } else {
-
1520  WriteMultiLevelPlotfile(plotfilename, finest_level+1,
-
1521  GetVecOfConstPtrs(mf2), varnames,
-
1522  g2, t_new[0], istep, rr);
-
1523  }
-
1524 
-
1525  } else {
-
1526  if (SolverChoice::terrain_type != TerrainType::None) {
-
1527  WriteMultiLevelPlotfileWithTerrain(plotfilename, finest_level+1,
-
1528  GetVecOfConstPtrs(mf),
-
1529  GetVecOfConstPtrs(mf_nd),
-
1530  varnames,
-
1531  geom, t_new[0], istep, ref_ratio);
-
1532  } else {
-
1533  WriteMultiLevelPlotfile(plotfilename, finest_level+1,
-
1534  GetVecOfConstPtrs(mf), varnames,
-
1535  geom, t_new[0], istep, ref_ratio);
-
1536  }
-
1537  if (m_plot_face_vels) {
-
1538  Print() << "Writing face velocities" << std::endl;
-
1539  WriteMultiLevelPlotfile(plotfilenameU, finest_level+1,
-
1540  GetVecOfConstPtrs(mf_u),
-
1541  {"x_velocity_stag"},
-
1542  geom, t_new[0], istep, ref_ratio);
-
1543  WriteMultiLevelPlotfile(plotfilenameV, finest_level+1,
-
1544  GetVecOfConstPtrs(mf_v),
-
1545  {"y_velocity_stag"},
-
1546  geom, t_new[0], istep, ref_ratio);
-
1547  WriteMultiLevelPlotfile(plotfilenameW, finest_level+1,
-
1548  GetVecOfConstPtrs(mf_w),
-
1549  {"z_velocity_stag"},
-
1550  geom, t_new[0], istep, ref_ratio);
-
1551  }
-
1552  } // ref_ratio test
-
1553 
-
1554  writeJobInfo(plotfilename);
-
1555 
-
1556 #ifdef ERF_USE_PARTICLES
-
1557  particleData.writePlotFile(plotfilename);
-
1558 #endif
-
1559 
-
1560 #ifdef ERF_USE_NETCDF
-
1561  } else if (plotfile_type == PlotFileType::Netcdf) {
-
1562  for (int lev = 0; lev <= finest_level; ++lev) {
-
1563  for (int which_box = 0; which_box < num_boxes_at_level[lev]; which_box++) {
-
1564  writeNCPlotFile(lev, which_box, plotfilename, GetVecOfConstPtrs(mf), varnames, istep, t_new[0]);
-
1565  }
-
1566  }
-
1567 #endif
-
1568  }
-
1569  } // end multi-level
-
1570 }
+
1137  }
+
1138 
+
1139 #ifdef ERF_USE_PARTICLES
+
1140  const auto& particles_namelist( particleData.getNames() );
+
1141  for (ParticlesNamesVector::size_type i = 0; i < particles_namelist.size(); i++) {
+
1142  if (containerHasElement(plot_var_names, std::string(particles_namelist[i]+"_count"))) {
+
1143  MultiFab temp_dat(mf[lev].boxArray(), mf[lev].DistributionMap(), 1, 0);
+
1144  temp_dat.setVal(0);
+
1145  particleData[particles_namelist[i]]->Increment(temp_dat, lev);
+
1146  MultiFab::Copy(mf[lev], temp_dat, 0, mf_comp, 1, 0);
+
1147  mf_comp += 1;
+
1148  }
+
1149  }
+
1150 
+
1151  Vector<std::string> particle_mesh_plot_names(0);
+
1152  particleData.GetMeshPlotVarNames( particle_mesh_plot_names );
+
1153  for (int i = 0; i < particle_mesh_plot_names.size(); i++) {
+
1154  std::string plot_var_name(particle_mesh_plot_names[i]);
+
1155  if (containerHasElement(plot_var_names, plot_var_name) ) {
+
1156  MultiFab temp_dat(mf[lev].boxArray(), mf[lev].DistributionMap(), 1, 1);
+
1157  temp_dat.setVal(0);
+
1158  particleData.GetMeshPlotVar(plot_var_name, temp_dat, lev);
+
1159  MultiFab::Copy(mf[lev], temp_dat, 0, mf_comp, 1, 0);
+
1160  mf_comp += 1;
+
1161  }
+
1162  }
+
1163 #endif
+
1164 
+
1165 #ifdef ERF_USE_EB
+
1166  if (containerHasElement(plot_var_names, "volfrac")) {
+
1167  MultiFab::Copy(mf[lev], EBFactory(lev).getVolFrac(), 0, mf_comp, 1, 0);
+
1168  mf_comp += 1;
+
1169  }
+
1170 #endif
+
1171 
+
1172 #ifdef ERF_COMPUTE_ERROR
+
1173  // Next, check for error in velocities and if desired, output them -- note we output none or all, not just some
+
1174  if (containerHasElement(plot_var_names, "xvel_err") ||
+
1175  containerHasElement(plot_var_names, "yvel_err") ||
+
1176  containerHasElement(plot_var_names, "zvel_err"))
+
1177  {
+
1178  //
+
1179  // Moving terrain ANALYTICAL
+
1180  //
+
1181  Real H = geom[lev].ProbHi()[2];
+
1182  Real Ampl = 0.16;
+
1183  Real wavelength = 100.;
+
1184  Real kp = 2. * PI / wavelength;
+
1185  Real g = CONST_GRAV;
+
1186  Real omega = std::sqrt(g * kp);
+
1187  Real omega_t = omega * t_new[lev];
+
1188 
+
1189  const auto dx = geom[lev].CellSizeArray();
+
1190 
+
1191 #ifdef _OPENMP
+
1192 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
1193 #endif
+
1194  for (MFIter mfi(mf[lev], TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
1195  {
+
1196  const Box& bx = mfi.validbox();
+
1197  Box xbx(bx); xbx.surroundingNodes(0);
+
1198  const Array4<Real> xvel_arr = vars_new[lev][Vars::xvel].array(mfi);
+
1199  const Array4<Real> zvel_arr = vars_new[lev][Vars::zvel].array(mfi);
+
1200 
+
1201  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
+
1202 
+
1203  ParallelFor(xbx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
+
1204  {
+
1205  Real x = i * dx[0];
+
1206  Real z = 0.25 * (z_nd(i,j,k) + z_nd(i,j+1,k) + z_nd(i,j,k+1) + z_nd(i,j+1,k+1));
+
1207 
+
1208  Real z_base = Ampl * std::sin(kp * x - omega_t);
+
1209  z -= z_base;
+
1210 
+
1211  Real fac = std::cosh( kp * (z - H) ) / std::sinh(kp * H);
+
1212 
+
1213  xvel_arr(i,j,k) -= -Ampl * omega * fac * std::sin(kp * x - omega_t);
+
1214  });
+
1215 
+
1216  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
+
1217  {
+
1218  Real x = (i + 0.5) * dx[0];
+
1219  Real z = 0.25 * ( z_nd(i,j,k) + z_nd(i+1,j,k) + z_nd(i,j+1,k) + z_nd(i+1,j+1,k));
+
1220 
+
1221  Real z_base = Ampl * std::sin(kp * x - omega_t);
+
1222  z -= z_base;
+
1223 
+
1224  Real fac = std::sinh( kp * (z - H) ) / std::sinh(kp * H);
+
1225 
+
1226  zvel_arr(i,j,k) -= Ampl * omega * fac * std::cos(kp * x - omega_t);
+
1227  });
+
1228  }
+
1229 
+
1230  MultiFab temp_mf(mf[lev].boxArray(), mf[lev].DistributionMap(), AMREX_SPACEDIM, 0);
+
1231  average_face_to_cellcenter(temp_mf,0,
+
1232  Array<const MultiFab*,3>{&vars_new[lev][Vars::xvel],&vars_new[lev][Vars::yvel],&vars_new[lev][Vars::zvel]});
+
1233 
+
1234  if (containerHasElement(plot_var_names, "xvel_err")) {
+
1235  MultiFab::Copy(mf[lev],temp_mf,0,mf_comp,1,0);
+
1236  mf_comp += 1;
+
1237  }
+
1238  if (containerHasElement(plot_var_names, "yvel_err")) {
+
1239  MultiFab::Copy(mf[lev],temp_mf,1,mf_comp,1,0);
+
1240  mf_comp += 1;
+
1241  }
+
1242  if (containerHasElement(plot_var_names, "zvel_err")) {
+
1243  MultiFab::Copy(mf[lev],temp_mf,2,mf_comp,1,0);
+
1244  mf_comp += 1;
+
1245  }
+
1246 
+
1247  // Now restore the velocities to what they were
+
1248 #ifdef _OPENMP
+
1249 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
1250 #endif
+
1251  for (MFIter mfi(mf[lev], TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
1252  {
+
1253  const Box& bx = mfi.validbox();
+
1254  Box xbx(bx); xbx.surroundingNodes(0);
+
1255 
+
1256  const Array4<Real> xvel_arr = vars_new[lev][Vars::xvel].array(mfi);
+
1257  const Array4<Real> zvel_arr = vars_new[lev][Vars::zvel].array(mfi);
+
1258 
+
1259  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
+
1260 
+
1261  ParallelFor(xbx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
+
1262  {
+
1263  Real x = i * dx[0];
+
1264  Real z = 0.25 * (z_nd(i,j,k) + z_nd(i,j+1,k) + z_nd(i,j,k+1) + z_nd(i,j+1,k+1));
+
1265  Real z_base = Ampl * std::sin(kp * x - omega_t);
+
1266 
+
1267  z -= z_base;
+
1268 
+
1269  Real fac = std::cosh( kp * (z - H) ) / std::sinh(kp * H);
+
1270  xvel_arr(i,j,k) += -Ampl * omega * fac * std::sin(kp * x - omega_t);
+
1271  });
+
1272  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
+
1273  {
+
1274  Real x = (i + 0.5) * dx[0];
+
1275  Real z = 0.25 * ( z_nd(i,j,k) + z_nd(i+1,j,k) + z_nd(i,j+1,k) + z_nd(i+1,j+1,k));
+
1276  Real z_base = Ampl * std::sin(kp * x - omega_t);
+
1277 
+
1278  z -= z_base;
+
1279  Real fac = std::sinh( kp * (z - H) ) / std::sinh(kp * H);
+
1280 
+
1281  zvel_arr(i,j,k) += Ampl * omega * fac * std::cos(kp * x - omega_t);
+
1282  });
+
1283  }
+
1284  } // end xvel_err, yvel_err, zvel_err
+
1285 
+
1286  if (containerHasElement(plot_var_names, "pp_err"))
+
1287  {
+
1288  // Moving terrain ANALYTICAL
+
1289 #ifdef _OPENMP
+
1290 #pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
+
1291 #endif
+
1292  for ( MFIter mfi(mf[lev],TilingIfNotGPU()); mfi.isValid(); ++mfi)
+
1293  {
+
1294  const Box& bx = mfi.tilebox();
+
1295  const Array4<Real>& derdat = mf[lev].array(mfi);
+
1296  const Array4<Real const>& p0_arr = p_hse.const_array(mfi);
+
1297  const Array4<Real const>& S_arr = vars_new[lev][Vars::cons].const_array(mfi);
+
1298 
+
1299  const auto dx = geom[lev].CellSizeArray();
+
1300  const Array4<Real const>& z_nd = z_phys_nd[lev]->const_array(mfi);
+
1301  const Array4<Real const>& r0_arr = r_hse.const_array(mfi);
+
1302 
+
1303  Real H = geom[lev].ProbHi()[2];
+
1304  Real Ampl = 0.16;
+
1305  Real wavelength = 100.;
+
1306  Real kp = 2. * PI / wavelength;
+
1307  Real g = CONST_GRAV;
+
1308  Real omega = std::sqrt(g * kp);
+
1309  Real omega_t = omega * t_new[lev];
+
1310 
+
1311  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
1312  {
+
1313  const Real rhotheta = S_arr(i,j,k,RhoTheta_comp);
+
1314  derdat(i, j, k, mf_comp) = getPgivenRTh(rhotheta) - p0_arr(i,j,k);
+
1315 
+
1316  Real rho_hse = r0_arr(i,j,k);
+
1317 
+
1318  Real x = (i + 0.5) * dx[0];
+
1319  Real z = 0.125 * ( z_nd(i,j,k ) + z_nd(i+1,j,k ) + z_nd(i,j+1,k ) + z_nd(i+1,j+1,k )
+
1320  +z_nd(i,j,k+1) + z_nd(i+1,j,k+1) + z_nd(i,j+1,k+1) + z_nd(i+1,j+1,k+1) );
+
1321  Real z_base = Ampl * std::sin(kp * x - omega_t);
+
1322 
+
1323  z -= z_base;
+
1324  Real fac = std::cosh( kp * (z - H) ) / std::sinh(kp * H);
+
1325  Real pprime_exact = -(Ampl * omega * omega / kp) * fac *
+
1326  std::sin(kp * x - omega_t) * r0_arr(i,j,k);
+
1327 
+
1328  derdat(i,j,k,mf_comp) -= pprime_exact;
+
1329  });
+
1330  }
+
1331  mf_comp += 1;
+
1332  }
+
1333 #endif
+
1334 
+
1335 #ifdef ERF_USE_RRTMGP
+
1336  if (containerHasElement(plot_var_names, "qsrc_sw")) {
+
1337  MultiFab::Copy(mf[lev], *(qheating_rates[lev]), 0, mf_comp, 1, 0);
+
1338  mf_comp += 1;
+
1339  }
+
1340  if (containerHasElement(plot_var_names, "qsrc_lw")) {
+
1341  MultiFab::Copy(mf[lev], *(qheating_rates[lev]), 1, mf_comp, 1, 0);
+
1342  mf_comp += 1;
+
1343  }
+
1344 #endif
+
1345  }
+
1346 
+
1347 #ifdef ERF_USE_EB
+
1348  for (int lev = 0; lev <= finest_level; ++lev) {
+
1349  EB_set_covered(mf[lev], 0.0);
+
1350  }
+
1351 #endif
+
1352 
+
1353  // Fill terrain distortion MF
+
1354  if (SolverChoice::terrain_type != TerrainType::None) {
+
1355  for (int lev(0); lev <= finest_level; ++lev) {
+
1356  MultiFab::Copy(mf_nd[lev],*z_phys_nd[lev],0,2,1,0);
+
1357  Real dz = Geom()[lev].CellSizeArray()[2];
+
1358  for (MFIter mfi(mf_nd[lev], TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
1359  const Box& bx = mfi.tilebox();
+
1360  Array4< Real> mf_arr = mf_nd[lev].array(mfi);
+
1361  ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) {
+
1362  mf_arr(i,j,k,2) -= k * dz;
+
1363  });
+
1364  }
+
1365  }
+
1366  }
+
1367 
+
1368  std::string plotfilename;
+
1369  std::string plotfilenameU;
+
1370  std::string plotfilenameV;
+
1371  std::string plotfilenameW;
+
1372  if (which == 1) {
+
1373  plotfilename = Concatenate(plot_file_1, istep[0], 5);
+
1374  plotfilenameU = Concatenate(plot_file_1+"U", istep[0], 5);
+
1375  plotfilenameV = Concatenate(plot_file_1+"V", istep[0], 5);
+
1376  plotfilenameW = Concatenate(plot_file_1+"W", istep[0], 5);
+
1377  } else if (which == 2) {
+
1378  plotfilename = Concatenate(plot_file_2, istep[0], 5);
+
1379  plotfilenameU = Concatenate(plot_file_2+"U", istep[0], 5);
+
1380  plotfilenameV = Concatenate(plot_file_2+"V", istep[0], 5);
+
1381  plotfilenameW = Concatenate(plot_file_2+"W", istep[0], 5);
+
1382  }
+
1383 
+
1384  // LSM writes it's own data
+
1385  if (which==1 && plot_lsm) {
+
1386  lsm.Plot_Lsm_Data(t_new[0], istep, refRatio());
+
1387  }
+
1388 
+
1389 #ifdef ERF_USE_RRTMGP
+
1390  // write additional RRTMGP data
+
1391  // TODO: currently single level only
+
1392  if (which==1 && plot_rad) {
+
1393  rad.writePlotfile(plot_file_1, t_new[0], istep[0]);
+
1394  }
+
1395 #endif
+
1396 
+
1397  // Single level
+
1398  if (finest_level == 0)
+
1399  {
+
1400  if (plotfile_type == PlotFileType::Amrex)
+
1401  {
+
1402  Print() << "Writing native plotfile " << plotfilename << "\n";
+
1403  if (SolverChoice::terrain_type != TerrainType::None) {
+
1404  WriteMultiLevelPlotfileWithTerrain(plotfilename, finest_level+1,
+
1405  GetVecOfConstPtrs(mf),
+
1406  GetVecOfConstPtrs(mf_nd),
+
1407  varnames,
+
1408  Geom(), t_new[0], istep, refRatio());
+
1409  } else {
+
1410  WriteMultiLevelPlotfile(plotfilename, finest_level+1,
+
1411  GetVecOfConstPtrs(mf),
+
1412  varnames,
+
1413  Geom(), t_new[0], istep, refRatio());
+
1414  }
+
1415  writeJobInfo(plotfilename);
+
1416 
+
1417  if (m_plot_face_vels) {
+
1418  Print() << "Writing face velocities" << std::endl;
+
1419  WriteMultiLevelPlotfile(plotfilenameU, finest_level+1,
+
1420  GetVecOfConstPtrs(mf_u),
+
1421  {"x_velocity_stag"},
+
1422  Geom(), t_new[0], istep, refRatio());
+
1423  WriteMultiLevelPlotfile(plotfilenameV, finest_level+1,
+
1424  GetVecOfConstPtrs(mf_v),
+
1425  {"y_velocity_stag"},
+
1426  Geom(), t_new[0], istep, refRatio());
+
1427  WriteMultiLevelPlotfile(plotfilenameW, finest_level+1,
+
1428  GetVecOfConstPtrs(mf_w),
+
1429  {"z_velocity_stag"},
+
1430  Geom(), t_new[0], istep, refRatio());
+
1431  }
+
1432 
+
1433 #ifdef ERF_USE_PARTICLES
+
1434  particleData.writePlotFile(plotfilename);
+
1435 #endif
+
1436 #ifdef ERF_USE_NETCDF
+
1437  } else if (plotfile_type == PlotFileType::Netcdf) {
+
1438  int lev = 0;
+
1439  int l_which = 0;
+
1440  writeNCPlotFile(lev, l_which, plotfilename, GetVecOfConstPtrs(mf), varnames, istep, t_new[0]);
+
1441 #endif
+
1442  } else {
+
1443  // Here we assume the plotfile_type is PlotFileType::None
+
1444  Print() << "Writing no plotfile since plotfile_type is none" << std::endl;
+
1445  }
+
1446 
+
1447  } else { // Multilevel
+
1448 
+
1449  if (plotfile_type == PlotFileType::Amrex) {
+
1450 
+
1451  int lev0 = 0;
+
1452  int desired_ratio = std::max(std::max(ref_ratio[lev0][0],ref_ratio[lev0][1]),ref_ratio[lev0][2]);
+
1453  bool any_ratio_one = ( ( (ref_ratio[lev0][0] == 1) || (ref_ratio[lev0][1] == 1) ) ||
+
1454  (ref_ratio[lev0][2] == 1) );
+
1455  for (int lev = 1; lev < finest_level; lev++) {
+
1456  any_ratio_one = any_ratio_one ||
+
1457  ( ( (ref_ratio[lev][0] == 1) || (ref_ratio[lev][1] == 1) ) ||
+
1458  (ref_ratio[lev][2] == 1) );
+
1459  }
+
1460 
+
1461  if (any_ratio_one && m_expand_plotvars_to_unif_rr)
+
1462  {
+
1463  Vector<IntVect> r2(finest_level);
+
1464  Vector<Geometry> g2(finest_level+1);
+
1465  Vector<MultiFab> mf2(finest_level+1);
+
1466 
+
1467  mf2[0].define(grids[0], dmap[0], ncomp_mf, 0);
+
1468 
+
1469  // Copy level 0 as is
+
1470  MultiFab::Copy(mf2[0],mf[0],0,0,mf[0].nComp(),0);
+
1471 
+
1472  // Define a new multi-level array of Geometry's so that we pass the new "domain" at lev > 0
+
1473  Array<int,AMREX_SPACEDIM> periodicity =
+
1474  {Geom()[lev0].isPeriodic(0),Geom()[lev0].isPeriodic(1),Geom()[lev0].isPeriodic(2)};
+
1475  g2[lev0].define(Geom()[lev0].Domain(),&(Geom()[lev0].ProbDomain()),0,periodicity.data());
+
1476 
+
1477  r2[0] = IntVect(desired_ratio/ref_ratio[lev0][0],
+
1478  desired_ratio/ref_ratio[lev0][1],
+
1479  desired_ratio/ref_ratio[lev0][2]);
+
1480 
+
1481  for (int lev = 1; lev <= finest_level; ++lev) {
+
1482  if (lev > 1) {
+
1483  r2[lev-1][0] = r2[lev-2][0] * desired_ratio / ref_ratio[lev-1][0];
+
1484  r2[lev-1][1] = r2[lev-2][1] * desired_ratio / ref_ratio[lev-1][1];
+
1485  r2[lev-1][2] = r2[lev-2][2] * desired_ratio / ref_ratio[lev-1][2];
+
1486  }
+
1487 
+
1488  mf2[lev].define(refine(grids[lev],r2[lev-1]), dmap[lev], ncomp_mf, 0);
+
1489 
+
1490  // Set the new problem domain
+
1491  Box d2(Geom()[lev].Domain());
+
1492  d2.refine(r2[lev-1]);
+
1493 
+
1494  g2[lev].define(d2,&(Geom()[lev].ProbDomain()),0,periodicity.data());
+
1495  }
+
1496 
+
1497  // Do piecewise interpolation of mf into mf2
+
1498  for (int lev = 1; lev <= finest_level; ++lev) {
+
1499  Interpolater* mapper_c = &pc_interp;
+
1500  InterpFromCoarseLevel(mf2[lev], t_new[lev], mf[lev],
+
1501  0, 0, ncomp_mf,
+
1502  geom[lev], g2[lev],
+ +
1504  r2[lev-1], mapper_c, domain_bcs_type, 0);
+
1505  }
+
1506 
+
1507  // Define an effective ref_ratio which is isotropic to be passed into WriteMultiLevelPlotfile
+
1508  Vector<IntVect> rr(finest_level);
+
1509  for (int lev = 0; lev < finest_level; ++lev) {
+
1510  rr[lev] = IntVect(desired_ratio);
+
1511  }
+
1512 
+
1513  Print() << "Writing plotfile " << plotfilename << "\n";
+
1514  if (SolverChoice::terrain_type != TerrainType::None) {
+
1515  WriteMultiLevelPlotfileWithTerrain(plotfilename, finest_level+1,
+
1516  GetVecOfConstPtrs(mf2),
+
1517  GetVecOfConstPtrs(mf_nd),
+
1518  varnames,
+
1519  g2, t_new[0], istep, rr);
+
1520  } else {
+
1521  WriteMultiLevelPlotfile(plotfilename, finest_level+1,
+
1522  GetVecOfConstPtrs(mf2), varnames,
+
1523  g2, t_new[0], istep, rr);
+
1524  }
+
1525 
+
1526  } else {
+
1527  if (SolverChoice::terrain_type != TerrainType::None) {
+
1528  WriteMultiLevelPlotfileWithTerrain(plotfilename, finest_level+1,
+
1529  GetVecOfConstPtrs(mf),
+
1530  GetVecOfConstPtrs(mf_nd),
+
1531  varnames,
+
1532  geom, t_new[0], istep, ref_ratio);
+
1533  } else {
+
1534  WriteMultiLevelPlotfile(plotfilename, finest_level+1,
+
1535  GetVecOfConstPtrs(mf), varnames,
+
1536  geom, t_new[0], istep, ref_ratio);
+
1537  }
+
1538  if (m_plot_face_vels) {
+
1539  Print() << "Writing face velocities" << std::endl;
+
1540  WriteMultiLevelPlotfile(plotfilenameU, finest_level+1,
+
1541  GetVecOfConstPtrs(mf_u),
+
1542  {"x_velocity_stag"},
+
1543  geom, t_new[0], istep, ref_ratio);
+
1544  WriteMultiLevelPlotfile(plotfilenameV, finest_level+1,
+
1545  GetVecOfConstPtrs(mf_v),
+
1546  {"y_velocity_stag"},
+
1547  geom, t_new[0], istep, ref_ratio);
+
1548  WriteMultiLevelPlotfile(plotfilenameW, finest_level+1,
+
1549  GetVecOfConstPtrs(mf_w),
+
1550  {"z_velocity_stag"},
+
1551  geom, t_new[0], istep, ref_ratio);
+
1552  }
+
1553  } // ref_ratio test
+
1554 
+
1555  writeJobInfo(plotfilename);
+
1556 
+
1557 #ifdef ERF_USE_PARTICLES
+
1558  particleData.writePlotFile(plotfilename);
+
1559 #endif
+
1560 
+
1561 #ifdef ERF_USE_NETCDF
+
1562  } else if (plotfile_type == PlotFileType::Netcdf) {
+
1563  for (int lev = 0; lev <= finest_level; ++lev) {
+
1564  for (int which_box = 0; which_box < num_boxes_at_level[lev]; which_box++) {
+
1565  writeNCPlotFile(lev, which_box, plotfilename, GetVecOfConstPtrs(mf), varnames, istep, t_new[0]);
+
1566  }
+
1567  }
+
1568 #endif
+
1569  }
+
1570  } // end multi-level
+
1571 }
constexpr amrex::Real Cp_d
Definition: ERF_Constants.H:12
constexpr amrex::Real PI
Definition: ERF_Constants.H:6
constexpr amrex::Real CONST_GRAV
Definition: ERF_Constants.H:21
@@ -18262,7 +18263,7 @@

AMREX_GPU_DEVICE AMREX_FORCE_INLINE amrex::Real Compute_h_eta_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:158
void FillBdyCCVels(amrex::Vector< amrex::MultiFab > &mf_cc_vel)
Definition: ERF_FillBdyCCVels.cpp:11
static amrex::Vector< std::string > PlotFileVarNames(amrex::Vector< std::string > plot_var_names)
Definition: ERF_Plotfile.cpp:174
-
void WriteMultiLevelPlotfileWithTerrain(const std::string &plotfilename, int nlevels, const amrex::Vector< const amrex::MultiFab * > &mf, const amrex::Vector< const amrex::MultiFab * > &mf_nd, const amrex::Vector< std::string > &varnames, const amrex::Vector< amrex::Geometry > &my_geom, amrex::Real time, const amrex::Vector< int > &level_steps, const amrex::Vector< amrex::IntVect > &my_ref_ratio, const std::string &versionName="HyperCLaw-V1.1", const std::string &levelPrefix="Level_", const std::string &mfPrefix="Cell", const amrex::Vector< std::string > &extra_dirs=amrex::Vector< std::string >()) const
Definition: ERF_Plotfile.cpp:1573
+
void WriteMultiLevelPlotfileWithTerrain(const std::string &plotfilename, int nlevels, const amrex::Vector< const amrex::MultiFab * > &mf, const amrex::Vector< const amrex::MultiFab * > &mf_nd, const amrex::Vector< std::string > &varnames, const amrex::Vector< amrex::Geometry > &my_geom, amrex::Real time, const amrex::Vector< int > &level_steps, const amrex::Vector< amrex::IntVect > &my_ref_ratio, const std::string &versionName="HyperCLaw-V1.1", const std::string &levelPrefix="Level_", const std::string &mfPrefix="Cell", const amrex::Vector< std::string > &extra_dirs=amrex::Vector< std::string >()) const
Definition: ERF_Plotfile.cpp:1574
void writeJobInfo(const std::string &dir) const
Definition: ERF_writeJobInfo.cpp:9
void Plot_Lsm_Data(amrex::Real time, const amrex::Vector< int > &level_steps, const amrex::Vector< amrex::IntVect > &ref_ratio)
Definition: ERF_LandSurface.H:84
@ Turb_lengthscale
Definition: ERF_IndexDefines.H:161
diff --git a/classEWP-members.html b/classEWP-members.html index 830451232..ce680bd7a 100644 --- a/classEWP-members.html +++ b/classEWP-members.html @@ -90,55 +90,56 @@

This is the complete list of members for EWP, including all inherited members.

- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +
advance(const amrex::Geometry &geom, const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars_ewp, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb, const amrex::MultiFab &mf_SMark, const amrex::Real &time) overrideEWPvirtual
EWP()EWPinline
find_if_marked(amrex::Real x1, amrex::Real x2, amrex::Real y1, amrex::Real y2, amrex::Real x0, amrex::Real y0, amrex::Real nx, amrex::Real ny, amrex::Real d_hub_height, amrex::Real d_rotor_rad, amrex::Real z)NullWindFarminlinestatic
get_blade_airfoil_spec(amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminline
get_blade_spec(amrex::Vector< amrex::Real > &bld_rad_loc, amrex::Vector< amrex::Real > &bld_twist, amrex::Vector< amrex::Real > &bld_chord)NullWindFarminline
get_turb_disk_angle(amrex::Real &turb_disk_angle)NullWindFarminline
get_turb_loc(amrex::Vector< amrex::Real > &xloc, amrex::Vector< amrex::Real > &yloc)NullWindFarminline
get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)NullWindFarminline
get_turb_spec_extra(amrex::Vector< amrex::Real > &velocity, amrex::Vector< amrex::Real > &C_P, amrex::Vector< amrex::Real > &C_T, amrex::Vector< amrex::Real > &rotor_RPM, amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminline
hub_heightEWPprotected
m_blade_pitchNullWindFarmprotected
m_bld_airfoil_aoaNullWindFarmprotected
m_bld_airfoil_CdNullWindFarmprotected
m_bld_airfoil_ClNullWindFarmprotected
m_bld_chordNullWindFarmprotected
m_bld_rad_locNullWindFarmprotected
m_bld_twistNullWindFarmprotected
m_C_PNullWindFarmprotected
m_C_TNullWindFarmprotected
m_hub_heightNullWindFarmprotected
m_nominal_powerNullWindFarmprotected
m_powerNullWindFarmprotected
m_rotor_radNullWindFarmprotected
m_rotor_RPMNullWindFarmprotected
m_thrust_coeffNullWindFarmprotected
m_thrust_coeff_standingNullWindFarmprotected
m_turb_disk_angleNullWindFarmprotected
m_velocityNullWindFarmprotected
m_wind_speedNullWindFarmprotected
m_xlocNullWindFarmprotected
m_ylocNullWindFarmprotected
nominal_powerEWPprotected
NullWindFarm()NullWindFarminline
powerEWPprotected
rotor_radEWPprotected
set_blade_airfoil_spec(const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminlinevirtual
set_blade_spec(const amrex::Vector< amrex::Real > &bld_rad_loc, const amrex::Vector< amrex::Real > &bld_twist, const amrex::Vector< amrex::Real > &bld_chord)NullWindFarminlinevirtual
set_turb_disk_angle(const amrex::Real &turb_disk_angle)NullWindFarminlinevirtual
set_turb_loc(const amrex::Vector< amrex::Real > &xloc, const amrex::Vector< amrex::Real > &yloc)NullWindFarminlinevirtual
set_turb_spec(const amrex::Real &rotor_rad, const amrex::Real &hub_height, const amrex::Real &thrust_coeff_standing, const amrex::Vector< amrex::Real > &wind_speed, const amrex::Vector< amrex::Real > &thrust_coeff, const amrex::Vector< amrex::Real > &power)NullWindFarminlinevirtual
set_turb_spec_extra(const amrex::Vector< amrex::Real > &velocity, const amrex::Vector< amrex::Real > &C_P, const amrex::Vector< amrex::Real > &C_T, const amrex::Vector< amrex::Real > &rotor_RPM, const amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminlinevirtual
source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb)EWP
thrust_coeffEWPprotected
thrust_coeff_standingEWPprotected
update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, const amrex::MultiFab &mf_vars_ewp)EWP
wind_speedEWPprotected
xlocEWPprotected
ylocEWPprotected
~EWP()=defaultEWPvirtual
~NullWindFarm()=defaultNullWindFarmvirtual
compute_power_output(const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_SMark, const amrex::MultiFab &mf_Nturb, const amrex::Real &time)EWP
EWP()EWPinline
find_if_marked(amrex::Real x1, amrex::Real x2, amrex::Real y1, amrex::Real y2, amrex::Real x0, amrex::Real y0, amrex::Real nx, amrex::Real ny, amrex::Real d_hub_height, amrex::Real d_rotor_rad, amrex::Real z)NullWindFarminlinestatic
get_blade_airfoil_spec(amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminline
get_blade_spec(amrex::Vector< amrex::Real > &bld_rad_loc, amrex::Vector< amrex::Real > &bld_twist, amrex::Vector< amrex::Real > &bld_chord)NullWindFarminline
get_turb_disk_angle(amrex::Real &turb_disk_angle)NullWindFarminline
get_turb_loc(amrex::Vector< amrex::Real > &xloc, amrex::Vector< amrex::Real > &yloc)NullWindFarminline
get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)NullWindFarminline
get_turb_spec_extra(amrex::Vector< amrex::Real > &velocity, amrex::Vector< amrex::Real > &C_P, amrex::Vector< amrex::Real > &C_T, amrex::Vector< amrex::Real > &rotor_RPM, amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminline
hub_heightEWPprotected
m_blade_pitchNullWindFarmprotected
m_bld_airfoil_aoaNullWindFarmprotected
m_bld_airfoil_CdNullWindFarmprotected
m_bld_airfoil_ClNullWindFarmprotected
m_bld_chordNullWindFarmprotected
m_bld_rad_locNullWindFarmprotected
m_bld_twistNullWindFarmprotected
m_C_PNullWindFarmprotected
m_C_TNullWindFarmprotected
m_hub_heightNullWindFarmprotected
m_nominal_powerNullWindFarmprotected
m_powerNullWindFarmprotected
m_rotor_radNullWindFarmprotected
m_rotor_RPMNullWindFarmprotected
m_thrust_coeffNullWindFarmprotected
m_thrust_coeff_standingNullWindFarmprotected
m_turb_disk_angleNullWindFarmprotected
m_velocityNullWindFarmprotected
m_wind_speedNullWindFarmprotected
m_xlocNullWindFarmprotected
m_ylocNullWindFarmprotected
nominal_powerEWPprotected
NullWindFarm()NullWindFarminline
powerEWPprotected
rotor_radEWPprotected
set_blade_airfoil_spec(const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminlinevirtual
set_blade_spec(const amrex::Vector< amrex::Real > &bld_rad_loc, const amrex::Vector< amrex::Real > &bld_twist, const amrex::Vector< amrex::Real > &bld_chord)NullWindFarminlinevirtual
set_turb_disk_angle(const amrex::Real &turb_disk_angle)NullWindFarminlinevirtual
set_turb_loc(const amrex::Vector< amrex::Real > &xloc, const amrex::Vector< amrex::Real > &yloc)NullWindFarminlinevirtual
set_turb_spec(const amrex::Real &rotor_rad, const amrex::Real &hub_height, const amrex::Real &thrust_coeff_standing, const amrex::Vector< amrex::Real > &wind_speed, const amrex::Vector< amrex::Real > &thrust_coeff, const amrex::Vector< amrex::Real > &power)NullWindFarminlinevirtual
set_turb_spec_extra(const amrex::Vector< amrex::Real > &velocity, const amrex::Vector< amrex::Real > &C_P, const amrex::Vector< amrex::Real > &C_T, const amrex::Vector< amrex::Real > &rotor_RPM, const amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminlinevirtual
source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb)EWP
thrust_coeffEWPprotected
thrust_coeff_standingEWPprotected
update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, const amrex::MultiFab &mf_vars_ewp)EWP
wind_speedEWPprotected
xlocEWPprotected
ylocEWPprotected
~EWP()=defaultEWPvirtual
~NullWindFarm()=defaultNullWindFarmvirtual
diff --git a/classEWP.html b/classEWP.html index 9587195b8..2ecb8e34d 100644 --- a/classEWP.html +++ b/classEWP.html @@ -126,6 +126,8 @@   void update (const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, const amrex::MultiFab &mf_vars_ewp)   +void compute_power_output (const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_SMark, const amrex::MultiFab &mf_Nturb, const amrex::Real &time) +  - Public Member Functions inherited from NullWindFarm  NullWindFarm ()   @@ -367,10 +369,146 @@

21  AMREX_ALWAYS_ASSERT(time > -1.0);
22  source_terms_cellcentered(geom, cons_in, mf_vars_ewp, U_old, V_old, W_old, mf_Nturb);
23  update(dt_advance, cons_in, U_old, V_old, mf_vars_ewp);
-
24 }
-
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb)
Definition: ERF_AdvanceEWP.cpp:62
-
void update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, const amrex::MultiFab &mf_vars_ewp)
Definition: ERF_AdvanceEWP.cpp:28
+
24  compute_power_output(cons_in, U_old, V_old, W_old, mf_SMark, mf_Nturb, time);
+
25 }
+
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb)
Definition: ERF_AdvanceEWP.cpp:128
+
void update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, const amrex::MultiFab &mf_vars_ewp)
Definition: ERF_AdvanceEWP.cpp:94
+
void compute_power_output(const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_SMark, const amrex::MultiFab &mf_Nturb, const amrex::Real &time)
Definition: ERF_AdvanceEWP.cpp:29
+ + + +

◆ compute_power_output()

+ +
+
+ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +
void EWP::compute_power_output (const amrex::MultiFab & cons_in,
const amrex::MultiFab & U_old,
const amrex::MultiFab & V_old,
const amrex::MultiFab & W_old,
const amrex::MultiFab & mf_SMark,
const amrex::MultiFab & mf_Nturb,
const amrex::Real & time 
)
+
+
36 {
+ + + +
40 
+
41  const int n_spec_table = wind_speed.size();
+
42 
+
43  Gpu::DeviceVector<Real> d_wind_speed(wind_speed.size());
+
44  Gpu::DeviceVector<Real> d_power(wind_speed.size());
+
45  Gpu::copy(Gpu::hostToDevice, wind_speed.begin(), wind_speed.end(), d_wind_speed.begin());
+
46  Gpu::copy(Gpu::hostToDevice, power.begin(), power.end(), d_power.begin());
+
47 
+
48  Gpu::DeviceScalar<Real> d_total_power(0.0);
+
49  Real* d_total_power_ptr = d_total_power.dataPtr();
+
50 
+
51  const Real* d_wind_speed_ptr = d_wind_speed.dataPtr();
+
52  const Real* d_power_ptr = d_power.dataPtr();
+
53 
+
54  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
55 
+
56  auto SMark_array = mf_SMark.array(mfi);
+
57  auto Nturb_array = mf_Nturb.array(mfi);
+
58  auto u_vel = U_old.array(mfi);
+
59  auto v_vel = V_old.array(mfi);
+
60  auto w_vel = W_old.array(mfi);
+
61  Box tbx = mfi.nodaltilebox(0);
+
62 
+
63  ParallelFor(tbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
64 
+
65  if(SMark_array(i,j,k,0) == 1.0) {
+
66  Real avg_vel = std::pow(u_vel(i,j,k)*u_vel(i,j,k) +
+
67  v_vel(i,j,k)*v_vel(i,j,k) +
+
68  w_vel(i,j,k)*w_vel(i,j,k),0.5);
+
69  Real turb_power = interpolate_1d(d_wind_speed_ptr, d_power_ptr, avg_vel, n_spec_table);
+
70  turb_power = turb_power*Nturb_array(i,j,k,0);
+
71  Gpu::Atomic::Add(d_total_power_ptr,turb_power);
+
72  }
+
73  });
+
74  }
+
75 
+
76  Real h_total_power = 0.0;
+
77  Gpu::copy(Gpu::deviceToHost, d_total_power.dataPtr(), d_total_power.dataPtr()+1, &h_total_power);
+
78 
+
79  amrex::ParallelAllReduce::Sum(&h_total_power, 1, amrex::ParallelContext::CommunicatorAll());
+
80 
+
81  if (ParallelDescriptor::IOProcessor()){
+
82  static std::ofstream file("power_output_EWP.txt", std::ios::app);
+
83  // Check if the file opened successfully
+
84  if (!file.is_open()) {
+
85  std::cerr << "Error opening file!" << std::endl;
+
86  Abort("Could not open file to write power output in ERF_AdvanceSimpleAD.cpp");
+
87  }
+
88  file << time << " " << h_total_power << "\n";
+
89  file.flush();
+
90  }
+
91 }
+
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE amrex::Real interpolate_1d(const amrex::Real *alpha, const amrex::Real *beta, const amrex::Real alpha_interp, const int alpha_size)
Definition: ERF_Interpolation_1D.H:12
+
amrex::Real thrust_coeff_standing
Definition: ERF_EWP.H:52
+
amrex::Real hub_height
Definition: ERF_EWP.H:52
+
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_EWP.H:53
+
amrex::Vector< amrex::Real > xloc
Definition: ERF_EWP.H:51
+
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_EWP.H:53
+
amrex::Vector< amrex::Real > power
Definition: ERF_EWP.H:53
+
amrex::Real rotor_rad
Definition: ERF_EWP.H:52
+
amrex::Vector< amrex::Real > yloc
Definition: ERF_EWP.H:51
+
void get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)
Definition: ERF_NullWindFarm.H:84
+
void get_turb_loc(amrex::Vector< amrex::Real > &xloc, amrex::Vector< amrex::Real > &yloc)
Definition: ERF_NullWindFarm.H:96
+
+Here is the call graph for this function:
+
+
+ + + + +
+
@@ -428,87 +566,79 @@

-
69 {
-
70 
- - -
73 
-
74  auto dx = geom.CellSizeArray();
-
75  auto ProbLoArr = geom.ProbLoArray();
-
76  Real sigma_0 = 1.7*rotor_rad;
-
77 
-
78  Real d_rotor_rad = rotor_rad;
-
79  Real d_hub_height = hub_height;
-
80 
-
81  Gpu::DeviceVector<Real> d_wind_speed(wind_speed.size());
-
82  Gpu::DeviceVector<Real> d_thrust_coeff(thrust_coeff.size());
-
83 
-
84  // Copy data from host vectors to device vectors
-
85  Gpu::copy(Gpu::hostToDevice, wind_speed.begin(), wind_speed.end(), d_wind_speed.begin());
-
86  Gpu::copy(Gpu::hostToDevice, thrust_coeff.begin(), thrust_coeff.end(), d_thrust_coeff.begin());
-
87 
-
88 
-
89  // Domain valid box
-
90  const amrex::Box& domain = geom.Domain();
-
91  int domlo_z = domain.smallEnd(2);
-
92  int domhi_z = domain.bigEnd(2) + 1;
-
93 
-
94  // The order of variables are - Vabs dVabsdt, dudt, dvdt, dTKEdt
-
95  mf_vars_ewp.setVal(0.0);
-
96 
-
97  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
-
98 
-
99  const Box& gbx = mfi.growntilebox(1);
-
100  auto ewp_array = mf_vars_ewp.array(mfi);
-
101  auto Nturb_array = mf_Nturb.array(mfi);
-
102  auto u_vel = U_old.array(mfi);
-
103  auto v_vel = V_old.array(mfi);
-
104  auto w_vel = W_old.array(mfi);
-
105 
-
106  const Real* wind_speed_d = d_wind_speed.dataPtr();
-
107  const Real* thrust_coeff_d = d_thrust_coeff.dataPtr();
-
108  const int n_spec_table = d_wind_speed.size();
-
109 
-
110  ParallelFor(gbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
111 
-
112  int kk = amrex::min(amrex::max(k, domlo_z), domhi_z);
-
113  Real z = ProbLoArr[2] + (kk+0.5) * dx[2];
-
114 
-
115  // Compute Fitch source terms
-
116 
-
117  Real Vabs = std::pow(u_vel(i,j,k)*u_vel(i,j,k) +
-
118  v_vel(i,j,k)*v_vel(i,j,k) +
-
119  w_vel(i,j,kk)*w_vel(i,j,kk), 0.5);
-
120 
-
121  Real C_T = interpolate_1d(wind_speed_d, thrust_coeff_d, Vabs, n_spec_table);
-
122 
-
123  Real C_TKE = 0.0;
-
124  Real K_turb = 1.0;
-
125 
-
126  Real L_wake = std::pow(dx[0]*dx[1],0.5)/2.0;
-
127  Real sigma_e = Vabs/(3.0*K_turb*L_wake)*
-
128  (std::pow(2.0*K_turb*L_wake/Vabs + std::pow(sigma_0,2),3.0/2.0) - std::pow(sigma_0,3));
-
129 
-
130  Real phi = std::atan2(v_vel(i,j,k),u_vel(i,j,k)); // Wind direction w.r.t the x-dreiction
-
131  Real fac = -std::pow(PI/8.0,0.5)*C_T*std::pow(d_rotor_rad,2)*
-
132  std::pow(Vabs,2)/(dx[0]*dx[1]*sigma_e)*
-
133  std::exp(-0.5*std::pow((z - d_hub_height)/sigma_e,2));
-
134  ewp_array(i,j,k,0) = fac*std::cos(phi)*Nturb_array(i,j,k);
-
135  ewp_array(i,j,k,1) = fac*std::sin(phi)*Nturb_array(i,j,k);
-
136  ewp_array(i,j,k,2) = C_TKE*0.0;
-
137  });
-
138  }
-
139 }
+
135 {
+
136 
+ + +
139 
+
140  auto dx = geom.CellSizeArray();
+
141  auto ProbLoArr = geom.ProbLoArray();
+
142  Real sigma_0 = 1.7*rotor_rad;
+
143 
+
144  Real d_rotor_rad = rotor_rad;
+
145  Real d_hub_height = hub_height;
+
146 
+
147  Gpu::DeviceVector<Real> d_wind_speed(wind_speed.size());
+
148  Gpu::DeviceVector<Real> d_thrust_coeff(thrust_coeff.size());
+
149 
+
150  // Copy data from host vectors to device vectors
+
151  Gpu::copy(Gpu::hostToDevice, wind_speed.begin(), wind_speed.end(), d_wind_speed.begin());
+
152  Gpu::copy(Gpu::hostToDevice, thrust_coeff.begin(), thrust_coeff.end(), d_thrust_coeff.begin());
+
153 
+
154 
+
155  // Domain valid box
+
156  const amrex::Box& domain = geom.Domain();
+
157  int domlo_z = domain.smallEnd(2);
+
158  int domhi_z = domain.bigEnd(2) + 1;
+
159 
+
160  // The order of variables are - Vabs dVabsdt, dudt, dvdt, dTKEdt
+
161  mf_vars_ewp.setVal(0.0);
+
162 
+
163  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
164 
+
165  const Box& gbx = mfi.growntilebox(1);
+
166  auto ewp_array = mf_vars_ewp.array(mfi);
+
167  auto Nturb_array = mf_Nturb.array(mfi);
+
168  auto u_vel = U_old.array(mfi);
+
169  auto v_vel = V_old.array(mfi);
+
170  auto w_vel = W_old.array(mfi);
+
171 
+
172  const Real* wind_speed_d = d_wind_speed.dataPtr();
+
173  const Real* thrust_coeff_d = d_thrust_coeff.dataPtr();
+
174  const int n_spec_table = d_wind_speed.size();
+
175 
+
176  ParallelFor(gbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
177 
+
178  int kk = amrex::min(amrex::max(k, domlo_z), domhi_z);
+
179  Real z = ProbLoArr[2] + (kk+0.5) * dx[2];
+
180 
+
181  // Compute Fitch source terms
+
182 
+
183  Real Vabs = std::pow(u_vel(i,j,k)*u_vel(i,j,k) +
+
184  v_vel(i,j,k)*v_vel(i,j,k) +
+
185  w_vel(i,j,kk)*w_vel(i,j,kk), 0.5);
+
186 
+
187  Real C_T = interpolate_1d(wind_speed_d, thrust_coeff_d, Vabs, n_spec_table);
+
188 
+
189  Real C_TKE = 0.0;
+
190  Real K_turb = 6.0;
+
191 
+
192  Real L_wake = std::pow(dx[0]*dx[1],0.5)/2.0;
+
193  Real sigma_e = Vabs/(3.0*K_turb*L_wake)*
+
194  (std::pow(2.0*K_turb*L_wake/Vabs + std::pow(sigma_0,2),3.0/2.0) - std::pow(sigma_0,3));
+
195 
+
196  Real phi = std::atan2(v_vel(i,j,k),u_vel(i,j,k)); // Wind direction w.r.t the x-dreiction
+
197  Real fac = -std::pow(PI/8.0,0.5)*C_T*std::pow(d_rotor_rad,2)*
+
198  std::pow(Vabs,2)/(dx[0]*dx[1]*sigma_e)*
+
199  std::exp(-0.5*std::pow((z - d_hub_height)/sigma_e,2));
+
200  ewp_array(i,j,k,0) = fac*std::cos(phi)*Nturb_array(i,j,k);
+
201  ewp_array(i,j,k,1) = fac*std::sin(phi)*Nturb_array(i,j,k);
+
202  ewp_array(i,j,k,2) = C_TKE*0.0;
+
203  });
+
204  }
+
205 }
constexpr amrex::Real PI
Definition: ERF_Constants.H:6
-
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE amrex::Real interpolate_1d(const amrex::Real *alpha, const amrex::Real *beta, const amrex::Real alpha_interp, const int alpha_size)
Definition: ERF_Interpolation_1D.H:12
-
amrex::Real thrust_coeff_standing
Definition: ERF_EWP.H:43
-
amrex::Real hub_height
Definition: ERF_EWP.H:43
-
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_EWP.H:44
-
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_EWP.H:44
-
amrex::Vector< amrex::Real > power
Definition: ERF_EWP.H:44
-
amrex::Real rotor_rad
Definition: ERF_EWP.H:43
-
void get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)
Definition: ERF_NullWindFarm.H:84
Here is the call graph for this function:
@@ -564,34 +694,34 @@

-
32 {
-
33 
-
34  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
-
35 
-
36  Box bx = mfi.tilebox();
-
37  Box tbx = mfi.nodaltilebox(0);
-
38  Box tby = mfi.nodaltilebox(1);
-
39 
-
40  auto cons_array = cons_in.array(mfi);
-
41  auto ewp_array = mf_vars_ewp.array(mfi);
-
42  auto u_vel = U_old.array(mfi);
-
43  auto v_vel = V_old.array(mfi);
-
44 
-
45  ParallelFor(tbx, tby, bx,
-
46  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
47  {
-
48  u_vel(i,j,k) = u_vel(i,j,k) + (ewp_array(i-1,j,k,0) + ewp_array(i,j,k,0))/2.0*dt_advance;
-
49  },
-
50  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
51  {
-
52  v_vel(i,j,k) = v_vel(i,j,k) + (ewp_array(i,j-1,k,1) + ewp_array(i,j,k,1))/2.0*dt_advance;
-
53  },
-
54  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
55  {
-
56  cons_array(i,j,k,RhoKE_comp) = cons_array(i,j,k,RhoKE_comp) + ewp_array(i,j,k,2)*dt_advance;
-
57  });
-
58  }
-
59 }
+
98 {
+
99 
+
100  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
101 
+
102  Box bx = mfi.tilebox();
+
103  Box tbx = mfi.nodaltilebox(0);
+
104  Box tby = mfi.nodaltilebox(1);
+
105 
+
106  auto cons_array = cons_in.array(mfi);
+
107  auto ewp_array = mf_vars_ewp.array(mfi);
+
108  auto u_vel = U_old.array(mfi);
+
109  auto v_vel = V_old.array(mfi);
+
110 
+
111  ParallelFor(tbx, tby, bx,
+
112  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
113  {
+
114  u_vel(i,j,k) = u_vel(i,j,k) + (ewp_array(i-1,j,k,0) + ewp_array(i,j,k,0))/2.0*dt_advance;
+
115  },
+
116  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
117  {
+
118  v_vel(i,j,k) = v_vel(i,j,k) + (ewp_array(i,j-1,k,1) + ewp_array(i,j,k,1))/2.0*dt_advance;
+
119  },
+
120  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
121  {
+
122  cons_array(i,j,k,RhoKE_comp) = cons_array(i,j,k,RhoKE_comp) + ewp_array(i,j,k,2)*dt_advance;
+
123  });
+
124  }
+
125 }
#define RhoKE_comp
Definition: ERF_IndexDefines.H:38
diff --git a/classEWP.js b/classEWP.js index dbb570872..cacfcffbe 100644 --- a/classEWP.js +++ b/classEWP.js @@ -3,6 +3,7 @@ var classEWP = [ "EWP", "classEWP.html#a4c32d700e8ba91dfbc07c332ad91ca71", null ], [ "~EWP", "classEWP.html#ad500c0f4245245d407e31633ec7cecff", null ], [ "advance", "classEWP.html#a675a92a8d9c16748a95412e48bae2457", null ], + [ "compute_power_output", "classEWP.html#af9cd3be628c58fca164e35db4a559fd9", null ], [ "source_terms_cellcentered", "classEWP.html#a4f28000173748f88919eda5fbed1368e", null ], [ "update", "classEWP.html#a762189d5d9c02d32fa1e6186adb35ae0", null ], [ "hub_height", "classEWP.html#a2ee471b0dcad3057297b809f4c5141ab", null ], diff --git a/classEWP_af9cd3be628c58fca164e35db4a559fd9_cgraph.map b/classEWP_af9cd3be628c58fca164e35db4a559fd9_cgraph.map new file mode 100644 index 000000000..106f3b3be --- /dev/null +++ b/classEWP_af9cd3be628c58fca164e35db4a559fd9_cgraph.map @@ -0,0 +1,4 @@ + + + + diff --git a/classEWP_af9cd3be628c58fca164e35db4a559fd9_cgraph.md5 b/classEWP_af9cd3be628c58fca164e35db4a559fd9_cgraph.md5 new file mode 100644 index 000000000..aa4d79b94 --- /dev/null +++ b/classEWP_af9cd3be628c58fca164e35db4a559fd9_cgraph.md5 @@ -0,0 +1 @@ +620382b428d3c7bec8ff05a53f14a789 \ No newline at end of file diff --git a/classEWP_af9cd3be628c58fca164e35db4a559fd9_cgraph.png b/classEWP_af9cd3be628c58fca164e35db4a559fd9_cgraph.png new file mode 100644 index 000000000..a822532c3 Binary files /dev/null and b/classEWP_af9cd3be628c58fca164e35db4a559fd9_cgraph.png differ diff --git a/classFitch-members.html b/classFitch-members.html index ce6a84154..ecd7c4209 100644 --- a/classFitch-members.html +++ b/classFitch-members.html @@ -90,15 +90,17 @@

This is the complete list of members for Fitch, including all inherited members.

- - - - - - - - - + + + + + + + + + + + diff --git a/classFitch.html b/classFitch.html index 3a15dfbbc..08c9ac367 100644 --- a/classFitch.html +++ b/classFitch.html @@ -106,11 +106,11 @@
Collaboration graph
- - + + - +
[legend]
advance(const amrex::Geometry &geom, const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars_fitch, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb, const amrex::MultiFab &mf_SMark, const amrex::Real &time) overrideFitchvirtual
find_if_marked(amrex::Real x1, amrex::Real x2, amrex::Real y1, amrex::Real y2, amrex::Real x0, amrex::Real y0, amrex::Real nx, amrex::Real ny, amrex::Real d_hub_height, amrex::Real d_rotor_rad, amrex::Real z)NullWindFarminlinestatic
Fitch()Fitchinline
get_blade_airfoil_spec(amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminline
get_blade_spec(amrex::Vector< amrex::Real > &bld_rad_loc, amrex::Vector< amrex::Real > &bld_twist, amrex::Vector< amrex::Real > &bld_chord)NullWindFarminline
get_turb_disk_angle(amrex::Real &turb_disk_angle)NullWindFarminline
get_turb_loc(amrex::Vector< amrex::Real > &xloc, amrex::Vector< amrex::Real > &yloc)NullWindFarminline
get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)NullWindFarminline
get_turb_spec_extra(amrex::Vector< amrex::Real > &velocity, amrex::Vector< amrex::Real > &C_P, amrex::Vector< amrex::Real > &C_T, amrex::Vector< amrex::Real > &rotor_RPM, amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminline
hub_heightFitchprotected
compute_power_output(const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &mf_SMark, const amrex::MultiFab &mf_Nturb, const amrex::Real &time)Fitch
find_if_marked(amrex::Real x1, amrex::Real x2, amrex::Real y1, amrex::Real y2, amrex::Real x0, amrex::Real y0, amrex::Real nx, amrex::Real ny, amrex::Real d_hub_height, amrex::Real d_rotor_rad, amrex::Real z)NullWindFarminlinestatic
Fitch()Fitchinline
get_blade_airfoil_spec(amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminline
get_blade_spec(amrex::Vector< amrex::Real > &bld_rad_loc, amrex::Vector< amrex::Real > &bld_twist, amrex::Vector< amrex::Real > &bld_chord)NullWindFarminline
get_turb_disk_angle(amrex::Real &turb_disk_angle)NullWindFarminline
get_turb_loc(amrex::Vector< amrex::Real > &xloc, amrex::Vector< amrex::Real > &yloc)NullWindFarminline
get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)NullWindFarminline
get_turb_spec_extra(amrex::Vector< amrex::Real > &velocity, amrex::Vector< amrex::Real > &C_P, amrex::Vector< amrex::Real > &C_T, amrex::Vector< amrex::Real > &rotor_RPM, amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminline
hub_heightFitchprotected
hub_height_velocityFitchprotected
m_blade_pitchNullWindFarmprotected
m_bld_airfoil_aoaNullWindFarmprotected
m_bld_airfoil_CdNullWindFarmprotected
@@ -126,6 +126,8 @@ + + @@ -158,6 +160,8 @@
 
void update (const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, const amrex::MultiFab &mf_vars_fitch)
 
void compute_power_output (const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &mf_SMark, const amrex::MultiFab &mf_Nturb, const amrex::Real &time)
 
- Public Member Functions inherited from NullWindFarm
 NullWindFarm ()
 
+ + @@ -368,10 +372,137 @@

61  AMREX_ALWAYS_ASSERT(time > -1.0);
62  source_terms_cellcentered(geom, cons_in, mf_vars_fitch, U_old, V_old, W_old, mf_Nturb);
63  update(dt_advance, cons_in, U_old, V_old, mf_vars_fitch);
-
64 }
+
64  compute_power_output(cons_in, U_old, V_old, mf_SMark, mf_Nturb, time);
+
65 }
void update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, const amrex::MultiFab &mf_vars_fitch)
Definition: ERF_AdvanceFitch.cpp:68
-
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars_ewp, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb)
Definition: ERF_AdvanceFitch.cpp:102
+
void compute_power_output(const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &mf_SMark, const amrex::MultiFab &mf_Nturb, const amrex::Real &time)
Definition: ERF_AdvanceFitch.cpp:102
+
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, amrex::MultiFab &mf_vars_ewp, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &W_old, const amrex::MultiFab &mf_Nturb)
Definition: ERF_AdvanceFitch.cpp:163
+ + + +

◆ compute_power_output()

+ +
+
+

Protected Attributes

amrex::Vector< amrex::Real > hub_height_velocity
 
amrex::Vector< amrex::Real > xloc
 
amrex::Vector< amrex::Real > yloc
+ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +
void Fitch::compute_power_output (const amrex::MultiFab & cons_in,
const amrex::MultiFab & U_old,
const amrex::MultiFab & V_old,
const amrex::MultiFab & mf_SMark,
const amrex::MultiFab & mf_Nturb,
const amrex::Real & time 
)
+

+
108 {
+ + + +
112 
+
113  const int n_spec_table = wind_speed.size();
+
114 
+
115  Gpu::DeviceVector<Real> d_wind_speed(wind_speed.size());
+
116  Gpu::DeviceVector<Real> d_power(wind_speed.size());
+
117  Gpu::copy(Gpu::hostToDevice, wind_speed.begin(), wind_speed.end(), d_wind_speed.begin());
+
118  Gpu::copy(Gpu::hostToDevice, power.begin(), power.end(), d_power.begin());
+
119 
+
120  Gpu::DeviceScalar<Real> d_total_power(0.0);
+
121  Real* d_total_power_ptr = d_total_power.dataPtr();
+
122 
+
123  const Real* d_wind_speed_ptr = d_wind_speed.dataPtr();
+
124  const Real* d_power_ptr = d_power.dataPtr();
+
125 
+
126  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
127 
+
128  auto SMark_array = mf_SMark.array(mfi);
+
129  auto Nturb_array = mf_Nturb.array(mfi);
+
130  auto u_vel = U_old.array(mfi);
+
131  auto v_vel = V_old.array(mfi);
+
132  Box tbx = mfi.nodaltilebox(0);
+
133 
+
134  ParallelFor(tbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
135 
+
136  if(SMark_array(i,j,k,0) == 1.0) {
+
137  Real avg_vel = std::pow(u_vel(i,j,k)*u_vel(i,j,k) + v_vel(i,j,k)*v_vel(i,j,k),0.5);
+
138  Real turb_power = interpolate_1d(d_wind_speed_ptr, d_power_ptr, avg_vel, n_spec_table);
+
139  turb_power = turb_power*Nturb_array(i,j,k,0);
+
140  Gpu::Atomic::Add(d_total_power_ptr,turb_power);
+
141  }
+
142  });
+
143  }
+
144 
+
145  Real h_total_power = 0.0;
+
146  Gpu::copy(Gpu::deviceToHost, d_total_power.dataPtr(), d_total_power.dataPtr()+1, &h_total_power);
+
147 
+
148  amrex::ParallelAllReduce::Sum(&h_total_power, 1, amrex::ParallelContext::CommunicatorAll());
+
149 
+
150  if (ParallelDescriptor::IOProcessor()){
+
151  static std::ofstream file("power_output_Fitch.txt", std::ios::app);
+
152  // Check if the file opened successfully
+
153  if (!file.is_open()) {
+
154  std::cerr << "Error opening file!" << std::endl;
+
155  Abort("Could not open file to write power output in ERF_AdvanceSimpleAD.cpp");
+
156  }
+
157  file << time << " " << h_total_power << "\n";
+
158  file.flush();
+
159  }
+
160 }
+
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE amrex::Real interpolate_1d(const amrex::Real *alpha, const amrex::Real *beta, const amrex::Real alpha_interp, const int alpha_size)
Definition: ERF_Interpolation_1D.H:12
+
amrex::Vector< amrex::Real > yloc
Definition: ERF_Fitch.H:50
+
amrex::Vector< amrex::Real > xloc
Definition: ERF_Fitch.H:50
+
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_Fitch.H:52
+
amrex::Vector< amrex::Real > power
Definition: ERF_Fitch.H:52
+
amrex::Real rotor_rad
Definition: ERF_Fitch.H:51
+
amrex::Real thrust_coeff_standing
Definition: ERF_Fitch.H:51
+
amrex::Real hub_height
Definition: ERF_Fitch.H:51
+
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_Fitch.H:52
+
void get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)
Definition: ERF_NullWindFarm.H:84
+
void get_turb_loc(amrex::Vector< amrex::Real > &xloc, amrex::Vector< amrex::Real > &yloc)
Definition: ERF_NullWindFarm.H:96
+
+Here is the call graph for this function:
+
+
+ + + + +
+
@@ -429,85 +560,77 @@

-
109 {
-
110 
- - -
113 
-
114  auto dx = geom.CellSizeArray();
-
115 
-
116  // Domain valid box
-
117  const amrex::Box& domain = geom.Domain();
-
118  int domlo_z = domain.smallEnd(2);
-
119  int domhi_z = domain.bigEnd(2) + 1;
-
120 
-
121 
-
122  //Real sum = 0.0;
-
123  //Real *sum_area = &sum;
-
124 
-
125  // The order of variables are - Vabs dVabsdt, dudt, dvdt, dTKEdt
-
126  mf_vars_fitch.setVal(0.0);
-
127  Real d_hub_height = hub_height;
-
128  Real d_rotor_rad = rotor_rad;
-
129  Gpu::DeviceVector<Real> d_wind_speed(wind_speed.size());
-
130  Gpu::DeviceVector<Real> d_thrust_coeff(thrust_coeff.size());
-
131 
-
132  // Copy data from host vectors to device vectors
-
133  Gpu::copy(Gpu::hostToDevice, wind_speed.begin(), wind_speed.end(), d_wind_speed.begin());
-
134  Gpu::copy(Gpu::hostToDevice, thrust_coeff.begin(), thrust_coeff.end(), d_thrust_coeff.begin());
-
135 
-
136  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
-
137 
-
138  const Box& gbx = mfi.growntilebox(1);
-
139  auto fitch_array = mf_vars_fitch.array(mfi);
-
140  auto Nturb_array = mf_Nturb.array(mfi);
-
141  auto u_vel = U_old.array(mfi);
-
142  auto v_vel = V_old.array(mfi);
-
143  auto w_vel = W_old.array(mfi);
-
144 
-
145  const Real* wind_speed_d = d_wind_speed.dataPtr();
-
146  const Real* thrust_coeff_d = d_thrust_coeff.dataPtr();
-
147  const int n_spec_table = d_wind_speed.size();
-
148 
-
149  ParallelFor(gbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
150  int kk = amrex::min(amrex::max(k, domlo_z), domhi_z);
-
151 
-
152  Real z_k = kk*dx[2];
-
153  Real z_kp1 = (kk+1)*dx[2];
-
154 
-
155  Real A_ijk = compute_Aijk(z_k, z_kp1, d_hub_height, d_rotor_rad);
-
156 
-
157  // Compute Fitch source terms
-
158 
-
159  Real Vabs = std::pow(u_vel(i,j,k)*u_vel(i,j,k) +
-
160  v_vel(i,j,k)*v_vel(i,j,k) +
-
161  w_vel(i,j,kk)*w_vel(i,j,kk), 0.5);
-
162 
-
163  Real C_T = interpolate_1d(wind_speed_d, thrust_coeff_d, Vabs, n_spec_table);
-
164  Real C_TKE = 0.0;
-
165 
-
166  fitch_array(i,j,k,0) = Vabs;
-
167  fitch_array(i,j,k,1) = -0.5*Nturb_array(i,j,k)/(dx[0]*dx[1])*C_T*Vabs*Vabs*A_ijk/(z_kp1 - z_k);
-
168  fitch_array(i,j,k,2) = u_vel(i,j,k)/Vabs*fitch_array(i,j,k,1);
-
169  fitch_array(i,j,k,3) = v_vel(i,j,k)/Vabs*fitch_array(i,j,k,1);
-
170  fitch_array(i,j,k,4) = 0.5*Nturb_array(i,j,k)/(dx[0]*dx[1])*C_TKE*std::pow(Vabs,3)*A_ijk/(z_kp1 - z_k);
+
170 {
171 
-
172  //amrex::Gpu::Atomic::Add(sum_area, A_ijk);
-
173  });
-
174  }
-
175  //std::cout << "Checking sum here...." <<"\n";
-
176  //printf("%0.15g, %0.15g\n", *sum_area , PI*R*R);
-
177  //exit(0);
-
178 }
+ + +
174 
+
175  auto dx = geom.CellSizeArray();
+
176 
+
177  // Domain valid box
+
178  const amrex::Box& domain = geom.Domain();
+
179  int domlo_z = domain.smallEnd(2);
+
180  int domhi_z = domain.bigEnd(2) + 1;
+
181 
+
182 
+
183  //Real sum = 0.0;
+
184  //Real *sum_area = &sum;
+
185 
+
186  // The order of variables are - Vabs dVabsdt, dudt, dvdt, dTKEdt
+
187  mf_vars_fitch.setVal(0.0);
+
188  Real d_hub_height = hub_height;
+
189  Real d_rotor_rad = rotor_rad;
+
190  Gpu::DeviceVector<Real> d_wind_speed(wind_speed.size());
+
191  Gpu::DeviceVector<Real> d_thrust_coeff(thrust_coeff.size());
+
192 
+
193  // Copy data from host vectors to device vectors
+
194  Gpu::copy(Gpu::hostToDevice, wind_speed.begin(), wind_speed.end(), d_wind_speed.begin());
+
195  Gpu::copy(Gpu::hostToDevice, thrust_coeff.begin(), thrust_coeff.end(), d_thrust_coeff.begin());
+
196 
+
197  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
198 
+
199  const Box& gbx = mfi.growntilebox(1);
+
200  auto fitch_array = mf_vars_fitch.array(mfi);
+
201  auto Nturb_array = mf_Nturb.array(mfi);
+
202  auto u_vel = U_old.array(mfi);
+
203  auto v_vel = V_old.array(mfi);
+
204  auto w_vel = W_old.array(mfi);
+
205 
+
206  const Real* wind_speed_d = d_wind_speed.dataPtr();
+
207  const Real* thrust_coeff_d = d_thrust_coeff.dataPtr();
+
208  const int n_spec_table = d_wind_speed.size();
+
209 
+
210  ParallelFor(gbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
211  int kk = amrex::min(amrex::max(k, domlo_z), domhi_z);
+
212 
+
213  Real z_k = kk*dx[2];
+
214  Real z_kp1 = (kk+1)*dx[2];
+
215 
+
216  Real A_ijk = compute_Aijk(z_k, z_kp1, d_hub_height, d_rotor_rad);
+
217 
+
218  // Compute Fitch source terms
+
219 
+
220  Real Vabs = std::pow(u_vel(i,j,k)*u_vel(i,j,k) +
+
221  v_vel(i,j,k)*v_vel(i,j,k) +
+
222  w_vel(i,j,kk)*w_vel(i,j,kk), 0.5);
+
223 
+
224  Real C_T = interpolate_1d(wind_speed_d, thrust_coeff_d, Vabs, n_spec_table);
+
225  Real C_TKE = 0.0;
+
226 
+
227  fitch_array(i,j,k,0) = Vabs;
+
228  fitch_array(i,j,k,1) = -0.5*Nturb_array(i,j,k)/(dx[0]*dx[1])*C_T*Vabs*Vabs*A_ijk/(z_kp1 - z_k);
+
229  fitch_array(i,j,k,2) = u_vel(i,j,k)/Vabs*fitch_array(i,j,k,1);
+
230  fitch_array(i,j,k,3) = v_vel(i,j,k)/Vabs*fitch_array(i,j,k,1);
+
231  fitch_array(i,j,k,4) = 0.5*Nturb_array(i,j,k)/(dx[0]*dx[1])*C_TKE*std::pow(Vabs,3)*A_ijk/(z_kp1 - z_k);
+
232 
+
233  //amrex::Gpu::Atomic::Add(sum_area, A_ijk);
+
234  });
+
235  }
+
236  //std::cout << "Checking sum here...." <<"\n";
+
237  //printf("%0.15g, %0.15g\n", *sum_area , PI*R*R);
+
238  //exit(0);
+
239 }
AMREX_FORCE_INLINE AMREX_GPU_DEVICE Real compute_Aijk(const Real z_k, const Real z_kp1, const Real hub_height, const Real rotor_rad)
Definition: ERF_AdvanceFitch.cpp:25
-
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE amrex::Real interpolate_1d(const amrex::Real *alpha, const amrex::Real *beta, const amrex::Real alpha_interp, const int alpha_size)
Definition: ERF_Interpolation_1D.H:12
-
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_Fitch.H:44
-
amrex::Vector< amrex::Real > power
Definition: ERF_Fitch.H:44
-
amrex::Real rotor_rad
Definition: ERF_Fitch.H:43
-
amrex::Real thrust_coeff_standing
Definition: ERF_Fitch.H:43
-
amrex::Real hub_height
Definition: ERF_Fitch.H:43
-
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_Fitch.H:44
-
void get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)
Definition: ERF_NullWindFarm.H:84
Here is the call graph for this function:
@@ -618,6 +741,28 @@

+

+
+ +

◆ hub_height_velocity

+ +
+
+ + + + + +
+ + + + +
amrex::Vector<amrex::Real> Fitch::hub_height_velocity
+
+protected
+
+
diff --git a/classFitch.js b/classFitch.js index 38f367b06..8846a5b3f 100644 --- a/classFitch.js +++ b/classFitch.js @@ -3,9 +3,11 @@ var classFitch = [ "Fitch", "classFitch.html#a3682b755760d9e2543182ffbc0f3a618", null ], [ "~Fitch", "classFitch.html#af9bc97ca62d0611ab2a300992ca8304d", null ], [ "advance", "classFitch.html#aa0af4287104d385bfcd5dc0c8fb5c68a", null ], + [ "compute_power_output", "classFitch.html#a1edfa2cd3db9e6aa95130f24307ac623", null ], [ "source_terms_cellcentered", "classFitch.html#aa56821341be1cf4d01558e297993c0f2", null ], [ "update", "classFitch.html#a1a2db68abb0185de73bd870884f0b019", null ], [ "hub_height", "classFitch.html#ae3af34c6c07fd2d8b9b081b5c7ceb443", null ], + [ "hub_height_velocity", "classFitch.html#af01d3f69b4f952f91970964d2f498e61", null ], [ "nominal_power", "classFitch.html#afeb1ae13c307eeb71af9dfa8d97a3f7e", null ], [ "power", "classFitch.html#a88af1c4430e37f4950396b5a92e9ba03", null ], [ "rotor_rad", "classFitch.html#aadaedef0e6f0ac149483ee6b4d8b1a4e", null ], diff --git a/classFitch__coll__graph.map b/classFitch__coll__graph.map index 3ef040ec4..ab4644354 100644 --- a/classFitch__coll__graph.map +++ b/classFitch__coll__graph.map @@ -1,7 +1,7 @@ - - + + - + diff --git a/classFitch__coll__graph.md5 b/classFitch__coll__graph.md5 index 53b2be108..ac15ab584 100644 --- a/classFitch__coll__graph.md5 +++ b/classFitch__coll__graph.md5 @@ -1 +1 @@ -bc4e83769592c0edb57dcd6de748229d \ No newline at end of file +1892a0c03b2c998283bcb87303749443 \ No newline at end of file diff --git a/classFitch__coll__graph.png b/classFitch__coll__graph.png index 70c16daab..5b3dac5aa 100644 Binary files a/classFitch__coll__graph.png and b/classFitch__coll__graph.png differ diff --git a/classFitch_a1edfa2cd3db9e6aa95130f24307ac623_cgraph.map b/classFitch_a1edfa2cd3db9e6aa95130f24307ac623_cgraph.map new file mode 100644 index 000000000..2cc37286b --- /dev/null +++ b/classFitch_a1edfa2cd3db9e6aa95130f24307ac623_cgraph.map @@ -0,0 +1,4 @@ + + + + diff --git a/classFitch_a1edfa2cd3db9e6aa95130f24307ac623_cgraph.md5 b/classFitch_a1edfa2cd3db9e6aa95130f24307ac623_cgraph.md5 new file mode 100644 index 000000000..f831b3127 --- /dev/null +++ b/classFitch_a1edfa2cd3db9e6aa95130f24307ac623_cgraph.md5 @@ -0,0 +1 @@ +a91f5aade430f528340d0be4d70f7171 \ No newline at end of file diff --git a/classFitch_a1edfa2cd3db9e6aa95130f24307ac623_cgraph.png b/classFitch_a1edfa2cd3db9e6aa95130f24307ac623_cgraph.png new file mode 100644 index 000000000..4b452b36f Binary files /dev/null and b/classFitch_a1edfa2cd3db9e6aa95130f24307ac623_cgraph.png differ diff --git a/classGeneralAD-members.html b/classGeneralAD-members.html index d509f4f44..9033c00f3 100644 --- a/classGeneralAD-members.html +++ b/classGeneralAD-members.html @@ -100,61 +100,62 @@ C_PGeneralADprotected C_TGeneralADprotected compute_freestream_velocity(const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &mf_SMark)GeneralAD - disk_cell_countGeneralADprotected - find_if_marked(amrex::Real x1, amrex::Real x2, amrex::Real y1, amrex::Real y2, amrex::Real x0, amrex::Real y0, amrex::Real nx, amrex::Real ny, amrex::Real d_hub_height, amrex::Real d_rotor_rad, amrex::Real z)NullWindFarminlinestatic - freestream_phiGeneralADprotected - freestream_velocityGeneralADprotected - GeneralAD()GeneralADinline - get_blade_airfoil_spec(amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminline - get_blade_spec(amrex::Vector< amrex::Real > &bld_rad_loc, amrex::Vector< amrex::Real > &bld_twist, amrex::Vector< amrex::Real > &bld_chord)NullWindFarminline - get_turb_disk_angle(amrex::Real &turb_disk_angle)NullWindFarminline - get_turb_loc(amrex::Vector< amrex::Real > &xloc, amrex::Vector< amrex::Real > &yloc)NullWindFarminline - get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)NullWindFarminline - get_turb_spec_extra(amrex::Vector< amrex::Real > &velocity, amrex::Vector< amrex::Real > &C_P, amrex::Vector< amrex::Real > &C_T, amrex::Vector< amrex::Real > &rotor_RPM, amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminline - hub_heightGeneralADprotected - m_blade_pitchNullWindFarmprotected - m_bld_airfoil_aoaNullWindFarmprotected - m_bld_airfoil_CdNullWindFarmprotected - m_bld_airfoil_ClNullWindFarmprotected - m_bld_chordNullWindFarmprotected - m_bld_rad_locNullWindFarmprotected - m_bld_twistNullWindFarmprotected - m_C_PNullWindFarmprotected - m_C_TNullWindFarmprotected - m_hub_heightNullWindFarmprotected - m_nominal_powerNullWindFarmprotected - m_powerNullWindFarmprotected - m_rotor_radNullWindFarmprotected - m_rotor_RPMNullWindFarmprotected - m_thrust_coeffNullWindFarmprotected - m_thrust_coeff_standingNullWindFarmprotected - m_turb_disk_angleNullWindFarmprotected - m_velocityNullWindFarmprotected - m_wind_speedNullWindFarmprotected - m_xlocNullWindFarmprotected - m_ylocNullWindFarmprotected - nominal_powerGeneralADprotected - NullWindFarm()NullWindFarminline - powerGeneralADprotected - rotor_radGeneralADprotected - rotor_RPMGeneralADprotected - set_blade_airfoil_spec(const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminlinevirtual - set_blade_spec(const amrex::Vector< amrex::Real > &bld_rad_loc, const amrex::Vector< amrex::Real > &bld_twist, const amrex::Vector< amrex::Real > &bld_chord)NullWindFarminlinevirtual - set_turb_disk_angle(const amrex::Real &turb_disk_angle)NullWindFarminlinevirtual - set_turb_loc(const amrex::Vector< amrex::Real > &xloc, const amrex::Vector< amrex::Real > &yloc)NullWindFarminlinevirtual - set_turb_spec(const amrex::Real &rotor_rad, const amrex::Real &hub_height, const amrex::Real &thrust_coeff_standing, const amrex::Vector< amrex::Real > &wind_speed, const amrex::Vector< amrex::Real > &thrust_coeff, const amrex::Vector< amrex::Real > &power)NullWindFarminlinevirtual - set_turb_spec_extra(const amrex::Vector< amrex::Real > &velocity, const amrex::Vector< amrex::Real > &C_P, const amrex::Vector< amrex::Real > &C_T, const amrex::Vector< amrex::Real > &rotor_RPM, const amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminlinevirtual - source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, const amrex::MultiFab &mf_Smark, amrex::MultiFab &mf_vars_generalAD)GeneralAD - thrust_coeffGeneralADprotected - thrust_coeff_standingGeneralADprotected - turb_disk_angleGeneralADprotected - update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_vars)GeneralAD - velocityGeneralADprotected - wind_speedGeneralADprotected - xlocGeneralADprotected - ylocGeneralADprotected - ~GeneralAD()=defaultGeneralADvirtual - ~NullWindFarm()=defaultNullWindFarmvirtual + compute_power_output(const amrex::Real &time)GeneralAD + disk_cell_countGeneralADprotected + find_if_marked(amrex::Real x1, amrex::Real x2, amrex::Real y1, amrex::Real y2, amrex::Real x0, amrex::Real y0, amrex::Real nx, amrex::Real ny, amrex::Real d_hub_height, amrex::Real d_rotor_rad, amrex::Real z)NullWindFarminlinestatic + freestream_phiGeneralADprotected + freestream_velocityGeneralADprotected + GeneralAD()GeneralADinline + get_blade_airfoil_spec(amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminline + get_blade_spec(amrex::Vector< amrex::Real > &bld_rad_loc, amrex::Vector< amrex::Real > &bld_twist, amrex::Vector< amrex::Real > &bld_chord)NullWindFarminline + get_turb_disk_angle(amrex::Real &turb_disk_angle)NullWindFarminline + get_turb_loc(amrex::Vector< amrex::Real > &xloc, amrex::Vector< amrex::Real > &yloc)NullWindFarminline + get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)NullWindFarminline + get_turb_spec_extra(amrex::Vector< amrex::Real > &velocity, amrex::Vector< amrex::Real > &C_P, amrex::Vector< amrex::Real > &C_T, amrex::Vector< amrex::Real > &rotor_RPM, amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminline + hub_heightGeneralADprotected + m_blade_pitchNullWindFarmprotected + m_bld_airfoil_aoaNullWindFarmprotected + m_bld_airfoil_CdNullWindFarmprotected + m_bld_airfoil_ClNullWindFarmprotected + m_bld_chordNullWindFarmprotected + m_bld_rad_locNullWindFarmprotected + m_bld_twistNullWindFarmprotected + m_C_PNullWindFarmprotected + m_C_TNullWindFarmprotected + m_hub_heightNullWindFarmprotected + m_nominal_powerNullWindFarmprotected + m_powerNullWindFarmprotected + m_rotor_radNullWindFarmprotected + m_rotor_RPMNullWindFarmprotected + m_thrust_coeffNullWindFarmprotected + m_thrust_coeff_standingNullWindFarmprotected + m_turb_disk_angleNullWindFarmprotected + m_velocityNullWindFarmprotected + m_wind_speedNullWindFarmprotected + m_xlocNullWindFarmprotected + m_ylocNullWindFarmprotected + nominal_powerGeneralADprotected + NullWindFarm()NullWindFarminline + powerGeneralADprotected + rotor_radGeneralADprotected + rotor_RPMGeneralADprotected + set_blade_airfoil_spec(const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, const amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminlinevirtual + set_blade_spec(const amrex::Vector< amrex::Real > &bld_rad_loc, const amrex::Vector< amrex::Real > &bld_twist, const amrex::Vector< amrex::Real > &bld_chord)NullWindFarminlinevirtual + set_turb_disk_angle(const amrex::Real &turb_disk_angle)NullWindFarminlinevirtual + set_turb_loc(const amrex::Vector< amrex::Real > &xloc, const amrex::Vector< amrex::Real > &yloc)NullWindFarminlinevirtual + set_turb_spec(const amrex::Real &rotor_rad, const amrex::Real &hub_height, const amrex::Real &thrust_coeff_standing, const amrex::Vector< amrex::Real > &wind_speed, const amrex::Vector< amrex::Real > &thrust_coeff, const amrex::Vector< amrex::Real > &power)NullWindFarminlinevirtual + set_turb_spec_extra(const amrex::Vector< amrex::Real > &velocity, const amrex::Vector< amrex::Real > &C_P, const amrex::Vector< amrex::Real > &C_T, const amrex::Vector< amrex::Real > &rotor_RPM, const amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminlinevirtual + source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, const amrex::MultiFab &mf_Smark, amrex::MultiFab &mf_vars_generalAD)GeneralAD + thrust_coeffGeneralADprotected + thrust_coeff_standingGeneralADprotected + turb_disk_angleGeneralADprotected + update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_vars)GeneralAD + velocityGeneralADprotected + wind_speedGeneralADprotected + xlocGeneralADprotected + ylocGeneralADprotected + ~GeneralAD()=defaultGeneralADvirtual + ~NullWindFarm()=defaultNullWindFarmvirtual diff --git a/classGeneralAD.html b/classGeneralAD.html index 4d608763a..81f44c5e7 100644 --- a/classGeneralAD.html +++ b/classGeneralAD.html @@ -128,6 +128,8 @@   void update (const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_vars)   +void compute_power_output (const amrex::Real &time) +  - Public Member Functions inherited from NullWindFarm  NullWindFarm ()   @@ -402,10 +404,12 @@

24  compute_freestream_velocity(cons_in, U_old, V_old, mf_SMark);
25  source_terms_cellcentered(geom, cons_in, mf_SMark, mf_vars_generalAD);
26  update(dt_advance, cons_in, U_old, V_old, W_old, mf_vars_generalAD);
-
27 }
-
void update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_vars)
Definition: ERF_AdvanceGeneralAD.cpp:30
-
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, const amrex::MultiFab &mf_Smark, amrex::MultiFab &mf_vars_generalAD)
Definition: ERF_AdvanceGeneralAD.cpp:287
-
void compute_freestream_velocity(const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &mf_SMark)
Definition: ERF_AdvanceGeneralAD.cpp:66
+ +
28 }
+
void update(const amrex::Real &dt_advance, amrex::MultiFab &cons_in, amrex::MultiFab &U_old, amrex::MultiFab &V_old, amrex::MultiFab &W_old, const amrex::MultiFab &mf_vars)
Definition: ERF_AdvanceGeneralAD.cpp:60
+
void source_terms_cellcentered(const amrex::Geometry &geom, const amrex::MultiFab &cons_in, const amrex::MultiFab &mf_Smark, amrex::MultiFab &mf_vars_generalAD)
Definition: ERF_AdvanceGeneralAD.cpp:317
+
void compute_freestream_velocity(const amrex::MultiFab &cons_in, const amrex::MultiFab &U_old, const amrex::MultiFab &V_old, const amrex::MultiFab &mf_SMark)
Definition: ERF_AdvanceGeneralAD.cpp:96
+
void compute_power_output(const amrex::Real &time)
Definition: ERF_AdvanceGeneralAD.cpp:31
@@ -446,84 +450,144 @@

-
70 {
- -
72  freestream_velocity.clear();
-
73  freestream_phi.clear();
-
74  disk_cell_count.clear();
-
75  freestream_velocity.resize(xloc.size(),0.0);
-
76  freestream_phi.resize(xloc.size(),0.0);
-
77  disk_cell_count.resize(xloc.size(),0.0);
-
78 
-
79  Gpu::DeviceVector<Real> d_freestream_velocity(xloc.size());
-
80  Gpu::DeviceVector<Real> d_freestream_phi(yloc.size());
-
81  Gpu::DeviceVector<Real> d_disk_cell_count(yloc.size());
-
82  Gpu::copy(Gpu::hostToDevice, freestream_velocity.begin(), freestream_velocity.end(), d_freestream_velocity.begin());
-
83  Gpu::copy(Gpu::hostToDevice, freestream_phi.begin(), freestream_phi.end(), d_freestream_phi.begin());
-
84  Gpu::copy(Gpu::hostToDevice, disk_cell_count.begin(), disk_cell_count.end(), d_disk_cell_count.begin());
-
85 
-
86  Real* d_freestream_velocity_ptr = d_freestream_velocity.data();
-
87  Real* d_freestream_phi_ptr = d_freestream_phi.data();
-
88  Real* d_disk_cell_count_ptr = d_disk_cell_count.data();
-
89 
-
90 
-
91  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
-
92 
-
93  auto SMark_array = mf_SMark.array(mfi);
-
94  auto u_vel = U_old.array(mfi);
-
95  auto v_vel = V_old.array(mfi);
-
96  Box tbx = mfi.nodaltilebox(0);
-
97 
-
98  ParallelFor(tbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
99 
-
100  if(SMark_array(i,j,k,0) != -1.0) {
-
101  int turb_index = static_cast<int>(SMark_array(i,j,k,0));
-
102  Real phi = std::atan2(v_vel(i,j,k),u_vel(i,j,k)); // Wind direction w.r.t the x-dreiction
-
103  Gpu::Atomic::Add(&d_freestream_velocity_ptr[turb_index],std::pow(u_vel(i,j,k)*u_vel(i,j,k) + v_vel(i,j,k)*v_vel(i,j,k),0.5));
-
104  Gpu::Atomic::Add(&d_disk_cell_count_ptr[turb_index],1.0);
-
105  Gpu::Atomic::Add(&d_freestream_phi_ptr[turb_index],phi);
-
106  }
-
107  });
-
108  }
-
109 
-
110  // Copy back to host
-
111  Gpu::copy(Gpu::deviceToHost, d_freestream_velocity.begin(), d_freestream_velocity.end(), freestream_velocity.begin());
-
112  Gpu::copy(Gpu::deviceToHost, d_freestream_phi.begin(), d_freestream_phi.end(), freestream_phi.begin());
-
113  Gpu::copy(Gpu::deviceToHost, d_disk_cell_count.begin(), d_disk_cell_count.end(), disk_cell_count.begin());
-
114 
-
115  // Reduce the data on every processor
-
116  amrex::ParallelAllReduce::Sum(freestream_velocity.data(),
-
117  freestream_velocity.size(),
-
118  amrex::ParallelContext::CommunicatorAll());
+
100 {
+ +
102  freestream_velocity.clear();
+
103  freestream_phi.clear();
+
104  disk_cell_count.clear();
+
105  freestream_velocity.resize(xloc.size(),0.0);
+
106  freestream_phi.resize(xloc.size(),0.0);
+
107  disk_cell_count.resize(xloc.size(),0.0);
+
108 
+
109  Gpu::DeviceVector<Real> d_freestream_velocity(xloc.size());
+
110  Gpu::DeviceVector<Real> d_freestream_phi(yloc.size());
+
111  Gpu::DeviceVector<Real> d_disk_cell_count(yloc.size());
+
112  Gpu::copy(Gpu::hostToDevice, freestream_velocity.begin(), freestream_velocity.end(), d_freestream_velocity.begin());
+
113  Gpu::copy(Gpu::hostToDevice, freestream_phi.begin(), freestream_phi.end(), d_freestream_phi.begin());
+
114  Gpu::copy(Gpu::hostToDevice, disk_cell_count.begin(), disk_cell_count.end(), d_disk_cell_count.begin());
+
115 
+
116  Real* d_freestream_velocity_ptr = d_freestream_velocity.data();
+
117  Real* d_freestream_phi_ptr = d_freestream_phi.data();
+
118  Real* d_disk_cell_count_ptr = d_disk_cell_count.data();
119 
-
120  amrex::ParallelAllReduce::Sum(freestream_phi.data(),
-
121  freestream_phi.size(),
-
122  amrex::ParallelContext::CommunicatorAll());
-
123 
-
124 
-
125  amrex::ParallelAllReduce::Sum(disk_cell_count.data(),
-
126  disk_cell_count.size(),
-
127  amrex::ParallelContext::CommunicatorAll());
-
128 
- -
130 
-
131 
-
132  if (ParallelDescriptor::IOProcessor()){
-
133  for(int it=0; it<xloc.size(); it++){
-
134  //std::cout << "turbine index, freestream velocity is " << it << " " << freestream_velocity[it] << " " <<
-
135  // disk_cell_count[it] << " " <<
-
136  // freestream_velocity[it]/(disk_cell_count[it] + 1e-10) << " " <<
-
137  // freestream_phi[it]/(disk_cell_count[it] + 1e-10) << "\n";
-
138  }
-
139  }
-
140 }
-
amrex::Vector< amrex::Real > freestream_velocity
Definition: ERF_GeneralAD.H:49
-
amrex::Vector< amrex::Real > xloc
Definition: ERF_GeneralAD.H:45
-
amrex::Vector< amrex::Real > disk_cell_count
Definition: ERF_GeneralAD.H:49
-
amrex::Vector< amrex::Real > freestream_phi
Definition: ERF_GeneralAD.H:49
-
amrex::Vector< amrex::Real > yloc
Definition: ERF_GeneralAD.H:45
+
120 
+
121  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
122 
+
123  auto SMark_array = mf_SMark.array(mfi);
+
124  auto u_vel = U_old.array(mfi);
+
125  auto v_vel = V_old.array(mfi);
+
126  Box tbx = mfi.nodaltilebox(0);
+
127 
+
128  ParallelFor(tbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
129 
+
130  if(SMark_array(i,j,k,0) != -1.0) {
+
131  int turb_index = static_cast<int>(SMark_array(i,j,k,0));
+
132  Real phi = std::atan2(v_vel(i,j,k),u_vel(i,j,k)); // Wind direction w.r.t the x-dreiction
+
133  Gpu::Atomic::Add(&d_freestream_velocity_ptr[turb_index],std::pow(u_vel(i,j,k)*u_vel(i,j,k) + v_vel(i,j,k)*v_vel(i,j,k),0.5));
+
134  Gpu::Atomic::Add(&d_disk_cell_count_ptr[turb_index],1.0);
+
135  Gpu::Atomic::Add(&d_freestream_phi_ptr[turb_index],phi);
+
136  }
+
137  });
+
138  }
+
139 
+
140  // Copy back to host
+
141  Gpu::copy(Gpu::deviceToHost, d_freestream_velocity.begin(), d_freestream_velocity.end(), freestream_velocity.begin());
+
142  Gpu::copy(Gpu::deviceToHost, d_freestream_phi.begin(), d_freestream_phi.end(), freestream_phi.begin());
+
143  Gpu::copy(Gpu::deviceToHost, d_disk_cell_count.begin(), d_disk_cell_count.end(), disk_cell_count.begin());
+
144 
+
145  // Reduce the data on every processor
+
146  amrex::ParallelAllReduce::Sum(freestream_velocity.data(),
+
147  freestream_velocity.size(),
+
148  amrex::ParallelContext::CommunicatorAll());
+
149 
+
150  amrex::ParallelAllReduce::Sum(freestream_phi.data(),
+
151  freestream_phi.size(),
+
152  amrex::ParallelContext::CommunicatorAll());
+
153 
+
154 
+
155  amrex::ParallelAllReduce::Sum(disk_cell_count.data(),
+
156  disk_cell_count.size(),
+
157  amrex::ParallelContext::CommunicatorAll());
+
158 
+ +
160 
+
161 
+
162  /*if (ParallelDescriptor::IOProcessor()){
+
163  for(int it=0; it<xloc.size(); it++){
+
164  std::cout << "turbine index, freestream velocity is " << it << " " << freestream_velocity[it] << " " <<
+
165  disk_cell_count[it] << " " <<
+
166  freestream_velocity[it]/(disk_cell_count[it] + 1e-10) << " " <<
+
167  freestream_phi[it]/(disk_cell_count[it] + 1e-10) << "\n";
+
168  }
+
169  }*/
+
170 }
+
amrex::Vector< amrex::Real > freestream_velocity
Definition: ERF_GeneralAD.H:51
+
amrex::Vector< amrex::Real > xloc
Definition: ERF_GeneralAD.H:47
+
amrex::Vector< amrex::Real > disk_cell_count
Definition: ERF_GeneralAD.H:51
+
amrex::Vector< amrex::Real > freestream_phi
Definition: ERF_GeneralAD.H:51
+
amrex::Vector< amrex::Real > yloc
Definition: ERF_GeneralAD.H:47
void get_turb_loc(amrex::Vector< amrex::Real > &xloc, amrex::Vector< amrex::Real > &yloc)
Definition: ERF_NullWindFarm.H:96
+
+ + +

◆ compute_power_output()

+ +
+
+ + + + + + + + +
void GeneralAD::compute_power_output (const amrex::Real & time)
+
+
32 {
+ + + +
36 
+
37  const int n_spec_table = wind_speed.size();
+
38  // Compute power based on the look-up table
+
39 
+
40  if (ParallelDescriptor::IOProcessor()){
+
41  static std::ofstream file("power_output_GeneralAD.txt", std::ios::app);
+
42  // Check if the file opened successfully
+
43  if (!file.is_open()) {
+
44  std::cerr << "Error opening file!" << std::endl;
+
45  Abort("Could not open file to write power output in ERF_AdvanceSimpleAD.cpp");
+
46  }
+
47  Real total_power = 0.0;
+
48  for(int it=0; it<xloc.size(); it++){
+
49  Real avg_vel = freestream_velocity[it]/(disk_cell_count[it] + 1e-10);
+
50  Real turb_power = interpolate_1d(wind_speed.data(), power.data(), avg_vel, n_spec_table);
+
51  total_power = total_power + turb_power;
+
52  }
+
53  file << time << " " << total_power << "\n";
+
54  file.flush();
+
55  }
+
56 }
+
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE amrex::Real interpolate_1d(const amrex::Real *alpha, const amrex::Real *beta, const amrex::Real alpha_interp, const int alpha_size)
Definition: ERF_Interpolation_1D.H:12
+
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_GeneralAD.H:50
+
amrex::Vector< amrex::Real > power
Definition: ERF_GeneralAD.H:50
+
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_GeneralAD.H:50
+
amrex::Real rotor_rad
Definition: ERF_GeneralAD.H:49
+
amrex::Real hub_height
Definition: ERF_GeneralAD.H:49
+
amrex::Real thrust_coeff_standing
Definition: ERF_GeneralAD.H:49
+
void get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)
Definition: ERF_NullWindFarm.H:84
+
+Here is the call graph for this function:
+
+
+ + + + +
+
@@ -563,243 +627,236 @@

-
291 {
-
292 
- -
294 
- - -
297 
- -
299 
- -
301 
- -
303 
-
304  Real d_hub_height = hub_height;
-
305  Real d_rotor_rad = rotor_rad;
-
306 
-
307  Gpu::DeviceVector<Real> d_xloc(xloc.size());
-
308  Gpu::DeviceVector<Real> d_yloc(yloc.size());
-
309  Gpu::copy(Gpu::hostToDevice, xloc.begin(), xloc.end(), d_xloc.begin());
-
310  Gpu::copy(Gpu::hostToDevice, yloc.begin(), yloc.end(), d_yloc.begin());
-
311 
-
312  auto dx = geom.CellSizeArray();
-
313 
-
314  // Domain valid box
-
315  const amrex::Box& domain = geom.Domain();
-
316  auto ProbLoArr = geom.ProbLoArray();
-
317  int domlo_x = domain.smallEnd(0);
-
318  int domhi_x = domain.bigEnd(0) + 1;
-
319  int domlo_y = domain.smallEnd(1);
-
320  int domhi_y = domain.bigEnd(1) + 1;
-
321  int domlo_z = domain.smallEnd(2);
-
322  int domhi_z = domain.bigEnd(2) + 1;
-
323 
-
324  // The order of variables are - Vabs dVabsdt, dudt, dvdt, dTKEdt
-
325  mf_vars_generalAD.setVal(0.0);
-
326 
-
327  long unsigned int nturbs = xloc.size();
-
328 
-
329  // This is the angle phi in Fig. 10 in Mirocha et. al. 2014
-
330  // set_turb_disk angle in ERF_InitWindFarm.cpp sets this phi as
-
331  // the turb_disk_angle
- -
333  Real d_turb_disk_angle = turb_disk_angle;
-
334 
-
335  Gpu::DeviceVector<Real> d_freestream_velocity(nturbs);
-
336  Gpu::DeviceVector<Real> d_disk_cell_count(nturbs);
-
337  Gpu::copy(Gpu::hostToDevice, freestream_velocity.begin(), freestream_velocity.end(), d_freestream_velocity.begin());
-
338  Gpu::copy(Gpu::hostToDevice, disk_cell_count.begin(), disk_cell_count.end(), d_disk_cell_count.begin());
-
339 
-
340  Real* d_xloc_ptr = d_xloc.data();
-
341  Real* d_yloc_ptr = d_yloc.data();
-
342  Real* d_freestream_velocity_ptr = d_freestream_velocity.data();
-
343  Real* d_disk_cell_count_ptr = d_disk_cell_count.data();
-
344 
-
345  int n_bld_sections = bld_rad_loc.size();
-
346 
-
347  Gpu::DeviceVector<Real> d_bld_rad_loc(n_bld_sections);
-
348  Gpu::DeviceVector<Real> d_bld_twist(n_bld_sections);
-
349  Gpu::DeviceVector<Real> d_bld_chord(n_bld_sections);
-
350 
-
351  Gpu::copy(Gpu::hostToDevice, bld_rad_loc.begin(), bld_rad_loc.end(), d_bld_rad_loc.begin());
-
352  Gpu::copy(Gpu::hostToDevice, bld_twist.begin(), bld_twist.end(), d_bld_twist.begin());
-
353  Gpu::copy(Gpu::hostToDevice, bld_chord.begin(), bld_chord.end(), d_bld_chord.begin());
-
354 
-
355  Real* bld_rad_loc_ptr = d_bld_rad_loc.data();
-
356  Real* bld_twist_ptr = d_bld_twist.data();
-
357  Real* bld_chord_ptr = d_bld_chord.data();
+
321 {
+
322 
+ +
324 
+ + +
327 
+ +
329 
+ +
331 
+ +
333 
+
334  Real d_hub_height = hub_height;
+
335  Real d_rotor_rad = rotor_rad;
+
336 
+
337  Gpu::DeviceVector<Real> d_xloc(xloc.size());
+
338  Gpu::DeviceVector<Real> d_yloc(yloc.size());
+
339  Gpu::copy(Gpu::hostToDevice, xloc.begin(), xloc.end(), d_xloc.begin());
+
340  Gpu::copy(Gpu::hostToDevice, yloc.begin(), yloc.end(), d_yloc.begin());
+
341 
+
342  auto dx = geom.CellSizeArray();
+
343 
+
344  // Domain valid box
+
345  const amrex::Box& domain = geom.Domain();
+
346  auto ProbLoArr = geom.ProbLoArray();
+
347  int domlo_x = domain.smallEnd(0);
+
348  int domhi_x = domain.bigEnd(0) + 1;
+
349  int domlo_y = domain.smallEnd(1);
+
350  int domhi_y = domain.bigEnd(1) + 1;
+
351  int domlo_z = domain.smallEnd(2);
+
352  int domhi_z = domain.bigEnd(2) + 1;
+
353 
+
354  // The order of variables are - Vabs dVabsdt, dudt, dvdt, dTKEdt
+
355  mf_vars_generalAD.setVal(0.0);
+
356 
+
357  long unsigned int nturbs = xloc.size();
358 
-
359  Vector<Gpu::DeviceVector<Real>> d_bld_airfoil_aoa(n_bld_sections);
-
360  Vector<Gpu::DeviceVector<Real>> d_bld_airfoil_Cl(n_bld_sections);
-
361  Vector<Gpu::DeviceVector<Real>> d_bld_airfoil_Cd(n_bld_sections);
-
362 
-
363  int n_pts_airfoil = bld_airfoil_aoa[0].size();
+
359  // This is the angle phi in Fig. 10 in Mirocha et. al. 2014
+
360  // set_turb_disk angle in ERF_InitWindFarm.cpp sets this phi as
+
361  // the turb_disk_angle
+ +
363  Real d_turb_disk_angle = turb_disk_angle;
364 
-
365  for(int i=0;i<n_bld_sections;i++){
-
366  d_bld_airfoil_aoa[i].resize(n_pts_airfoil);
-
367  d_bld_airfoil_Cl[i].resize(n_pts_airfoil);
-
368  d_bld_airfoil_Cd[i].resize(n_pts_airfoil);
-
369  Gpu::copy(Gpu::hostToDevice, bld_airfoil_aoa[i].begin(), bld_airfoil_aoa[i].end(), d_bld_airfoil_aoa[i].begin());
-
370  Gpu::copy(Gpu::hostToDevice, bld_airfoil_Cl[i].begin(), bld_airfoil_Cl[i].end(), d_bld_airfoil_Cl[i].begin());
-
371  Gpu::copy(Gpu::hostToDevice, bld_airfoil_Cd[i].begin(), bld_airfoil_Cd[i].end(), d_bld_airfoil_Cd[i].begin());
-
372  }
-
373 
-
374  Vector<Real*> hp_bld_airfoil_aoa, hp_bld_airfoil_Cl, hp_bld_airfoil_Cd;
-
375  for (auto & v :d_bld_airfoil_aoa) {
-
376  hp_bld_airfoil_aoa.push_back(v.data());
-
377  }
-
378  for (auto & v :d_bld_airfoil_Cl) {
-
379  hp_bld_airfoil_Cl.push_back(v.data());
-
380  }
-
381  for (auto & v :d_bld_airfoil_Cd) {
-
382  hp_bld_airfoil_Cd.push_back(v.data());
-
383  }
+
365  Gpu::DeviceVector<Real> d_freestream_velocity(nturbs);
+
366  Gpu::DeviceVector<Real> d_disk_cell_count(nturbs);
+
367  Gpu::copy(Gpu::hostToDevice, freestream_velocity.begin(), freestream_velocity.end(), d_freestream_velocity.begin());
+
368  Gpu::copy(Gpu::hostToDevice, disk_cell_count.begin(), disk_cell_count.end(), d_disk_cell_count.begin());
+
369 
+
370  Real* d_xloc_ptr = d_xloc.data();
+
371  Real* d_yloc_ptr = d_yloc.data();
+
372  Real* d_freestream_velocity_ptr = d_freestream_velocity.data();
+
373  Real* d_disk_cell_count_ptr = d_disk_cell_count.data();
+
374 
+
375  int n_bld_sections = bld_rad_loc.size();
+
376 
+
377  Gpu::DeviceVector<Real> d_bld_rad_loc(n_bld_sections);
+
378  Gpu::DeviceVector<Real> d_bld_twist(n_bld_sections);
+
379  Gpu::DeviceVector<Real> d_bld_chord(n_bld_sections);
+
380 
+
381  Gpu::copy(Gpu::hostToDevice, bld_rad_loc.begin(), bld_rad_loc.end(), d_bld_rad_loc.begin());
+
382  Gpu::copy(Gpu::hostToDevice, bld_twist.begin(), bld_twist.end(), d_bld_twist.begin());
+
383  Gpu::copy(Gpu::hostToDevice, bld_chord.begin(), bld_chord.end(), d_bld_chord.begin());
384 
-
385  Gpu::AsyncArray<Real*> aoa(hp_bld_airfoil_aoa.data(), n_bld_sections);
-
386  Gpu::AsyncArray<Real*> Cl(hp_bld_airfoil_Cl.data(), n_bld_sections);
-
387  Gpu::AsyncArray<Real*> Cd(hp_bld_airfoil_Cd.data(), n_bld_sections);
+
385  Real* bld_rad_loc_ptr = d_bld_rad_loc.data();
+
386  Real* bld_twist_ptr = d_bld_twist.data();
+
387  Real* bld_chord_ptr = d_bld_chord.data();
388 
-
389  auto d_bld_airfoil_aoa_ptr = aoa.data();
-
390  auto d_bld_airfoil_Cl_ptr = Cl.data();
-
391  auto d_bld_airfoil_Cd_ptr = Cd.data();
+
389  Vector<Gpu::DeviceVector<Real>> d_bld_airfoil_aoa(n_bld_sections);
+
390  Vector<Gpu::DeviceVector<Real>> d_bld_airfoil_Cl(n_bld_sections);
+
391  Vector<Gpu::DeviceVector<Real>> d_bld_airfoil_Cd(n_bld_sections);
392 
-
393  int n_spec_extra = velocity.size();
+
393  int n_pts_airfoil = bld_airfoil_aoa[0].size();
394 
-
395  Gpu::DeviceVector<Real> d_velocity(n_spec_extra);
-
396  Gpu::DeviceVector<Real> d_rotor_RPM(n_spec_extra);
-
397  Gpu::DeviceVector<Real> d_blade_pitch(n_spec_extra);
-
398 
-
399  Gpu::copy(Gpu::hostToDevice, velocity.begin(), velocity.end(), d_velocity.begin());
-
400  Gpu::copy(Gpu::hostToDevice, rotor_RPM.begin(), rotor_RPM.end(), d_rotor_RPM.begin());
-
401  Gpu::copy(Gpu::hostToDevice, blade_pitch.begin(), blade_pitch.end(), d_blade_pitch.begin());
-
402 
-
403  auto d_velocity_ptr = d_velocity.data();
-
404  auto d_rotor_RPM_ptr = d_rotor_RPM.data();
-
405  auto d_blade_pitch_ptr = d_blade_pitch.data();
-
406 
-
407  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
-
408 
-
409  const Box& gbx = mfi.growntilebox(1);
-
410  auto SMark_array = mf_SMark.array(mfi);
-
411  auto generalAD_array = mf_vars_generalAD.array(mfi);
-
412 
-
413  ParallelFor(gbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
414  int ii = amrex::min(amrex::max(i, domlo_x), domhi_x);
-
415  int jj = amrex::min(amrex::max(j, domlo_y), domhi_y);
-
416  int kk = amrex::min(amrex::max(k, domlo_z), domhi_z);
-
417 
-
418  Real x = ProbLoArr[0] + (ii+0.5)*dx[0];
-
419  Real y = ProbLoArr[1] + (jj+0.5)*dx[1];
-
420  Real z = ProbLoArr[2] + (kk+0.5)*dx[2];
-
421  // ?? Density needed here
+
395  for(int i=0;i<n_bld_sections;i++){
+
396  d_bld_airfoil_aoa[i].resize(n_pts_airfoil);
+
397  d_bld_airfoil_Cl[i].resize(n_pts_airfoil);
+
398  d_bld_airfoil_Cd[i].resize(n_pts_airfoil);
+
399  Gpu::copy(Gpu::hostToDevice, bld_airfoil_aoa[i].begin(), bld_airfoil_aoa[i].end(), d_bld_airfoil_aoa[i].begin());
+
400  Gpu::copy(Gpu::hostToDevice, bld_airfoil_Cl[i].begin(), bld_airfoil_Cl[i].end(), d_bld_airfoil_Cl[i].begin());
+
401  Gpu::copy(Gpu::hostToDevice, bld_airfoil_Cd[i].begin(), bld_airfoil_Cd[i].end(), d_bld_airfoil_Cd[i].begin());
+
402  }
+
403 
+
404  Vector<Real*> hp_bld_airfoil_aoa, hp_bld_airfoil_Cl, hp_bld_airfoil_Cd;
+
405  for (auto & v :d_bld_airfoil_aoa) {
+
406  hp_bld_airfoil_aoa.push_back(v.data());
+
407  }
+
408  for (auto & v :d_bld_airfoil_Cl) {
+
409  hp_bld_airfoil_Cl.push_back(v.data());
+
410  }
+
411  for (auto & v :d_bld_airfoil_Cd) {
+
412  hp_bld_airfoil_Cd.push_back(v.data());
+
413  }
+
414 
+
415  Gpu::AsyncArray<Real*> aoa(hp_bld_airfoil_aoa.data(), n_bld_sections);
+
416  Gpu::AsyncArray<Real*> Cl(hp_bld_airfoil_Cl.data(), n_bld_sections);
+
417  Gpu::AsyncArray<Real*> Cd(hp_bld_airfoil_Cd.data(), n_bld_sections);
+
418 
+
419  auto d_bld_airfoil_aoa_ptr = aoa.data();
+
420  auto d_bld_airfoil_Cl_ptr = Cl.data();
+
421  auto d_bld_airfoil_Cd_ptr = Cd.data();
422 
-
423  int check_int = 0;
+
423  int n_spec_extra = velocity.size();
424 
-
425  Real source_x = 0.0, source_y = 0.0, source_z = 0.0;
-
426  std::array<Real,2> Fn_and_Ft;
-
427 
-
428  for(long unsigned int it=0;it<nturbs;it++) {
-
429  Real avg_vel = d_freestream_velocity_ptr[it]/(d_disk_cell_count_ptr[it] + 1e-10);
-
430  Real phi = d_turb_disk_angle;
-
431 
-
432  // This if check makes sure it is a point on the actuator disk
-
433  if(SMark_array(ii,jj,kk,1) == static_cast<double>(it)) {
-
434  check_int++;
-
435 
-
436  // Find radial distance of the point and the zeta angle
-
437  Real rad = std::pow( (x-d_xloc_ptr[it])*(x-d_xloc_ptr[it]) +
-
438  (y-d_yloc_ptr[it])*(y-d_yloc_ptr[it]) +
-
439  (z-d_hub_height)*(z-d_hub_height), 0.5 );
-
440 
-
441  int index = find_rad_loc_index(rad, bld_rad_loc_ptr, n_bld_sections);
+
425  Gpu::DeviceVector<Real> d_velocity(n_spec_extra);
+
426  Gpu::DeviceVector<Real> d_rotor_RPM(n_spec_extra);
+
427  Gpu::DeviceVector<Real> d_blade_pitch(n_spec_extra);
+
428 
+
429  Gpu::copy(Gpu::hostToDevice, velocity.begin(), velocity.end(), d_velocity.begin());
+
430  Gpu::copy(Gpu::hostToDevice, rotor_RPM.begin(), rotor_RPM.end(), d_rotor_RPM.begin());
+
431  Gpu::copy(Gpu::hostToDevice, blade_pitch.begin(), blade_pitch.end(), d_blade_pitch.begin());
+
432 
+
433  auto d_velocity_ptr = d_velocity.data();
+
434  auto d_rotor_RPM_ptr = d_rotor_RPM.data();
+
435  auto d_blade_pitch_ptr = d_blade_pitch.data();
+
436 
+
437  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
438 
+
439  const Box& gbx = mfi.growntilebox(1);
+
440  auto SMark_array = mf_SMark.array(mfi);
+
441  auto generalAD_array = mf_vars_generalAD.array(mfi);
442 
-
443  // This if check makes sure it is a point with radial distance
-
444  // between the hub radius and the rotor radius.
-
445  // ?? hub radius needed here
-
446  if(rad >= 2.0 and rad <= d_rotor_rad) {
-
447  //AMREX_ASSERT( (z-d_hub_height) <= rad );
-
448  // Consider the vector that joines the point and the turbine center.
-
449  // Dot it on to the vector that joins the turbine center and along
-
450  // the plane of the disk. See fig. 10 in Mirocha et. al. 2014.
-
451 
-
452  Real vec_proj = (x-d_xloc_ptr[it])*(std::sin(phi)) +
-
453  (y-d_yloc_ptr[it])*(-std::cos(phi));
+
443  ParallelFor(gbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
444  int ii = amrex::min(amrex::max(i, domlo_x), domhi_x);
+
445  int jj = amrex::min(amrex::max(j, domlo_y), domhi_y);
+
446  int kk = amrex::min(amrex::max(k, domlo_z), domhi_z);
+
447 
+
448  Real x = ProbLoArr[0] + (ii+0.5)*dx[0];
+
449  Real y = ProbLoArr[1] + (jj+0.5)*dx[1];
+
450  Real z = ProbLoArr[2] + (kk+0.5)*dx[2];
+
451  // ?? Density needed here
+
452 
+
453  int check_int = 0;
454 
-
455 
-
456  Real zeta = std::atan2(z-d_hub_height, vec_proj);
-
457  //printf("zeta val is %0.15g\n", zeta*180.0/PI);
-
458  Fn_and_Ft = compute_source_terms_Fn_Ft(rad, avg_vel,
-
459  bld_rad_loc_ptr,
-
460  bld_twist_ptr,
-
461  bld_chord_ptr,
-
462  n_bld_sections,
-
463  d_bld_airfoil_aoa_ptr[index],
-
464  d_bld_airfoil_Cl_ptr[index],
-
465  d_bld_airfoil_Cd_ptr[index],
-
466  n_pts_airfoil,
-
467  d_velocity_ptr,
-
468  d_rotor_RPM_ptr,
-
469  d_blade_pitch_ptr,
-
470  n_spec_extra);
-
471 
-
472  Real Fn = 3.0*Fn_and_Ft[0];
-
473  Real Ft = 3.0*Fn_and_Ft[1];
-
474  // Compute the source terms - pass in radial distance, free stream velocity
-
475 
-
476  Real Fx = Fn*std::cos(phi) + Ft*std::sin(zeta)*std::sin(phi);
-
477  Real Fy = Fn*std::sin(phi) - Ft*std::sin(zeta)*std::cos(phi);
-
478  Real Fz = -Ft*std::cos(zeta);
-
479 
-
480  //Real dn = (
+
455  Real source_x = 0.0, source_y = 0.0, source_z = 0.0;
+
456  std::array<Real,2> Fn_and_Ft;
+
457 
+
458  for(long unsigned int it=0;it<nturbs;it++) {
+
459  Real avg_vel = d_freestream_velocity_ptr[it]/(d_disk_cell_count_ptr[it] + 1e-10);
+
460  Real phi = d_turb_disk_angle;
+
461 
+
462  // This if check makes sure it is a point on the actuator disk
+
463  if(SMark_array(ii,jj,kk,1) == static_cast<double>(it)) {
+
464  check_int++;
+
465 
+
466  // Find radial distance of the point and the zeta angle
+
467  Real rad = std::pow( (x-d_xloc_ptr[it])*(x-d_xloc_ptr[it]) +
+
468  (y-d_yloc_ptr[it])*(y-d_yloc_ptr[it]) +
+
469  (z-d_hub_height)*(z-d_hub_height), 0.5 );
+
470 
+
471  int index = find_rad_loc_index(rad, bld_rad_loc_ptr, n_bld_sections);
+
472 
+
473  // This if check makes sure it is a point with radial distance
+
474  // between the hub radius and the rotor radius.
+
475  // ?? hub radius needed here
+
476  if(rad >= 2.0 and rad <= d_rotor_rad) {
+
477  //AMREX_ASSERT( (z-d_hub_height) <= rad );
+
478  // Consider the vector that joines the point and the turbine center.
+
479  // Dot it on to the vector that joins the turbine center and along
+
480  // the plane of the disk. See fig. 10 in Mirocha et. al. 2014.
481 
-
482  source_x = -Fx/(2.0*PI*rad*dx[0])*1.0/std::pow(2.0*PI,0.5);
-
483  source_y = -Fy/(2.0*PI*rad*dx[0])*1.0/std::pow(2.0*PI,0.5);
-
484  source_z = -Fz/(2.0*PI*rad*dx[0])*1.0/std::pow(2.0*PI,0.5);
+
482  Real vec_proj = (x-d_xloc_ptr[it])*(std::sin(phi)) +
+
483  (y-d_yloc_ptr[it])*(-std::cos(phi));
+
484 
485 
-
486 
-
487  //printf("Val source_x, is %0.15g, %0.15g, %0.15g %0.15g %0.15g %0.15g\n", rad, Fn, Ft, source_x, source_y, source_z);
-
488  }
-
489  }
-
490  }
-
491 
-
492  if(check_int > 1){
-
493  amrex::Error("Actuator disks are overlapping. Visualize actuator_disks.vtk "
-
494  "and check the windturbine locations input file. Exiting..");
-
495  }
-
496 
-
497  generalAD_array(i,j,k,0) = source_x;
-
498  generalAD_array(i,j,k,1) = source_y;
-
499  generalAD_array(i,j,k,2) = source_z;
-
500  });
-
501  }
-
502 }
-
AMREX_FORCE_INLINE AMREX_GPU_DEVICE int find_rad_loc_index(const Real rad, const Real *bld_rad_loc, const int n_bld_sections)
Definition: ERF_AdvanceGeneralAD.cpp:144
-
AMREX_FORCE_INLINE AMREX_GPU_DEVICE std::array< Real, 2 > compute_source_terms_Fn_Ft(const Real rad, const Real avg_vel, const Real *bld_rad_loc, const Real *bld_twist, const Real *bld_chord, int n_bld_sections, const Real *bld_airfoil_aoa, const Real *bld_airfoil_Cl, const Real *bld_airfoil_Cd, const int n_pts_airfoil, const Real *velocity, const Real *rotor_RPM, const Real *blade_pitch, const int n_spec_extra)
Definition: ERF_AdvanceGeneralAD.cpp:177
+
486  Real zeta = std::atan2(z-d_hub_height, vec_proj);
+
487  //printf("zeta val is %0.15g\n", zeta*180.0/PI);
+
488  Fn_and_Ft = compute_source_terms_Fn_Ft(rad, avg_vel,
+
489  bld_rad_loc_ptr,
+
490  bld_twist_ptr,
+
491  bld_chord_ptr,
+
492  n_bld_sections,
+
493  d_bld_airfoil_aoa_ptr[index],
+
494  d_bld_airfoil_Cl_ptr[index],
+
495  d_bld_airfoil_Cd_ptr[index],
+
496  n_pts_airfoil,
+
497  d_velocity_ptr,
+
498  d_rotor_RPM_ptr,
+
499  d_blade_pitch_ptr,
+
500  n_spec_extra);
+
501 
+
502  Real Fn = 3.0*Fn_and_Ft[0];
+
503  Real Ft = 3.0*Fn_and_Ft[1];
+
504  // Compute the source terms - pass in radial distance, free stream velocity
+
505 
+
506  Real Fx = Fn*std::cos(phi) + Ft*std::sin(zeta)*std::sin(phi);
+
507  Real Fy = Fn*std::sin(phi) - Ft*std::sin(zeta)*std::cos(phi);
+
508  Real Fz = -Ft*std::cos(zeta);
+
509 
+
510  //Real dn = (
+
511 
+
512  source_x = -Fx/(2.0*PI*rad*dx[0])*1.0/std::pow(2.0*PI,0.5);
+
513  source_y = -Fy/(2.0*PI*rad*dx[0])*1.0/std::pow(2.0*PI,0.5);
+
514  source_z = -Fz/(2.0*PI*rad*dx[0])*1.0/std::pow(2.0*PI,0.5);
+
515 
+
516 
+
517  //printf("Val source_x, is %0.15g, %0.15g, %0.15g %0.15g %0.15g %0.15g\n", rad, Fn, Ft, source_x, source_y, source_z);
+
518  }
+
519  }
+
520  }
+
521 
+
522  if(check_int > 1){
+
523  amrex::Error("Actuator disks are overlapping. Visualize actuator_disks.vtk "
+
524  "and check the windturbine locations input file. Exiting..");
+
525  }
+
526 
+
527  generalAD_array(i,j,k,0) = source_x;
+
528  generalAD_array(i,j,k,1) = source_y;
+
529  generalAD_array(i,j,k,2) = source_z;
+
530  });
+
531  }
+
532 }
+
AMREX_FORCE_INLINE AMREX_GPU_DEVICE int find_rad_loc_index(const Real rad, const Real *bld_rad_loc, const int n_bld_sections)
Definition: ERF_AdvanceGeneralAD.cpp:174
+
AMREX_FORCE_INLINE AMREX_GPU_DEVICE std::array< Real, 2 > compute_source_terms_Fn_Ft(const Real rad, const Real avg_vel, const Real *bld_rad_loc, const Real *bld_twist, const Real *bld_chord, int n_bld_sections, const Real *bld_airfoil_aoa, const Real *bld_airfoil_Cl, const Real *bld_airfoil_Cd, const int n_pts_airfoil, const Real *velocity, const Real *rotor_RPM, const Real *blade_pitch, const int n_spec_extra)
Definition: ERF_AdvanceGeneralAD.cpp:207
constexpr amrex::Real PI
Definition: ERF_Constants.H:6
-
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_GeneralAD.H:48
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cl
Definition: ERF_GeneralAD.H:51
-
amrex::Vector< amrex::Real > power
Definition: ERF_GeneralAD.H:48
-
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_GeneralAD.H:48
-
amrex::Real rotor_rad
Definition: ERF_GeneralAD.H:47
-
amrex::Vector< amrex::Real > velocity
Definition: ERF_GeneralAD.H:52
-
amrex::Vector< amrex::Real > blade_pitch
Definition: ERF_GeneralAD.H:52
-
amrex::Vector< amrex::Real > C_P
Definition: ERF_GeneralAD.H:52
-
amrex::Vector< amrex::Real > bld_twist
Definition: ERF_GeneralAD.H:50
-
amrex::Vector< amrex::Real > bld_chord
Definition: ERF_GeneralAD.H:50
-
amrex::Vector< amrex::Real > bld_rad_loc
Definition: ERF_GeneralAD.H:50
-
amrex::Real hub_height
Definition: ERF_GeneralAD.H:47
-
amrex::Real turb_disk_angle
Definition: ERF_GeneralAD.H:46
-
amrex::Real thrust_coeff_standing
Definition: ERF_GeneralAD.H:47
-
amrex::Vector< amrex::Real > C_T
Definition: ERF_GeneralAD.H:52
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_aoa
Definition: ERF_GeneralAD.H:51
-
amrex::Vector< amrex::Real > rotor_RPM
Definition: ERF_GeneralAD.H:52
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cd
Definition: ERF_GeneralAD.H:51
-
void get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)
Definition: ERF_NullWindFarm.H:84
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cl
Definition: ERF_GeneralAD.H:53
+
amrex::Vector< amrex::Real > velocity
Definition: ERF_GeneralAD.H:54
+
amrex::Vector< amrex::Real > blade_pitch
Definition: ERF_GeneralAD.H:54
+
amrex::Vector< amrex::Real > C_P
Definition: ERF_GeneralAD.H:54
+
amrex::Vector< amrex::Real > bld_twist
Definition: ERF_GeneralAD.H:52
+
amrex::Vector< amrex::Real > bld_chord
Definition: ERF_GeneralAD.H:52
+
amrex::Vector< amrex::Real > bld_rad_loc
Definition: ERF_GeneralAD.H:52
+
amrex::Real turb_disk_angle
Definition: ERF_GeneralAD.H:48
+
amrex::Vector< amrex::Real > C_T
Definition: ERF_GeneralAD.H:54
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_aoa
Definition: ERF_GeneralAD.H:53
+
amrex::Vector< amrex::Real > rotor_RPM
Definition: ERF_GeneralAD.H:54
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cd
Definition: ERF_GeneralAD.H:53
void get_turb_spec_extra(amrex::Vector< amrex::Real > &velocity, amrex::Vector< amrex::Real > &C_P, amrex::Vector< amrex::Real > &C_T, amrex::Vector< amrex::Real > &rotor_RPM, amrex::Vector< amrex::Real > &blade_pitch)
Definition: ERF_NullWindFarm.H:126
void get_blade_airfoil_spec(amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)
Definition: ERF_NullWindFarm.H:117
void get_turb_disk_angle(amrex::Real &turb_disk_angle)
Definition: ERF_NullWindFarm.H:103
@@ -867,35 +924,35 @@

-
36 {
-
37 
-
38  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
-
39 
-
40  Box tbx = mfi.nodaltilebox(0);
-
41  Box tby = mfi.nodaltilebox(1);
-
42  Box tbz = mfi.nodaltilebox(2);
-
43 
-
44  auto generalAD_array = mf_vars_generalAD.array(mfi);
-
45  auto u_vel = U_old.array(mfi);
-
46  auto v_vel = V_old.array(mfi);
-
47  auto w_vel = W_old.array(mfi);
-
48 
-
49  ParallelFor(tbx, tby, tbz,
-
50  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
51  {
-
52  u_vel(i,j,k) = u_vel(i,j,k) + (generalAD_array(i-1,j,k,0) + generalAD_array(i,j,k,0))/2.0*dt_advance;
-
53  },
-
54  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
55  {
-
56  v_vel(i,j,k) = v_vel(i,j,k) + (generalAD_array(i,j-1,k,1) + generalAD_array(i,j,k,1))/2.0*dt_advance;
-
57  },
-
58  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
-
59  {
-
60  w_vel(i,j,k) = w_vel(i,j,k) + (generalAD_array(i,j,k-1,2) + generalAD_array(i,j,k,2))/2.0*dt_advance;
-
61  });
-
62 
-
63  }
-
64 }
+
66 {
+
67 
+
68  for ( MFIter mfi(cons_in,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
69 
+
70  Box tbx = mfi.nodaltilebox(0);
+
71  Box tby = mfi.nodaltilebox(1);
+
72  Box tbz = mfi.nodaltilebox(2);
+
73 
+
74  auto generalAD_array = mf_vars_generalAD.array(mfi);
+
75  auto u_vel = U_old.array(mfi);
+
76  auto v_vel = V_old.array(mfi);
+
77  auto w_vel = W_old.array(mfi);
+
78 
+
79  ParallelFor(tbx, tby, tbz,
+
80  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
81  {
+
82  u_vel(i,j,k) = u_vel(i,j,k) + (generalAD_array(i-1,j,k,0) + generalAD_array(i,j,k,0))/2.0*dt_advance;
+
83  },
+
84  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
85  {
+
86  v_vel(i,j,k) = v_vel(i,j,k) + (generalAD_array(i,j-1,k,1) + generalAD_array(i,j,k,1))/2.0*dt_advance;
+
87  },
+
88  [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept
+
89  {
+
90  w_vel(i,j,k) = w_vel(i,j,k) + (generalAD_array(i,j,k-1,2) + generalAD_array(i,j,k,2))/2.0*dt_advance;
+
91  });
+
92 
+
93  }
+
94 }

diff --git a/classGeneralAD.js b/classGeneralAD.js index cc7b54886..0c0177ac1 100644 --- a/classGeneralAD.js +++ b/classGeneralAD.js @@ -4,6 +4,7 @@ var classGeneralAD = [ "~GeneralAD", "classGeneralAD.html#ac44ff0908ec3c419196fb45efd0c7c13", null ], [ "advance", "classGeneralAD.html#aa2727df24bc4d49692be1e4fae865806", null ], [ "compute_freestream_velocity", "classGeneralAD.html#aaa071c6bfd4e647404242328fd1b3643", null ], + [ "compute_power_output", "classGeneralAD.html#af6b71032fe0417e12b9aefff0ba2066b", null ], [ "source_terms_cellcentered", "classGeneralAD.html#a5be79013be63b8105a01534ca186de32", null ], [ "update", "classGeneralAD.html#a2c22ccda2fdf9b29e4325c22b84bea2c", null ], [ "blade_pitch", "classGeneralAD.html#a735e81390aef6a10e396bf4b7f1c7661", null ], diff --git a/classGeneralAD_af6b71032fe0417e12b9aefff0ba2066b_cgraph.map b/classGeneralAD_af6b71032fe0417e12b9aefff0ba2066b_cgraph.map new file mode 100644 index 000000000..b664646b1 --- /dev/null +++ b/classGeneralAD_af6b71032fe0417e12b9aefff0ba2066b_cgraph.map @@ -0,0 +1,4 @@ + + + + diff --git a/classGeneralAD_af6b71032fe0417e12b9aefff0ba2066b_cgraph.md5 b/classGeneralAD_af6b71032fe0417e12b9aefff0ba2066b_cgraph.md5 new file mode 100644 index 000000000..d7502548f --- /dev/null +++ b/classGeneralAD_af6b71032fe0417e12b9aefff0ba2066b_cgraph.md5 @@ -0,0 +1 @@ +d0811a0479a40fda32dc44b5a042e8f0 \ No newline at end of file diff --git a/classGeneralAD_af6b71032fe0417e12b9aefff0ba2066b_cgraph.png b/classGeneralAD_af6b71032fe0417e12b9aefff0ba2066b_cgraph.png new file mode 100644 index 000000000..f3e817d43 Binary files /dev/null and b/classGeneralAD_af6b71032fe0417e12b9aefff0ba2066b_cgraph.png differ diff --git a/classSimpleAD.html b/classSimpleAD.html index 38ed0a5bf..2a807661a 100644 --- a/classSimpleAD.html +++ b/classSimpleAD.html @@ -529,7 +529,7 @@

35  // Compute power based on the look-up table

36 
37  if (ParallelDescriptor::IOProcessor()){
-
38  static std::ofstream file("power_output.txt", std::ios::app);
+
38  static std::ofstream file("power_output_SimpleAD.txt", std::ios::app);
39  // Check if the file opened successfully
40  if (!file.is_open()) {
41  std::cerr << "Error opening file!" << std::endl;
diff --git a/classWindFarm-members.html b/classWindFarm-members.html index d2700fab1..1b9790bfb 100644 --- a/classWindFarm-members.html +++ b/classWindFarm-members.html @@ -99,75 +99,76 @@ bld_twistWindFarmprotected C_PWindFarmprotected C_TWindFarmprotected - fill_Nturb_multifab(const amrex::Geometry &geom, amrex::MultiFab &mf_Nturb, std::unique_ptr< amrex::MultiFab > &z_phys_cc)WindFarm + fill_Nturb_multifab(const amrex::Geometry &geom, amrex::MultiFab &mf_Nturb, std::unique_ptr< amrex::MultiFab > &z_phys_nd)WindFarm fill_SMark_multifab(const amrex::Geometry &geom, amrex::MultiFab &mf_SMark, const amrex::Real &sampling_distance_by_D, const amrex::Real &turb_disk_angle, std::unique_ptr< amrex::MultiFab > &z_phys_cc)WindFarm - find_if_marked(amrex::Real x1, amrex::Real x2, amrex::Real y1, amrex::Real y2, amrex::Real x0, amrex::Real y0, amrex::Real nx, amrex::Real ny, amrex::Real d_hub_height, amrex::Real d_rotor_rad, amrex::Real z)NullWindFarminlinestatic - gatherKeyValuePairs(const std::vector< std::pair< int, double >> &localData, std::vector< std::pair< int, double >> &globalData)WindFarm - get_blade_airfoil_spec(amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminline - get_blade_spec(amrex::Vector< amrex::Real > &bld_rad_loc, amrex::Vector< amrex::Real > &bld_twist, amrex::Vector< amrex::Real > &bld_chord)NullWindFarminline - get_turb_disk_angle(amrex::Real &turb_disk_angle)NullWindFarminline - get_turb_loc(amrex::Vector< amrex::Real > &xloc, amrex::Vector< amrex::Real > &yloc)NullWindFarminline - get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)NullWindFarminline - get_turb_spec_extra(amrex::Vector< amrex::Real > &velocity, amrex::Vector< amrex::Real > &C_P, amrex::Vector< amrex::Real > &C_T, amrex::Vector< amrex::Real > &rotor_RPM, amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminline - hub_heightWindFarmprotected - init_windfarm_lat_lon(const std::string windfarm_loc_table, const amrex::Real windfarm_x_shift, const amrex::Real windfarm_y_shift)WindFarm - init_windfarm_x_y(const std::string windfarm_loc_table)WindFarm - m_blade_pitchNullWindFarmprotected - m_bld_airfoil_aoaNullWindFarmprotected - m_bld_airfoil_CdNullWindFarmprotected - m_bld_airfoil_ClNullWindFarmprotected - m_bld_chordNullWindFarmprotected - m_bld_rad_locNullWindFarmprotected - m_bld_twistNullWindFarmprotected - m_C_PNullWindFarmprotected - m_C_TNullWindFarmprotected - m_hub_heightNullWindFarmprotected - m_nominal_powerNullWindFarmprotected - m_powerNullWindFarmprotected - m_rotor_radNullWindFarmprotected - m_rotor_RPMNullWindFarmprotected - m_thrust_coeffNullWindFarmprotected - m_thrust_coeff_standingNullWindFarmprotected - m_turb_disk_angleNullWindFarmprotected - m_velocityNullWindFarmprotected - m_wind_speedNullWindFarmprotected - m_windfarm_modelWindFarmprivate - m_xlocNullWindFarmprotected - m_ylocNullWindFarmprotected - my_turb_disk_angleWindFarmprotected - n_bld_sectionsWindFarmprotected - nominal_powerWindFarmprotected - NullWindFarm()NullWindFarminline - powerWindFarmprotected - read_tables(std::string windfarm_loc_table, std::string windfarm_spec_table, bool x_y, bool lat_lon, const amrex::Real windfarm_x_shift=0.0, const amrex::Real windfarm_y_shift=0.0)WindFarm - read_windfarm_airfoil_tables(const std::string windfarm_airfoil_tables, const std::string windfarm_blade_table)WindFarm - read_windfarm_blade_table(const std::string windfarm_blade_table)WindFarm - read_windfarm_locations_table(const std::string windfarm_loc_table, bool x_y, bool lat_lon, const amrex::Real windfarm_x_shift=0.0, const amrex::Real windfarm_y_shift=0.0)WindFarm - read_windfarm_spec_table(const std::string windfarm_spec_table)WindFarm - read_windfarm_spec_table_extra(const std::string windfarm_spec_table_extra)WindFarm - rotor_radWindFarmprotected - rotor_RPMWindFarmprotected - set_blade_airfoil_spec(const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_aoa, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cl, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cd) overrideWindFarminlinevirtual - set_blade_spec(const amrex::Vector< amrex::Real > &a_bld_rad_loc, const amrex::Vector< amrex::Real > &a_bld_twist, const amrex::Vector< amrex::Real > &a_bld_chord) overrideWindFarminlinevirtual - set_turb_disk_angle(const amrex::Real &a_turb_disk_angle) overrideWindFarminlinevirtual - set_turb_loc(const amrex::Vector< amrex::Real > &a_xloc, const amrex::Vector< amrex::Real > &a_yloc) overrideWindFarminlinevirtual - set_turb_spec(const amrex::Real &a_rotor_rad, const amrex::Real &a_hub_height, const amrex::Real &a_thrust_coeff_standing, const amrex::Vector< amrex::Real > &a_wind_speed, const amrex::Vector< amrex::Real > &a_thrust_coeff, const amrex::Vector< amrex::Real > &a_power) overrideWindFarminlinevirtual - set_turb_spec_extra(const amrex::Vector< amrex::Real > &a_velocity, const amrex::Vector< amrex::Real > &a_C_P, const amrex::Vector< amrex::Real > &a_C_T, const amrex::Vector< amrex::Real > &a_rotor_RPM, const amrex::Vector< amrex::Real > &a_blade_pitch) overrideWindFarminlinevirtual - SetModel()WindFarminlineprotected - thrust_coeffWindFarmprotected - thrust_coeff_standingWindFarmprotected - turb_indexWindFarmprotected - velocityWindFarmprotected - wind_speedWindFarmprotected - WindFarm()WindFarminline - WindFarm(int nlev, const WindFarmType &a_windfarm_type)WindFarminline - write_actuator_disks_vtk(const amrex::Geometry &geom, const amrex::Real &sampling_distance_by_D)WindFarm - write_turbine_locations_vtk()WindFarm - xlocWindFarmprotected - ylocWindFarmprotected - zlocWindFarmprotected - ~NullWindFarm()=defaultNullWindFarmvirtual - ~WindFarm()=defaultWindFarmvirtual + fill_SMark_multifab_mesoscale_models(const amrex::Geometry &geom, amrex::MultiFab &mf_SMark, const amrex::MultiFab &mf_Nturb, std::unique_ptr< amrex::MultiFab > &z_phys_cc)WindFarm + find_if_marked(amrex::Real x1, amrex::Real x2, amrex::Real y1, amrex::Real y2, amrex::Real x0, amrex::Real y0, amrex::Real nx, amrex::Real ny, amrex::Real d_hub_height, amrex::Real d_rotor_rad, amrex::Real z)NullWindFarminlinestatic + gatherKeyValuePairs(const std::vector< std::pair< int, double >> &localData, std::vector< std::pair< int, double >> &globalData)WindFarm + get_blade_airfoil_spec(amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_aoa, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cl, amrex::Vector< amrex::Vector< amrex::Real >> &bld_airfoil_Cd)NullWindFarminline + get_blade_spec(amrex::Vector< amrex::Real > &bld_rad_loc, amrex::Vector< amrex::Real > &bld_twist, amrex::Vector< amrex::Real > &bld_chord)NullWindFarminline + get_turb_disk_angle(amrex::Real &turb_disk_angle)NullWindFarminline + get_turb_loc(amrex::Vector< amrex::Real > &xloc, amrex::Vector< amrex::Real > &yloc)NullWindFarminline + get_turb_spec(amrex::Real &rotor_rad, amrex::Real &hub_height, amrex::Real &thrust_coeff_standing, amrex::Vector< amrex::Real > &wind_speed, amrex::Vector< amrex::Real > &thrust_coeff, amrex::Vector< amrex::Real > &power)NullWindFarminline + get_turb_spec_extra(amrex::Vector< amrex::Real > &velocity, amrex::Vector< amrex::Real > &C_P, amrex::Vector< amrex::Real > &C_T, amrex::Vector< amrex::Real > &rotor_RPM, amrex::Vector< amrex::Real > &blade_pitch)NullWindFarminline + hub_heightWindFarmprotected + init_windfarm_lat_lon(const std::string windfarm_loc_table, const amrex::Real windfarm_x_shift, const amrex::Real windfarm_y_shift)WindFarm + init_windfarm_x_y(const std::string windfarm_loc_table)WindFarm + m_blade_pitchNullWindFarmprotected + m_bld_airfoil_aoaNullWindFarmprotected + m_bld_airfoil_CdNullWindFarmprotected + m_bld_airfoil_ClNullWindFarmprotected + m_bld_chordNullWindFarmprotected + m_bld_rad_locNullWindFarmprotected + m_bld_twistNullWindFarmprotected + m_C_PNullWindFarmprotected + m_C_TNullWindFarmprotected + m_hub_heightNullWindFarmprotected + m_nominal_powerNullWindFarmprotected + m_powerNullWindFarmprotected + m_rotor_radNullWindFarmprotected + m_rotor_RPMNullWindFarmprotected + m_thrust_coeffNullWindFarmprotected + m_thrust_coeff_standingNullWindFarmprotected + m_turb_disk_angleNullWindFarmprotected + m_velocityNullWindFarmprotected + m_wind_speedNullWindFarmprotected + m_windfarm_modelWindFarmprivate + m_xlocNullWindFarmprotected + m_ylocNullWindFarmprotected + my_turb_disk_angleWindFarmprotected + n_bld_sectionsWindFarmprotected + nominal_powerWindFarmprotected + NullWindFarm()NullWindFarminline + powerWindFarmprotected + read_tables(std::string windfarm_loc_table, std::string windfarm_spec_table, bool x_y, bool lat_lon, const amrex::Real windfarm_x_shift=0.0, const amrex::Real windfarm_y_shift=0.0)WindFarm + read_windfarm_airfoil_tables(const std::string windfarm_airfoil_tables, const std::string windfarm_blade_table)WindFarm + read_windfarm_blade_table(const std::string windfarm_blade_table)WindFarm + read_windfarm_locations_table(const std::string windfarm_loc_table, bool x_y, bool lat_lon, const amrex::Real windfarm_x_shift=0.0, const amrex::Real windfarm_y_shift=0.0)WindFarm + read_windfarm_spec_table(const std::string windfarm_spec_table)WindFarm + read_windfarm_spec_table_extra(const std::string windfarm_spec_table_extra)WindFarm + rotor_radWindFarmprotected + rotor_RPMWindFarmprotected + set_blade_airfoil_spec(const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_aoa, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cl, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cd) overrideWindFarminlinevirtual + set_blade_spec(const amrex::Vector< amrex::Real > &a_bld_rad_loc, const amrex::Vector< amrex::Real > &a_bld_twist, const amrex::Vector< amrex::Real > &a_bld_chord) overrideWindFarminlinevirtual + set_turb_disk_angle(const amrex::Real &a_turb_disk_angle) overrideWindFarminlinevirtual + set_turb_loc(const amrex::Vector< amrex::Real > &a_xloc, const amrex::Vector< amrex::Real > &a_yloc) overrideWindFarminlinevirtual + set_turb_spec(const amrex::Real &a_rotor_rad, const amrex::Real &a_hub_height, const amrex::Real &a_thrust_coeff_standing, const amrex::Vector< amrex::Real > &a_wind_speed, const amrex::Vector< amrex::Real > &a_thrust_coeff, const amrex::Vector< amrex::Real > &a_power) overrideWindFarminlinevirtual + set_turb_spec_extra(const amrex::Vector< amrex::Real > &a_velocity, const amrex::Vector< amrex::Real > &a_C_P, const amrex::Vector< amrex::Real > &a_C_T, const amrex::Vector< amrex::Real > &a_rotor_RPM, const amrex::Vector< amrex::Real > &a_blade_pitch) overrideWindFarminlinevirtual + SetModel()WindFarminlineprotected + thrust_coeffWindFarmprotected + thrust_coeff_standingWindFarmprotected + turb_indexWindFarmprotected + velocityWindFarmprotected + wind_speedWindFarmprotected + WindFarm()WindFarminline + WindFarm(int nlev, const WindFarmType &a_windfarm_type)WindFarminline + write_actuator_disks_vtk(const amrex::Geometry &geom, const amrex::Real &sampling_distance_by_D)WindFarm + write_turbine_locations_vtk()WindFarm + xlocWindFarmprotected + ylocWindFarmprotected + zlocWindFarmprotected + ~NullWindFarm()=defaultNullWindFarmvirtual + ~WindFarm()=defaultWindFarmvirtual diff --git a/classWindFarm.html b/classWindFarm.html index be012bb96..66df1bbb7 100644 --- a/classWindFarm.html +++ b/classWindFarm.html @@ -143,10 +143,12 @@   void read_windfarm_spec_table_extra (const std::string windfarm_spec_table_extra)   -void fill_Nturb_multifab (const amrex::Geometry &geom, amrex::MultiFab &mf_Nturb, std::unique_ptr< amrex::MultiFab > &z_phys_cc) -  +void fill_Nturb_multifab (const amrex::Geometry &geom, amrex::MultiFab &mf_Nturb, std::unique_ptr< amrex::MultiFab > &z_phys_nd) +  void fill_SMark_multifab (const amrex::Geometry &geom, amrex::MultiFab &mf_SMark, const amrex::Real &sampling_distance_by_D, const amrex::Real &turb_disk_angle, std::unique_ptr< amrex::MultiFab > &z_phys_cc)   +void fill_SMark_multifab_mesoscale_models (const amrex::Geometry &geom, amrex::MultiFab &mf_SMark, const amrex::MultiFab &mf_Nturb, std::unique_ptr< amrex::MultiFab > &z_phys_cc) +  void write_turbine_locations_vtk ()   void write_actuator_disks_vtk (const amrex::Geometry &geom, const amrex::Real &sampling_distance_by_D) @@ -404,7 +406,7 @@

43  amrex::Abort("WindFarm: Dont know this windfarm_type!") ;
44  }
45  }
-
amrex::Vector< std::unique_ptr< NullWindFarm > > m_windfarm_model
Definition: ERF_WindFarm.H:171
+
amrex::Vector< std::unique_ptr< NullWindFarm > > m_windfarm_model
Definition: ERF_WindFarm.H:176
@@ -492,15 +494,15 @@

Implements NullWindFarm.

-
101  {
-
102  m_windfarm_model[0]->advance(a_geom, dt_advance, cons_in, mf_vars_windfarm,
-
103  U_old, V_old, W_old, mf_Nturb, mf_SMark, time);
-
104  }
+
106  {
+
107  m_windfarm_model[0]->advance(a_geom, dt_advance, cons_in, mf_vars_windfarm,
+
108  U_old, V_old, W_old, mf_Nturb, mf_SMark, time);
+
109  }
- -

◆ fill_Nturb_multifab()

+ +

◆ fill_Nturb_multifab()

@@ -521,7 +523,7 @@

std::unique_ptr< amrex::MultiFab > &  - z_phys_cc  + z_phys_nd  @@ -530,99 +532,96 @@

-
433 {
-
434 
-
435  zloc.resize(xloc.size(),-1.0);
-
436  turb_index.resize(xloc.size(),-1);
-
437 
-
438  amrex::Gpu::DeviceVector<Real> d_xloc(xloc.size());
-
439  amrex::Gpu::DeviceVector<Real> d_yloc(yloc.size());
-
440  amrex::Gpu::DeviceVector<Real> d_zloc(xloc.size());
-
441  amrex::Gpu::DeviceVector<int> d_turb_index(xloc.size());
-
442  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, xloc.begin(), xloc.end(), d_xloc.begin());
-
443  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, yloc.begin(), yloc.end(), d_yloc.begin());
-
444  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, zloc.begin(), zloc.end(), d_zloc.begin());
-
445  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, turb_index.begin(), turb_index.end(), d_turb_index.begin());
-
446 
-
447  Real* d_xloc_ptr = d_xloc.data();
-
448  Real* d_yloc_ptr = d_yloc.data();
-
449  Real* d_zloc_ptr = d_zloc.data();
-
450  int* d_turb_index_ptr = d_turb_index.data();
-
451 
-
452  mf_Nturb.setVal(0);
-
453 
-
454  int i_lo = geom.Domain().smallEnd(0); int i_hi = geom.Domain().bigEnd(0);
-
455  int j_lo = geom.Domain().smallEnd(1); int j_hi = geom.Domain().bigEnd(1);
-
456  auto dx = geom.CellSizeArray();
-
457  if(dx[0]<= 1e-3 or dx[1]<=1e-3 or dx[2]<= 1e-3) {
-
458  Abort("The value of mesh spacing for wind farm parametrization cannot be less than 1e-3 m. "
-
459  "It should be usually of order 1 m");
-
460  }
-
461  auto ProbLoArr = geom.ProbLoArray();
-
462  int num_turb = xloc.size();
-
463 
-
464  bool is_terrain = z_phys_cc ? true: false;
-
465 
-
466  // Initialize wind farm
-
467  for ( MFIter mfi(mf_Nturb,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
-
468  const Box& bx = mfi.tilebox();
-
469  auto Nturb_array = mf_Nturb.array(mfi);
-
470  const Array4<const Real>& z_cc_arr = (z_phys_cc) ? z_phys_cc->const_array(mfi) : Array4<Real>{};
-
471  int k0 = bx.smallEnd()[2];
-
472  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
473  int li = amrex::min(amrex::max(i, i_lo), i_hi);
-
474  int lj = amrex::min(amrex::max(j, j_lo), j_hi);
-
475 
-
476  Real x1 = ProbLoArr[0] + li*dx[0];
-
477  Real x2 = ProbLoArr[0] + (li+1)*dx[0];
-
478  Real y1 = ProbLoArr[1] + lj*dx[1];
-
479  Real y2 = ProbLoArr[1] + (lj+1)*dx[1];
-
480 
-
481  for(int it=0; it<num_turb; it++){
-
482  if( d_xloc_ptr[it]+1e-3 > x1 and d_xloc_ptr[it]+1e-3 < x2 and
-
483  d_yloc_ptr[it]+1e-3 > y1 and d_yloc_ptr[it]+1e-3 < y2){
-
484  Nturb_array(i,j,k,0) = Nturb_array(i,j,k,0) + 1;
-
485  if(is_terrain) {
-
486  d_zloc_ptr[it] = z_cc_arr(i,j,k0);
+
429 {
+
430 
+
431  zloc.resize(xloc.size(),-1.0);
+
432  turb_index.resize(xloc.size(),-1);
+
433 
+
434  amrex::Gpu::DeviceVector<Real> d_xloc(xloc.size());
+
435  amrex::Gpu::DeviceVector<Real> d_yloc(yloc.size());
+
436  amrex::Gpu::DeviceVector<Real> d_zloc(xloc.size());
+
437  amrex::Gpu::DeviceVector<int> d_turb_index(xloc.size());
+
438  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, xloc.begin(), xloc.end(), d_xloc.begin());
+
439  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, yloc.begin(), yloc.end(), d_yloc.begin());
+
440  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, zloc.begin(), zloc.end(), d_zloc.begin());
+
441  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, turb_index.begin(), turb_index.end(), d_turb_index.begin());
+
442 
+
443  Real* d_xloc_ptr = d_xloc.data();
+
444  Real* d_yloc_ptr = d_yloc.data();
+
445  Real* d_zloc_ptr = d_zloc.data();
+
446  int* d_turb_index_ptr = d_turb_index.data();
+
447 
+
448  mf_Nturb.setVal(0);
+
449 
+
450  int i_lo = geom.Domain().smallEnd(0); int i_hi = geom.Domain().bigEnd(0);
+
451  int j_lo = geom.Domain().smallEnd(1); int j_hi = geom.Domain().bigEnd(1);
+
452  auto dx = geom.CellSizeArray();
+
453  if(dx[0]<= 1e-3 or dx[1]<=1e-3 or dx[2]<= 1e-3) {
+
454  Abort("The value of mesh spacing for wind farm parametrization cannot be less than 1e-3 m. "
+
455  "It should be usually of order 1 m");
+
456  }
+
457  auto ProbLoArr = geom.ProbLoArray();
+
458  int num_turb = xloc.size();
+
459 
+
460  bool is_terrain = z_phys_nd ? true: false;
+
461 
+
462  // Initialize wind farm
+
463  for ( MFIter mfi(mf_Nturb,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
464  const Box& bx = mfi.tilebox();
+
465  auto Nturb_array = mf_Nturb.array(mfi);
+
466  const Array4<const Real>& z_nd_arr = (z_phys_nd) ? z_phys_nd->const_array(mfi) : Array4<Real>{};
+
467  int k0 = bx.smallEnd()[2];
+
468  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
469  int li = amrex::min(amrex::max(i, i_lo), i_hi);
+
470  int lj = amrex::min(amrex::max(j, j_lo), j_hi);
+
471 
+
472  Real x1 = ProbLoArr[0] + li*dx[0];
+
473  Real x2 = ProbLoArr[0] + (li+1)*dx[0];
+
474  Real y1 = ProbLoArr[1] + lj*dx[1];
+
475  Real y2 = ProbLoArr[1] + (lj+1)*dx[1];
+
476 
+
477  for(int it=0; it<num_turb; it++){
+
478  if( d_xloc_ptr[it]+1e-3 > x1 and d_xloc_ptr[it]+1e-3 < x2 and
+
479  d_yloc_ptr[it]+1e-3 > y1 and d_yloc_ptr[it]+1e-3 < y2){
+
480  Nturb_array(i,j,k,0) = Nturb_array(i,j,k,0) + 1;
+
481  if(is_terrain) {
+
482  d_zloc_ptr[it] = z_nd_arr(i,j,k0);
+
483  d_turb_index_ptr[it] = it;
+
484  }
+
485  else {
+
486  d_zloc_ptr[it] = 0.0;
487  d_turb_index_ptr[it] = it;
488  }
-
489  else {
-
490  d_zloc_ptr[it] = 0.0;
-
491  d_turb_index_ptr[it] = it;
-
492  }
-
493  }
-
494  }
-
495  });
-
496  }
-
497 
-
498  Gpu::copy(Gpu::deviceToHost, d_zloc.begin(), d_zloc.end(), zloc.begin());
-
499  Gpu::copy(Gpu::deviceToHost, d_turb_index.begin(), d_turb_index.end(), turb_index.begin());
-
500 
-
501  if(is_terrain) {
-
502 
-
503  std::vector<std::pair<int, double>> turb_index_zloc;
-
504  for(int it=0;it<xloc.size();it++){
-
505  if(turb_index[it] != -1) {
-
506  turb_index_zloc.emplace_back(std::make_pair(turb_index[it], zloc[it]));
-
507  }
-
508  }
-
509 
-
510  std::vector<std::pair<int, double>> turb_index_zloc_glob;
-
511 
-
512  gatherKeyValuePairs(turb_index_zloc, turb_index_zloc_glob);
-
513 
-
514  // Each process now has the global array
-
515  for (const auto& kv : turb_index_zloc_glob) {
-
516  std::cout << "Rank " << amrex::ParallelDescriptor::MyProc() << "Global data" << kv.first << " " << kv.second << "\n";
-
517  zloc[kv.first] = kv.second;
-
518  }
-
519  }
-
520 }
-
amrex::Vector< amrex::Real > yloc
Definition: ERF_WindFarm.H:151
-
amrex::Vector< amrex::Real > zloc
Definition: ERF_WindFarm.H:151
+
489  }
+
490  }
+
491  });
+
492  }
+
493 
+
494  Gpu::copy(Gpu::deviceToHost, d_zloc.begin(), d_zloc.end(), zloc.begin());
+
495  Gpu::copy(Gpu::deviceToHost, d_turb_index.begin(), d_turb_index.end(), turb_index.begin());
+
496 
+
497  std::vector<std::pair<int, double>> turb_index_zloc;
+
498  for(int it=0;it<xloc.size();it++){
+
499  if(turb_index[it] != -1) {
+
500  turb_index_zloc.emplace_back(std::make_pair(turb_index[it], zloc[it]));
+
501  }
+
502  }
+
503 
+
504  std::vector<std::pair<int, double>> turb_index_zloc_glob;
+
505 
+
506  gatherKeyValuePairs(turb_index_zloc, turb_index_zloc_glob);
+
507 
+
508  // Each process now has the global array
+
509  for (const auto& kv : turb_index_zloc_glob) {
+
510  //std::cout << "Rank " << amrex::ParallelDescriptor::MyProc() << "Global data" << kv.first << " " << kv.second << "\n";
+
511  zloc[kv.first] = kv.second;
+
512  }
+
513 }
+
amrex::Vector< amrex::Real > yloc
Definition: ERF_WindFarm.H:156
+
amrex::Vector< amrex::Real > zloc
Definition: ERF_WindFarm.H:156
void gatherKeyValuePairs(const std::vector< std::pair< int, double >> &localData, std::vector< std::pair< int, double >> &globalData)
Definition: ERF_InitWindFarm.cpp:354
-
amrex::Vector< amrex::Real > xloc
Definition: ERF_WindFarm.H:151
-
amrex::Vector< int > turb_index
Definition: ERF_WindFarm.H:152
+
amrex::Vector< amrex::Real > xloc
Definition: ERF_WindFarm.H:156
+
amrex::Vector< int > turb_index
Definition: ERF_WindFarm.H:157

@@ -669,106 +668,199 @@

-
528 {
-
529  amrex::Gpu::DeviceVector<Real> d_xloc(xloc.size());
-
530  amrex::Gpu::DeviceVector<Real> d_yloc(yloc.size());
-
531  amrex::Gpu::DeviceVector<Real> d_zloc(yloc.size());
-
532  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, xloc.begin(), xloc.end(), d_xloc.begin());
-
533  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, yloc.begin(), yloc.end(), d_yloc.begin());
-
534  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, zloc.begin(), zloc.end(), d_zloc.begin());
-
535 
-
536  Real d_rotor_rad = rotor_rad;
-
537  Real d_hub_height = hub_height;
-
538  Real d_sampling_distance = sampling_distance_by_D*2.0*rotor_rad;
-
539 
-
540  Real* d_xloc_ptr = d_xloc.data();
-
541  Real* d_yloc_ptr = d_yloc.data();
-
542  Real* d_zloc_ptr = d_zloc.data();
-
543 
-
544  mf_SMark.setVal(-1.0);
-
545 
-
546  int i_lo = geom.Domain().smallEnd(0); int i_hi = geom.Domain().bigEnd(0);
-
547  int j_lo = geom.Domain().smallEnd(1); int j_hi = geom.Domain().bigEnd(1);
-
548  int k_lo = geom.Domain().smallEnd(2); int k_hi = geom.Domain().bigEnd(2);
-
549  auto dx = geom.CellSizeArray();
-
550  auto ProbLoArr = geom.ProbLoArray();
-
551  int num_turb = xloc.size();
-
552 
-
553  Real theta = turb_disk_angle*M_PI/180.0-0.5*M_PI;
-
554 
- - -
557 
-
558  Real nx = -std::cos(theta);
-
559  Real ny = -std::sin(theta);
-
560 
-
561  // Initialize wind farm
-
562  for ( MFIter mfi(mf_SMark,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
-
563  //const Box& bx = mfi.tilebox();
-
564  const Box& gbx = mfi.growntilebox(1);
-
565  auto SMark_array = mf_SMark.array(mfi);
-
566 
-
567  const Array4<const Real>& z_cc_arr = (z_phys_cc) ? z_phys_cc->const_array(mfi) : Array4<Real>{};
-
568 
-
569  ParallelFor(gbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
-
570  int ii = amrex::min(amrex::max(i, i_lo), i_hi);
-
571  int jj = amrex::min(amrex::max(j, j_lo), j_hi);
-
572  int kk = amrex::min(amrex::max(k, k_lo), k_hi);
-
573 
-
574  Real x1 = ProbLoArr[0] + ii*dx[0];
-
575  Real x2 = ProbLoArr[0] + (ii+1)*dx[0];
-
576  Real y1 = ProbLoArr[1] + jj*dx[1];
-
577  Real y2 = ProbLoArr[1] + (jj+1)*dx[1];
-
578 
-
579  //Real z = ProbLoArr[2] + (kk+0.5) * dx[2];
-
580  Real z = (z_cc_arr) ? z_cc_arr(ii,jj,kk) : ProbLoArr[2] + (kk+0.5) * dx[2];
-
581 
-
582  int turb_indices_overlap[2];
-
583  int check_int = 0;
-
584  for(int it=0; it<num_turb; it++){
-
585  Real x0 = d_xloc_ptr[it] + d_sampling_distance*nx;
-
586  Real y0 = d_yloc_ptr[it] + d_sampling_distance*ny;
-
587 
-
588  Real z0 = 0.0;
-
589  if(z_cc_arr) {
-
590  z0 = d_zloc_ptr[it];
-
591  }
+
577 {
+
578  amrex::Gpu::DeviceVector<Real> d_xloc(xloc.size());
+
579  amrex::Gpu::DeviceVector<Real> d_yloc(yloc.size());
+
580  amrex::Gpu::DeviceVector<Real> d_zloc(yloc.size());
+
581  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, xloc.begin(), xloc.end(), d_xloc.begin());
+
582  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, yloc.begin(), yloc.end(), d_yloc.begin());
+
583  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, zloc.begin(), zloc.end(), d_zloc.begin());
+
584 
+
585  Real d_rotor_rad = rotor_rad;
+
586  Real d_hub_height = hub_height;
+
587  Real d_sampling_distance = sampling_distance_by_D*2.0*rotor_rad;
+
588 
+
589  Real* d_xloc_ptr = d_xloc.data();
+
590  Real* d_yloc_ptr = d_yloc.data();
+
591  Real* d_zloc_ptr = d_zloc.data();
592 
-
593  bool is_cell_marked = find_if_marked(x1, x2, y1, y2, x0, y0,
-
594  nx, ny, d_hub_height+z0, d_rotor_rad, z);
-
595  if(is_cell_marked) {
-
596  SMark_array(i,j,k,0) = it;
-
597  }
-
598  x0 = d_xloc_ptr[it];
-
599  y0 = d_yloc_ptr[it];
-
600 
-
601  is_cell_marked = find_if_marked(x1, x2, y1, y2, x0, y0,
-
602  nx, ny, d_hub_height+z0, d_rotor_rad, z);
-
603  if(is_cell_marked) {
-
604  SMark_array(i,j,k,1) = it;
-
605  turb_indices_overlap[check_int] = it;
-
606  check_int++;
-
607  if(check_int > 1){
-
608  printf("Actuator disks with indices %d and %d are overlapping\n",
-
609  turb_indices_overlap[0],turb_indices_overlap[1]);
-
610  amrex::Error("Actuator disks are overlapping. Visualize actuator_disks.vtk "
-
611  " and check the windturbine locations input file. Exiting..");
-
612  }
-
613  }
-
614  }
-
615  });
-
616  }
-
617 }
+
593  mf_SMark.setVal(-1.0);
+
594 
+
595  int i_lo = geom.Domain().smallEnd(0); int i_hi = geom.Domain().bigEnd(0);
+
596  int j_lo = geom.Domain().smallEnd(1); int j_hi = geom.Domain().bigEnd(1);
+
597  int k_lo = geom.Domain().smallEnd(2); int k_hi = geom.Domain().bigEnd(2);
+
598  auto dx = geom.CellSizeArray();
+
599  auto ProbLoArr = geom.ProbLoArray();
+
600  int num_turb = xloc.size();
+
601 
+
602  Real theta = turb_disk_angle*M_PI/180.0-0.5*M_PI;
+
603 
+ + +
606 
+
607  Real nx = -std::cos(theta);
+
608  Real ny = -std::sin(theta);
+
609 
+
610  // Initialize wind farm
+
611  for ( MFIter mfi(mf_SMark,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
612  //const Box& bx = mfi.tilebox();
+
613  const Box& gbx = mfi.growntilebox(1);
+
614  auto SMark_array = mf_SMark.array(mfi);
+
615 
+
616  const Array4<const Real>& z_cc_arr = (z_phys_cc) ? z_phys_cc->const_array(mfi) : Array4<Real>{};
+
617 
+
618  ParallelFor(gbx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
619  int ii = amrex::min(amrex::max(i, i_lo), i_hi);
+
620  int jj = amrex::min(amrex::max(j, j_lo), j_hi);
+
621  int kk = amrex::min(amrex::max(k, k_lo), k_hi);
+
622 
+
623  // The x and y extents of the current mesh cell
+
624 
+
625  Real x1 = ProbLoArr[0] + ii*dx[0];
+
626  Real x2 = ProbLoArr[0] + (ii+1)*dx[0];
+
627  Real y1 = ProbLoArr[1] + jj*dx[1];
+
628  Real y2 = ProbLoArr[1] + (jj+1)*dx[1];
+
629 
+
630  // The mesh cell centered z value
+
631 
+
632  Real z = (z_cc_arr) ? z_cc_arr(ii,jj,kk) : ProbLoArr[2] + (kk+0.5) * dx[2];
+
633 
+
634  int turb_indices_overlap[2];
+
635  int check_int = 0;
+
636  for(int it=0; it<num_turb; it++){
+
637  Real x0 = d_xloc_ptr[it] + d_sampling_distance*nx;
+
638  Real y0 = d_yloc_ptr[it] + d_sampling_distance*ny;
+
639 
+
640  Real z0 = 0.0;
+
641  if(z_cc_arr) {
+
642  z0 = d_zloc_ptr[it];
+
643  }
+
644 
+
645  bool is_cell_marked = find_if_marked(x1, x2, y1, y2, x0, y0,
+
646  nx, ny, d_hub_height+z0, d_rotor_rad, z);
+
647  if(is_cell_marked) {
+
648  SMark_array(i,j,k,0) = it;
+
649  }
+
650  x0 = d_xloc_ptr[it];
+
651  y0 = d_yloc_ptr[it];
+
652 
+
653  is_cell_marked = find_if_marked(x1, x2, y1, y2, x0, y0,
+
654  nx, ny, d_hub_height+z0, d_rotor_rad, z);
+
655  if(is_cell_marked) {
+
656  SMark_array(i,j,k,1) = it;
+
657  turb_indices_overlap[check_int] = it;
+
658  check_int++;
+
659  if(check_int > 1){
+
660  printf("Actuator disks with indices %d and %d are overlapping\n",
+
661  turb_indices_overlap[0],turb_indices_overlap[1]);
+
662  amrex::Error("Actuator disks are overlapping. Visualize actuator_disks.vtk "
+
663  " and check the windturbine locations input file. Exiting..");
+
664  }
+
665  }
+
666  }
+
667  });
+
668  }
+
669 }
static AMREX_GPU_DEVICE bool find_if_marked(amrex::Real x1, amrex::Real x2, amrex::Real y1, amrex::Real y2, amrex::Real x0, amrex::Real y0, amrex::Real nx, amrex::Real ny, amrex::Real d_hub_height, amrex::Real d_rotor_rad, amrex::Real z)
Definition: ERF_NullWindFarm.H:140
-
amrex::Real my_turb_disk_angle
Definition: ERF_WindFarm.H:153
-
amrex::Real hub_height
Definition: ERF_WindFarm.H:154
-
amrex::Real rotor_rad
Definition: ERF_WindFarm.H:154
-
void set_turb_disk_angle(const amrex::Real &a_turb_disk_angle) override
Definition: ERF_WindFarm.H:121
+
amrex::Real my_turb_disk_angle
Definition: ERF_WindFarm.H:158
+
amrex::Real hub_height
Definition: ERF_WindFarm.H:159
+
amrex::Real rotor_rad
Definition: ERF_WindFarm.H:159
+
void set_turb_disk_angle(const amrex::Real &a_turb_disk_angle) override
Definition: ERF_WindFarm.H:126
@ theta
Definition: ERF_MM5.H:20

+ +

◆ fill_SMark_multifab_mesoscale_models()

+ +
+
+ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +
void WindFarm::fill_SMark_multifab_mesoscale_models (const amrex::Geometry & geom,
amrex::MultiFab & mf_SMark,
const amrex::MultiFab & mf_Nturb,
std::unique_ptr< amrex::MultiFab > & z_phys_cc 
)
+
+
520 {
+
521  mf_SMark.setVal(-1.0);
+
522 
+
523  Real d_hub_height = hub_height;
+
524 
+
525  amrex::Gpu::DeviceVector<Real> d_xloc(xloc.size());
+
526  amrex::Gpu::DeviceVector<Real> d_yloc(yloc.size());
+
527  amrex::Gpu::DeviceVector<Real> d_zloc(xloc.size());
+
528  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, xloc.begin(), xloc.end(), d_xloc.begin());
+
529  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, yloc.begin(), yloc.end(), d_yloc.begin());
+
530  amrex::Gpu::copyAsync(amrex::Gpu::hostToDevice, zloc.begin(), zloc.end(), d_zloc.begin());
+
531 
+
532  int i_lo = geom.Domain().smallEnd(0); int i_hi = geom.Domain().bigEnd(0);
+
533  int j_lo = geom.Domain().smallEnd(1); int j_hi = geom.Domain().bigEnd(1);
+
534  int k_lo = geom.Domain().smallEnd(2); int k_hi = geom.Domain().bigEnd(2);
+
535 
+
536  auto dx = geom.CellSizeArray();
+
537  auto ProbLoArr = geom.ProbLoArray();
+
538 
+
539  // Initialize wind farm
+
540  for ( MFIter mfi(mf_SMark,TilingIfNotGPU()); mfi.isValid(); ++mfi) {
+
541 
+
542  const Box& bx = mfi.tilebox();
+
543  auto SMark_array = mf_SMark.array(mfi);
+
544  auto Nturb_array = mf_Nturb.array(mfi);
+
545  const Array4<const Real>& z_nd_arr = (z_phys_nd) ? z_phys_nd->const_array(mfi) : Array4<Real>{};
+
546  int k0 = bx.smallEnd()[2];
+
547 
+
548  ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k) noexcept {
+
549  if(Nturb_array(i,j,k,0) > 0) {
+
550  int li = amrex::min(amrex::max(i, i_lo), i_hi);
+
551  int lj = amrex::min(amrex::max(j, j_lo), j_hi);
+
552  int lk = amrex::min(amrex::max(k, k_lo), k_hi);
+
553 
+
554  Real z1 = (z_nd_arr) ? z_nd_arr(li,lj,lk) : ProbLoArr[2] + lk * dx[2];
+
555  Real z2 = (z_nd_arr) ? z_nd_arr(li,lj,lk+1) : ProbLoArr[2] + (lk+1) * dx[2];
+
556 
+
557  Real zturb;
+
558  if(z_nd_arr) {
+
559  zturb = z_nd_arr(li,lj,k0) + d_hub_height;
+
560  } else {
+
561  zturb = d_hub_height;
+
562  }
+
563  if(zturb+1e-3 > z1 and zturb+1e-3 < z2) {
+
564  SMark_array(i,j,k,0) = 1.0;
+
565  }
+
566  }
+
567  });
+
568  }
+
569 }
+
+
+

◆ gatherKeyValuePairs()

@@ -860,11 +952,7 @@

419  amrex::ParallelDescriptor::Bcast(&globalData[i].first, 1, 0);
420  amrex::ParallelDescriptor::Bcast(&globalData[i].second, 1, 0);
421  }
-
422 
-
423  for (const auto& kv : globalData) {
-
424  std::cout << "Rank " << myRank << "Key: " << kv.first << ", Value: " << kv.second << std::endl;
-
425  }
-
426 }
+
422 }
@@ -1181,11 +1269,11 @@

349 
351 }
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cl
Definition: ERF_WindFarm.H:157
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_aoa
Definition: ERF_WindFarm.H:157
-
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cd
Definition: ERF_WindFarm.H:157
-
int n_bld_sections
Definition: ERF_WindFarm.H:158
-
void set_blade_airfoil_spec(const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_aoa, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cl, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cd) override
Definition: ERF_WindFarm.H:133
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cl
Definition: ERF_WindFarm.H:162
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_aoa
Definition: ERF_WindFarm.H:162
+
amrex::Vector< amrex::Vector< amrex::Real > > bld_airfoil_Cd
Definition: ERF_WindFarm.H:162
+
int n_bld_sections
Definition: ERF_WindFarm.H:163
+
void set_blade_airfoil_spec(const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_aoa, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cl, const amrex::Vector< amrex::Vector< amrex::Real >> &a_bld_airfoil_Cd) override
Definition: ERF_WindFarm.H:138
@@ -1234,10 +1322,10 @@

230  n_bld_sections = bld_rad_loc.size();
231  }
232 }
-
void set_blade_spec(const amrex::Vector< amrex::Real > &a_bld_rad_loc, const amrex::Vector< amrex::Real > &a_bld_twist, const amrex::Vector< amrex::Real > &a_bld_chord) override
Definition: ERF_WindFarm.H:126
-
amrex::Vector< amrex::Real > bld_twist
Definition: ERF_WindFarm.H:156
-
amrex::Vector< amrex::Real > bld_chord
Definition: ERF_WindFarm.H:156
-
amrex::Vector< amrex::Real > bld_rad_loc
Definition: ERF_WindFarm.H:156
+
void set_blade_spec(const amrex::Vector< amrex::Real > &a_bld_rad_loc, const amrex::Vector< amrex::Real > &a_bld_twist, const amrex::Vector< amrex::Real > &a_bld_chord) override
Definition: ERF_WindFarm.H:131
+
amrex::Vector< amrex::Real > bld_twist
Definition: ERF_WindFarm.H:161
+
amrex::Vector< amrex::Real > bld_chord
Definition: ERF_WindFarm.H:161
+
amrex::Vector< amrex::Real > bld_rad_loc
Definition: ERF_WindFarm.H:161
@@ -1298,7 +1386,7 @@

50 
52 }
-
void set_turb_loc(const amrex::Vector< amrex::Real > &a_xloc, const amrex::Vector< amrex::Real > &a_yloc) override
Definition: ERF_WindFarm.H:115
+
void set_turb_loc(const amrex::Vector< amrex::Real > &a_xloc, const amrex::Vector< amrex::Real > &a_yloc) override
Definition: ERF_WindFarm.H:120
void init_windfarm_x_y(const std::string windfarm_loc_table)
Definition: ERF_InitWindFarm.cpp:132
void init_windfarm_lat_lon(const std::string windfarm_loc_table, const amrex::Real windfarm_x_shift, const amrex::Real windfarm_y_shift)
Definition: ERF_InitWindFarm.cpp:55
@@ -1364,12 +1452,12 @@

197  wind_speed, thrust_coeff, power);
198 
199 }
-
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_WindFarm.H:155
-
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_WindFarm.H:155
-
amrex::Real nominal_power
Definition: ERF_WindFarm.H:154
-
void set_turb_spec(const amrex::Real &a_rotor_rad, const amrex::Real &a_hub_height, const amrex::Real &a_thrust_coeff_standing, const amrex::Vector< amrex::Real > &a_wind_speed, const amrex::Vector< amrex::Real > &a_thrust_coeff, const amrex::Vector< amrex::Real > &a_power) override
Definition: ERF_WindFarm.H:106
-
amrex::Real thrust_coeff_standing
Definition: ERF_WindFarm.H:154
-
amrex::Vector< amrex::Real > power
Definition: ERF_WindFarm.H:155
+
amrex::Vector< amrex::Real > wind_speed
Definition: ERF_WindFarm.H:160
+
amrex::Vector< amrex::Real > thrust_coeff
Definition: ERF_WindFarm.H:160
+
amrex::Real nominal_power
Definition: ERF_WindFarm.H:159
+
void set_turb_spec(const amrex::Real &a_rotor_rad, const amrex::Real &a_hub_height, const amrex::Real &a_thrust_coeff_standing, const amrex::Vector< amrex::Real > &a_wind_speed, const amrex::Vector< amrex::Real > &a_thrust_coeff, const amrex::Vector< amrex::Real > &a_power) override
Definition: ERF_WindFarm.H:111
+
amrex::Real thrust_coeff_standing
Definition: ERF_WindFarm.H:159
+
amrex::Vector< amrex::Real > power
Definition: ERF_WindFarm.H:160
@@ -1423,12 +1511,12 @@

268 
270 }
-
amrex::Vector< amrex::Real > blade_pitch
Definition: ERF_WindFarm.H:159
-
void set_turb_spec_extra(const amrex::Vector< amrex::Real > &a_velocity, const amrex::Vector< amrex::Real > &a_C_P, const amrex::Vector< amrex::Real > &a_C_T, const amrex::Vector< amrex::Real > &a_rotor_RPM, const amrex::Vector< amrex::Real > &a_blade_pitch) override
Definition: ERF_WindFarm.H:140
-
amrex::Vector< amrex::Real > velocity
Definition: ERF_WindFarm.H:159
-
amrex::Vector< amrex::Real > C_P
Definition: ERF_WindFarm.H:159
-
amrex::Vector< amrex::Real > C_T
Definition: ERF_WindFarm.H:159
-
amrex::Vector< amrex::Real > rotor_RPM
Definition: ERF_WindFarm.H:159
+
amrex::Vector< amrex::Real > blade_pitch
Definition: ERF_WindFarm.H:164
+
void set_turb_spec_extra(const amrex::Vector< amrex::Real > &a_velocity, const amrex::Vector< amrex::Real > &a_C_P, const amrex::Vector< amrex::Real > &a_C_T, const amrex::Vector< amrex::Real > &a_rotor_RPM, const amrex::Vector< amrex::Real > &a_blade_pitch) override
Definition: ERF_WindFarm.H:145
+
amrex::Vector< amrex::Real > velocity
Definition: ERF_WindFarm.H:164
+
amrex::Vector< amrex::Real > C_P
Definition: ERF_WindFarm.H:164
+
amrex::Vector< amrex::Real > C_T
Definition: ERF_WindFarm.H:164
+
amrex::Vector< amrex::Real > rotor_RPM
Definition: ERF_WindFarm.H:164
@ V
Definition: ERF_IndexDefines.H:98
@@ -1474,9 +1562,9 @@

Reimplemented from NullWindFarm.

-
136  {
-
137  m_windfarm_model[0]->set_blade_airfoil_spec(a_bld_airfoil_aoa, a_bld_airfoil_Cl, a_bld_airfoil_Cd);
-
138  }
+
141  {
+
142  m_windfarm_model[0]->set_blade_airfoil_spec(a_bld_airfoil_aoa, a_bld_airfoil_Cl, a_bld_airfoil_Cd);
+
143  }
@@ -1521,9 +1609,9 @@

Reimplemented from NullWindFarm.

-
129  {
-
130  m_windfarm_model[0]->set_blade_spec(a_bld_rad_loc, a_bld_twist, a_bld_chord);
-
131  }
+
134  {
+
135  m_windfarm_model[0]->set_blade_spec(a_bld_rad_loc, a_bld_twist, a_bld_chord);
+
136  }
@@ -1552,9 +1640,9 @@

Reimplemented from NullWindFarm.

-
122  {
-
123  m_windfarm_model[0]->set_turb_disk_angle(a_turb_disk_angle);
-
124  }
+
127  {
+
128  m_windfarm_model[0]->set_turb_disk_angle(a_turb_disk_angle);
+
129  }
@@ -1593,9 +1681,9 @@

Reimplemented from NullWindFarm.

-
117  {
-
118  m_windfarm_model[0]->set_turb_loc(a_xloc, a_yloc);
-
119  }
+
122  {
+
123  m_windfarm_model[0]->set_turb_loc(a_xloc, a_yloc);
+
124  }
@@ -1658,10 +1746,10 @@

Reimplemented from NullWindFarm.

-
110  {
-
111  m_windfarm_model[0]->set_turb_spec(a_rotor_rad, a_hub_height, a_thrust_coeff_standing,
-
112  a_wind_speed, a_thrust_coeff, a_power);
-
113  }
+
115  {
+
116  m_windfarm_model[0]->set_turb_spec(a_rotor_rad, a_hub_height, a_thrust_coeff_standing,
+
117  a_wind_speed, a_thrust_coeff, a_power);
+
118  }
@@ -1718,9 +1806,9 @@

Reimplemented from NullWindFarm.

-
145  {
-
146  m_windfarm_model[0]->set_turb_spec_extra(a_velocity, a_C_P, a_C_T, a_rotor_RPM, a_blade_pitch);
-
147  }
+
150  {
+
151  m_windfarm_model[0]->set_turb_spec_extra(a_velocity, a_C_P, a_C_T, a_rotor_RPM, a_blade_pitch);
+
152  }
@@ -1750,11 +1838,11 @@

Create and set the specified windfarm model.

-
164  {
-
165  for (int lev(0); lev<m_windfarm_model.size(); ++lev) {
-
166  m_windfarm_model[lev] = std::make_unique<NewWindFarmModel>();
-
167  }
-
168  }
+
169  {
+
170  for (int lev(0); lev<m_windfarm_model.size(); ++lev) {
+
171  m_windfarm_model[lev] = std::make_unique<NewWindFarmModel>();
+
172  }
+
173  }
@@ -1783,107 +1871,107 @@

-
641 {
-
642 
-
643  Real sampling_distance = sampling_distance_by_D*2.0*rotor_rad;
-
644 
-
645  if (ParallelDescriptor::IOProcessor()){
-
646  FILE *file_actuator_disks_all, *file_actuator_disks_in_dom, *file_averaging_disks_in_dom;
-
647  file_actuator_disks_all = fopen("actuator_disks_all.vtk","w");
-
648  fprintf(file_actuator_disks_all, "%s\n","# vtk DataFile Version 3.0");
-
649  fprintf(file_actuator_disks_all, "%s\n","Actuator Disks");
-
650  fprintf(file_actuator_disks_all, "%s\n","ASCII");
-
651  fprintf(file_actuator_disks_all, "%s\n","DATASET POLYDATA");
-
652 
-
653  file_actuator_disks_in_dom = fopen("actuator_disks_in_dom.vtk","w");
-
654  fprintf(file_actuator_disks_in_dom, "%s\n","# vtk DataFile Version 3.0");
-
655  fprintf(file_actuator_disks_in_dom, "%s\n","Actuator Disks");
-
656  fprintf(file_actuator_disks_in_dom, "%s\n","ASCII");
-
657  fprintf(file_actuator_disks_in_dom, "%s\n","DATASET POLYDATA");
-
658 
-
659  file_averaging_disks_in_dom = fopen("averaging_disks_in_dom.vtk","w");
-
660  fprintf(file_averaging_disks_in_dom, "%s\n","# vtk DataFile Version 3.0");
-
661  fprintf(file_averaging_disks_in_dom, "%s\n","Actuator Disks");
-
662  fprintf(file_averaging_disks_in_dom, "%s\n","ASCII");
-
663  fprintf(file_averaging_disks_in_dom, "%s\n","DATASET POLYDATA");
-
664 
-
665 
-
666  int npts = 100;
-
667  fprintf(file_actuator_disks_all, "%s %ld %s\n", "POINTS", xloc.size()*npts, "float");
-
668  auto ProbLoArr = geom.ProbLoArray();
-
669  auto ProbHiArr = geom.ProbHiArray();
-
670  int num_turb_in_dom = 0;
-
671 
-
672  // Find the number of turbines inside the specified computational domain
-
673 
-
674  for(int it=0; it<xloc.size(); it++){
-
675  Real x = xloc[it];
-
676  Real y = yloc[it];
-
677  if(x > ProbLoArr[0] and x < ProbHiArr[0] and y > ProbLoArr[1] and y < ProbHiArr[1]) {
-
678  num_turb_in_dom++;
-
679  }
-
680  }
-
681  fprintf(file_actuator_disks_in_dom, "%s %ld %s\n", "POINTS", static_cast<long int>(num_turb_in_dom*npts), "float");
-
682  fprintf(file_averaging_disks_in_dom, "%s %ld %s\n", "POINTS", static_cast<long int>(num_turb_in_dom*npts), "float");
-
683 
-
684  Real nx = std::cos(my_turb_disk_angle+0.5*M_PI);
-
685  Real ny = std::sin(my_turb_disk_angle+0.5*M_PI);
-
686 
-
687  Real nx1 = -std::cos(my_turb_disk_angle);
-
688  Real ny1 = -std::sin(my_turb_disk_angle);
-
689 
-
690  for(int it=0; it<xloc.size(); it++){
-
691  for(int pt=0;pt<100;pt++){
-
692  Real x, y, z, xavg, yavg;
-
693  Real theta = 2.0*M_PI/npts*pt;
-
694  x = xloc[it] + rotor_rad*cos(theta)*nx;
-
695  y = yloc[it] + rotor_rad*cos(theta)*ny;
-
696  z = hub_height + zloc[it] + rotor_rad*sin(theta);
-
697 
-
698  xavg = xloc[it] + sampling_distance*nx1 + rotor_rad*cos(theta)*nx;
-
699  yavg = yloc[it] + sampling_distance*ny1 + rotor_rad*cos(theta)*ny;
-
700 
-
701  fprintf(file_actuator_disks_all, "%0.15g %0.15g %0.15g\n", x, y, z);
-
702  if(xloc[it] > ProbLoArr[0] and xloc[it] < ProbHiArr[0] and yloc[it] > ProbLoArr[1] and yloc[it] < ProbHiArr[1]) {
-
703  fprintf(file_actuator_disks_in_dom, "%0.15g %0.15g %0.15g\n", x, y, z);
-
704  fprintf(file_averaging_disks_in_dom, "%0.15g %0.15g %0.15g\n", xavg, yavg, z);
-
705  }
-
706  }
-
707  }
-
708  fprintf(file_actuator_disks_all, "%s %ld %ld\n", "LINES", xloc.size()*(npts-1), static_cast<long int>(xloc.size()*(npts-1)*3));
-
709  fprintf(file_actuator_disks_in_dom, "%s %ld %ld\n", "LINES", static_cast<long int>(num_turb_in_dom*(npts-1)), static_cast<long int>(num_turb_in_dom*(npts-1)*3));
-
710  fprintf(file_averaging_disks_in_dom, "%s %ld %ld\n", "LINES", static_cast<long int>(num_turb_in_dom*(npts-1)), static_cast<long int>(num_turb_in_dom*(npts-1)*3));
-
711  for(int it=0; it<xloc.size(); it++){
-
712  for(int pt=0;pt<99;pt++){
-
713  fprintf(file_actuator_disks_all, "%ld %ld %ld\n",
-
714  static_cast<long int>(2),
-
715  static_cast<long int>(it*npts+pt),
-
716  static_cast<long int>(it*npts+pt+1));
-
717  }
-
718  }
-
719  for(int it=0; it<num_turb_in_dom; it++){
-
720  for(int pt=0;pt<99;pt++){
-
721  fprintf(file_actuator_disks_in_dom, "%ld %ld %ld\n",
-
722  static_cast<long int>(2),
-
723  static_cast<long int>(it*npts+pt),
-
724  static_cast<long int>(it*npts+pt+1));
-
725  }
-
726  }
-
727 
-
728  for(int it=0; it<num_turb_in_dom; it++){
-
729  for(int pt=0;pt<99;pt++){
-
730  fprintf(file_averaging_disks_in_dom, "%ld %ld %ld\n",
-
731  static_cast<long int>(2),
-
732  static_cast<long int>(it*npts+pt),
-
733  static_cast<long int>(it*npts+pt+1));
-
734  }
-
735  }
-
736 
-
737  fclose(file_actuator_disks_all);
-
738  fclose(file_actuator_disks_in_dom);
-
739  fclose(file_averaging_disks_in_dom);
-
740  }
-
741 }
+
693 {
+
694 
+
695  Real sampling_distance = sampling_distance_by_D*2.0*rotor_rad;
+
696 
+
697  if (ParallelDescriptor::IOProcessor()){
+
698  FILE *file_actuator_disks_all, *file_actuator_disks_in_dom, *file_averaging_disks_in_dom;
+
699  file_actuator_disks_all = fopen("actuator_disks_all.vtk","w");
+
700  fprintf(file_actuator_disks_all, "%s\n","# vtk DataFile Version 3.0");
+
701  fprintf(file_actuator_disks_all, "%s\n","Actuator Disks");
+
702  fprintf(file_actuator_disks_all, "%s\n","ASCII");
+
703  fprintf(file_actuator_disks_all, "%s\n","DATASET POLYDATA");
+
704 
+
705  file_actuator_disks_in_dom = fopen("actuator_disks_in_dom.vtk","w");
+
706  fprintf(file_actuator_disks_in_dom, "%s\n","# vtk DataFile Version 3.0");
+
707  fprintf(file_actuator_disks_in_dom, "%s\n","Actuator Disks");
+
708  fprintf(file_actuator_disks_in_dom, "%s\n","ASCII");
+
709  fprintf(file_actuator_disks_in_dom, "%s\n","DATASET POLYDATA");
+
710 
+
711  file_averaging_disks_in_dom = fopen("averaging_disks_in_dom.vtk","w");
+
712  fprintf(file_averaging_disks_in_dom, "%s\n","# vtk DataFile Version 3.0");
+
713  fprintf(file_averaging_disks_in_dom, "%s\n","Actuator Disks");
+
714  fprintf(file_averaging_disks_in_dom, "%s\n","ASCII");
+
715  fprintf(file_averaging_disks_in_dom, "%s\n","DATASET POLYDATA");
+
716 
+
717 
+
718  int npts = 100;
+
719  fprintf(file_actuator_disks_all, "%s %ld %s\n", "POINTS", xloc.size()*npts, "float");
+
720  auto ProbLoArr = geom.ProbLoArray();
+
721  auto ProbHiArr = geom.ProbHiArray();
+
722  int num_turb_in_dom = 0;
+
723 
+
724  // Find the number of turbines inside the specified computational domain
+
725 
+
726  for(int it=0; it<xloc.size(); it++){
+
727  Real x = xloc[it];
+
728  Real y = yloc[it];
+
729  if(x > ProbLoArr[0] and x < ProbHiArr[0] and y > ProbLoArr[1] and y < ProbHiArr[1]) {
+
730  num_turb_in_dom++;
+
731  }
+
732  }
+
733  fprintf(file_actuator_disks_in_dom, "%s %ld %s\n", "POINTS", static_cast<long int>(num_turb_in_dom*npts), "float");
+
734  fprintf(file_averaging_disks_in_dom, "%s %ld %s\n", "POINTS", static_cast<long int>(num_turb_in_dom*npts), "float");
+
735 
+
736  Real nx = std::cos(my_turb_disk_angle+0.5*M_PI);
+
737  Real ny = std::sin(my_turb_disk_angle+0.5*M_PI);
+
738 
+
739  Real nx1 = -std::cos(my_turb_disk_angle);
+
740  Real ny1 = -std::sin(my_turb_disk_angle);
+
741 
+
742  for(int it=0; it<xloc.size(); it++){
+
743  for(int pt=0;pt<100;pt++){
+
744  Real x, y, z, xavg, yavg;
+
745  Real theta = 2.0*M_PI/npts*pt;
+
746  x = xloc[it] + rotor_rad*cos(theta)*nx;
+
747  y = yloc[it] + rotor_rad*cos(theta)*ny;
+
748  z = hub_height + zloc[it] + rotor_rad*sin(theta);
+
749 
+
750  xavg = xloc[it] + sampling_distance*nx1 + rotor_rad*cos(theta)*nx;
+
751  yavg = yloc[it] + sampling_distance*ny1 + rotor_rad*cos(theta)*ny;
+
752 
+
753  fprintf(file_actuator_disks_all, "%0.15g %0.15g %0.15g\n", x, y, z);
+
754  if(xloc[it] > ProbLoArr[0] and xloc[it] < ProbHiArr[0] and yloc[it] > ProbLoArr[1] and yloc[it] < ProbHiArr[1]) {
+
755  fprintf(file_actuator_disks_in_dom, "%0.15g %0.15g %0.15g\n", x, y, z);
+
756  fprintf(file_averaging_disks_in_dom, "%0.15g %0.15g %0.15g\n", xavg, yavg, z);
+
757  }
+
758  }
+
759  }
+
760  fprintf(file_actuator_disks_all, "%s %ld %ld\n", "LINES", xloc.size()*(npts-1), static_cast<long int>(xloc.size()*(npts-1)*3));
+
761  fprintf(file_actuator_disks_in_dom, "%s %ld %ld\n", "LINES", static_cast<long int>(num_turb_in_dom*(npts-1)), static_cast<long int>(num_turb_in_dom*(npts-1)*3));
+
762  fprintf(file_averaging_disks_in_dom, "%s %ld %ld\n", "LINES", static_cast<long int>(num_turb_in_dom*(npts-1)), static_cast<long int>(num_turb_in_dom*(npts-1)*3));
+
763  for(int it=0; it<xloc.size(); it++){
+
764  for(int pt=0;pt<99;pt++){
+
765  fprintf(file_actuator_disks_all, "%ld %ld %ld\n",
+
766  static_cast<long int>(2),
+
767  static_cast<long int>(it*npts+pt),
+
768  static_cast<long int>(it*npts+pt+1));
+
769  }
+
770  }
+
771  for(int it=0; it<num_turb_in_dom; it++){
+
772  for(int pt=0;pt<99;pt++){
+
773  fprintf(file_actuator_disks_in_dom, "%ld %ld %ld\n",
+
774  static_cast<long int>(2),
+
775  static_cast<long int>(it*npts+pt),
+
776  static_cast<long int>(it*npts+pt+1));
+
777  }
+
778  }
+
779 
+
780  for(int it=0; it<num_turb_in_dom; it++){
+
781  for(int pt=0;pt<99;pt++){
+
782  fprintf(file_averaging_disks_in_dom, "%ld %ld %ld\n",
+
783  static_cast<long int>(2),
+
784  static_cast<long int>(it*npts+pt),
+
785  static_cast<long int>(it*npts+pt+1));
+
786  }
+
787  }
+
788 
+
789  fclose(file_actuator_disks_all);
+
790  fclose(file_actuator_disks_in_dom);
+
791  fclose(file_averaging_disks_in_dom);
+
792  }
+
793 }
@@ -1903,21 +1991,21 @@

-
621 {
-
622  if (ParallelDescriptor::IOProcessor()){
-
623  FILE* file_turbloc_vtk;
-
624  file_turbloc_vtk = fopen("turbine_locations.vtk","w");
-
625  fprintf(file_turbloc_vtk, "%s\n","# vtk DataFile Version 3.0");
-
626  fprintf(file_turbloc_vtk, "%s\n","Wind turbine locations");
-
627  fprintf(file_turbloc_vtk, "%s\n","ASCII");
-
628  fprintf(file_turbloc_vtk, "%s\n","DATASET POLYDATA");
-
629  fprintf(file_turbloc_vtk, "%s %ld %s\n", "POINTS", xloc.size(), "float");
-
630  for(int it=0; it<xloc.size(); it++){
-
631  fprintf(file_turbloc_vtk, "%0.15g %0.15g %0.15g\n", xloc[it], yloc[it], hub_height);
-
632  }
-
633  fclose(file_turbloc_vtk);
-
634  }
-
635 }
+
673 {
+
674  if (ParallelDescriptor::IOProcessor()){
+
675  FILE* file_turbloc_vtk;
+
676  file_turbloc_vtk = fopen("turbine_locations.vtk","w");
+
677  fprintf(file_turbloc_vtk, "%s\n","# vtk DataFile Version 3.0");
+
678  fprintf(file_turbloc_vtk, "%s\n","Wind turbine locations");
+
679  fprintf(file_turbloc_vtk, "%s\n","ASCII");
+
680  fprintf(file_turbloc_vtk, "%s\n","DATASET POLYDATA");
+
681  fprintf(file_turbloc_vtk, "%s %ld %s\n", "POINTS", xloc.size(), "float");
+
682  for(int it=0; it<xloc.size(); it++){
+
683  fprintf(file_turbloc_vtk, "%0.15g %0.15g %0.15g\n", xloc[it], yloc[it], hub_height);
+
684  }
+
685  fclose(file_turbloc_vtk);
+
686  }
+
687 }

diff --git a/classWindFarm.js b/classWindFarm.js index f1596296b..0838c1bad 100644 --- a/classWindFarm.js +++ b/classWindFarm.js @@ -4,8 +4,9 @@ var classWindFarm = [ "~WindFarm", "classWindFarm.html#a1be0e27ac213ad5faaf2fb2e114eab48", null ], [ "WindFarm", "classWindFarm.html#aa029a9a7efa768d39849b4fb27ab5eeb", null ], [ "advance", "classWindFarm.html#a2e5541f6986770bc1b8b48fa2720ba1c", null ], - [ "fill_Nturb_multifab", "classWindFarm.html#aea0f3ab253607ca28ab0085c9a0865e7", null ], + [ "fill_Nturb_multifab", "classWindFarm.html#ac57fc0cf5e0666fd8aabbf7863412eb5", null ], [ "fill_SMark_multifab", "classWindFarm.html#ad4c606e93225c44abd0e854081602c2a", null ], + [ "fill_SMark_multifab_mesoscale_models", "classWindFarm.html#a74983b05c969cace5b73aeae42830d2c", null ], [ "gatherKeyValuePairs", "classWindFarm.html#aaa0f45adf2528c2f8c5be67ac4a18e8b", null ], [ "init_windfarm_lat_lon", "classWindFarm.html#aab3b5df05c4a5f0604ad7c378ba34d1e", null ], [ "init_windfarm_x_y", "classWindFarm.html#aaa79cb89d8f18f2a059d1ff62c5e5dd3", null ], diff --git a/functions_c.html b/functions_c.html index c7a7378db..c19c2a9b1 100644 --- a/functions_c.html +++ b/functions_c.html @@ -352,7 +352,7 @@

- c -

  • compute_averages() : MOSTAverage -, PlaneAverage +, PlaneAverage
  • Compute_Coefficients() : SAM @@ -378,7 +378,10 @@

    - c -

      : MOSTAverage
    • compute_power_output() -: SimpleAD +: EWP +, Fitch +, GeneralAD +, SimpleAD
    • compute_q_flux() : custom_flux diff --git a/functions_d.html b/functions_d.html index 6ab091f1b..10b7a7162 100644 --- a/functions_d.html +++ b/functions_d.html @@ -127,12 +127,12 @@

      - d -

      • data_sampler : ERF
      • -
      • DataLog() -: ERF -
      • datalog : ERF
      • +
      • DataLog() +: ERF +
      • DataLogName() : ERF
      • diff --git a/functions_f.html b/functions_f.html index db5a2a227..3f0afc18b 100644 --- a/functions_f.html +++ b/functions_f.html @@ -121,7 +121,7 @@

        - f -

          : ERF
        • fill_Nturb_multifab() -: WindFarm +: WindFarm
        • fill_rhs() : ERF @@ -129,6 +129,9 @@

          - f -

          • fill_SMark_multifab() : WindFarm
          • +
          • fill_SMark_multifab_mesoscale_models() +: WindFarm +
          • FillBdyCCVels() : ERF
          • diff --git a/functions_func_c.html b/functions_func_c.html index cb577d925..8e7159554 100644 --- a/functions_func_c.html +++ b/functions_func_c.html @@ -159,7 +159,7 @@

            - c -

            • compute_averages() : MOSTAverage -, PlaneAverage +, PlaneAverage
            • Compute_Coefficients() : SAM @@ -178,14 +178,17 @@

              - c -

                : ABLMost
              • compute_pblh() -: ABLMost +: ABLMost , MYNNPBLH
              • compute_plane_averages() : MOSTAverage
              • compute_power_output() -: SimpleAD +: EWP +, Fitch +, GeneralAD +, SimpleAD
              • compute_q_flux() : custom_flux diff --git a/functions_func_f.html b/functions_func_f.html index 067a6f0d9..cb85bce77 100644 --- a/functions_func_f.html +++ b/functions_func_f.html @@ -95,7 +95,7 @@

                - f -

                  : ERF
                • fill_Nturb_multifab() -: WindFarm +: WindFarm
                • fill_rhs() : ERF @@ -103,6 +103,9 @@

                  - f -

                  • fill_SMark_multifab() : WindFarm
                  • +
                  • fill_SMark_multifab_mesoscale_models() +: WindFarm +
                  • FillBdyCCVels() : ERF
                  • @@ -113,7 +116,7 @@

                    - f -

                      : ERF
                    • FillPatch() -: ERF +: ERF
                    • FillPatchBlocks() : MultiBlockContainer diff --git a/functions_h.html b/functions_h.html index dafe75858..544bbdd63 100644 --- a/functions_h.html +++ b/functions_h.html @@ -153,6 +153,9 @@

                      - h -

                        , SimpleAD , WindFarm +
                      • hub_height_velocity +: Fitch +
                      • huge_real : ModalAeroWateruptake
                      • diff --git a/functions_s.html b/functions_s.html index cf6485170..5b93e4f0e 100644 --- a/functions_s.html +++ b/functions_s.html @@ -121,18 +121,18 @@

                        - s -

                        • SampleLineLog() : ERF
                        • -
                        • SampleLineLogName() -: ERF -
                        • samplelinelogname : ERF
                        • -
                        • samplepoint -: ERF +
                        • SampleLineLogName() +: ERF
                        • SamplePoint() : ERF
                        • +
                        • samplepoint +: ERF +
                        • SamplePointLog() : ERF
                        • diff --git a/functions_vars_h.html b/functions_vars_h.html index 538449cbe..b1f604dea 100644 --- a/functions_vars_h.html +++ b/functions_vars_h.html @@ -134,6 +134,9 @@

                          - h -

                            , SimpleAD , WindFarm +
                          • hub_height_velocity +: Fitch +
                          • huge_real : ModalAeroWateruptake
                          • diff --git a/navtreedata.js b/navtreedata.js index 2ba3a9784..1797745cd 100644 --- a/navtreedata.js +++ b/navtreedata.js @@ -78,15 +78,16 @@ var NAVTREEINDEX = "ERF__Write1DProfiles__stag_8cpp.html", "classCloudRadProps.html#a7c91a5b46f8d85666e0ca0d1de8d23aa", "classERF.html#aa8b243c093bd872b6f7592603ff97792", -"classEulerianMicrophysics.html#aa882ea75f222099b16b43a579d11e2c1", -"classMRISplitIntegrator.html#a277f590efb755921c145d09f84e740af", -"classNullWindFarm.html#ae4797e5a94227d10ed3b39dfd7bf4444", -"classRadiation.html#a8f47b85f948822c0e450beddb92373f4", -"classSimpleAD.html#a1665d726556fc42558e77fe94e732d43", -"functions_func_l.html", -"structDiffChoice.html", -"structSolverChoice.html#a396122e87a3d15c4ec8666d7dd18c095", -"structWENO__Z3.html#a448d977459d12ff43f0a74da29e94014" +"classEulerianMicrophysics.html#a6f0dc90119a228e56c5616267eba6009", +"classMRISplitIntegrator.html#a14fd551d7a7ff5bf6c58500740a64547", +"classNullWindFarm.html#ad337a725edf9efdaf1fd4a49ddd35505", +"classRadiation.html#a8b27a952d1ceb83c174a5d30f6198230", +"classSimpleAD.html", +"functions_func_f.html", +"structCENTERED6.html#aacd79f8ed62a166d5f4d44a20d09fc13", +"structSolverChoice.html#a29517ec608149342f25aa89f18204fac", +"structWENO__MZQ3.html#ad02f88cd05b6e31261fb3380887a2099", +"structsurface__temp__wave__coupled.html#abf85e6ffabb9974a13bc03e6f7d11e96" ]; var SYNCONMSG = 'click to disable panel synchronisation'; diff --git a/navtreeindex10.js b/navtreeindex10.js index 5cf18e3f0..5daeab7c4 100644 --- a/navtreeindex10.js +++ b/navtreeindex10.js @@ -1,5 +1,9 @@ var NAVTREEINDEX10 = { +"classSimpleAD.html":[2,0,77], +"classSimpleAD.html#a04490ef9f591e86588c5bb7870c1b77f":[2,0,77,13], +"classSimpleAD.html#a0d915eaf360210453a081a2b721d0fa0":[2,0,77,14], +"classSimpleAD.html#a1320fd9378b5802905f2a101a81b8067":[2,0,77,3], "classSimpleAD.html#a1665d726556fc42558e77fe94e732d43":[2,0,77,15], "classSimpleAD.html#a171f86e19e21f7c5632ca2c459d489f5":[2,0,77,17], "classSimpleAD.html#a1d87675adbb7e56ff0969cd1543c72c4":[2,0,77,6], @@ -83,55 +87,56 @@ var NAVTREEINDEX10 = "classWaterVaporSat.html#acb27b106d02d30d688faa223d7f5131b":[2,0,102,6], "classWaterVaporSat.html#afae0dfb4f85c8ac528ff330ccfa182b2":[2,0,102,10], "classWindFarm.html":[2,0,110], -"classWindFarm.html#a0d274380a6e7a61593459bb0b0f642d2":[2,0,110,35], -"classWindFarm.html#a18280646bd55077f0a59ea45506a630b":[2,0,110,47], +"classWindFarm.html#a0d274380a6e7a61593459bb0b0f642d2":[2,0,110,36], +"classWindFarm.html#a18280646bd55077f0a59ea45506a630b":[2,0,110,48], "classWindFarm.html#a1be0e27ac213ad5faaf2fb2e114eab48":[2,0,110,1], -"classWindFarm.html#a2a7411926b7f581556ab806dc2d9f3db":[2,0,110,27], +"classWindFarm.html#a2a7411926b7f581556ab806dc2d9f3db":[2,0,110,28], "classWindFarm.html#a2e5541f6986770bc1b8b48fa2720ba1c":[2,0,110,3], -"classWindFarm.html#a2fc81cd15b5bbaec6e10bab30997fa7c":[2,0,110,24], +"classWindFarm.html#a2fc81cd15b5bbaec6e10bab30997fa7c":[2,0,110,25], "classWindFarm.html#a3248ba59be840e23843bebe9b2c82f36":[2,0,110,0], -"classWindFarm.html#a38b7fff20a8b1882965e1bbfefe5419a":[2,0,110,12], -"classWindFarm.html#a4afb42d44ea84a770d4dbfe8beb33f7e":[2,0,110,20], -"classWindFarm.html#a4bfca70fee27062cd4eca4209ddfb16b":[2,0,110,9], -"classWindFarm.html#a510ceec29875903a4ca1d6e82fcbbf37":[2,0,110,14], -"classWindFarm.html#a5746b9a61d306dc1b8a8ca121e2906bb":[2,0,110,25], -"classWindFarm.html#a57a72ded446162e2e365dc0ff7c6e06a":[2,0,110,44], -"classWindFarm.html#a584e7ba8dd495cbedf35150dfce68f26":[2,0,110,11], -"classWindFarm.html#a5d1dbc2f5df3a2ee2b239f04b82a2c6b":[2,0,110,45], -"classWindFarm.html#a5defcbb732ba325db7b6e8a819ab381e":[2,0,110,18], -"classWindFarm.html#a6206e875bd0ab78e9b997d115a6c7b33":[2,0,110,16], -"classWindFarm.html#a638bdc717e37526689d507a5cd36735e":[2,0,110,21], -"classWindFarm.html#a63c20a3eac21bceea0ae4bfbe4c9acac":[2,0,110,31], -"classWindFarm.html#a6dfd6451498f50c17cb67c386d13ddfb":[2,0,110,33], -"classWindFarm.html#a70d65d49e7ee4191c7f009416ab6ba27":[2,0,110,48], -"classWindFarm.html#a735f2980748b427839b5a5f492f3add8":[2,0,110,30], -"classWindFarm.html#a759d6e1b93757a50ff7001382399ae9c":[2,0,110,22], -"classWindFarm.html#a80014fbca537f74f24f5c54d69467866":[2,0,110,26], -"classWindFarm.html#a87e2fe5c89e49801a70f6acf9836e1e1":[2,0,110,32], -"classWindFarm.html#a8d5e6333f2f9f8e36dfd4766ad171b84":[2,0,110,41], -"classWindFarm.html#a92bd0b9d5124a84555b8ea2633502191":[2,0,110,13], -"classWindFarm.html#a9e263152650471997aa43658904bc563":[2,0,110,36], +"classWindFarm.html#a38b7fff20a8b1882965e1bbfefe5419a":[2,0,110,13], +"classWindFarm.html#a4afb42d44ea84a770d4dbfe8beb33f7e":[2,0,110,21], +"classWindFarm.html#a4bfca70fee27062cd4eca4209ddfb16b":[2,0,110,10], +"classWindFarm.html#a510ceec29875903a4ca1d6e82fcbbf37":[2,0,110,15], +"classWindFarm.html#a5746b9a61d306dc1b8a8ca121e2906bb":[2,0,110,26], +"classWindFarm.html#a57a72ded446162e2e365dc0ff7c6e06a":[2,0,110,45], +"classWindFarm.html#a584e7ba8dd495cbedf35150dfce68f26":[2,0,110,12], +"classWindFarm.html#a5d1dbc2f5df3a2ee2b239f04b82a2c6b":[2,0,110,46], +"classWindFarm.html#a5defcbb732ba325db7b6e8a819ab381e":[2,0,110,19], +"classWindFarm.html#a6206e875bd0ab78e9b997d115a6c7b33":[2,0,110,17], +"classWindFarm.html#a638bdc717e37526689d507a5cd36735e":[2,0,110,22], +"classWindFarm.html#a63c20a3eac21bceea0ae4bfbe4c9acac":[2,0,110,32], +"classWindFarm.html#a6dfd6451498f50c17cb67c386d13ddfb":[2,0,110,34], +"classWindFarm.html#a70d65d49e7ee4191c7f009416ab6ba27":[2,0,110,49], +"classWindFarm.html#a735f2980748b427839b5a5f492f3add8":[2,0,110,31], +"classWindFarm.html#a74983b05c969cace5b73aeae42830d2c":[2,0,110,6], +"classWindFarm.html#a759d6e1b93757a50ff7001382399ae9c":[2,0,110,23], +"classWindFarm.html#a80014fbca537f74f24f5c54d69467866":[2,0,110,27], +"classWindFarm.html#a87e2fe5c89e49801a70f6acf9836e1e1":[2,0,110,33], +"classWindFarm.html#a8d5e6333f2f9f8e36dfd4766ad171b84":[2,0,110,42], +"classWindFarm.html#a92bd0b9d5124a84555b8ea2633502191":[2,0,110,14], +"classWindFarm.html#a9e263152650471997aa43658904bc563":[2,0,110,37], "classWindFarm.html#aa029a9a7efa768d39849b4fb27ab5eeb":[2,0,110,2], -"classWindFarm.html#aa542d50137f25dcb568fafc483a83178":[2,0,110,37], -"classWindFarm.html#aa96d62f2d3d93c79e318ed0e321973fa":[2,0,110,15], -"classWindFarm.html#aaa0f45adf2528c2f8c5be67ac4a18e8b":[2,0,110,6], -"classWindFarm.html#aaa79cb89d8f18f2a059d1ff62c5e5dd3":[2,0,110,8], -"classWindFarm.html#aaab919aaa049f74aaa240318df77a890":[2,0,110,28], -"classWindFarm.html#aab3b5df05c4a5f0604ad7c378ba34d1e":[2,0,110,7], -"classWindFarm.html#aabf18956cad4a8546eb60ff8300c94c8":[2,0,110,19], -"classWindFarm.html#ab8d68a72cf4346074daf47f825eff105":[2,0,110,42], -"classWindFarm.html#ac1bd117bca25527ede4ea107ad22b07c":[2,0,110,46], -"classWindFarm.html#acddba73addcac3477acc274faaf62467":[2,0,110,10], -"classWindFarm.html#ad0925f54be32d71ae431a2078afee91b":[2,0,110,39], +"classWindFarm.html#aa542d50137f25dcb568fafc483a83178":[2,0,110,38], +"classWindFarm.html#aa96d62f2d3d93c79e318ed0e321973fa":[2,0,110,16], +"classWindFarm.html#aaa0f45adf2528c2f8c5be67ac4a18e8b":[2,0,110,7], +"classWindFarm.html#aaa79cb89d8f18f2a059d1ff62c5e5dd3":[2,0,110,9], +"classWindFarm.html#aaab919aaa049f74aaa240318df77a890":[2,0,110,29], +"classWindFarm.html#aab3b5df05c4a5f0604ad7c378ba34d1e":[2,0,110,8], +"classWindFarm.html#aabf18956cad4a8546eb60ff8300c94c8":[2,0,110,20], +"classWindFarm.html#ab8d68a72cf4346074daf47f825eff105":[2,0,110,43], +"classWindFarm.html#ac1bd117bca25527ede4ea107ad22b07c":[2,0,110,47], +"classWindFarm.html#ac57fc0cf5e0666fd8aabbf7863412eb5":[2,0,110,4], +"classWindFarm.html#acddba73addcac3477acc274faaf62467":[2,0,110,11], +"classWindFarm.html#ad0925f54be32d71ae431a2078afee91b":[2,0,110,40], "classWindFarm.html#ad4c606e93225c44abd0e854081602c2a":[2,0,110,5], -"classWindFarm.html#ad777d1138832963ea3158ec66c86e0c7":[2,0,110,23], -"classWindFarm.html#ae10dbee3f3d8b126e52df83ea97d57b1":[2,0,110,40], -"classWindFarm.html#aea0f3ab253607ca28ab0085c9a0865e7":[2,0,110,4], -"classWindFarm.html#aea801fd8c22bf9d4bdcec847f4e7f50a":[2,0,110,38], -"classWindFarm.html#aecf311136c814318eccea16a2a3c5efd":[2,0,110,29], -"classWindFarm.html#aed4eeef484f5e77b3c3038a1606f1875":[2,0,110,17], -"classWindFarm.html#af3061fab41eb0d20c97164376cc370dc":[2,0,110,43], -"classWindFarm.html#af3953694e6a246585c20f50436a65123":[2,0,110,34], +"classWindFarm.html#ad777d1138832963ea3158ec66c86e0c7":[2,0,110,24], +"classWindFarm.html#ae10dbee3f3d8b126e52df83ea97d57b1":[2,0,110,41], +"classWindFarm.html#aea801fd8c22bf9d4bdcec847f4e7f50a":[2,0,110,39], +"classWindFarm.html#aecf311136c814318eccea16a2a3c5efd":[2,0,110,30], +"classWindFarm.html#aed4eeef484f5e77b3c3038a1606f1875":[2,0,110,18], +"classWindFarm.html#af3061fab41eb0d20c97164376cc370dc":[2,0,110,44], +"classWindFarm.html#af3953694e6a246585c20f50436a65123":[2,0,110,35], "classWriteBndryPlanes.html":[2,0,111], "classWriteBndryPlanes.html#a007dc2174ebcc2e2d79e8f31f41255cb":[2,0,111,5], "classWriteBndryPlanes.html#a0f85ce22ec7a00d38091d2aa2b829fca":[2,0,111,2], @@ -230,8 +235,8 @@ var NAVTREEINDEX10 = "dir_fbd11baa4baa1a8b78c4a3d08373cbc6.html":[3,0,1,11], "dir_fc0c15590968603ac439df7b0a572228.html":[3,0,1,3], "files.html":[3,0], -"functions.html":[2,3,0], "functions.html":[2,3,0,0], +"functions.html":[2,3,0], "functions_b.html":[2,3,0,1], "functions_c.html":[2,3,0,2], "functions_d.html":[2,3,0,3], @@ -244,10 +249,5 @@ var NAVTREEINDEX10 = "functions_func_b.html":[2,3,1,1], "functions_func_c.html":[2,3,1,2], "functions_func_d.html":[2,3,1,3], -"functions_func_e.html":[2,3,1,4], -"functions_func_f.html":[2,3,1,5], -"functions_func_g.html":[2,3,1,6], -"functions_func_h.html":[2,3,1,7], -"functions_func_i.html":[2,3,1,8], -"functions_func_k.html":[2,3,1,9] +"functions_func_e.html":[2,3,1,4] }; diff --git a/navtreeindex11.js b/navtreeindex11.js index 6c6449f8d..667b3ed43 100644 --- a/navtreeindex11.js +++ b/navtreeindex11.js @@ -1,5 +1,10 @@ var NAVTREEINDEX11 = { +"functions_func_f.html":[2,3,1,5], +"functions_func_g.html":[2,3,1,6], +"functions_func_h.html":[2,3,1,7], +"functions_func_i.html":[2,3,1,8], +"functions_func_k.html":[2,3,1,9], "functions_func_l.html":[2,3,1,10], "functions_func_m.html":[2,3,1,11], "functions_func_n.html":[2,3,1,12], @@ -33,8 +38,8 @@ var NAVTREEINDEX11 = "functions_type.html":[2,3,3], "functions_u.html":[2,3,0,20], "functions_v.html":[2,3,0,21], -"functions_vars.html":[2,3,2], "functions_vars.html":[2,3,2,0], +"functions_vars.html":[2,3,2], "functions_vars_b.html":[2,3,2,1], "functions_vars_c.html":[2,3,2,2], "functions_vars_d.html":[2,3,2,3], @@ -244,10 +249,5 @@ var NAVTREEINDEX11 = "structCENTERED6.html#a16a6ea9f7d0663518b97353b2224ee33":[2,0,12,3], "structCENTERED6.html#a32c3566f07adb5481cf94c54893a4206":[2,0,12,6], "structCENTERED6.html#a6ffd5cab531876c4cb61598e3021e401":[2,0,12,5], -"structCENTERED6.html#a732a4a686c30a3233c939f453b74f0b9":[2,0,12,8], -"structCENTERED6.html#aacd79f8ed62a166d5f4d44a20d09fc13":[2,0,12,1], -"structCENTERED6.html#acedba4c2b029f363a47c32ad0c6f30e8":[2,0,12,0], -"structCENTERED6.html#ad80522d3ef86f7d5dc0173d50132d80e":[2,0,12,4], -"structCENTERED6.html#addc1b756f97d4883080045a187e4d433":[2,0,12,7], -"structCENTERED6.html#af5abc40fa48386ff2e8853265ab2f636":[2,0,12,2] +"structCENTERED6.html#a732a4a686c30a3233c939f453b74f0b9":[2,0,12,8] }; diff --git a/navtreeindex12.js b/navtreeindex12.js index 148d664da..217f05fea 100644 --- a/navtreeindex12.js +++ b/navtreeindex12.js @@ -1,5 +1,10 @@ var NAVTREEINDEX12 = { +"structCENTERED6.html#aacd79f8ed62a166d5f4d44a20d09fc13":[2,0,12,1], +"structCENTERED6.html#acedba4c2b029f363a47c32ad0c6f30e8":[2,0,12,0], +"structCENTERED6.html#ad80522d3ef86f7d5dc0173d50132d80e":[2,0,12,4], +"structCENTERED6.html#addc1b756f97d4883080045a187e4d433":[2,0,12,7], +"structCENTERED6.html#af5abc40fa48386ff2e8853265ab2f636":[2,0,12,2], "structDiffChoice.html":[2,0,16], "structDiffChoice.html#a4df179b6e7d84efc89a22ac5900f98c8":[2,0,16,7], "structDiffChoice.html#a553bdd290d667cca9699ed37f86f7e22":[2,0,16,8], @@ -244,10 +249,5 @@ var NAVTREEINDEX12 = "structSolverChoice.html#a1b2950247c4d2789597b7610c69ff5b6":[2,0,80,79], "structSolverChoice.html#a1bae456f7b26e8ed50d78ce1af1b5ef0":[2,0,80,46], "structSolverChoice.html#a1d9237205fd632dcde1599511f203131":[2,0,80,52], -"structSolverChoice.html#a238b0871f38f8b134ff3fe5af0d05479":[2,0,80,41], -"structSolverChoice.html#a29517ec608149342f25aa89f18204fac":[2,0,80,49], -"structSolverChoice.html#a2e1ef762ee1dc1bd3d4cbd08125c758a":[2,0,80,51], -"structSolverChoice.html#a31e016e3da7c175ac02427767286bc42":[2,0,80,4], -"structSolverChoice.html#a34c427126677860aa8acad633e6fb2be":[2,0,80,76], -"structSolverChoice.html#a3660145ad90d59b2a6693fd88bb01381":[2,0,80,69] +"structSolverChoice.html#a238b0871f38f8b134ff3fe5af0d05479":[2,0,80,41] }; diff --git a/navtreeindex13.js b/navtreeindex13.js index 08f3f18dd..76ec6e3e7 100644 --- a/navtreeindex13.js +++ b/navtreeindex13.js @@ -1,5 +1,10 @@ var NAVTREEINDEX13 = { +"structSolverChoice.html#a29517ec608149342f25aa89f18204fac":[2,0,80,49], +"structSolverChoice.html#a2e1ef762ee1dc1bd3d4cbd08125c758a":[2,0,80,51], +"structSolverChoice.html#a31e016e3da7c175ac02427767286bc42":[2,0,80,4], +"structSolverChoice.html#a34c427126677860aa8acad633e6fb2be":[2,0,80,76], +"structSolverChoice.html#a3660145ad90d59b2a6693fd88bb01381":[2,0,80,69], "structSolverChoice.html#a396122e87a3d15c4ec8666d7dd18c095":[2,0,80,25], "structSolverChoice.html#a39a214d3b761245913bc3f80e5bde880":[2,0,80,5], "structSolverChoice.html#a3ab48411073a3c1f75435292d7b407e5":[2,0,80,66], @@ -244,10 +249,5 @@ var NAVTREEINDEX13 = "structWENO__MZQ3.html#a8dcc9655166c1217b7056f244d4cfde2":[2,0,106,1], "structWENO__MZQ3.html#a97cfb78afa5c496fb3194141f284556c":[2,0,106,8], "structWENO__MZQ3.html#a9d80ce41fb8ce4487f97fe4448fcb131":[2,0,106,0], -"structWENO__MZQ3.html#ab9cb2f483989b377e7de79587d44c8c1":[2,0,106,3], -"structWENO__MZQ3.html#ad02f88cd05b6e31261fb3380887a2099":[2,0,106,5], -"structWENO__MZQ3.html#ad6c988889194e31f809b878a8b75390e":[2,0,106,6], -"structWENO__MZQ3.html#af1d30022fe1ebe59529f45843dff3ae5":[2,0,106,10], -"structWENO__Z3.html":[2,0,107], -"structWENO__Z3.html#a04370c4cf4d845f967ec610ff66f5d2b":[2,0,107,5] +"structWENO__MZQ3.html#ab9cb2f483989b377e7de79587d44c8c1":[2,0,106,3] }; diff --git a/navtreeindex14.js b/navtreeindex14.js index 28c658870..a38b094a3 100644 --- a/navtreeindex14.js +++ b/navtreeindex14.js @@ -1,5 +1,10 @@ var NAVTREEINDEX14 = { +"structWENO__MZQ3.html#ad02f88cd05b6e31261fb3380887a2099":[2,0,106,5], +"structWENO__MZQ3.html#ad6c988889194e31f809b878a8b75390e":[2,0,106,6], +"structWENO__MZQ3.html#af1d30022fe1ebe59529f45843dff3ae5":[2,0,106,10], +"structWENO__Z3.html":[2,0,107], +"structWENO__Z3.html#a04370c4cf4d845f967ec610ff66f5d2b":[2,0,107,5], "structWENO__Z3.html#a448d977459d12ff43f0a74da29e94014":[2,0,107,3], "structWENO__Z3.html#a70222f603b0f834b5c6cab9d2d500149":[2,0,107,2], "structWENO__Z3.html#a810a42fb5036957a15fd24569248f814":[2,0,107,0], @@ -244,9 +249,5 @@ var NAVTREEINDEX14 = "structsurface__temp__wave__coupled.html#a3715864e9c6bfdc6e4556925d0fc48fa":[2,0,91,5], "structsurface__temp__wave__coupled.html#a44d84ddefc6dc5572f1b1e614996b288":[2,0,91,3], "structsurface__temp__wave__coupled.html#a46050c5d081b11e873c0078b3e7b5e7b":[2,0,91,1], -"structsurface__temp__wave__coupled.html#abd39570dca269dda79fbb946df0a02ca":[2,0,91,7], -"structsurface__temp__wave__coupled.html#abf85e6ffabb9974a13bc03e6f7d11e96":[2,0,91,4], -"structsurface__temp__wave__coupled.html#aedbd53ee9bf7b4c98f5a2b88207cbb01":[2,0,91,8], -"structsurface__temp__wave__coupled.html#af09bca4efd34fd9d8b6bb6a2f363ebee":[2,0,91,6], -"structsurface__temp__wave__coupled.html#afb061b2c2b86edd4821efbcb70295412":[2,0,91,0] +"structsurface__temp__wave__coupled.html#abd39570dca269dda79fbb946df0a02ca":[2,0,91,7] }; diff --git a/navtreeindex15.js b/navtreeindex15.js new file mode 100644 index 000000000..712afa67e --- /dev/null +++ b/navtreeindex15.js @@ -0,0 +1,7 @@ +var NAVTREEINDEX15 = +{ +"structsurface__temp__wave__coupled.html#abf85e6ffabb9974a13bc03e6f7d11e96":[2,0,91,4], +"structsurface__temp__wave__coupled.html#aedbd53ee9bf7b4c98f5a2b88207cbb01":[2,0,91,8], +"structsurface__temp__wave__coupled.html#af09bca4efd34fd9d8b6bb6a2f363ebee":[2,0,91,6], +"structsurface__temp__wave__coupled.html#afb061b2c2b86edd4821efbcb70295412":[2,0,91,0] +}; diff --git a/navtreeindex5.js b/navtreeindex5.js index 7a85ce03f..20402e213 100644 --- a/navtreeindex5.js +++ b/navtreeindex5.js @@ -221,20 +221,21 @@ var NAVTREEINDEX5 = "classERFPhysBCFunct__w.html#ae949a3df422d9d5082146a46c9eca565":[2,0,29,1], "classERFPhysBCFunct__w.html#afcaa9deb9258f849737281efb4327694":[2,0,29,5], "classEWP.html":[2,0,31], -"classEWP.html#a00497b6ecc9493be40be6ce4f5ae02c5":[2,0,31,6], -"classEWP.html#a22f50393881ced019cae2a74ee04cdea":[2,0,31,10], -"classEWP.html#a2ee471b0dcad3057297b809f4c5141ab":[2,0,31,5], -"classEWP.html#a30275b7045b523cfe7afb5683f66d87a":[2,0,31,11], +"classEWP.html#a00497b6ecc9493be40be6ce4f5ae02c5":[2,0,31,7], +"classEWP.html#a22f50393881ced019cae2a74ee04cdea":[2,0,31,11], +"classEWP.html#a2ee471b0dcad3057297b809f4c5141ab":[2,0,31,6], +"classEWP.html#a30275b7045b523cfe7afb5683f66d87a":[2,0,31,12], "classEWP.html#a4c32d700e8ba91dfbc07c332ad91ca71":[2,0,31,0], -"classEWP.html#a4f28000173748f88919eda5fbed1368e":[2,0,31,3], +"classEWP.html#a4f28000173748f88919eda5fbed1368e":[2,0,31,4], "classEWP.html#a675a92a8d9c16748a95412e48bae2457":[2,0,31,2], -"classEWP.html#a71d81573a989603580abd5dc33d85619":[2,0,31,12], -"classEWP.html#a762189d5d9c02d32fa1e6186adb35ae0":[2,0,31,4], -"classEWP.html#a9cdc57dc5a1a63c4a4e62ba85dffecc4":[2,0,31,9], -"classEWP.html#ab9a34e54d36268a3f7a0b376543bbff5":[2,0,31,7], -"classEWP.html#ac89ee08eabbf2cc7a64a7908a449f016":[2,0,31,8], +"classEWP.html#a71d81573a989603580abd5dc33d85619":[2,0,31,13], +"classEWP.html#a762189d5d9c02d32fa1e6186adb35ae0":[2,0,31,5], +"classEWP.html#a9cdc57dc5a1a63c4a4e62ba85dffecc4":[2,0,31,10], +"classEWP.html#ab9a34e54d36268a3f7a0b376543bbff5":[2,0,31,8], +"classEWP.html#ac89ee08eabbf2cc7a64a7908a449f016":[2,0,31,9], "classEWP.html#ad500c0f4245245d407e31633ec7cecff":[2,0,31,1], -"classEWP.html#ad5aa60df138d71a40225791390e169e7":[2,0,31,13], +"classEWP.html#ad5aa60df138d71a40225791390e169e7":[2,0,31,14], +"classEWP.html#af9cd3be628c58fca164e35db4a559fd9":[2,0,31,3], "classEbertCurry.html":[2,0,22], "classEbertCurry.html#ab8edf44ffa6bd8f71ad9748b92928072":[2,0,22,2], "classEbertCurry.html#ae258a04b9aaba9ca0052793a2d57f05e":[2,0,22,0], @@ -248,6 +249,5 @@ var NAVTREEINDEX5 = "classEulerianMicrophysics.html#a3e973738b4e0bbaa7269ab2395322929":[2,0,30,8], "classEulerianMicrophysics.html#a416981f230a126387b9a664a5a241e9c":[2,0,30,5], "classEulerianMicrophysics.html#a444c916c5bb1167ea1efc9f2b9595436":[2,0,30,4], -"classEulerianMicrophysics.html#a6cc7efaa2f4f27f8a7f485fd96e5635b":[2,0,30,3], -"classEulerianMicrophysics.html#a6f0dc90119a228e56c5616267eba6009":[2,0,30,12] +"classEulerianMicrophysics.html#a6cc7efaa2f4f27f8a7f485fd96e5635b":[2,0,30,3] }; diff --git a/navtreeindex6.js b/navtreeindex6.js index 558d21fc8..620b8d20b 100644 --- a/navtreeindex6.js +++ b/navtreeindex6.js @@ -1,25 +1,28 @@ var NAVTREEINDEX6 = { +"classEulerianMicrophysics.html#a6f0dc90119a228e56c5616267eba6009":[2,0,30,12], "classEulerianMicrophysics.html#aa882ea75f222099b16b43a579d11e2c1":[2,0,30,10], "classEulerianMicrophysics.html#ac68028f2920ccb380c605099adb7d604":[2,0,30,9], "classEulerianMicrophysics.html#ad4983e19f621a55ad7d942c881215c72":[2,0,30,7], "classEulerianMicrophysics.html#af78c2f059431d49deec9f570ada4daaa":[2,0,30,0], "classF.html":[2,0,32], "classFitch.html":[2,0,33], -"classFitch.html#a1a2db68abb0185de73bd870884f0b019":[2,0,33,4], -"classFitch.html#a2626dfdc3df0f209b2bcf6a265575228":[2,0,33,13], +"classFitch.html#a1a2db68abb0185de73bd870884f0b019":[2,0,33,5], +"classFitch.html#a1edfa2cd3db9e6aa95130f24307ac623":[2,0,33,3], +"classFitch.html#a2626dfdc3df0f209b2bcf6a265575228":[2,0,33,15], "classFitch.html#a3682b755760d9e2543182ffbc0f3a618":[2,0,33,0], -"classFitch.html#a6ee3e00c1e1678e194aa6e6e27e8b7b5":[2,0,33,12], -"classFitch.html#a7cafd25264dba6194d42285153683f34":[2,0,33,9], -"classFitch.html#a88af1c4430e37f4950396b5a92e9ba03":[2,0,33,7], +"classFitch.html#a6ee3e00c1e1678e194aa6e6e27e8b7b5":[2,0,33,14], +"classFitch.html#a7cafd25264dba6194d42285153683f34":[2,0,33,11], +"classFitch.html#a88af1c4430e37f4950396b5a92e9ba03":[2,0,33,9], "classFitch.html#aa0af4287104d385bfcd5dc0c8fb5c68a":[2,0,33,2], -"classFitch.html#aa56821341be1cf4d01558e297993c0f2":[2,0,33,3], -"classFitch.html#aadaedef0e6f0ac149483ee6b4d8b1a4e":[2,0,33,8], -"classFitch.html#adc5df318361103709d0fa5421358e29d":[2,0,33,10], -"classFitch.html#ae3af34c6c07fd2d8b9b081b5c7ceb443":[2,0,33,5], -"classFitch.html#aed06c922f243b8a80c17d17770430af5":[2,0,33,11], +"classFitch.html#aa56821341be1cf4d01558e297993c0f2":[2,0,33,4], +"classFitch.html#aadaedef0e6f0ac149483ee6b4d8b1a4e":[2,0,33,10], +"classFitch.html#adc5df318361103709d0fa5421358e29d":[2,0,33,12], +"classFitch.html#ae3af34c6c07fd2d8b9b081b5c7ceb443":[2,0,33,6], +"classFitch.html#aed06c922f243b8a80c17d17770430af5":[2,0,33,13], +"classFitch.html#af01d3f69b4f952f91970964d2f498e61":[2,0,33,7], "classFitch.html#af9bc97ca62d0611ab2a300992ca8304d":[2,0,33,1], -"classFitch.html#afeb1ae13c307eeb71af9dfa8d97a3f7e":[2,0,33,6], +"classFitch.html#afeb1ae13c307eeb71af9dfa8d97a3f7e":[2,0,33,8], "classFlowerIF.html":[2,0,34], "classFlowerIF.html#a09721c1438c00c21d1babb121dc3d447":[2,0,34,7], "classFlowerIF.html#a13021976563f28b30e35c378d19a5d75":[2,0,34,6], @@ -45,36 +48,37 @@ var NAVTREEINDEX6 = "classForestDrag.html#adf4abd455b45d7a38422ffe2dc7b499f":[2,0,35,2], "classForestDrag.html#af1a72c6ce2a773a31ae0d6f84aa2aa71":[2,0,35,12], "classGeneralAD.html":[2,0,36], -"classGeneralAD.html#a0c19baa06277206decbdc1da57c02ea5":[2,0,36,27], -"classGeneralAD.html#a0db6baf8703517d3974b08ba7d854fc4":[2,0,36,9], -"classGeneralAD.html#a1a247dae534aad8b40e7780b3f296afe":[2,0,36,20], -"classGeneralAD.html#a2232a2f38c6bfd8102e38e383b10ea0b":[2,0,36,17], -"classGeneralAD.html#a2c22ccda2fdf9b29e4325c22b84bea2c":[2,0,36,5], -"classGeneralAD.html#a370786ec406f37da4fb54cc21745c1f3":[2,0,36,28], -"classGeneralAD.html#a45f8887ce8907918ceebf0a804eaffea":[2,0,36,23], -"classGeneralAD.html#a4a6d71d880f30aeb756885ac4e8d2b5b":[2,0,36,15], -"classGeneralAD.html#a5be79013be63b8105a01534ca186de32":[2,0,36,4], -"classGeneralAD.html#a5c234bf71184a01e624baf9f9247b3d5":[2,0,36,21], -"classGeneralAD.html#a5d98b31e348b25201d92055c16b6b6da":[2,0,36,26], -"classGeneralAD.html#a735e81390aef6a10e396bf4b7f1c7661":[2,0,36,6], -"classGeneralAD.html#a789afc5fc0d7b06f7dc79e6eb05a5760":[2,0,36,13], -"classGeneralAD.html#a7dd38f7dc025fcf192e502321ceddc3e":[2,0,36,12], +"classGeneralAD.html#a0c19baa06277206decbdc1da57c02ea5":[2,0,36,28], +"classGeneralAD.html#a0db6baf8703517d3974b08ba7d854fc4":[2,0,36,10], +"classGeneralAD.html#a1a247dae534aad8b40e7780b3f296afe":[2,0,36,21], +"classGeneralAD.html#a2232a2f38c6bfd8102e38e383b10ea0b":[2,0,36,18], +"classGeneralAD.html#a2c22ccda2fdf9b29e4325c22b84bea2c":[2,0,36,6], +"classGeneralAD.html#a370786ec406f37da4fb54cc21745c1f3":[2,0,36,29], +"classGeneralAD.html#a45f8887ce8907918ceebf0a804eaffea":[2,0,36,24], +"classGeneralAD.html#a4a6d71d880f30aeb756885ac4e8d2b5b":[2,0,36,16], +"classGeneralAD.html#a5be79013be63b8105a01534ca186de32":[2,0,36,5], +"classGeneralAD.html#a5c234bf71184a01e624baf9f9247b3d5":[2,0,36,22], +"classGeneralAD.html#a5d98b31e348b25201d92055c16b6b6da":[2,0,36,27], +"classGeneralAD.html#a735e81390aef6a10e396bf4b7f1c7661":[2,0,36,7], +"classGeneralAD.html#a789afc5fc0d7b06f7dc79e6eb05a5760":[2,0,36,14], +"classGeneralAD.html#a7dd38f7dc025fcf192e502321ceddc3e":[2,0,36,13], "classGeneralAD.html#a94e69e67c451652660642f85b48de07b":[2,0,36,0], "classGeneralAD.html#aa2727df24bc4d49692be1e4fae865806":[2,0,36,2], "classGeneralAD.html#aaa071c6bfd4e647404242328fd1b3643":[2,0,36,3], -"classGeneralAD.html#ab4b3db7ac8efd8610b63ee32349e234e":[2,0,36,10], -"classGeneralAD.html#abf37f6f4405fc016a3c6b9afda47b4ff":[2,0,36,11], +"classGeneralAD.html#ab4b3db7ac8efd8610b63ee32349e234e":[2,0,36,11], +"classGeneralAD.html#abf37f6f4405fc016a3c6b9afda47b4ff":[2,0,36,12], "classGeneralAD.html#ac44ff0908ec3c419196fb45efd0c7c13":[2,0,36,1], -"classGeneralAD.html#ac82bba9c2818ca1e77adb01fdcdcaf66":[2,0,36,18], -"classGeneralAD.html#acd1962338f30947c30f916121b8ca0e0":[2,0,36,16], -"classGeneralAD.html#ad5945bec35f72c63369436bf3edce069":[2,0,36,25], -"classGeneralAD.html#ad75081940389e9013c4ca501713883e1":[2,0,36,29], -"classGeneralAD.html#ad96abbb1f20b4ea0abf49d0fb88b289a":[2,0,36,24], -"classGeneralAD.html#ae82cceda872623720416dc9221693379":[2,0,36,14], -"classGeneralAD.html#ae95fc1dda876a138123f8eddce348d28":[2,0,36,7], -"classGeneralAD.html#aeb00654d82c5f266554bd8cba035d19b":[2,0,36,19], -"classGeneralAD.html#aeddf04c6e2386ba28aac00e2124c39a5":[2,0,36,22], -"classGeneralAD.html#af8542d68395d4daa200c5ea4e25514dc":[2,0,36,8], +"classGeneralAD.html#ac82bba9c2818ca1e77adb01fdcdcaf66":[2,0,36,19], +"classGeneralAD.html#acd1962338f30947c30f916121b8ca0e0":[2,0,36,17], +"classGeneralAD.html#ad5945bec35f72c63369436bf3edce069":[2,0,36,26], +"classGeneralAD.html#ad75081940389e9013c4ca501713883e1":[2,0,36,30], +"classGeneralAD.html#ad96abbb1f20b4ea0abf49d0fb88b289a":[2,0,36,25], +"classGeneralAD.html#ae82cceda872623720416dc9221693379":[2,0,36,15], +"classGeneralAD.html#ae95fc1dda876a138123f8eddce348d28":[2,0,36,8], +"classGeneralAD.html#aeb00654d82c5f266554bd8cba035d19b":[2,0,36,20], +"classGeneralAD.html#aeddf04c6e2386ba28aac00e2124c39a5":[2,0,36,23], +"classGeneralAD.html#af6b71032fe0417e12b9aefff0ba2066b":[2,0,36,4], +"classGeneralAD.html#af8542d68395d4daa200c5ea4e25514dc":[2,0,36,9], "classIntersectionCIF.html":[2,0,39], "classIntersectionCIF.html#a0b24d2c5c189c43b259c173c162aa1f1":[2,0,39,10], "classIntersectionCIF.html#a335f81a1bad5ad2693b59b62ba19ed6b":[2,0,39,5], @@ -245,9 +249,5 @@ var NAVTREEINDEX6 = "classMRISplitIntegrator.html":[2,0,52], "classMRISplitIntegrator.html#a088e107111ca012e026908b0c0b3cef7":[2,0,52,24], "classMRISplitIntegrator.html#a10fa09211f3b0a6b7357ab79dbadbb80":[2,0,52,37], -"classMRISplitIntegrator.html#a137a1ceb1e8051b5a97aaab40492c0e1":[2,0,52,18], -"classMRISplitIntegrator.html#a14fd551d7a7ff5bf6c58500740a64547":[2,0,52,10], -"classMRISplitIntegrator.html#a168352ef9fbddab9850fc5d1686d3e66":[2,0,52,35], -"classMRISplitIntegrator.html#a216903aa134536df210f489acdfd2b8b":[2,0,52,14], -"classMRISplitIntegrator.html#a26955c190dfb0d6cef7237198dbfd099":[2,0,52,16] +"classMRISplitIntegrator.html#a137a1ceb1e8051b5a97aaab40492c0e1":[2,0,52,18] }; diff --git a/navtreeindex7.js b/navtreeindex7.js index abf549395..dc52c065d 100644 --- a/navtreeindex7.js +++ b/navtreeindex7.js @@ -1,5 +1,9 @@ var NAVTREEINDEX7 = { +"classMRISplitIntegrator.html#a14fd551d7a7ff5bf6c58500740a64547":[2,0,52,10], +"classMRISplitIntegrator.html#a168352ef9fbddab9850fc5d1686d3e66":[2,0,52,35], +"classMRISplitIntegrator.html#a216903aa134536df210f489acdfd2b8b":[2,0,52,14], +"classMRISplitIntegrator.html#a26955c190dfb0d6cef7237198dbfd099":[2,0,52,16], "classMRISplitIntegrator.html#a277f590efb755921c145d09f84e740af":[2,0,52,23], "classMRISplitIntegrator.html#a294f18465629a72da152b3e9aa4b0455":[2,0,52,21], "classMRISplitIntegrator.html#a3f21bedf222ce95136d4889012401612":[2,0,52,38], @@ -245,9 +249,5 @@ var NAVTREEINDEX7 = "classNullWindFarm.html#ac88481b8d5d1cf63fabe89edee9cc8cd":[2,0,61,5], "classNullWindFarm.html#ac8ff132b0d2d52032ec19344ec6a74c6":[2,0,61,35], "classNullWindFarm.html#acbc82ecabc6211a7d2070f24a805fbc9":[2,0,61,20], -"classNullWindFarm.html#ad19bb9c4842c561c0024ae6d686b1a78":[2,0,61,29], -"classNullWindFarm.html#ad337a725edf9efdaf1fd4a49ddd35505":[2,0,61,19], -"classNullWindFarm.html#ad3f68562d1b6b5a224644e283f8a146d":[2,0,61,12], -"classNullWindFarm.html#ad403f4133b2292495e5dd949fcc59207":[2,0,61,25], -"classNullWindFarm.html#ade1a0b0eacbb79784db4c49cd8b1bae2":[2,0,61,15] +"classNullWindFarm.html#ad19bb9c4842c561c0024ae6d686b1a78":[2,0,61,29] }; diff --git a/navtreeindex8.js b/navtreeindex8.js index f6ab9a790..b2374fc8e 100644 --- a/navtreeindex8.js +++ b/navtreeindex8.js @@ -1,5 +1,9 @@ var NAVTREEINDEX8 = { +"classNullWindFarm.html#ad337a725edf9efdaf1fd4a49ddd35505":[2,0,61,19], +"classNullWindFarm.html#ad3f68562d1b6b5a224644e283f8a146d":[2,0,61,12], +"classNullWindFarm.html#ad403f4133b2292495e5dd949fcc59207":[2,0,61,25], +"classNullWindFarm.html#ade1a0b0eacbb79784db4c49cd8b1bae2":[2,0,61,15], "classNullWindFarm.html#ae4797e5a94227d10ed3b39dfd7bf4444":[2,0,61,0], "classNullWindFarm.html#af31330323768a6cc38c99205d987b558":[2,0,61,10], "classNullWindFarm.html#af83e2833c70c7374fa00ec94755e8038":[2,0,61,33], @@ -245,9 +249,5 @@ var NAVTREEINDEX8 = "classRadiation.html#a889a5f62e829af86690ece49bf2f9c6e":[2,0,69,29], "classRadiation.html#a89625b089dbe4acbc85a7241fcbd3839":[2,0,69,97], "classRadiation.html#a8a48736892a600948ffa42c9d1b38700":[2,0,69,63], -"classRadiation.html#a8ac40edc77ac51d941c954c15bb9dbf5":[2,0,69,130], -"classRadiation.html#a8b27a952d1ceb83c174a5d30f6198230":[2,0,69,122], -"classRadiation.html#a8c411f9344910aab58b29c4a3bcab401":[2,0,69,52], -"classRadiation.html#a8ddade9e3b5ad13008fb253d2e7c17a4":[2,0,69,30], -"classRadiation.html#a8ed843e3e2bb03d388b0c3ab869b1dba":[2,0,69,128] +"classRadiation.html#a8ac40edc77ac51d941c954c15bb9dbf5":[2,0,69,130] }; diff --git a/navtreeindex9.js b/navtreeindex9.js index 65a2a60db..ec7e4e1bf 100644 --- a/navtreeindex9.js +++ b/navtreeindex9.js @@ -1,5 +1,9 @@ var NAVTREEINDEX9 = { +"classRadiation.html#a8b27a952d1ceb83c174a5d30f6198230":[2,0,69,122], +"classRadiation.html#a8c411f9344910aab58b29c4a3bcab401":[2,0,69,52], +"classRadiation.html#a8ddade9e3b5ad13008fb253d2e7c17a4":[2,0,69,30], +"classRadiation.html#a8ed843e3e2bb03d388b0c3ab869b1dba":[2,0,69,128], "classRadiation.html#a8f47b85f948822c0e450beddb92373f4":[2,0,69,92], "classRadiation.html#a913e1b4a5c5ddf093f81c6a6c7051035":[2,0,69,107], "classRadiation.html#a95d771d1d4157cb2640e6657b1af9937":[2,0,69,117], @@ -245,9 +249,5 @@ var NAVTREEINDEX9 = "classSatMethods.html#a9e929b8ac05dbeaa78dc158159f84758":[2,0,75,2], "classSatMethods.html#aac1daa9a38464e217df80a4f9613bcb3":[2,0,75,5], "classSatMethods.html#ac2fa5e55257c6021e9e7fd897f4950b7":[2,0,75,13], -"classSatMethods.html#add2fde8076c60c19ed9f4f78c9891e0e":[2,0,75,11], -"classSimpleAD.html":[2,0,77], -"classSimpleAD.html#a04490ef9f591e86588c5bb7870c1b77f":[2,0,77,13], -"classSimpleAD.html#a0d915eaf360210453a081a2b721d0fa0":[2,0,77,14], -"classSimpleAD.html#a1320fd9378b5802905f2a101a81b8067":[2,0,77,3] +"classSatMethods.html#add2fde8076c60c19ed9f4f78c9891e0e":[2,0,75,11] }; diff --git a/search/all_12.js b/search/all_12.js index 7225403ac..9664e5d9c 100644 --- a/search/all_12.js +++ b/search/all_12.js @@ -12,10 +12,10 @@ var searchData= ['sampleline_2111',['SampleLine',['../classERF.html#a54357e2f81f3d7d3a9189a3e21283e6b',1,'ERF']]], ['samplelinelog_2112',['SampleLineLog',['../classERF.html#aa559426d0435e669b04148c58b20caef',1,'ERF']]], ['samplelinelog_2113',['samplelinelog',['../classERF.html#a4990f1796b65ec8ee602f177a66afc3e',1,'ERF']]], - ['samplelinelogname_2114',['samplelinelogname',['../classERF.html#a0553967f1131860bb8ecb47c0f192eaa',1,'ERF']]], - ['samplelinelogname_2115',['SampleLineLogName',['../classERF.html#a59eae161173111d66e88dc3acc65b552',1,'ERF']]], - ['samplepoint_2116',['SamplePoint',['../classERF.html#a9095d1b641b4d7f32ca5acb679786891',1,'ERF']]], - ['samplepoint_2117',['samplepoint',['../classERF.html#ae8a57b7fbf5a67c99d04b7d4f43ad100',1,'ERF']]], + ['samplelinelogname_2114',['SampleLineLogName',['../classERF.html#a59eae161173111d66e88dc3acc65b552',1,'ERF']]], + ['samplelinelogname_2115',['samplelinelogname',['../classERF.html#a0553967f1131860bb8ecb47c0f192eaa',1,'ERF']]], + ['samplepoint_2116',['samplepoint',['../classERF.html#ae8a57b7fbf5a67c99d04b7d4f43ad100',1,'ERF']]], + ['samplepoint_2117',['SamplePoint',['../classERF.html#a9095d1b641b4d7f32ca5acb679786891',1,'ERF']]], ['samplepointlog_2118',['SamplePointLog',['../classERF.html#af5f6c32cc5463e52901f21117d3156c7',1,'ERF']]], ['samplepointlogname_2119',['SamplePointLogName',['../classERF.html#aa87242f053bfae4efb2a7698ef417ab9',1,'ERF']]], ['sampleptlog_2120',['sampleptlog',['../classERF.html#a9737ddb0de6b9e8a5b17c109d5ad3e08',1,'ERF']]], diff --git a/search/all_2.js b/search/all_2.js index 75fc4380b..a65f555ac 100644 --- a/search/all_2.js +++ b/search/all_2.js @@ -1,201 +1,200 @@ var searchData= [ - ['c1_195',['c1',['../structWENO5.html#a3acb5e8bde92b17f3eefb2a0cc3dad2e',1,'WENO5::c1()'],['../structWENO__Z5.html#aaef4d108f7f40585ead5bdb4d8ba5c67',1,'WENO_Z5::c1()']]], - ['c1_196',['C1',['../structMYNNLevel25.html#a56b79a6d80bf23bedd64223516746ae7',1,'MYNNLevel25']]], + ['c1_195',['C1',['../structMYNNLevel25.html#a56b79a6d80bf23bedd64223516746ae7',1,'MYNNLevel25']]], + ['c1_196',['c1',['../structWENO5.html#a3acb5e8bde92b17f3eefb2a0cc3dad2e',1,'WENO5::c1()'],['../structWENO__Z5.html#aaef4d108f7f40585ead5bdb4d8ba5c67',1,'WENO_Z5::c1()']]], ['c2_197',['C2',['../structMYNNLevel25.html#a6d0246567e40d4625f019983bb1ed8e8',1,'MYNNLevel25']]], ['c3_198',['C3',['../structMYNNLevel25.html#a6b42dbf8b3f6a136e5d7a1517fa24119',1,'MYNNLevel25']]], ['c4_199',['C4',['../structMYNNLevel25.html#a55fad52b96bc4c5d909e1cc4332c54ad',1,'MYNNLevel25']]], ['c5_200',['C5',['../structMYNNLevel25.html#abccb8d9a56c593f5f75ce7f6a170a3be',1,'MYNNLevel25']]], - ['c_5fp_201',['C_P',['../classGeneralAD.html#a789afc5fc0d7b06f7dc79e6eb05a5760',1,'GeneralAD']]], - ['c_5fp_202',['c_p',['../structSolverChoice.html#a43d16f0628ba5fbe64a813de7f25f56a',1,'SolverChoice']]], - ['c_5fp_203',['C_P',['../classWindFarm.html#a63c20a3eac21bceea0ae4bfbe4c9acac',1,'WindFarm']]], - ['c_5ft_204',['C_T',['../classGeneralAD.html#ae82cceda872623720416dc9221693379',1,'GeneralAD::C_T()'],['../classWindFarm.html#a87e2fe5c89e49801a70f6acf9836e1e1',1,'WindFarm::C_T()']]], - ['calc_5ffifth_5forder_5fderiv_205',['calc_fifth_order_deriv',['../ERF__NumericalDiffusion_8H.html#a2985fd8720853d6b8c663c68744dbd97',1,'ERF_NumericalDiffusion.H']]], - ['calc_5fhltalt_206',['calc_hltalt',['../classWaterVaporSat.html#a6e0a9f07f0f59514f56536e44025e980',1,'WaterVaporSat']]], - ['calc_5fpsi_5fh_207',['calc_psi_h',['../structsimilarity__funs.html#a7dcb32f637eab66d2314902d03289bc2',1,'similarity_funs']]], - ['calc_5fpsi_5fm_208',['calc_psi_m',['../structsimilarity__funs.html#a21cb206b0dd78dc2ac7211de8dbcb8d2',1,'similarity_funs']]], - ['calc_5frf_209',['calc_Rf',['../structMYNNLevel2.html#a2970f316de64a2a1c605baaea1f34aec',1,'MYNNLevel2']]], - ['calc_5frho_5fp_210',['calc_rho_p',['../structInputSoundingData.html#a830608de7ca272770d8ddb659d65eb31',1,'InputSoundingData']]], - ['calc_5fsh_211',['calc_SH',['../structMYNNLevel2.html#a75e52da99ede6eb7b361e3ae12c08b1e',1,'MYNNLevel2']]], - ['calc_5fsm_212',['calc_SM',['../structMYNNLevel2.html#a5e7e202941dd61d8aa7f3367031c9b8f',1,'MYNNLevel2']]], - ['calc_5fstability_5ffuncs_213',['calc_stability_funcs',['../structMYNNLevel25.html#a15e53c3496f45cad7a7f794b86b31e9b',1,'MYNNLevel25']]], - ['calc_5ftpi_5famp_214',['calc_tpi_amp',['../structTurbulentPerturbation.html#a6690a1ccf037f5cf892e72724c21b3a5',1,'TurbulentPerturbation']]], - ['calc_5ftpi_5fmeanmag_5fperbox_215',['calc_tpi_meanMag_perBox',['../structTurbulentPerturbation.html#ac2f49dd6a95ab0bb291fa4977d9682e5',1,'TurbulentPerturbation']]], - ['calc_5ftpi_5fupdate_216',['calc_tpi_update',['../structTurbulentPerturbation.html#a5e6200f8b6bea3c4944dccc6c7285102',1,'TurbulentPerturbation']]], - ['calc_5fwstar_217',['calc_wstar',['../ERF__Wstar_8H.html#ae4dec2546738e08263cd23690c9028fe',1,'calc_wstar(const amrex::Real &hfx, const amrex::Real &pblh, const amrex::Real &thv): ERF_Wstar.H'],['../ERF__Wstar_8H.html#a07708294fc196cae6c560e47360c6600',1,'calc_wstar(const amrex::Real &ust, const amrex::Real &tst, const amrex::Real &qst, const amrex::Real &pblh, const amrex::Real &th, const amrex::Real &thv, const amrex::Real &qv=0.0): ERF_Wstar.H']]], - ['calculate_5fheating_5frate_218',['calculate_heating_rate',['../classRadiation.html#ad37acecc5f023e2da167f49e09247233',1,'Radiation']]], - ['camname_219',['camname',['../structMamConstituents_1_1aerosol__t.html#a23e50740903b1b826352cd7486c69913',1,'MamConstituents::aerosol_t::camname()'],['../structMamConstituents_1_1gas__t.html#ab996ee58a5c7dc033d07938d487e79f3',1,'MamConstituents::gas_t::camname()']]], - ['camname_5fmmr_5fa_220',['camname_mmr_a',['../structMamConstituents_1_1mode__component__t.html#a3adfcd2619c7f477e8ecd6529d8f98b6',1,'MamConstituents::mode_component_t']]], - ['camname_5fmmr_5fc_221',['camname_mmr_c',['../structMamConstituents_1_1mode__component__t.html#aab0b2aef67ab3544af7fb0ecf2930415',1,'MamConstituents::mode_component_t']]], - ['camname_5fnum_5fa_222',['camname_num_a',['../structMamConstituents_1_1mode__component__t.html#a5a1aa28df874b8cb28f19e730b36f037',1,'MamConstituents::mode_component_t']]], - ['camname_5fnum_5fc_223',['camname_num_c',['../structMamConstituents_1_1mode__component__t.html#a6f588bac515da5d63593bb61df75e432',1,'MamConstituents::mode_component_t']]], - ['ce_224',['Ce',['../structTurbChoice.html#ab6d0ae39e92dcbe7362abf53364c1a8e',1,'TurbChoice']]], - ['ce_5fwall_225',['Ce_wall',['../structTurbChoice.html#ab2d1ecb36171ca19ea851e8e682a1478',1,'TurbChoice']]], - ['centered2_226',['CENTERED2',['../structCENTERED2.html#a09644816e71e1ade052d277199a8d785',1,'CENTERED2::CENTERED2()'],['../structCENTERED2.html',1,'CENTERED2']]], - ['centered4_227',['CENTERED4',['../structCENTERED4.html',1,'CENTERED4'],['../structCENTERED4.html#a36a14bbf9f418feee5e1af3685e1b4fb',1,'CENTERED4::CENTERED4()']]], - ['centered6_228',['CENTERED6',['../structCENTERED6.html#acedba4c2b029f363a47c32ad0c6f30e8',1,'CENTERED6::CENTERED6()'],['../structCENTERED6.html',1,'CENTERED6']]], - ['centered_5f2nd_229',['Centered_2nd',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70ada570868919bafaab1776170229a7049',1,'ERF_IndexDefines.H']]], - ['centered_5f4th_230',['Centered_4th',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a778e0ed47937713eb1c4bedef6b00161',1,'ERF_IndexDefines.H']]], - ['centered_5f6th_231',['Centered_6th',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a8c9475eb6bfde28e5bcb5230ac2e22a9',1,'ERF_IndexDefines.H']]], - ['centimeter_232',['centimeter',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1a135cc2d02c99a9ca6a6413cacea93664',1,'RadConstants']]], - ['cf_5fset_5fwidth_233',['cf_set_width',['../classERF.html#a1e3e2855b6e811596226c167573ad62d',1,'ERF']]], - ['cf_5fwidth_234',['cf_width',['../classERF.html#ad9084179f7384e10a519989ffd51fd34',1,'ERF']]], - ['cfl_235',['cfl',['../classERF.html#a89f605d1a1eae06a7c79f9b6b65c637f',1,'ERF']]], - ['cfl_5fmax_236',['CFL_MAX',['../classSAM.html#ab22f37f1f2b5d72ee2d20af56a29fc40',1,'SAM::CFL_MAX()'],['../classKessler.html#ab65a6b7181e08edaa8de14ea26bb8d62',1,'Kessler::CFL_MAX()']]], - ['cgrau_237',['cgrau',['../ERF__Constants_8H.html#a22bb5d96152ac76ffe39d98d67b2b07a',1,'ERF_Constants.H']]], - ['change_5fmax_238',['change_max',['../classERF.html#ae16d413b172bb3b3400af6d5cb236fd4',1,'ERF']]], - ['charnock_239',['CHARNOCK',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13addbb8213265f3ad773f7af2cb8147062',1,'ABLMost']]], - ['check_5ffile_240',['check_file',['../classERF.html#ae701564fbe3da5bbd88587e5a08eca4e',1,'ERF']]], - ['check_5fparams_241',['check_params',['../structSolverChoice.html#a4c875e5fe0f3dd69fbcc145b7066c766',1,'SolverChoice']]], - ['check_5ftype_242',['check_type',['../classERF.html#a32e0d0f5ae0db18ee81f9d4325a14f64',1,'ERF']]], - ['chen2021_243',['CHEN2021',['../ERF__MYNNStruct_8H.html#a103de8b695a78549c43fa852d9c4dd25abe8de8e777a612742c642b372ab3dc9e',1,'ERF_MYNNStruct.H']]], - ['chopgrids2d_244',['ChopGrids2D',['../ERF__ChopGrids_8cpp.html#a6fe49eeaa200ab6ab8ae0a6e048f3ded',1,'ChopGrids2D(BoxArray &ba, const Box &domain, int target_size): ERF_ChopGrids.cpp'],['../ERF__Utils_8H.html#ae73f998519cf6628e7c4a90cea4cb4f5',1,'ChopGrids2D(amrex::BoxArray &ba, const amrex::Box &domain, int target_size): ERF_Utils.H']]], - ['ci_245',['CI',['../structTurbChoice.html#afbf3b28d53a35977d4ff77e6928122c0',1,'TurbChoice']]], - ['cif_246',['CIF',['../classCIF.html',1,'CIF< F >'],['../classCIF.html#aeb3766fcdd40058f9116d815743381c9',1,'CIF::CIF(CIF &&rhs) noexcept=default'],['../classCIF.html#aeda8119c592d6acaf71927b7d8fe3887',1,'CIF::CIF(const CIF &rhs)=default'],['../classCIF.html#a0e65a3004e88fe6f772690a89a87256f',1,'CIF::CIF(F &&f, bool a_active)']]], - ['ck_247',['Ck',['../structTurbChoice.html#a61ff7dc6ee4001ae8f2978efd5ff57e4',1,'TurbChoice']]], - ['cld_248',['cld',['../classRadiation.html#a889a5f62e829af86690ece49bf2f9c6e',1,'Radiation']]], - ['cld_5fasm_5fbnd_5fsw_249',['cld_asm_bnd_sw',['../classRadiation.html#a8ddade9e3b5ad13008fb253d2e7c17a4',1,'Radiation']]], - ['cld_5fasm_5fbnd_5fsw_5f1d_250',['cld_asm_bnd_sw_1d',['../classRadiation.html#aff0446369d923ec1ba5b20e6b257d52d',1,'Radiation']]], - ['cld_5fasm_5fbnd_5fsw_5fo_5f1d_251',['cld_asm_bnd_sw_o_1d',['../classRadiation.html#a4b3eed1432c08adcac97160424dafc79',1,'Radiation']]], - ['cld_5fasm_5fgpt_5fsw_252',['cld_asm_gpt_sw',['../classRadiation.html#a8718e64a2e3ba0aa52e12bcac9dcb202',1,'Radiation']]], - ['cld_5fssa_5fbnd_5fsw_253',['cld_ssa_bnd_sw',['../classRadiation.html#af35ffb83d032a581c45673e2627f8bb5',1,'Radiation']]], - ['cld_5fssa_5fbnd_5fsw_5f1d_254',['cld_ssa_bnd_sw_1d',['../classRadiation.html#ad13553538dacaf76d38eacf804a13276',1,'Radiation']]], - ['cld_5fssa_5fbnd_5fsw_5fo_5f1d_255',['cld_ssa_bnd_sw_o_1d',['../classRadiation.html#ad139630194e6035320fe89c828287912',1,'Radiation']]], - ['cld_5fssa_5fgpt_5fsw_256',['cld_ssa_gpt_sw',['../classRadiation.html#a23309b232cd21359d1ffd8832acd4e09',1,'Radiation']]], - ['cld_5ftau_5fbnd_5flw_257',['cld_tau_bnd_lw',['../classRadiation.html#a6f6042a4b1744a110d7955c6d0d8d08c',1,'Radiation']]], - ['cld_5ftau_5fbnd_5fsw_258',['cld_tau_bnd_sw',['../classRadiation.html#aeae6687bdc7bfc93f2e7ff079fbb3244',1,'Radiation']]], - ['cld_5ftau_5fbnd_5fsw_5f1d_259',['cld_tau_bnd_sw_1d',['../classRadiation.html#a6ffc09147dd502ea1b9ef005da70fa2d',1,'Radiation']]], - ['cld_5ftau_5fbnd_5fsw_5fo_5f1d_260',['cld_tau_bnd_sw_o_1d',['../classRadiation.html#a4b65612bc60bb15b9e89971e5bed81b8',1,'Radiation']]], - ['cld_5ftau_5fgpt_5flw_261',['cld_tau_gpt_lw',['../classRadiation.html#a038b9faf1daea703e3f7d82f0e889b05',1,'Radiation']]], - ['cld_5ftau_5fgpt_5fsw_262',['cld_tau_gpt_sw',['../classRadiation.html#abbe4431f5c94243dd57fa8adb55d05e6',1,'Radiation']]], - ['cldfsnow_263',['cldfsnow',['../classRadiation.html#ae535dbfdb6158094e4182ea1b660e7cc',1,'Radiation']]], - ['clear_264',['clear',['../structTimeInterpolatedData.html#a68d1abba77684ee584ba484a185a44e2',1,'TimeInterpolatedData']]], - ['clear_5frh_265',['clear_rh',['../classRadiation.html#a04fcc2194ca5c8df13d384ae567aa3c7',1,'Radiation']]], - ['clearlevel_266',['ClearLevel',['../classERF.html#ac44e400a7ce68e18fa44e9416cb1344e',1,'ERF']]], - ['clim_5fmodal_5faero_267',['clim_modal_aero',['../classMam4__aer.html#a83c2a65a851a3329d62fca09dd0263d5',1,'Mam4_aer']]], - ['close_268',['close',['../classncutils_1_1NCFile.html#af2c4a20c38edb3fae69087a80875b8b9',1,'ncutils::NCFile']]], - ['closest_5findex_269',['closest_index',['../ERF__ReadBndryPlanes_8cpp.html#adc5227730afe35653b2dfa88898eb00a',1,'ERF_ReadBndryPlanes.cpp']]], - ['cloud_270',['Cloud',['../classSAM.html#a48d25f57da2ba1d7ddb503ede0b8d998',1,'SAM']]], - ['cloud_5ffraction_271',['cloud_fraction',['../classERF.html#a0f6effb7eeed11385b20e4bbf516b459',1,'ERF']]], - ['cloud_5foptics_272',['cloud_optics',['../classOptics.html#a90c700e69b63c61c6275b12c63033334',1,'Optics']]], - ['cloudradprops_273',['CloudRadProps',['../classCloudRadProps.html',1,'CloudRadProps'],['../classCloudRadProps.html#aade37d67dde6092189402829442285d4',1,'CloudRadProps::CloudRadProps()']]], - ['cmd_274',['cmd',['../classMultiBlockContainer.html#ac2e558406e28ee31351eb60c7465d0ad',1,'MultiBlockContainer']]], - ['cnk_5fa_275',['Cnk_a',['../structmost__data.html#a83c3a7004441c335b630dd2d6973f518',1,'most_data']]], - ['cnk_5fa_276',['cnk_a',['../classABLMost.html#a75310e9079ee238a932900feaad85ac5',1,'ABLMost']]], - ['cnk_5fb_277',['Cnk_b',['../structmost__data.html#a51b78fb4a4b8fb6aa512d4bd4fcd3cd7',1,'most_data']]], - ['cnk_5fb1_278',['Cnk_b1',['../structmost__data.html#acfac0135facabddbdd699609bac908e4',1,'most_data']]], - ['cnk_5fb2_279',['Cnk_b2',['../structmost__data.html#a4488059550159398fd2cddaf4d37f31b',1,'most_data']]], - ['cnk_5fd_280',['Cnk_d',['../structmost__data.html#a73b1c119aa9b4bcaac98753a4fde9e86',1,'most_data']]], - ['cnk_5fvisc_281',['cnk_visc',['../classABLMost.html#a4f97d1d8c347710155ead2c1310338a0',1,'ABLMost']]], - ['coare3_5froughness_282',['COARE3_roughness',['../ERF__MOSTRoughness_8H.html#a9fb5194b85e904a3f0a0500a05438b5e',1,'ERF_MOSTRoughness.H']]], - ['coefficients_5ffile_5flw_283',['coefficients_file_lw',['../classRrtmgp.html#a02493ce8d504b6a4d4a9a5cfec8d44f5',1,'Rrtmgp']]], - ['coefficients_5ffile_5fsw_284',['coefficients_file_sw',['../classRrtmgp.html#a5fa9f64db9791a7f152055f484113714',1,'Rrtmgp']]], - ['coefice_285',['coefice',['../classSAM.html#aad8c4616221c01599e4e32f2ebb08698',1,'SAM']]], - ['column_5ffile_5fname_286',['column_file_name',['../classERF.html#a48bba6b1c1b39940b09aefbe56311e2f',1,'ERF']]], - ['column_5finterval_287',['column_interval',['../classERF.html#afa0bef6d3146788302b81c0d4f4802d1',1,'ERF']]], - ['column_5floc_5fx_288',['column_loc_x',['../classERF.html#a930b7d48218b3fc41d8719b50b3f6086',1,'ERF']]], - ['column_5floc_5fy_289',['column_loc_y',['../classERF.html#a2b911f3a5a324813b1ff4462df6044a6',1,'ERF']]], - ['column_5fper_290',['column_per',['../classERF.html#a7b0175190c6fcf829c7f2841f729b12a',1,'ERF']]], - ['combine_5fproperties_291',['combine_properties',['../classOptics.html#a6cbf46804754b07ab0ccf03e6db25207',1,'Optics']]], - ['comps_292',['comps',['../structMamConstituents_1_1modes__t.html#a51263b4f4e52ec4e2068e775d7f5f1f4',1,'MamConstituents::modes_t']]], - ['compute_5fa_293',['compute_A',['../ERF__AdvanceFitch_8cpp.html#a7b6c67da0ff16af60b10f434632b06ce',1,'ERF_AdvanceFitch.cpp']]], - ['compute_5faijk_294',['compute_Aijk',['../ERF__AdvanceFitch_8cpp.html#a68e0a40af0744df9f7e79d181225f615',1,'ERF_AdvanceFitch.cpp']]], - ['compute_5faverages_295',['compute_averages',['../classMOSTAverage.html#a7a28005871bb8abb49f44c3976133a4f',1,'MOSTAverage::compute_averages()'],['../classPlaneAverage.html#a603aee4caf3a370d06bee77fddb0e33e',1,'PlaneAverage::compute_averages(const IndexSelector &idxOp, const amrex::MultiFab &mfab)'],['../classPlaneAverage.html#a0b4bb610551a2f07eb05b8e8b7d91820',1,'PlaneAverage::compute_averages(const IndexSelector &idxOp, const amrex::MultiFab &mfab)']]], - ['compute_5fcoefficients_296',['Compute_Coefficients',['../classSAM.html#a77dd99de0896cf9f9bf8299c2c80bc40',1,'SAM']]], - ['compute_5fdivergence_297',['compute_divergence',['../classERF.html#a4aaad0c261cb89d575d46083a509dbb9',1,'ERF']]], - ['compute_5ffluxes_298',['compute_fluxes',['../classABLMost.html#a829339fc8e70a5dff8b7c85f3c2e4138',1,'ABLMost']]], - ['compute_5ffreestream_5fvelocity_299',['compute_freestream_velocity',['../classGeneralAD.html#aaa071c6bfd4e647404242328fd1b3643',1,'GeneralAD::compute_freestream_velocity()'],['../classSimpleAD.html#a1320fd9378b5802905f2a101a81b8067',1,'SimpleAD::compute_freestream_velocity()']]], - ['compute_5fh_5feta_5fatcellcenter_300',['Compute_h_eta_AtCellCenter',['../ERF__TerrainMetrics_8H.html#a43b431cbd97421014ff80245883e06d2',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5feta_5fatedgecenteri_301',['Compute_h_eta_AtEdgeCenterI',['../ERF__TerrainMetrics_8H.html#aed973861215c4eb0697f7a83b37016a9',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5feta_5fatedgecenterj_302',['Compute_h_eta_AtEdgeCenterJ',['../ERF__TerrainMetrics_8H.html#a0251c09947155307e047f79fccdbd463',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5feta_5fatedgecenterk_303',['Compute_h_eta_AtEdgeCenterK',['../ERF__TerrainMetrics_8H.html#ac1434a53d9966d992133433473bc629a',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5feta_5fatiface_304',['Compute_h_eta_AtIface',['../ERF__TerrainMetrics_8H.html#ad06b0ae003cb3d59227ce85a5fa8a669',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5feta_5fatjface_305',['Compute_h_eta_AtJface',['../ERF__TerrainMetrics_8H.html#ae609a5c1f84347b66e9a8b712271c4ce',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5feta_5fatkface_306',['Compute_h_eta_AtKface',['../ERF__TerrainMetrics_8H.html#af2b7bda0da3e8024e9b02b6d69c366fe',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fxi_5fatcellcenter_307',['Compute_h_xi_AtCellCenter',['../ERF__TerrainMetrics_8H.html#ada44020dc4ec27c5bebf8fd82d336cee',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fxi_5fatedgecenteri_308',['Compute_h_xi_AtEdgeCenterI',['../ERF__TerrainMetrics_8H.html#ad56aa9e0cc7428ea33d4ac90d91c1f56',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fxi_5fatedgecenterj_309',['Compute_h_xi_AtEdgeCenterJ',['../ERF__TerrainMetrics_8H.html#a1582797e6ac6cf0c1e0b94a619bc13b8',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fxi_5fatedgecenterk_310',['Compute_h_xi_AtEdgeCenterK',['../ERF__TerrainMetrics_8H.html#a07e83bf0f142a953679c9edfa42b398d',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fxi_5fatiface_311',['Compute_h_xi_AtIface',['../ERF__TerrainMetrics_8H.html#a2116df83b61a39fb50b9a2d7474c00d7',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fxi_5fatjface_312',['Compute_h_xi_AtJface',['../ERF__TerrainMetrics_8H.html#a9ec5ec17f16954e56733db6dd98fe07d',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fxi_5fatkface_313',['Compute_h_xi_AtKface',['../ERF__TerrainMetrics_8H.html#aba0de207695f9674a9e0678a19f22677',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fzeta_5fatcellcenter_314',['Compute_h_zeta_AtCellCenter',['../ERF__TerrainMetrics_8H.html#a32eeeb066c70da970aa6a60918515987',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fzeta_5fatedgecenteri_315',['Compute_h_zeta_AtEdgeCenterI',['../ERF__TerrainMetrics_8H.html#a3e3ceccddeb3cca9d9e4573af2311a5e',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fzeta_5fatedgecenterj_316',['Compute_h_zeta_AtEdgeCenterJ',['../ERF__TerrainMetrics_8H.html#a21aac76e0b284b33e302526e1f292c76',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fzeta_5fatedgecenterk_317',['Compute_h_zeta_AtEdgeCenterK',['../ERF__TerrainMetrics_8H.html#a2b9e684355ee8d6dad22950c8c51716b',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fzeta_5fatiface_318',['Compute_h_zeta_AtIface',['../ERF__TerrainMetrics_8H.html#a8d96671d41364f1e24391375a2bc0f1e',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fzeta_5fatjface_319',['Compute_h_zeta_AtJface',['../ERF__TerrainMetrics_8H.html#ada12bcb6beb3fa0d00dbdacb37f3c60f',1,'ERF_TerrainMetrics.H']]], - ['compute_5fh_5fzeta_5fatkface_320',['Compute_h_zeta_AtKface',['../ERF__TerrainMetrics_8H.html#a48f57e72ac183fdf1a984f58f3d24ee0',1,'ERF_TerrainMetrics.H']]], - ['compute_5finterior_5fghost_5fbxs_5fxy_321',['compute_interior_ghost_bxs_xy',['../ERF__InteriorGhostCells_8cpp.html#a58aa7f6d6812d4dea186477114d1a47c',1,'compute_interior_ghost_bxs_xy(const Box &bx, const Box &domain, const int &width, const int &set_width, Box &bx_xlo, Box &bx_xhi, Box &bx_ylo, Box &bx_yhi, const IntVect &ng_vect, const bool get_int_ng): ERF_InteriorGhostCells.cpp'],['../ERF__Utils_8H.html#aaa3f051b9681a4e20d0d88b3715d8897',1,'compute_interior_ghost_bxs_xy(const amrex::Box &bx, const amrex::Box &domain, const int &width, const int &set_width, amrex::Box &bx_xlo, amrex::Box &bx_xhi, amrex::Box &bx_ylo, amrex::Box &bx_yhi, const amrex::IntVect &ng_vect=amrex::IntVect(0, 0, 0), const bool get_int_ng=false): ERF_Utils.H']]], - ['compute_5fmost_5fbcs_322',['compute_most_bcs',['../classABLMost.html#a10ead55e11cc666e966cc68a1d1513b9',1,'ABLMost::compute_most_bcs(const int &lev, const Vector< MultiFab * > &mfs, MultiFab *xxmom_flux, MultiFab *yymom_flux, MultiFab *zzmom_flux, MultiFab *xymom_flux, MultiFab *yxmom_flux, MultiFab *xzmom_flux, MultiFab *zxmom_flux, MultiFab *yzmom_flux, MultiFab *zymom_flux, MultiFab *xheat_flux, MultiFab *yheat_flux, MultiFab *zheat_flux, MultiFab *xqv_flux, MultiFab *yqv_flux, MultiFab *zqv_flux, MultiFab *z_phys, const FluxCalc &flux_comp)'],['../classABLMost.html#ac1b3a987e1f8518eec9552f6b747a4b1',1,'ABLMost::compute_most_bcs(const int &lev, const amrex::Vector< amrex::MultiFab * > &mfs, amrex::MultiFab *xxmom_flux, amrex::MultiFab *yymom_flux, amrex::MultiFab *zzmom_flux, amrex::MultiFab *xymom_flux, amrex::MultiFab *yxmom_flux, amrex::MultiFab *xzmom_flux, amrex::MultiFab *zxmom_flux, amrex::MultiFab *yzmom_flux, amrex::MultiFab *zymom_flux, amrex::MultiFab *xheat_flux, amrex::MultiFab *yheat_flux, amrex::MultiFab *zheat_flux, amrex::MultiFab *xqv_flux, amrex::MultiFab *yqv_flux, amrex::MultiFab *zqv_flux, amrex::MultiFab *z_phys, const FluxCalc &flux_comp)']]], - ['compute_5fpblh_323',['compute_pblh',['../classABLMost.html#a7f3d29d94d0808b3e0fe083396da8557',1,'ABLMost::compute_pblh()'],['../structMYNNPBLH.html#a3911e13c78754ba2bf50e3e94f74bba8',1,'MYNNPBLH::compute_pblh()'],['../classABLMost.html#af57fb2913f44e158afcc637a342df049',1,'ABLMost::compute_pblh()']]], - ['compute_5fplane_5faverages_324',['compute_plane_averages',['../classMOSTAverage.html#ab85828af24cd22d737931c51862389e4',1,'MOSTAverage']]], - ['compute_5fpower_5foutput_325',['compute_power_output',['../classSimpleAD.html#ab13cca46ef87d42822ab2228976fc9ed',1,'SimpleAD']]], - ['compute_5fq_5fflux_326',['compute_q_flux',['../structmoeng__flux.html#a5d40e64bd085af2f4c63cfa1e9e20aa6',1,'moeng_flux::compute_q_flux()'],['../structrotate__flux.html#a4a217b139f9bcbfdd615b4decb4c2f17',1,'rotate_flux::compute_q_flux()'],['../structcustom__flux.html#ae9e13bc10b4594df556671d9a042b48b',1,'custom_flux::compute_q_flux()'],['../structdonelan__flux.html#adb397919f3dc33f33d8bdc7b99c52efc',1,'donelan_flux::compute_q_flux()']]], - ['compute_5fregion_5faverages_327',['compute_region_averages',['../classMOSTAverage.html#aaea0b00766b3cdeefd2b54bade8a86bd',1,'MOSTAverage']]], - ['compute_5fsource_5fterms_5ffn_5fft_328',['compute_source_terms_Fn_Ft',['../ERF__AdvanceGeneralAD_8cpp.html#afffd9801c692fcb424381db8ca2dc8f2',1,'ERF_AdvanceGeneralAD.cpp']]], - ['compute_5ft_5fflux_329',['compute_t_flux',['../structrotate__flux.html#a7827a8b9fcf4800189b67242befc1c31',1,'rotate_flux::compute_t_flux()'],['../structcustom__flux.html#abb193ac77724a6452a6068c3b5954081',1,'custom_flux::compute_t_flux()'],['../structdonelan__flux.html#a999e3bdb322d29fcdfbd51047fb32ee0',1,'donelan_flux::compute_t_flux()'],['../structmoeng__flux.html#a946d89f0b1c8287c83bea9ff628bdb1e',1,'moeng_flux::compute_t_flux(const int &i, const int &j, const int &k, const int &n, const int &icomp, const amrex::Real &dz, const amrex::Real &dz1, const bool &exp_most, const amrex::Array4< const amrex::Real > &eta_arr, const amrex::Array4< const amrex::Real > &cons_arr, const amrex::Array4< const amrex::Real > &velx_arr, const amrex::Array4< const amrex::Real > &vely_arr, const amrex::Array4< const amrex::Real > &umm_arr, const amrex::Array4< const amrex::Real > &tm_arr, const amrex::Array4< const amrex::Real > &u_star_arr, const amrex::Array4< const amrex::Real > &t_star_arr, const amrex::Array4< const amrex::Real > &t_surf_arr, const amrex::Array4< amrex::Real > &dest_arr) const']]], - ['compute_5fu_5fflux_330',['compute_u_flux',['../structmoeng__flux.html#a2451f21fea8f87cec2e5f626c36489cb',1,'moeng_flux::compute_u_flux()'],['../structrotate__flux.html#ab29d4027d09cb56c8cce2fab327bd758',1,'rotate_flux::compute_u_flux()'],['../structcustom__flux.html#a6ab8b167f190f9b0c4c6adb05acfff40',1,'custom_flux::compute_u_flux()'],['../structdonelan__flux.html#a44a032acc6bd6f42ff90f5a0ac14f4cf',1,'donelan_flux::compute_u_flux()']]], - ['compute_5fv_5fflux_331',['compute_v_flux',['../structrotate__flux.html#aca0eb2ba8e9e5fb863297a39ad7cd140',1,'rotate_flux::compute_v_flux()'],['../structcustom__flux.html#a2fe8dd883e33e274f6e44f9c0c5cf118',1,'custom_flux::compute_v_flux()'],['../structdonelan__flux.html#ad2da09025b821f79782fa580010c4df2',1,'donelan_flux::compute_v_flux()'],['../structmoeng__flux.html#a5ec0786b043f57c8c41edfd677dde8c9',1,'moeng_flux::compute_v_flux()']]], - ['compute_5fvapor_5fpressure_332',['compute_vapor_pressure',['../ERF__EOS_8H.html#a380a4683a461f710517afc27bc29d46f',1,'ERF_EOS.H']]], - ['compute_5fzrel_5fatcellcenter_333',['Compute_Zrel_AtCellCenter',['../ERF__TerrainMetrics_8H.html#a41f9b3a5604791daf44935b10a55a565',1,'ERF_TerrainMetrics.H']]], - ['computediffusivitymynn25_334',['ComputeDiffusivityMYNN25',['../ERF__PBLModels_8H.html#af2bea8fffff60778a8e48189b4406a03',1,'ComputeDiffusivityMYNN25(const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &cons_in, amrex::MultiFab &eddyViscosity, const amrex::Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool use_moisture, int level, const amrex::BCRec *bc_ptr, bool, const std::unique_ptr< amrex::MultiFab > &z_phys_nd, const int RhoQv_comp, const int RhoQr_comp): ERF_PBLModels.H'],['../ERF__ComputeDiffusivityMYNN25_8cpp.html#a4b51698073bd67922bc46675fce968cf',1,'ComputeDiffusivityMYNN25(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_moisture, int level, const BCRec *bc_ptr, bool, const std::unique_ptr< MultiFab > &z_phys_nd, const int RhoQv_comp, const int RhoQr_comp): ERF_ComputeDiffusivityMYNN25.cpp']]], - ['computediffusivityysu_335',['ComputeDiffusivityYSU',['../ERF__PBLModels_8H.html#ace7a2f37421af958b8f63b049b7c0835',1,'ComputeDiffusivityYSU(const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &cons_in, amrex::MultiFab &eddyViscosity, const amrex::Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool use_moisture, int level, const amrex::BCRec *bc_ptr, bool, const std::unique_ptr< amrex::MultiFab > &z_phys_nd): ERF_PBLModels.H'],['../ERF__ComputeDiffusivityYSU_8cpp.html#a22f1a268ea7d16d0817f082a47ffc98a',1,'ComputeDiffusivityYSU(const MultiFab &xvel, const MultiFab &yvel, const MultiFab &cons_in, MultiFab &eddyViscosity, const Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool, int level, const BCRec *bc_ptr, bool, const std::unique_ptr< MultiFab > &z_phys_nd): ERF_ComputeDiffusivityYSU.cpp']]], - ['computedt_336',['ComputeDt',['../classERF.html#aa38639155e79bab8a0c283aa6e7afa81',1,'ERF']]], - ['computefluxes_337',['ComputeFluxes',['../classSLM.html#aaafd49733163332a7f9616374d103cbb',1,'SLM::ComputeFluxes()'],['../classMM5.html#a109a5f7a252a6ab6c8e5373ca68c32fb',1,'MM5::ComputeFluxes()']]], - ['computeghostcells_338',['ComputeGhostCells',['../classERF.html#ae68b1f54d196d0a4b19716d65a59d4c5',1,'ERF']]], - ['computeqkesourceterms_339',['ComputeQKESourceTerms',['../ERF__PBLModels_8H.html#aeebffefd91e8d17e6af632b6076ce455',1,'ERF_PBLModels.H']]], - ['computesmnsmn_340',['ComputeSmnSmn',['../ERF__EddyViscosity_8H.html#a1d775f0ce64d37053b33d514438ee856',1,'ERF_EddyViscosity.H']]], - ['computestrain_5fn_341',['ComputeStrain_N',['../ERF__ComputeStrain__N_8cpp.html#a72f6c981375a19d6e96b875837b57ae0',1,'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 BCRec *bc_ptr, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_m, const Array4< const Real > &mf_u, const Array4< const Real > &mf_v): ERF_ComputeStrain_N.cpp'],['../ERF__Diffusion_8H.html#a6338bbbd04537c72c5a57e8a6a52d3c0',1,'ComputeStrain_N(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Box domain, const amrex::Array4< const amrex::Real > &u, const amrex::Array4< const amrex::Real > &v, const amrex::Array4< const amrex::Real > &w, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau23, const amrex::BCRec *bc_ptr, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v): ERF_Diffusion.H']]], - ['computestrain_5ft_342',['ComputeStrain_T',['../ERF__ComputeStrain__T_8cpp.html#a0234205e441f6147ae82e31753d893e2',1,'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 > &tau13, Array4< Real > &tau21, Array4< Real > &tau23, Array4< Real > &tau31, Array4< Real > &tau32, const Array4< const Real > &z_nd, const Array4< const Real > &detJ, const BCRec *bc_ptr, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_m, const Array4< const Real > &mf_u, const Array4< const Real > &mf_v): ERF_ComputeStrain_T.cpp'],['../ERF__Diffusion_8H.html#a1c7f3e532227403ddafd0ebde7365262',1,'ComputeStrain_T(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Box domain, const amrex::Array4< const amrex::Real > &u, const amrex::Array4< const amrex::Real > &v, const amrex::Array4< const amrex::Real > &w, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau21, amrex::Array4< amrex::Real > &tau23, amrex::Array4< amrex::Real > &tau31, amrex::Array4< amrex::Real > &tau32, const amrex::Array4< const amrex::Real > &z_nd, const amrex::Array4< const amrex::Real > &detJ, const amrex::BCRec *bc_ptr, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v): ERF_Diffusion.H']]], - ['computestressconsvisc_5fn_343',['ComputeStressConsVisc_N',['../ERF__ComputeStress__N_8cpp.html#a90e3a746cdb875f5eb328b01d5168506',1,'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): ERF_ComputeStress_N.cpp'],['../ERF__Diffusion_8H.html#a094da213d571d4c5be5c1f8a355be78f',1,'ComputeStressConsVisc_N(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Real mu_eff, const amrex::Array4< const amrex::Real > &cell_data, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau23, const amrex::Array4< const amrex::Real > &er_arr): ERF_Diffusion.H']]], - ['computestressconsvisc_5ft_344',['ComputeStressConsVisc_T',['../ERF__ComputeStress__T_8cpp.html#af10fca5e9a1f97c4743e76cc935230bd',1,'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 > &tau13, Array4< Real > &tau21, Array4< Real > &tau23, Array4< Real > &tau31, 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): ERF_ComputeStress_T.cpp'],['../ERF__Diffusion_8H.html#a61297def6144337bbf34010d410f4e4a',1,'ComputeStressConsVisc_T(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Real mu_eff, const amrex::Array4< const amrex::Real > &cell_data, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau21, amrex::Array4< amrex::Real > &tau23, amrex::Array4< amrex::Real > &tau31, amrex::Array4< amrex::Real > &tau32, const amrex::Array4< const amrex::Real > &er_arr, const amrex::Array4< const amrex::Real > &z_nd, const amrex::Array4< const amrex::Real > &detJ, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv): ERF_Diffusion.H']]], - ['computestressvarvisc_5fn_345',['ComputeStressVarVisc_N',['../ERF__Diffusion_8H.html#af89bc368023b73bc1d4e3844d74b8ec2',1,'ComputeStressVarVisc_N(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Real mu_eff, const amrex::Array4< const amrex::Real > &mu_turb, const amrex::Array4< const amrex::Real > &cell_data, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau23, const amrex::Array4< const amrex::Real > &er_arr): ERF_Diffusion.H'],['../ERF__ComputeStress__N_8cpp.html#a3ccb3579df8fa971a01bc7504db45a1e',1,'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): ERF_ComputeStress_N.cpp']]], - ['computestressvarvisc_5ft_346',['ComputeStressVarVisc_T',['../ERF__ComputeStress__T_8cpp.html#a25509867afb4acb014b0eae79da251ae',1,'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 > &tau13, Array4< Real > &tau21, Array4< Real > &tau23, Array4< Real > &tau31, 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): ERF_ComputeStress_T.cpp'],['../ERF__Diffusion_8H.html#a4151c371e6c66295da065ed9ed323dbe',1,'ComputeStressVarVisc_T(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Real mu_eff, const amrex::Array4< const amrex::Real > &mu_turb, const amrex::Array4< const amrex::Real > &cell_data, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau21, amrex::Array4< amrex::Real > &tau23, amrex::Array4< amrex::Real > &tau31, amrex::Array4< amrex::Real > &tau32, const amrex::Array4< const amrex::Real > &er_arr, const amrex::Array4< const amrex::Real > &z_nd, const amrex::Array4< const amrex::Real > &detJ, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv): ERF_Diffusion.H']]], - ['computetsurf_347',['ComputeTsurf',['../classSLM.html#a0db509945fed4bf6ffae276c1c183707',1,'SLM::ComputeTsurf()'],['../classMM5.html#a9fc8c9cf8b165b28583be7bb7e8ac7c3',1,'MM5::ComputeTsurf()']]], - ['computeturbulentviscosity_348',['ComputeTurbulentViscosity',['../ERF__ComputeTurbulentViscosity_8cpp.html#a3865612b809df828f44e9c18218b1e37',1,'ComputeTurbulentViscosity(const MultiFab &xvel, const MultiFab &yvel, const MultiFab &Tau11, const MultiFab &Tau22, const MultiFab &Tau33, const MultiFab &Tau12, const MultiFab &Tau13, const MultiFab &Tau23, const MultiFab &cons_in, MultiFab &eddyViscosity, MultiFab &Hfx1, MultiFab &Hfx2, MultiFab &Hfx3, MultiFab &Diss, const Geometry &geom, const MultiFab &mapfac_u, const MultiFab &mapfac_v, const std::unique_ptr< MultiFab > &z_phys_nd, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const bool &exp_most, const bool &use_moisture, int level, const BCRec *bc_ptr, bool vert_only): ERF_ComputeTurbulentViscosity.cpp'],['../ERF__EddyViscosity_8H.html#a2b687f91a8d8385766be20222af4ccac',1,'ComputeTurbulentViscosity(const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &Tau11, const amrex::MultiFab &Tau22, const amrex::MultiFab &Tau33, const amrex::MultiFab &Tau12, const amrex::MultiFab &Tau13, const amrex::MultiFab &Tau23, const amrex::MultiFab &cons_in, amrex::MultiFab &eddyViscosity, amrex::MultiFab &Hfx1, amrex::MultiFab &Hfx2, amrex::MultiFab &Hfx3, amrex::MultiFab &Diss, const amrex::Geometry &geom, const amrex::MultiFab &mapfac_u, const amrex::MultiFab &mapfac_v, const std::unique_ptr< amrex::MultiFab > &z_phys_nd, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const bool &exp_most, const bool &use_moisture, int level, const amrex::BCRec *bc_ptr, bool vert_only=false): ERF_EddyViscosity.H']]], - ['computeturbulentviscosityles_349',['ComputeTurbulentViscosityLES',['../ERF__ComputeTurbulentViscosity_8cpp.html#a730dd933a41b48fe17b15e46d4dce964',1,'ERF_ComputeTurbulentViscosity.cpp']]], - ['computeverticalderivativespbl_350',['ComputeVerticalDerivativesPBL',['../ERF__PBLModels_8H.html#a33bb37a040bfadb1956539905ef016c3',1,'ERF_PBLModels.H']]], - ['config_351',['config',['../structMYNNLevel25.html#a6065f4b0ba5299d0be0f92a614188034',1,'MYNNLevel25']]], - ['cons_352',['cons',['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a47abe072e12c61d29cde15a509a0664b',1,'Vars::cons()'],['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daa2e7100afbf5e7a39371f1cb29f6f570a',1,'IntVars::cons()']]], - ['cons_5fbc_353',['cons_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aaaf601346b01655b32acf66d07b856aec',1,'BCVars']]], - ['cons_5fnames_354',['cons_names',['../classERF.html#afd8cd5a477754776135befa668fdd0c9',1,'ERF']]], - ['cons_5fto_5fprim_355',['cons_to_prim',['../ERF__TI__utils_8H.html#a76b27b6105fe279f9a43296072c843b3',1,'ERF_TI_utils.H']]], - ['const_5fgrav_356',['CONST_GRAV',['../ERF__Constants_8H.html#ac2d0c304ab1117368778efcda612de43',1,'ERF_Constants.H']]], - ['constant_357',['CONSTANT',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13a8d6b5cada83510220f59e00ce86d4d92',1,'ABLMost']]], - ['constant_358',['Constant',['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735acb17869fe51048b5a5c4c6106551a255',1,'ERF_DiffStruct.H']]], - ['constant_5fdensity_359',['constant_density',['../structSolverChoice.html#aa9cf425ef14a7e28ec3411044e737b23',1,'SolverChoice']]], - ['constantalpha_360',['ConstantAlpha',['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735a6f0229db491c3b01860363456dc57288',1,'ERF_DiffStruct.H']]], - ['construct_5ferffillpatchers_361',['Construct_ERFFillPatchers',['../classERF.html#adc284f421c5fd9dd15c0e5cbe4ff5fc8',1,'ERF']]], - ['containerhaselement_362',['containerHasElement',['../ERF__Plotfile_8cpp.html#a1f8554e7b211b0acfc202e8a600e7d67',1,'ERF_Plotfile.cpp']]], - ['coord_363',['Coord',['../ERF__DataStruct_8H.html#a627f1f843904477f763577ad1460de01',1,'ERF_DataStruct.H']]], - ['copy_5fmicro_5fto_5fstate_364',['Copy_Micro_to_State',['../classNullMoist.html#a11a25944d4ddb955f74e355838b9d8b0',1,'NullMoist::Copy_Micro_to_State()'],['../classNullSurf.html#a45d066ae7b9d2435f5477e35dd75bcfb',1,'NullSurf::Copy_Micro_to_State()'],['../classSAM.html#a007ed40ac7278996d257b4c0ab6c1320',1,'SAM::Copy_Micro_to_State()'],['../classKessler.html#a747a85d4c8004b299ca49dcb1f221c7c',1,'Kessler::Copy_Micro_to_State()']]], - ['copy_5fstate_5fto_5fmicro_365',['Copy_State_to_Micro',['../classNullSurf.html#a1c31c18677e12226716217ca87cd526c',1,'NullSurf::Copy_State_to_Micro()'],['../classKessler.html#a18f83fc4dff53c8c29ee9ee974e65ac2',1,'Kessler::Copy_State_to_Micro()'],['../classNullMoist.html#aacb06ee696c6870e899d1bc26aa9933e',1,'NullMoist::Copy_State_to_Micro()'],['../classSAM.html#a1df931f91be89514c09f69f24cfeca53',1,'SAM::Copy_State_to_Micro()']]], - ['coriolis_5f3d_366',['coriolis_3d',['../structSolverChoice.html#a7e93900ec3e84826fcf1e02435bdae42',1,'SolverChoice']]], - ['coriolis_5ffactor_367',['coriolis_factor',['../structSolverChoice.html#a1163778ed56af6977001ef4ec55a3da3',1,'SolverChoice']]], - ['cosphi_368',['cosphi',['../structSolverChoice.html#a411fbfea721cd40033e113cf54a8047f',1,'SolverChoice']]], - ['coszrs_369',['coszrs',['../classRadiation.html#ada2d1a89ee69c66d7dd3ebf7a2f98d7b',1,'Radiation']]], - ['coupling_5ftype_370',['coupling_type',['../structSolverChoice.html#af976afa61859c07e6249963edc367c2d',1,'SolverChoice']]], - ['cp_5fd_371',['Cp_d',['../ERF__Constants_8H.html#a1ee33e063343c8fb15ed025c456ebd46',1,'ERF_Constants.H']]], - ['cp_5fl_372',['Cp_l',['../ERF__Constants_8H.html#acecae1da25fb8c8d32d1f175e18df41f',1,'ERF_Constants.H']]], - ['cp_5fv_373',['Cp_v',['../ERF__Constants_8H.html#aea1cea8d633adb36e2ea5018925b68ee',1,'ERF_Constants.H']]], - ['crain_374',['crain',['../ERF__Constants_8H.html#aedc41c83fba50dcbd5e1385007d3edec',1,'ERF_Constants.H']]], - ['create_375',['create',['../classncutils_1_1NCFile.html#a47bdccee2cc22a735ca715d9c88e4f6b',1,'ncutils::NCFile']]], - ['create_5fpar_376',['create_par',['../classncutils_1_1NCFile.html#a6607bd5f3f75b451e2436ff713931f19',1,'ncutils::NCFile']]], - ['crefwlwi_377',['crefwlwi',['../classMam4__aer.html#a32d3651a6f9299ecee85fee320dfda50',1,'Mam4_aer']]], - ['crefwlwr_378',['crefwlwr',['../classMam4__aer.html#ae1eea21725e40b02e21086cd73dc9d66',1,'Mam4_aer']]], - ['crefwswi_379',['crefwswi',['../classMam4__aer.html#ad48a521caea628250a1faa6154f6094b',1,'Mam4_aer']]], - ['crefwswr_380',['crefwswr',['../classMam4__aer.html#a139c9796ada84ff24405114f8691d7cd',1,'Mam4_aer']]], - ['cs_381',['Cs',['../structTurbChoice.html#aa75682bb872d7917ffb8fddb21532f40',1,'TurbChoice']]], - ['csnow_382',['csnow',['../ERF__Constants_8H.html#a00a835048e6d7b67e76cd044f483a0e2',1,'ERF_Constants.H']]], - ['custom_383',['CUSTOM',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0a72baef04098f035e8a320b03ad197818',1,'ABLMost']]], - ['custom_5fflux_384',['custom_flux',['../structcustom__flux.html',1,'custom_flux'],['../structcustom__flux.html#aa9715fd8b84d6df19fa17c89a703210a',1,'custom_flux::custom_flux()']]], - ['custom_5fforcing_5fprim_5fvars_385',['custom_forcing_prim_vars',['../structSolverChoice.html#aae4f377d36d01b85a1f322c45009ac75',1,'SolverChoice']]], - ['custom_5fgeostrophic_5fprofile_386',['custom_geostrophic_profile',['../structSolverChoice.html#a5e8754b29072596a584633734a9f64ef',1,'SolverChoice']]], - ['custom_5fmoisture_5fforcing_387',['custom_moisture_forcing',['../structSolverChoice.html#aa2e312b4e6d08797fc3c1b6d67313d48',1,'SolverChoice']]], - ['custom_5fqstar_388',['custom_qstar',['../classABLMost.html#a31707b89fbbbdeb445ba35ed240046c3',1,'ABLMost']]], - ['custom_5frhotheta_5fforcing_389',['custom_rhotheta_forcing',['../structSolverChoice.html#a4e81a09c9f454c680568b7776a3ed90e',1,'SolverChoice']]], - ['custom_5ftstar_390',['custom_tstar',['../classABLMost.html#afbd0b1a37d9e9d716d82910db203e82f',1,'ABLMost']]], - ['custom_5fustar_391',['custom_ustar',['../classABLMost.html#a1bce26c6253a6191424e7b753cd24cfa',1,'ABLMost']]], - ['custom_5fw_5fsubsidence_392',['custom_w_subsidence',['../structSolverChoice.html#a596f061b796ada0389c81a6125150b6e',1,'SolverChoice']]] + ['c_5fp_201',['c_p',['../structSolverChoice.html#a43d16f0628ba5fbe64a813de7f25f56a',1,'SolverChoice']]], + ['c_5fp_202',['C_P',['../classWindFarm.html#a63c20a3eac21bceea0ae4bfbe4c9acac',1,'WindFarm::C_P()'],['../classGeneralAD.html#a789afc5fc0d7b06f7dc79e6eb05a5760',1,'GeneralAD::C_P()']]], + ['c_5ft_203',['C_T',['../classGeneralAD.html#ae82cceda872623720416dc9221693379',1,'GeneralAD::C_T()'],['../classWindFarm.html#a87e2fe5c89e49801a70f6acf9836e1e1',1,'WindFarm::C_T()']]], + ['calc_5ffifth_5forder_5fderiv_204',['calc_fifth_order_deriv',['../ERF__NumericalDiffusion_8H.html#a2985fd8720853d6b8c663c68744dbd97',1,'ERF_NumericalDiffusion.H']]], + ['calc_5fhltalt_205',['calc_hltalt',['../classWaterVaporSat.html#a6e0a9f07f0f59514f56536e44025e980',1,'WaterVaporSat']]], + ['calc_5fpsi_5fh_206',['calc_psi_h',['../structsimilarity__funs.html#a7dcb32f637eab66d2314902d03289bc2',1,'similarity_funs']]], + ['calc_5fpsi_5fm_207',['calc_psi_m',['../structsimilarity__funs.html#a21cb206b0dd78dc2ac7211de8dbcb8d2',1,'similarity_funs']]], + ['calc_5frf_208',['calc_Rf',['../structMYNNLevel2.html#a2970f316de64a2a1c605baaea1f34aec',1,'MYNNLevel2']]], + ['calc_5frho_5fp_209',['calc_rho_p',['../structInputSoundingData.html#a830608de7ca272770d8ddb659d65eb31',1,'InputSoundingData']]], + ['calc_5fsh_210',['calc_SH',['../structMYNNLevel2.html#a75e52da99ede6eb7b361e3ae12c08b1e',1,'MYNNLevel2']]], + ['calc_5fsm_211',['calc_SM',['../structMYNNLevel2.html#a5e7e202941dd61d8aa7f3367031c9b8f',1,'MYNNLevel2']]], + ['calc_5fstability_5ffuncs_212',['calc_stability_funcs',['../structMYNNLevel25.html#a15e53c3496f45cad7a7f794b86b31e9b',1,'MYNNLevel25']]], + ['calc_5ftpi_5famp_213',['calc_tpi_amp',['../structTurbulentPerturbation.html#a6690a1ccf037f5cf892e72724c21b3a5',1,'TurbulentPerturbation']]], + ['calc_5ftpi_5fmeanmag_5fperbox_214',['calc_tpi_meanMag_perBox',['../structTurbulentPerturbation.html#ac2f49dd6a95ab0bb291fa4977d9682e5',1,'TurbulentPerturbation']]], + ['calc_5ftpi_5fupdate_215',['calc_tpi_update',['../structTurbulentPerturbation.html#a5e6200f8b6bea3c4944dccc6c7285102',1,'TurbulentPerturbation']]], + ['calc_5fwstar_216',['calc_wstar',['../ERF__Wstar_8H.html#ae4dec2546738e08263cd23690c9028fe',1,'calc_wstar(const amrex::Real &hfx, const amrex::Real &pblh, const amrex::Real &thv): ERF_Wstar.H'],['../ERF__Wstar_8H.html#a07708294fc196cae6c560e47360c6600',1,'calc_wstar(const amrex::Real &ust, const amrex::Real &tst, const amrex::Real &qst, const amrex::Real &pblh, const amrex::Real &th, const amrex::Real &thv, const amrex::Real &qv=0.0): ERF_Wstar.H']]], + ['calculate_5fheating_5frate_217',['calculate_heating_rate',['../classRadiation.html#ad37acecc5f023e2da167f49e09247233',1,'Radiation']]], + ['camname_218',['camname',['../structMamConstituents_1_1aerosol__t.html#a23e50740903b1b826352cd7486c69913',1,'MamConstituents::aerosol_t::camname()'],['../structMamConstituents_1_1gas__t.html#ab996ee58a5c7dc033d07938d487e79f3',1,'MamConstituents::gas_t::camname()']]], + ['camname_5fmmr_5fa_219',['camname_mmr_a',['../structMamConstituents_1_1mode__component__t.html#a3adfcd2619c7f477e8ecd6529d8f98b6',1,'MamConstituents::mode_component_t']]], + ['camname_5fmmr_5fc_220',['camname_mmr_c',['../structMamConstituents_1_1mode__component__t.html#aab0b2aef67ab3544af7fb0ecf2930415',1,'MamConstituents::mode_component_t']]], + ['camname_5fnum_5fa_221',['camname_num_a',['../structMamConstituents_1_1mode__component__t.html#a5a1aa28df874b8cb28f19e730b36f037',1,'MamConstituents::mode_component_t']]], + ['camname_5fnum_5fc_222',['camname_num_c',['../structMamConstituents_1_1mode__component__t.html#a6f588bac515da5d63593bb61df75e432',1,'MamConstituents::mode_component_t']]], + ['ce_223',['Ce',['../structTurbChoice.html#ab6d0ae39e92dcbe7362abf53364c1a8e',1,'TurbChoice']]], + ['ce_5fwall_224',['Ce_wall',['../structTurbChoice.html#ab2d1ecb36171ca19ea851e8e682a1478',1,'TurbChoice']]], + ['centered2_225',['CENTERED2',['../structCENTERED2.html#a09644816e71e1ade052d277199a8d785',1,'CENTERED2::CENTERED2()'],['../structCENTERED2.html',1,'CENTERED2']]], + ['centered4_226',['CENTERED4',['../structCENTERED4.html',1,'CENTERED4'],['../structCENTERED4.html#a36a14bbf9f418feee5e1af3685e1b4fb',1,'CENTERED4::CENTERED4()']]], + ['centered6_227',['CENTERED6',['../structCENTERED6.html#acedba4c2b029f363a47c32ad0c6f30e8',1,'CENTERED6::CENTERED6()'],['../structCENTERED6.html',1,'CENTERED6']]], + ['centered_5f2nd_228',['Centered_2nd',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70ada570868919bafaab1776170229a7049',1,'ERF_IndexDefines.H']]], + ['centered_5f4th_229',['Centered_4th',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a778e0ed47937713eb1c4bedef6b00161',1,'ERF_IndexDefines.H']]], + ['centered_5f6th_230',['Centered_6th',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a8c9475eb6bfde28e5bcb5230ac2e22a9',1,'ERF_IndexDefines.H']]], + ['centimeter_231',['centimeter',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1a135cc2d02c99a9ca6a6413cacea93664',1,'RadConstants']]], + ['cf_5fset_5fwidth_232',['cf_set_width',['../classERF.html#a1e3e2855b6e811596226c167573ad62d',1,'ERF']]], + ['cf_5fwidth_233',['cf_width',['../classERF.html#ad9084179f7384e10a519989ffd51fd34',1,'ERF']]], + ['cfl_234',['cfl',['../classERF.html#a89f605d1a1eae06a7c79f9b6b65c637f',1,'ERF']]], + ['cfl_5fmax_235',['CFL_MAX',['../classSAM.html#ab22f37f1f2b5d72ee2d20af56a29fc40',1,'SAM::CFL_MAX()'],['../classKessler.html#ab65a6b7181e08edaa8de14ea26bb8d62',1,'Kessler::CFL_MAX()']]], + ['cgrau_236',['cgrau',['../ERF__Constants_8H.html#a22bb5d96152ac76ffe39d98d67b2b07a',1,'ERF_Constants.H']]], + ['change_5fmax_237',['change_max',['../classERF.html#ae16d413b172bb3b3400af6d5cb236fd4',1,'ERF']]], + ['charnock_238',['CHARNOCK',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13addbb8213265f3ad773f7af2cb8147062',1,'ABLMost']]], + ['check_5ffile_239',['check_file',['../classERF.html#ae701564fbe3da5bbd88587e5a08eca4e',1,'ERF']]], + ['check_5fparams_240',['check_params',['../structSolverChoice.html#a4c875e5fe0f3dd69fbcc145b7066c766',1,'SolverChoice']]], + ['check_5ftype_241',['check_type',['../classERF.html#a32e0d0f5ae0db18ee81f9d4325a14f64',1,'ERF']]], + ['chen2021_242',['CHEN2021',['../ERF__MYNNStruct_8H.html#a103de8b695a78549c43fa852d9c4dd25abe8de8e777a612742c642b372ab3dc9e',1,'ERF_MYNNStruct.H']]], + ['chopgrids2d_243',['ChopGrids2D',['../ERF__ChopGrids_8cpp.html#a6fe49eeaa200ab6ab8ae0a6e048f3ded',1,'ChopGrids2D(BoxArray &ba, const Box &domain, int target_size): ERF_ChopGrids.cpp'],['../ERF__Utils_8H.html#ae73f998519cf6628e7c4a90cea4cb4f5',1,'ChopGrids2D(amrex::BoxArray &ba, const amrex::Box &domain, int target_size): ERF_Utils.H']]], + ['ci_244',['CI',['../structTurbChoice.html#afbf3b28d53a35977d4ff77e6928122c0',1,'TurbChoice']]], + ['cif_245',['CIF',['../classCIF.html',1,'CIF< F >'],['../classCIF.html#aeb3766fcdd40058f9116d815743381c9',1,'CIF::CIF(CIF &&rhs) noexcept=default'],['../classCIF.html#aeda8119c592d6acaf71927b7d8fe3887',1,'CIF::CIF(const CIF &rhs)=default'],['../classCIF.html#a0e65a3004e88fe6f772690a89a87256f',1,'CIF::CIF(F &&f, bool a_active)']]], + ['ck_246',['Ck',['../structTurbChoice.html#a61ff7dc6ee4001ae8f2978efd5ff57e4',1,'TurbChoice']]], + ['cld_247',['cld',['../classRadiation.html#a889a5f62e829af86690ece49bf2f9c6e',1,'Radiation']]], + ['cld_5fasm_5fbnd_5fsw_248',['cld_asm_bnd_sw',['../classRadiation.html#a8ddade9e3b5ad13008fb253d2e7c17a4',1,'Radiation']]], + ['cld_5fasm_5fbnd_5fsw_5f1d_249',['cld_asm_bnd_sw_1d',['../classRadiation.html#aff0446369d923ec1ba5b20e6b257d52d',1,'Radiation']]], + ['cld_5fasm_5fbnd_5fsw_5fo_5f1d_250',['cld_asm_bnd_sw_o_1d',['../classRadiation.html#a4b3eed1432c08adcac97160424dafc79',1,'Radiation']]], + ['cld_5fasm_5fgpt_5fsw_251',['cld_asm_gpt_sw',['../classRadiation.html#a8718e64a2e3ba0aa52e12bcac9dcb202',1,'Radiation']]], + ['cld_5fssa_5fbnd_5fsw_252',['cld_ssa_bnd_sw',['../classRadiation.html#af35ffb83d032a581c45673e2627f8bb5',1,'Radiation']]], + ['cld_5fssa_5fbnd_5fsw_5f1d_253',['cld_ssa_bnd_sw_1d',['../classRadiation.html#ad13553538dacaf76d38eacf804a13276',1,'Radiation']]], + ['cld_5fssa_5fbnd_5fsw_5fo_5f1d_254',['cld_ssa_bnd_sw_o_1d',['../classRadiation.html#ad139630194e6035320fe89c828287912',1,'Radiation']]], + ['cld_5fssa_5fgpt_5fsw_255',['cld_ssa_gpt_sw',['../classRadiation.html#a23309b232cd21359d1ffd8832acd4e09',1,'Radiation']]], + ['cld_5ftau_5fbnd_5flw_256',['cld_tau_bnd_lw',['../classRadiation.html#a6f6042a4b1744a110d7955c6d0d8d08c',1,'Radiation']]], + ['cld_5ftau_5fbnd_5fsw_257',['cld_tau_bnd_sw',['../classRadiation.html#aeae6687bdc7bfc93f2e7ff079fbb3244',1,'Radiation']]], + ['cld_5ftau_5fbnd_5fsw_5f1d_258',['cld_tau_bnd_sw_1d',['../classRadiation.html#a6ffc09147dd502ea1b9ef005da70fa2d',1,'Radiation']]], + ['cld_5ftau_5fbnd_5fsw_5fo_5f1d_259',['cld_tau_bnd_sw_o_1d',['../classRadiation.html#a4b65612bc60bb15b9e89971e5bed81b8',1,'Radiation']]], + ['cld_5ftau_5fgpt_5flw_260',['cld_tau_gpt_lw',['../classRadiation.html#a038b9faf1daea703e3f7d82f0e889b05',1,'Radiation']]], + ['cld_5ftau_5fgpt_5fsw_261',['cld_tau_gpt_sw',['../classRadiation.html#abbe4431f5c94243dd57fa8adb55d05e6',1,'Radiation']]], + ['cldfsnow_262',['cldfsnow',['../classRadiation.html#ae535dbfdb6158094e4182ea1b660e7cc',1,'Radiation']]], + ['clear_263',['clear',['../structTimeInterpolatedData.html#a68d1abba77684ee584ba484a185a44e2',1,'TimeInterpolatedData']]], + ['clear_5frh_264',['clear_rh',['../classRadiation.html#a04fcc2194ca5c8df13d384ae567aa3c7',1,'Radiation']]], + ['clearlevel_265',['ClearLevel',['../classERF.html#ac44e400a7ce68e18fa44e9416cb1344e',1,'ERF']]], + ['clim_5fmodal_5faero_266',['clim_modal_aero',['../classMam4__aer.html#a83c2a65a851a3329d62fca09dd0263d5',1,'Mam4_aer']]], + ['close_267',['close',['../classncutils_1_1NCFile.html#af2c4a20c38edb3fae69087a80875b8b9',1,'ncutils::NCFile']]], + ['closest_5findex_268',['closest_index',['../ERF__ReadBndryPlanes_8cpp.html#adc5227730afe35653b2dfa88898eb00a',1,'ERF_ReadBndryPlanes.cpp']]], + ['cloud_269',['Cloud',['../classSAM.html#a48d25f57da2ba1d7ddb503ede0b8d998',1,'SAM']]], + ['cloud_5ffraction_270',['cloud_fraction',['../classERF.html#a0f6effb7eeed11385b20e4bbf516b459',1,'ERF']]], + ['cloud_5foptics_271',['cloud_optics',['../classOptics.html#a90c700e69b63c61c6275b12c63033334',1,'Optics']]], + ['cloudradprops_272',['CloudRadProps',['../classCloudRadProps.html',1,'CloudRadProps'],['../classCloudRadProps.html#aade37d67dde6092189402829442285d4',1,'CloudRadProps::CloudRadProps()']]], + ['cmd_273',['cmd',['../classMultiBlockContainer.html#ac2e558406e28ee31351eb60c7465d0ad',1,'MultiBlockContainer']]], + ['cnk_5fa_274',['Cnk_a',['../structmost__data.html#a83c3a7004441c335b630dd2d6973f518',1,'most_data']]], + ['cnk_5fa_275',['cnk_a',['../classABLMost.html#a75310e9079ee238a932900feaad85ac5',1,'ABLMost']]], + ['cnk_5fb_276',['Cnk_b',['../structmost__data.html#a51b78fb4a4b8fb6aa512d4bd4fcd3cd7',1,'most_data']]], + ['cnk_5fb1_277',['Cnk_b1',['../structmost__data.html#acfac0135facabddbdd699609bac908e4',1,'most_data']]], + ['cnk_5fb2_278',['Cnk_b2',['../structmost__data.html#a4488059550159398fd2cddaf4d37f31b',1,'most_data']]], + ['cnk_5fd_279',['Cnk_d',['../structmost__data.html#a73b1c119aa9b4bcaac98753a4fde9e86',1,'most_data']]], + ['cnk_5fvisc_280',['cnk_visc',['../classABLMost.html#a4f97d1d8c347710155ead2c1310338a0',1,'ABLMost']]], + ['coare3_5froughness_281',['COARE3_roughness',['../ERF__MOSTRoughness_8H.html#a9fb5194b85e904a3f0a0500a05438b5e',1,'ERF_MOSTRoughness.H']]], + ['coefficients_5ffile_5flw_282',['coefficients_file_lw',['../classRrtmgp.html#a02493ce8d504b6a4d4a9a5cfec8d44f5',1,'Rrtmgp']]], + ['coefficients_5ffile_5fsw_283',['coefficients_file_sw',['../classRrtmgp.html#a5fa9f64db9791a7f152055f484113714',1,'Rrtmgp']]], + ['coefice_284',['coefice',['../classSAM.html#aad8c4616221c01599e4e32f2ebb08698',1,'SAM']]], + ['column_5ffile_5fname_285',['column_file_name',['../classERF.html#a48bba6b1c1b39940b09aefbe56311e2f',1,'ERF']]], + ['column_5finterval_286',['column_interval',['../classERF.html#afa0bef6d3146788302b81c0d4f4802d1',1,'ERF']]], + ['column_5floc_5fx_287',['column_loc_x',['../classERF.html#a930b7d48218b3fc41d8719b50b3f6086',1,'ERF']]], + ['column_5floc_5fy_288',['column_loc_y',['../classERF.html#a2b911f3a5a324813b1ff4462df6044a6',1,'ERF']]], + ['column_5fper_289',['column_per',['../classERF.html#a7b0175190c6fcf829c7f2841f729b12a',1,'ERF']]], + ['combine_5fproperties_290',['combine_properties',['../classOptics.html#a6cbf46804754b07ab0ccf03e6db25207',1,'Optics']]], + ['comps_291',['comps',['../structMamConstituents_1_1modes__t.html#a51263b4f4e52ec4e2068e775d7f5f1f4',1,'MamConstituents::modes_t']]], + ['compute_5fa_292',['compute_A',['../ERF__AdvanceFitch_8cpp.html#a7b6c67da0ff16af60b10f434632b06ce',1,'ERF_AdvanceFitch.cpp']]], + ['compute_5faijk_293',['compute_Aijk',['../ERF__AdvanceFitch_8cpp.html#a68e0a40af0744df9f7e79d181225f615',1,'ERF_AdvanceFitch.cpp']]], + ['compute_5faverages_294',['compute_averages',['../classMOSTAverage.html#a7a28005871bb8abb49f44c3976133a4f',1,'MOSTAverage::compute_averages()'],['../classPlaneAverage.html#a603aee4caf3a370d06bee77fddb0e33e',1,'PlaneAverage::compute_averages(const IndexSelector &idxOp, const amrex::MultiFab &mfab)'],['../classPlaneAverage.html#a0b4bb610551a2f07eb05b8e8b7d91820',1,'PlaneAverage::compute_averages(const IndexSelector &idxOp, const amrex::MultiFab &mfab)']]], + ['compute_5fcoefficients_295',['Compute_Coefficients',['../classSAM.html#a77dd99de0896cf9f9bf8299c2c80bc40',1,'SAM']]], + ['compute_5fdivergence_296',['compute_divergence',['../classERF.html#a4aaad0c261cb89d575d46083a509dbb9',1,'ERF']]], + ['compute_5ffluxes_297',['compute_fluxes',['../classABLMost.html#a829339fc8e70a5dff8b7c85f3c2e4138',1,'ABLMost']]], + ['compute_5ffreestream_5fvelocity_298',['compute_freestream_velocity',['../classGeneralAD.html#aaa071c6bfd4e647404242328fd1b3643',1,'GeneralAD::compute_freestream_velocity()'],['../classSimpleAD.html#a1320fd9378b5802905f2a101a81b8067',1,'SimpleAD::compute_freestream_velocity()']]], + ['compute_5fh_5feta_5fatcellcenter_299',['Compute_h_eta_AtCellCenter',['../ERF__TerrainMetrics_8H.html#a43b431cbd97421014ff80245883e06d2',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5feta_5fatedgecenteri_300',['Compute_h_eta_AtEdgeCenterI',['../ERF__TerrainMetrics_8H.html#aed973861215c4eb0697f7a83b37016a9',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5feta_5fatedgecenterj_301',['Compute_h_eta_AtEdgeCenterJ',['../ERF__TerrainMetrics_8H.html#a0251c09947155307e047f79fccdbd463',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5feta_5fatedgecenterk_302',['Compute_h_eta_AtEdgeCenterK',['../ERF__TerrainMetrics_8H.html#ac1434a53d9966d992133433473bc629a',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5feta_5fatiface_303',['Compute_h_eta_AtIface',['../ERF__TerrainMetrics_8H.html#ad06b0ae003cb3d59227ce85a5fa8a669',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5feta_5fatjface_304',['Compute_h_eta_AtJface',['../ERF__TerrainMetrics_8H.html#ae609a5c1f84347b66e9a8b712271c4ce',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5feta_5fatkface_305',['Compute_h_eta_AtKface',['../ERF__TerrainMetrics_8H.html#af2b7bda0da3e8024e9b02b6d69c366fe',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fxi_5fatcellcenter_306',['Compute_h_xi_AtCellCenter',['../ERF__TerrainMetrics_8H.html#ada44020dc4ec27c5bebf8fd82d336cee',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fxi_5fatedgecenteri_307',['Compute_h_xi_AtEdgeCenterI',['../ERF__TerrainMetrics_8H.html#ad56aa9e0cc7428ea33d4ac90d91c1f56',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fxi_5fatedgecenterj_308',['Compute_h_xi_AtEdgeCenterJ',['../ERF__TerrainMetrics_8H.html#a1582797e6ac6cf0c1e0b94a619bc13b8',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fxi_5fatedgecenterk_309',['Compute_h_xi_AtEdgeCenterK',['../ERF__TerrainMetrics_8H.html#a07e83bf0f142a953679c9edfa42b398d',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fxi_5fatiface_310',['Compute_h_xi_AtIface',['../ERF__TerrainMetrics_8H.html#a2116df83b61a39fb50b9a2d7474c00d7',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fxi_5fatjface_311',['Compute_h_xi_AtJface',['../ERF__TerrainMetrics_8H.html#a9ec5ec17f16954e56733db6dd98fe07d',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fxi_5fatkface_312',['Compute_h_xi_AtKface',['../ERF__TerrainMetrics_8H.html#aba0de207695f9674a9e0678a19f22677',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fzeta_5fatcellcenter_313',['Compute_h_zeta_AtCellCenter',['../ERF__TerrainMetrics_8H.html#a32eeeb066c70da970aa6a60918515987',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fzeta_5fatedgecenteri_314',['Compute_h_zeta_AtEdgeCenterI',['../ERF__TerrainMetrics_8H.html#a3e3ceccddeb3cca9d9e4573af2311a5e',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fzeta_5fatedgecenterj_315',['Compute_h_zeta_AtEdgeCenterJ',['../ERF__TerrainMetrics_8H.html#a21aac76e0b284b33e302526e1f292c76',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fzeta_5fatedgecenterk_316',['Compute_h_zeta_AtEdgeCenterK',['../ERF__TerrainMetrics_8H.html#a2b9e684355ee8d6dad22950c8c51716b',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fzeta_5fatiface_317',['Compute_h_zeta_AtIface',['../ERF__TerrainMetrics_8H.html#a8d96671d41364f1e24391375a2bc0f1e',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fzeta_5fatjface_318',['Compute_h_zeta_AtJface',['../ERF__TerrainMetrics_8H.html#ada12bcb6beb3fa0d00dbdacb37f3c60f',1,'ERF_TerrainMetrics.H']]], + ['compute_5fh_5fzeta_5fatkface_319',['Compute_h_zeta_AtKface',['../ERF__TerrainMetrics_8H.html#a48f57e72ac183fdf1a984f58f3d24ee0',1,'ERF_TerrainMetrics.H']]], + ['compute_5finterior_5fghost_5fbxs_5fxy_320',['compute_interior_ghost_bxs_xy',['../ERF__InteriorGhostCells_8cpp.html#a58aa7f6d6812d4dea186477114d1a47c',1,'compute_interior_ghost_bxs_xy(const Box &bx, const Box &domain, const int &width, const int &set_width, Box &bx_xlo, Box &bx_xhi, Box &bx_ylo, Box &bx_yhi, const IntVect &ng_vect, const bool get_int_ng): ERF_InteriorGhostCells.cpp'],['../ERF__Utils_8H.html#aaa3f051b9681a4e20d0d88b3715d8897',1,'compute_interior_ghost_bxs_xy(const amrex::Box &bx, const amrex::Box &domain, const int &width, const int &set_width, amrex::Box &bx_xlo, amrex::Box &bx_xhi, amrex::Box &bx_ylo, amrex::Box &bx_yhi, const amrex::IntVect &ng_vect=amrex::IntVect(0, 0, 0), const bool get_int_ng=false): ERF_Utils.H']]], + ['compute_5fmost_5fbcs_321',['compute_most_bcs',['../classABLMost.html#ac1b3a987e1f8518eec9552f6b747a4b1',1,'ABLMost::compute_most_bcs(const int &lev, const amrex::Vector< amrex::MultiFab * > &mfs, amrex::MultiFab *xxmom_flux, amrex::MultiFab *yymom_flux, amrex::MultiFab *zzmom_flux, amrex::MultiFab *xymom_flux, amrex::MultiFab *yxmom_flux, amrex::MultiFab *xzmom_flux, amrex::MultiFab *zxmom_flux, amrex::MultiFab *yzmom_flux, amrex::MultiFab *zymom_flux, amrex::MultiFab *xheat_flux, amrex::MultiFab *yheat_flux, amrex::MultiFab *zheat_flux, amrex::MultiFab *xqv_flux, amrex::MultiFab *yqv_flux, amrex::MultiFab *zqv_flux, amrex::MultiFab *z_phys, const FluxCalc &flux_comp)'],['../classABLMost.html#a10ead55e11cc666e966cc68a1d1513b9',1,'ABLMost::compute_most_bcs(const int &lev, const Vector< MultiFab * > &mfs, MultiFab *xxmom_flux, MultiFab *yymom_flux, MultiFab *zzmom_flux, MultiFab *xymom_flux, MultiFab *yxmom_flux, MultiFab *xzmom_flux, MultiFab *zxmom_flux, MultiFab *yzmom_flux, MultiFab *zymom_flux, MultiFab *xheat_flux, MultiFab *yheat_flux, MultiFab *zheat_flux, MultiFab *xqv_flux, MultiFab *yqv_flux, MultiFab *zqv_flux, MultiFab *z_phys, const FluxCalc &flux_comp)']]], + ['compute_5fpblh_322',['compute_pblh',['../classABLMost.html#a7f3d29d94d0808b3e0fe083396da8557',1,'ABLMost::compute_pblh()'],['../structMYNNPBLH.html#a3911e13c78754ba2bf50e3e94f74bba8',1,'MYNNPBLH::compute_pblh()'],['../classABLMost.html#af57fb2913f44e158afcc637a342df049',1,'ABLMost::compute_pblh()']]], + ['compute_5fplane_5faverages_323',['compute_plane_averages',['../classMOSTAverage.html#ab85828af24cd22d737931c51862389e4',1,'MOSTAverage']]], + ['compute_5fpower_5foutput_324',['compute_power_output',['../classFitch.html#a1edfa2cd3db9e6aa95130f24307ac623',1,'Fitch::compute_power_output()'],['../classSimpleAD.html#ab13cca46ef87d42822ab2228976fc9ed',1,'SimpleAD::compute_power_output()'],['../classGeneralAD.html#af6b71032fe0417e12b9aefff0ba2066b',1,'GeneralAD::compute_power_output()'],['../classEWP.html#af9cd3be628c58fca164e35db4a559fd9',1,'EWP::compute_power_output()']]], + ['compute_5fq_5fflux_325',['compute_q_flux',['../structrotate__flux.html#a4a217b139f9bcbfdd615b4decb4c2f17',1,'rotate_flux::compute_q_flux()'],['../structcustom__flux.html#ae9e13bc10b4594df556671d9a042b48b',1,'custom_flux::compute_q_flux()'],['../structdonelan__flux.html#adb397919f3dc33f33d8bdc7b99c52efc',1,'donelan_flux::compute_q_flux()'],['../structmoeng__flux.html#a5d40e64bd085af2f4c63cfa1e9e20aa6',1,'moeng_flux::compute_q_flux()']]], + ['compute_5fregion_5faverages_326',['compute_region_averages',['../classMOSTAverage.html#aaea0b00766b3cdeefd2b54bade8a86bd',1,'MOSTAverage']]], + ['compute_5fsource_5fterms_5ffn_5fft_327',['compute_source_terms_Fn_Ft',['../ERF__AdvanceGeneralAD_8cpp.html#afffd9801c692fcb424381db8ca2dc8f2',1,'ERF_AdvanceGeneralAD.cpp']]], + ['compute_5ft_5fflux_328',['compute_t_flux',['../structrotate__flux.html#a7827a8b9fcf4800189b67242befc1c31',1,'rotate_flux::compute_t_flux()'],['../structcustom__flux.html#abb193ac77724a6452a6068c3b5954081',1,'custom_flux::compute_t_flux()'],['../structdonelan__flux.html#a999e3bdb322d29fcdfbd51047fb32ee0',1,'donelan_flux::compute_t_flux()'],['../structmoeng__flux.html#a946d89f0b1c8287c83bea9ff628bdb1e',1,'moeng_flux::compute_t_flux()']]], + ['compute_5fu_5fflux_329',['compute_u_flux',['../structrotate__flux.html#ab29d4027d09cb56c8cce2fab327bd758',1,'rotate_flux::compute_u_flux()'],['../structcustom__flux.html#a6ab8b167f190f9b0c4c6adb05acfff40',1,'custom_flux::compute_u_flux()'],['../structdonelan__flux.html#a44a032acc6bd6f42ff90f5a0ac14f4cf',1,'donelan_flux::compute_u_flux()'],['../structmoeng__flux.html#a2451f21fea8f87cec2e5f626c36489cb',1,'moeng_flux::compute_u_flux()']]], + ['compute_5fv_5fflux_330',['compute_v_flux',['../structrotate__flux.html#aca0eb2ba8e9e5fb863297a39ad7cd140',1,'rotate_flux::compute_v_flux()'],['../structcustom__flux.html#a2fe8dd883e33e274f6e44f9c0c5cf118',1,'custom_flux::compute_v_flux()'],['../structdonelan__flux.html#ad2da09025b821f79782fa580010c4df2',1,'donelan_flux::compute_v_flux()'],['../structmoeng__flux.html#a5ec0786b043f57c8c41edfd677dde8c9',1,'moeng_flux::compute_v_flux()']]], + ['compute_5fvapor_5fpressure_331',['compute_vapor_pressure',['../ERF__EOS_8H.html#a380a4683a461f710517afc27bc29d46f',1,'ERF_EOS.H']]], + ['compute_5fzrel_5fatcellcenter_332',['Compute_Zrel_AtCellCenter',['../ERF__TerrainMetrics_8H.html#a41f9b3a5604791daf44935b10a55a565',1,'ERF_TerrainMetrics.H']]], + ['computediffusivitymynn25_333',['ComputeDiffusivityMYNN25',['../ERF__PBLModels_8H.html#af2bea8fffff60778a8e48189b4406a03',1,'ComputeDiffusivityMYNN25(const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &cons_in, amrex::MultiFab &eddyViscosity, const amrex::Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool use_moisture, int level, const amrex::BCRec *bc_ptr, bool, const std::unique_ptr< amrex::MultiFab > &z_phys_nd, const int RhoQv_comp, const int RhoQr_comp): ERF_PBLModels.H'],['../ERF__ComputeDiffusivityMYNN25_8cpp.html#a4b51698073bd67922bc46675fce968cf',1,'ComputeDiffusivityMYNN25(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_moisture, int level, const BCRec *bc_ptr, bool, const std::unique_ptr< MultiFab > &z_phys_nd, const int RhoQv_comp, const int RhoQr_comp): ERF_ComputeDiffusivityMYNN25.cpp']]], + ['computediffusivityysu_334',['ComputeDiffusivityYSU',['../ERF__PBLModels_8H.html#ace7a2f37421af958b8f63b049b7c0835',1,'ComputeDiffusivityYSU(const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &cons_in, amrex::MultiFab &eddyViscosity, const amrex::Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool use_moisture, int level, const amrex::BCRec *bc_ptr, bool, const std::unique_ptr< amrex::MultiFab > &z_phys_nd): ERF_PBLModels.H'],['../ERF__ComputeDiffusivityYSU_8cpp.html#a22f1a268ea7d16d0817f082a47ffc98a',1,'ComputeDiffusivityYSU(const MultiFab &xvel, const MultiFab &yvel, const MultiFab &cons_in, MultiFab &eddyViscosity, const Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool, int level, const BCRec *bc_ptr, bool, const std::unique_ptr< MultiFab > &z_phys_nd): ERF_ComputeDiffusivityYSU.cpp']]], + ['computedt_335',['ComputeDt',['../classERF.html#aa38639155e79bab8a0c283aa6e7afa81',1,'ERF']]], + ['computefluxes_336',['ComputeFluxes',['../classSLM.html#aaafd49733163332a7f9616374d103cbb',1,'SLM::ComputeFluxes()'],['../classMM5.html#a109a5f7a252a6ab6c8e5373ca68c32fb',1,'MM5::ComputeFluxes()']]], + ['computeghostcells_337',['ComputeGhostCells',['../classERF.html#ae68b1f54d196d0a4b19716d65a59d4c5',1,'ERF']]], + ['computeqkesourceterms_338',['ComputeQKESourceTerms',['../ERF__PBLModels_8H.html#aeebffefd91e8d17e6af632b6076ce455',1,'ERF_PBLModels.H']]], + ['computesmnsmn_339',['ComputeSmnSmn',['../ERF__EddyViscosity_8H.html#a1d775f0ce64d37053b33d514438ee856',1,'ERF_EddyViscosity.H']]], + ['computestrain_5fn_340',['ComputeStrain_N',['../ERF__ComputeStrain__N_8cpp.html#a72f6c981375a19d6e96b875837b57ae0',1,'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 BCRec *bc_ptr, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_m, const Array4< const Real > &mf_u, const Array4< const Real > &mf_v): ERF_ComputeStrain_N.cpp'],['../ERF__Diffusion_8H.html#a6338bbbd04537c72c5a57e8a6a52d3c0',1,'ComputeStrain_N(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Box domain, const amrex::Array4< const amrex::Real > &u, const amrex::Array4< const amrex::Real > &v, const amrex::Array4< const amrex::Real > &w, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau23, const amrex::BCRec *bc_ptr, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v): ERF_Diffusion.H']]], + ['computestrain_5ft_341',['ComputeStrain_T',['../ERF__ComputeStrain__T_8cpp.html#a0234205e441f6147ae82e31753d893e2',1,'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 > &tau13, Array4< Real > &tau21, Array4< Real > &tau23, Array4< Real > &tau31, Array4< Real > &tau32, const Array4< const Real > &z_nd, const Array4< const Real > &detJ, const BCRec *bc_ptr, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_m, const Array4< const Real > &mf_u, const Array4< const Real > &mf_v): ERF_ComputeStrain_T.cpp'],['../ERF__Diffusion_8H.html#a1c7f3e532227403ddafd0ebde7365262',1,'ComputeStrain_T(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Box domain, const amrex::Array4< const amrex::Real > &u, const amrex::Array4< const amrex::Real > &v, const amrex::Array4< const amrex::Real > &w, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau21, amrex::Array4< amrex::Real > &tau23, amrex::Array4< amrex::Real > &tau31, amrex::Array4< amrex::Real > &tau32, const amrex::Array4< const amrex::Real > &z_nd, const amrex::Array4< const amrex::Real > &detJ, const amrex::BCRec *bc_ptr, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v): ERF_Diffusion.H']]], + ['computestressconsvisc_5fn_342',['ComputeStressConsVisc_N',['../ERF__ComputeStress__N_8cpp.html#a90e3a746cdb875f5eb328b01d5168506',1,'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): ERF_ComputeStress_N.cpp'],['../ERF__Diffusion_8H.html#a094da213d571d4c5be5c1f8a355be78f',1,'ComputeStressConsVisc_N(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Real mu_eff, const amrex::Array4< const amrex::Real > &cell_data, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau23, const amrex::Array4< const amrex::Real > &er_arr): ERF_Diffusion.H']]], + ['computestressconsvisc_5ft_343',['ComputeStressConsVisc_T',['../ERF__ComputeStress__T_8cpp.html#af10fca5e9a1f97c4743e76cc935230bd',1,'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 > &tau13, Array4< Real > &tau21, Array4< Real > &tau23, Array4< Real > &tau31, 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): ERF_ComputeStress_T.cpp'],['../ERF__Diffusion_8H.html#a61297def6144337bbf34010d410f4e4a',1,'ComputeStressConsVisc_T(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Real mu_eff, const amrex::Array4< const amrex::Real > &cell_data, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau21, amrex::Array4< amrex::Real > &tau23, amrex::Array4< amrex::Real > &tau31, amrex::Array4< amrex::Real > &tau32, const amrex::Array4< const amrex::Real > &er_arr, const amrex::Array4< const amrex::Real > &z_nd, const amrex::Array4< const amrex::Real > &detJ, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv): ERF_Diffusion.H']]], + ['computestressvarvisc_5fn_344',['ComputeStressVarVisc_N',['../ERF__ComputeStress__N_8cpp.html#a3ccb3579df8fa971a01bc7504db45a1e',1,'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): ERF_ComputeStress_N.cpp'],['../ERF__Diffusion_8H.html#af89bc368023b73bc1d4e3844d74b8ec2',1,'ComputeStressVarVisc_N(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Real mu_eff, const amrex::Array4< const amrex::Real > &mu_turb, const amrex::Array4< const amrex::Real > &cell_data, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau23, const amrex::Array4< const amrex::Real > &er_arr): ERF_Diffusion.H']]], + ['computestressvarvisc_5ft_345',['ComputeStressVarVisc_T',['../ERF__ComputeStress__T_8cpp.html#a25509867afb4acb014b0eae79da251ae',1,'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 > &tau13, Array4< Real > &tau21, Array4< Real > &tau23, Array4< Real > &tau31, 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): ERF_ComputeStress_T.cpp'],['../ERF__Diffusion_8H.html#a4151c371e6c66295da065ed9ed323dbe',1,'ComputeStressVarVisc_T(amrex::Box bxcc, amrex::Box tbxxy, amrex::Box tbxxz, amrex::Box tbxyz, amrex::Real mu_eff, const amrex::Array4< const amrex::Real > &mu_turb, const amrex::Array4< const amrex::Real > &cell_data, amrex::Array4< amrex::Real > &tau11, amrex::Array4< amrex::Real > &tau22, amrex::Array4< amrex::Real > &tau33, amrex::Array4< amrex::Real > &tau12, amrex::Array4< amrex::Real > &tau13, amrex::Array4< amrex::Real > &tau21, amrex::Array4< amrex::Real > &tau23, amrex::Array4< amrex::Real > &tau31, amrex::Array4< amrex::Real > &tau32, const amrex::Array4< const amrex::Real > &er_arr, const amrex::Array4< const amrex::Real > &z_nd, const amrex::Array4< const amrex::Real > &detJ, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv): ERF_Diffusion.H']]], + ['computetsurf_346',['ComputeTsurf',['../classSLM.html#a0db509945fed4bf6ffae276c1c183707',1,'SLM::ComputeTsurf()'],['../classMM5.html#a9fc8c9cf8b165b28583be7bb7e8ac7c3',1,'MM5::ComputeTsurf()']]], + ['computeturbulentviscosity_347',['ComputeTurbulentViscosity',['../ERF__ComputeTurbulentViscosity_8cpp.html#a3865612b809df828f44e9c18218b1e37',1,'ComputeTurbulentViscosity(const MultiFab &xvel, const MultiFab &yvel, const MultiFab &Tau11, const MultiFab &Tau22, const MultiFab &Tau33, const MultiFab &Tau12, const MultiFab &Tau13, const MultiFab &Tau23, const MultiFab &cons_in, MultiFab &eddyViscosity, MultiFab &Hfx1, MultiFab &Hfx2, MultiFab &Hfx3, MultiFab &Diss, const Geometry &geom, const MultiFab &mapfac_u, const MultiFab &mapfac_v, const std::unique_ptr< MultiFab > &z_phys_nd, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const bool &exp_most, const bool &use_moisture, int level, const BCRec *bc_ptr, bool vert_only): ERF_ComputeTurbulentViscosity.cpp'],['../ERF__EddyViscosity_8H.html#a2b687f91a8d8385766be20222af4ccac',1,'ComputeTurbulentViscosity(const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &Tau11, const amrex::MultiFab &Tau22, const amrex::MultiFab &Tau33, const amrex::MultiFab &Tau12, const amrex::MultiFab &Tau13, const amrex::MultiFab &Tau23, const amrex::MultiFab &cons_in, amrex::MultiFab &eddyViscosity, amrex::MultiFab &Hfx1, amrex::MultiFab &Hfx2, amrex::MultiFab &Hfx3, amrex::MultiFab &Diss, const amrex::Geometry &geom, const amrex::MultiFab &mapfac_u, const amrex::MultiFab &mapfac_v, const std::unique_ptr< amrex::MultiFab > &z_phys_nd, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const bool &exp_most, const bool &use_moisture, int level, const amrex::BCRec *bc_ptr, bool vert_only=false): ERF_EddyViscosity.H']]], + ['computeturbulentviscosityles_348',['ComputeTurbulentViscosityLES',['../ERF__ComputeTurbulentViscosity_8cpp.html#a730dd933a41b48fe17b15e46d4dce964',1,'ERF_ComputeTurbulentViscosity.cpp']]], + ['computeverticalderivativespbl_349',['ComputeVerticalDerivativesPBL',['../ERF__PBLModels_8H.html#a33bb37a040bfadb1956539905ef016c3',1,'ERF_PBLModels.H']]], + ['config_350',['config',['../structMYNNLevel25.html#a6065f4b0ba5299d0be0f92a614188034',1,'MYNNLevel25']]], + ['cons_351',['cons',['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daa2e7100afbf5e7a39371f1cb29f6f570a',1,'IntVars::cons()'],['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a47abe072e12c61d29cde15a509a0664b',1,'Vars::cons()']]], + ['cons_5fbc_352',['cons_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aaaf601346b01655b32acf66d07b856aec',1,'BCVars']]], + ['cons_5fnames_353',['cons_names',['../classERF.html#afd8cd5a477754776135befa668fdd0c9',1,'ERF']]], + ['cons_5fto_5fprim_354',['cons_to_prim',['../ERF__TI__utils_8H.html#a76b27b6105fe279f9a43296072c843b3',1,'ERF_TI_utils.H']]], + ['const_5fgrav_355',['CONST_GRAV',['../ERF__Constants_8H.html#ac2d0c304ab1117368778efcda612de43',1,'ERF_Constants.H']]], + ['constant_356',['CONSTANT',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13a8d6b5cada83510220f59e00ce86d4d92',1,'ABLMost']]], + ['constant_357',['Constant',['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735acb17869fe51048b5a5c4c6106551a255',1,'ERF_DiffStruct.H']]], + ['constant_5fdensity_358',['constant_density',['../structSolverChoice.html#aa9cf425ef14a7e28ec3411044e737b23',1,'SolverChoice']]], + ['constantalpha_359',['ConstantAlpha',['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735a6f0229db491c3b01860363456dc57288',1,'ERF_DiffStruct.H']]], + ['construct_5ferffillpatchers_360',['Construct_ERFFillPatchers',['../classERF.html#adc284f421c5fd9dd15c0e5cbe4ff5fc8',1,'ERF']]], + ['containerhaselement_361',['containerHasElement',['../ERF__Plotfile_8cpp.html#a1f8554e7b211b0acfc202e8a600e7d67',1,'ERF_Plotfile.cpp']]], + ['coord_362',['Coord',['../ERF__DataStruct_8H.html#a627f1f843904477f763577ad1460de01',1,'ERF_DataStruct.H']]], + ['copy_5fmicro_5fto_5fstate_363',['Copy_Micro_to_State',['../classSAM.html#a007ed40ac7278996d257b4c0ab6c1320',1,'SAM::Copy_Micro_to_State()'],['../classNullMoist.html#a11a25944d4ddb955f74e355838b9d8b0',1,'NullMoist::Copy_Micro_to_State()'],['../classKessler.html#a747a85d4c8004b299ca49dcb1f221c7c',1,'Kessler::Copy_Micro_to_State()'],['../classNullSurf.html#a45d066ae7b9d2435f5477e35dd75bcfb',1,'NullSurf::Copy_Micro_to_State()']]], + ['copy_5fstate_5fto_5fmicro_364',['Copy_State_to_Micro',['../classNullMoist.html#aacb06ee696c6870e899d1bc26aa9933e',1,'NullMoist::Copy_State_to_Micro()'],['../classSAM.html#a1df931f91be89514c09f69f24cfeca53',1,'SAM::Copy_State_to_Micro()'],['../classKessler.html#a18f83fc4dff53c8c29ee9ee974e65ac2',1,'Kessler::Copy_State_to_Micro()'],['../classNullSurf.html#a1c31c18677e12226716217ca87cd526c',1,'NullSurf::Copy_State_to_Micro()']]], + ['coriolis_5f3d_365',['coriolis_3d',['../structSolverChoice.html#a7e93900ec3e84826fcf1e02435bdae42',1,'SolverChoice']]], + ['coriolis_5ffactor_366',['coriolis_factor',['../structSolverChoice.html#a1163778ed56af6977001ef4ec55a3da3',1,'SolverChoice']]], + ['cosphi_367',['cosphi',['../structSolverChoice.html#a411fbfea721cd40033e113cf54a8047f',1,'SolverChoice']]], + ['coszrs_368',['coszrs',['../classRadiation.html#ada2d1a89ee69c66d7dd3ebf7a2f98d7b',1,'Radiation']]], + ['coupling_5ftype_369',['coupling_type',['../structSolverChoice.html#af976afa61859c07e6249963edc367c2d',1,'SolverChoice']]], + ['cp_5fd_370',['Cp_d',['../ERF__Constants_8H.html#a1ee33e063343c8fb15ed025c456ebd46',1,'ERF_Constants.H']]], + ['cp_5fl_371',['Cp_l',['../ERF__Constants_8H.html#acecae1da25fb8c8d32d1f175e18df41f',1,'ERF_Constants.H']]], + ['cp_5fv_372',['Cp_v',['../ERF__Constants_8H.html#aea1cea8d633adb36e2ea5018925b68ee',1,'ERF_Constants.H']]], + ['crain_373',['crain',['../ERF__Constants_8H.html#aedc41c83fba50dcbd5e1385007d3edec',1,'ERF_Constants.H']]], + ['create_374',['create',['../classncutils_1_1NCFile.html#a47bdccee2cc22a735ca715d9c88e4f6b',1,'ncutils::NCFile']]], + ['create_5fpar_375',['create_par',['../classncutils_1_1NCFile.html#a6607bd5f3f75b451e2436ff713931f19',1,'ncutils::NCFile']]], + ['crefwlwi_376',['crefwlwi',['../classMam4__aer.html#a32d3651a6f9299ecee85fee320dfda50',1,'Mam4_aer']]], + ['crefwlwr_377',['crefwlwr',['../classMam4__aer.html#ae1eea21725e40b02e21086cd73dc9d66',1,'Mam4_aer']]], + ['crefwswi_378',['crefwswi',['../classMam4__aer.html#ad48a521caea628250a1faa6154f6094b',1,'Mam4_aer']]], + ['crefwswr_379',['crefwswr',['../classMam4__aer.html#a139c9796ada84ff24405114f8691d7cd',1,'Mam4_aer']]], + ['cs_380',['Cs',['../structTurbChoice.html#aa75682bb872d7917ffb8fddb21532f40',1,'TurbChoice']]], + ['csnow_381',['csnow',['../ERF__Constants_8H.html#a00a835048e6d7b67e76cd044f483a0e2',1,'ERF_Constants.H']]], + ['custom_382',['CUSTOM',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0a72baef04098f035e8a320b03ad197818',1,'ABLMost']]], + ['custom_5fflux_383',['custom_flux',['../structcustom__flux.html',1,'custom_flux'],['../structcustom__flux.html#aa9715fd8b84d6df19fa17c89a703210a',1,'custom_flux::custom_flux()']]], + ['custom_5fforcing_5fprim_5fvars_384',['custom_forcing_prim_vars',['../structSolverChoice.html#aae4f377d36d01b85a1f322c45009ac75',1,'SolverChoice']]], + ['custom_5fgeostrophic_5fprofile_385',['custom_geostrophic_profile',['../structSolverChoice.html#a5e8754b29072596a584633734a9f64ef',1,'SolverChoice']]], + ['custom_5fmoisture_5fforcing_386',['custom_moisture_forcing',['../structSolverChoice.html#aa2e312b4e6d08797fc3c1b6d67313d48',1,'SolverChoice']]], + ['custom_5fqstar_387',['custom_qstar',['../classABLMost.html#a31707b89fbbbdeb445ba35ed240046c3',1,'ABLMost']]], + ['custom_5frhotheta_5fforcing_388',['custom_rhotheta_forcing',['../structSolverChoice.html#a4e81a09c9f454c680568b7776a3ed90e',1,'SolverChoice']]], + ['custom_5ftstar_389',['custom_tstar',['../classABLMost.html#afbd0b1a37d9e9d716d82910db203e82f',1,'ABLMost']]], + ['custom_5fustar_390',['custom_ustar',['../classABLMost.html#a1bce26c6253a6191424e7b753cd24cfa',1,'ABLMost']]], + ['custom_5fw_5fsubsidence_391',['custom_w_subsidence',['../structSolverChoice.html#a596f061b796ada0389c81a6125150b6e',1,'SolverChoice']]] ]; diff --git a/search/all_3.js b/search/all_3.js index 4089ade8d..e59d2e9f2 100644 --- a/search/all_3.js +++ b/search/all_3.js @@ -1,103 +1,103 @@ var searchData= [ - ['d_5fhavg_5fdensity_393',['d_havg_density',['../classERF.html#a84cf7616e7b3928f08f4bd56112db01e',1,'ERF']]], - ['d_5fhavg_5fpressure_394',['d_havg_pressure',['../classERF.html#a9a4f076c56f31fbb5e68c09706605a05',1,'ERF']]], - ['d_5fhavg_5fqc_395',['d_havg_qc',['../classERF.html#a8199cc1ec38b9dfd47262ccc7df6a941',1,'ERF']]], - ['d_5fhavg_5fqv_396',['d_havg_qv',['../classERF.html#a2b0085123e02051ac4c2a72e9972e6ee',1,'ERF']]], - ['d_5fhavg_5ftemperature_397',['d_havg_temperature',['../classERF.html#a20350959b7b3e252ee3a802e7998ca8d',1,'ERF']]], - ['d_5frayleigh_5fptrs_398',['d_rayleigh_ptrs',['../classERF.html#ad598bde8e728479faaa7c2820096b47a',1,'ERF']]], - ['d_5frhoqt_5fsrc_399',['d_rhoqt_src',['../classERF.html#a838687881ef3626f932d0e95ceff0e53',1,'ERF']]], - ['d_5frhotheta_5fsrc_400',['d_rhotheta_src',['../classERF.html#a0c1fdcfbc9cbd6cb13e41d1170b161f8',1,'ERF']]], - ['d_5fsponge_5fptrs_401',['d_sponge_ptrs',['../classERF.html#a3b9bcb54c278dfec6027e9727cc01bc5',1,'ERF']]], - ['d_5fu_5fgeos_402',['d_u_geos',['../classERF.html#ac020980af9dbf46be43dd9f7127c06da',1,'ERF']]], - ['d_5fv_5fgeos_403',['d_v_geos',['../classERF.html#a7d245afb7b3236b5967902f50bf9000b',1,'ERF']]], - ['d_5fw_5fsubsid_404',['d_w_subsid',['../classERF.html#ac94ddee2f501dbcea2a516284b7119b5',1,'ERF']]], - ['data_405',['data',['../structNDArray.html#a9d3679c95b5bf1813a7edaedf221837e',1,'NDArray']]], - ['data_5fsampler_406',['data_sampler',['../classERF.html#a83ad7f8f4cf9920a6798f3b931355a2f',1,'ERF']]], + ['d_5fhavg_5fdensity_392',['d_havg_density',['../classERF.html#a84cf7616e7b3928f08f4bd56112db01e',1,'ERF']]], + ['d_5fhavg_5fpressure_393',['d_havg_pressure',['../classERF.html#a9a4f076c56f31fbb5e68c09706605a05',1,'ERF']]], + ['d_5fhavg_5fqc_394',['d_havg_qc',['../classERF.html#a8199cc1ec38b9dfd47262ccc7df6a941',1,'ERF']]], + ['d_5fhavg_5fqv_395',['d_havg_qv',['../classERF.html#a2b0085123e02051ac4c2a72e9972e6ee',1,'ERF']]], + ['d_5fhavg_5ftemperature_396',['d_havg_temperature',['../classERF.html#a20350959b7b3e252ee3a802e7998ca8d',1,'ERF']]], + ['d_5frayleigh_5fptrs_397',['d_rayleigh_ptrs',['../classERF.html#ad598bde8e728479faaa7c2820096b47a',1,'ERF']]], + ['d_5frhoqt_5fsrc_398',['d_rhoqt_src',['../classERF.html#a838687881ef3626f932d0e95ceff0e53',1,'ERF']]], + ['d_5frhotheta_5fsrc_399',['d_rhotheta_src',['../classERF.html#a0c1fdcfbc9cbd6cb13e41d1170b161f8',1,'ERF']]], + ['d_5fsponge_5fptrs_400',['d_sponge_ptrs',['../classERF.html#a3b9bcb54c278dfec6027e9727cc01bc5',1,'ERF']]], + ['d_5fu_5fgeos_401',['d_u_geos',['../classERF.html#ac020980af9dbf46be43dd9f7127c06da',1,'ERF']]], + ['d_5fv_5fgeos_402',['d_v_geos',['../classERF.html#a7d245afb7b3236b5967902f50bf9000b',1,'ERF']]], + ['d_5fw_5fsubsid_403',['d_w_subsid',['../classERF.html#ac94ddee2f501dbcea2a516284b7119b5',1,'ERF']]], + ['data_404',['data',['../structNDArray.html#a9d3679c95b5bf1813a7edaedf221837e',1,'NDArray']]], + ['data_5fsampler_405',['data_sampler',['../classERF.html#a83ad7f8f4cf9920a6798f3b931355a2f',1,'ERF']]], + ['datalog_406',['datalog',['../classERF.html#a1cade630b005dbcc0f644987ef3db287',1,'ERF']]], ['datalog_407',['DataLog',['../classERF.html#aa2c3ee1910008b828b9da79ccdfe3871',1,'ERF']]], - ['datalog_408',['datalog',['../classERF.html#a1cade630b005dbcc0f644987ef3db287',1,'ERF']]], - ['datalogname_409',['DataLogName',['../classERF.html#a16e1f6b8bbb05ae738daf2abe626c159',1,'ERF']]], - ['datalogname_410',['datalogname',['../classERF.html#a9248a4eb025c2647e003f838cba52a21',1,'ERF']]], - ['debug_411',['debug',['../structTurbulentPerturbation.html#aa7c1ce943bf06d347d762131ec0c24cf',1,'TurbulentPerturbation']]], - ['def_5farray_412',['def_array',['../classncutils_1_1NCGroup.html#acf969a6598527e2d00a84d35e0522fa1',1,'ncutils::NCGroup']]], - ['def_5fdim_413',['def_dim',['../classncutils_1_1NCGroup.html#a8c9376a217f29012f565a13f131bea84',1,'ncutils::NCGroup']]], - ['def_5fvar_414',['def_var',['../classncutils_1_1NCGroup.html#ae640d6aef18835f643e3cbaacb43e682',1,'ncutils::NCGroup']]], - ['define_415',['Define',['../classSAM.html#aba6460f2d34882d6b512574106e44531',1,'SAM::Define()'],['../classMM5.html#aca75345d5bf1a5ef4ce434047cc70437',1,'MM5::Define()'],['../classNullSurf.html#a5aec888a24181ce049b48ed10817489c',1,'NullSurf::Define()'],['../classSLM.html#aa6b96866fc326fe740b163be0141ff56',1,'SLM::Define()'],['../classEulerianMicrophysics.html#a444c916c5bb1167ea1efc9f2b9595436',1,'EulerianMicrophysics::Define()'],['../classMicrophysics.html#a380240aa9ec93af02a9b27ba1be4172a',1,'Microphysics::Define()'],['../classKessler.html#a5e989e5755fb57a853e2f1f0ec4c49e8',1,'Kessler::Define()'],['../classNullMoist.html#aab112947c592c330b45a2d7e5529ec07',1,'NullMoist::Define()'],['../classLandSurface.html#ae2087847b83c6a9e4453ccaa110134ce',1,'LandSurface::Define()'],['../classERFFillPatcher.html#a3dcdf3322c58c07eec765f6e3413ba68',1,'ERFFillPatcher::Define()']]], - ['define_5fdrag_5ffield_416',['define_drag_field',['../classForestDrag.html#adf4abd455b45d7a38422ffe2dc7b499f',1,'ForestDrag']]], - ['define_5ferffillpatchers_417',['Define_ERFFillPatchers',['../classERF.html#ac0951404aa6802aad7a3be6b7375dfa2',1,'ERF']]], - ['define_5flevel_5fdata_418',['define_level_data',['../classReadBndryPlanes.html#a16ed881bb428b7abb89e4284b356c8d6',1,'ReadBndryPlanes']]], - ['dei_419',['dei',['../classRadiation.html#a5d6b802fde5710034668dec77e7a39a8',1,'Radiation']]], - ['density_5faer_420',['density_aer',['../structPhysProp_1_1physprop__t.html#a8df74558339352f0e8c0031fc3160a09',1,'PhysProp::physprop_t']]], - ['depth_421',['depth',['../classABLMost.html#a38ed37dd984fcc7be3b5ae04b7272459',1,'ABLMost']]], - ['deriv_5foutputs_422',['deriv_outputs',['../classWaterVaporSat.html#a9d72a29e54869f42ec419639d6c3d70f',1,'WaterVaporSat']]], - ['derive_5fdiag_5fprofiles_423',['derive_diag_profiles',['../classERF.html#ab5b66549344d8b04b126fa0ef16c7ca2',1,'ERF']]], - ['derive_5fdiag_5fprofiles_5fstag_424',['derive_diag_profiles_stag',['../classERF.html#a8b93b715895b00e86e7db653d2a7284a',1,'ERF']]], - ['derive_5fstress_5fprofiles_425',['derive_stress_profiles',['../classERF.html#ad7886dcab90f37a8fcc91ede0c68b6cb',1,'ERF']]], - ['derive_5fstress_5fprofiles_5fstag_426',['derive_stress_profiles_stag',['../classERF.html#ae09680325ba108583147eb2e254a266e',1,'ERF']]], - ['derive_5fupwp_427',['derive_upwp',['../classERF.html#af1981699bedbbfd6785f26ca340a74d8',1,'ERF']]], - ['derived_428',['derived',['../namespacederived.html',1,'']]], - ['derived_5fnames_429',['derived_names',['../classERF.html#a9fc0f6e6ca35036d2e3a36dd42e66435',1,'ERF']]], - ['des_430',['des',['../classRadiation.html#a6fb15791b58bf08aea781bc906b3c431',1,'Radiation']]], - ['destag_5fprofiles_431',['destag_profiles',['../classERF.html#a65f19c55c8d3669445866a1c3bbb628d',1,'ERF']]], - ['detj_5fcc_432',['detJ_cc',['../classERF.html#a30f8b851ed29d38695d44cff257f14e6',1,'ERF']]], - ['detj_5fcc_5fnew_433',['detJ_cc_new',['../classERF.html#ae39bf64c5306b1dd939d82d9df728daa',1,'ERF']]], - ['detj_5fcc_5fsrc_434',['detJ_cc_src',['../classERF.html#a9a411e0ea9d9bdbfab957c8081229091',1,'ERF']]], - ['dgnum_435',['dgnum',['../structPhysProp_1_1physprop__t.html#a66b63e7d4250ce345343af372d529193',1,'PhysProp::physprop_t']]], - ['dgnumdry_5fm_436',['dgnumdry_m',['../classMam4__aer.html#a12eaca69207827a3988597c3e2f2bb0e',1,'Mam4_aer']]], - ['dgnumhi_437',['dgnumhi',['../structPhysProp_1_1physprop__t.html#a0a6b0b2e1d1906ac628da5c03c54dd2c',1,'PhysProp::physprop_t']]], - ['dgnumlo_438',['dgnumlo',['../structPhysProp_1_1physprop__t.html#a2e423bf4c825875ea8d9a72ead6c3b20',1,'PhysProp::physprop_t']]], - ['dgnumwet_5fm_439',['dgnumwet_m',['../classMam4__aer.html#a69a1949364f03af84c9e4c12973a5223',1,'Mam4_aer']]], - ['diffchoice_440',['diffChoice',['../structSolverChoice.html#a396122e87a3d15c4ec8666d7dd18c095',1,'SolverChoice']]], - ['diffchoice_441',['DiffChoice',['../structDiffChoice.html',1,'']]], - ['diffelq_442',['diffelq',['../ERF__Constants_8H.html#a4e1c44dade7fcd7648d3e87ba5bba4c1',1,'ERF_Constants.H']]], - ['diffuse_5fke_5f3d_443',['diffuse_KE_3D',['../structTurbChoice.html#a5864f0fe05bcbd45554301ade763d5ca',1,'TurbChoice']]], - ['diffuse_5fmoistvars_444',['diffuse_moistvars',['../structMYNNLevel25.html#af677ab24bae6b1f78751489a8df5b1be',1,'MYNNLevel25']]], - ['diffusionsrcformom_5fn_445',['DiffusionSrcForMom_N',['../ERF__DiffusionSrcForMom__N_8cpp.html#a426fe9fce28e7c29e11b29197e98f6a4',1,'DiffusionSrcForMom_N(const Box &bxx, const Box &bxy, const Box &bxz, const Array4< Real > &rho_u_rhs, const Array4< Real > &rho_v_rhs, const Array4< Real > &rho_w_rhs, const Array4< const Real > &tau11, const Array4< const Real > &tau22, const Array4< const Real > &tau33, const Array4< const Real > &tau12, const Array4< const Real > &tau13, const Array4< const Real > &tau23, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_m, const Array4< const Real > &, const Array4< const Real > &): ERF_DiffusionSrcForMom_N.cpp'],['../ERF__Diffusion_8H.html#a1385ec02c8aa1a6916f0827a359efa2b',1,'DiffusionSrcForMom_N(const amrex::Box &bxx, const amrex::Box &bxy, const amrex::Box &bxz, const amrex::Array4< amrex::Real > &rho_u_rhs, const amrex::Array4< amrex::Real > &rho_v_rhs, const amrex::Array4< amrex::Real > &rho_w_rhs, const amrex::Array4< const amrex::Real > &tau11, const amrex::Array4< const amrex::Real > &tau22, const amrex::Array4< const amrex::Real > &tau33, const amrex::Array4< const amrex::Real > &tau12, const amrex::Array4< const amrex::Real > &tau13, const amrex::Array4< const amrex::Real > &tau23, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v): ERF_Diffusion.H']]], - ['diffusionsrcformom_5ft_446',['DiffusionSrcForMom_T',['../ERF__DiffusionSrcForMom__T_8cpp.html#abd43ffde58dc80eec337c1fa12a0e2cf',1,'DiffusionSrcForMom_T(const Box &bxx, const Box &bxy, const Box &bxz, const Array4< Real > &rho_u_rhs, const Array4< Real > &rho_v_rhs, const Array4< Real > &rho_w_rhs, const Array4< const Real > &tau11, const Array4< const Real > &tau22, const Array4< const Real > &tau33, const Array4< const Real > &tau12, const Array4< const Real > &tau13, const Array4< const Real > &tau21, const Array4< const Real > &tau23, const Array4< const Real > &tau31, const Array4< const Real > &tau32, const Array4< const Real > &detJ, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_m, const Array4< const Real > &, const Array4< const Real > &): ERF_DiffusionSrcForMom_T.cpp'],['../ERF__Diffusion_8H.html#a9c81dadeb1784c3274f6f8c9a9d1bcb7',1,'DiffusionSrcForMom_T(const amrex::Box &bxx, const amrex::Box &bxy, const amrex::Box &bxz, const amrex::Array4< amrex::Real > &rho_u_rhs, const amrex::Array4< amrex::Real > &rho_v_rhs, const amrex::Array4< amrex::Real > &rho_w_rhs, const amrex::Array4< const amrex::Real > &tau11, const amrex::Array4< const amrex::Real > &tau22, const amrex::Array4< const amrex::Real > &tau33, const amrex::Array4< const amrex::Real > &tau12, const amrex::Array4< const amrex::Real > &tau13, const amrex::Array4< const amrex::Real > &tau21, const amrex::Array4< const amrex::Real > &tau23, const amrex::Array4< const amrex::Real > &tau31, const amrex::Array4< const amrex::Real > &tau32, const amrex::Array4< const amrex::Real > &detJ, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v): ERF_Diffusion.H']]], - ['diffusionsrcforstate_5fn_447',['DiffusionSrcForState_N',['../ERF__Diffusion_8H.html#a31a619f70cd632a82eb50a2863c66f82',1,'DiffusionSrcForState_N(const amrex::Box &bx, const amrex::Box &domain, int start_comp, int num_comp, const bool &exp_most, const amrex::Array4< const amrex::Real > &u, const amrex::Array4< const amrex::Real > &v, const amrex::Array4< const amrex::Real > &cell_data, const amrex::Array4< const amrex::Real > &cell_prim, const amrex::Array4< amrex::Real > &cell_rhs, const amrex::Array4< amrex::Real > &xflux, const amrex::Array4< amrex::Real > &yflux, const amrex::Array4< amrex::Real > &zflux, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &cellSizeInv, const amrex::Array4< const amrex::Real > &SmnSmn_a, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v, amrex::Array4< amrex::Real > &hfx_z, amrex::Array4< amrex::Real > &qfx1_z, amrex::Array4< amrex::Real > &qfx2_z, amrex::Array4< amrex::Real > &diss, const amrex::Array4< const amrex::Real > &mu_turb, const SolverChoice &solverChoice, const int level, const amrex::Array4< const amrex::Real > &tm_arr, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > grav_gpu, const amrex::BCRec *bc_ptr, const bool use_most): ERF_Diffusion.H'],['../ERF__DiffusionSrcForState__N_8cpp.html#a61d842d8a45b6d97948ce19b106bba0a',1,'DiffusionSrcForState_N(const Box &bx, const Box &domain, int start_comp, int num_comp, const bool &exp_most, const Array4< const Real > &u, const Array4< const Real > &v, const Array4< const Real > &cell_data, const Array4< const Real > &cell_prim, const Array4< Real > &cell_rhs, const Array4< Real > &xflux, const Array4< Real > &yflux, const Array4< Real > &zflux, const GpuArray< Real, AMREX_SPACEDIM > &cellSizeInv, const Array4< const Real > &SmnSmn_a, const Array4< const Real > &mf_m, const Array4< const Real > &mf_u, const Array4< const Real > &mf_v, Array4< Real > &hfx_z, Array4< Real > &qfx1_z, Array4< Real > &qfx2_z, Array4< Real > &diss, const Array4< const Real > &mu_turb, const SolverChoice &solverChoice, const int level, const Array4< const Real > &tm_arr, const GpuArray< Real, AMREX_SPACEDIM > grav_gpu, const BCRec *bc_ptr, const bool use_most): ERF_DiffusionSrcForState_N.cpp']]], - ['diffusionsrcforstate_5ft_448',['DiffusionSrcForState_T',['../ERF__Diffusion_8H.html#ae72c4a9e8ca7e9d1c84d96bb7bc9c7d0',1,'DiffusionSrcForState_T(const amrex::Box &bx, const amrex::Box &domain, int start_comp, int num_comp, const bool &exp_most, const bool &rot_most, const amrex::Array4< const amrex::Real > &u, const amrex::Array4< const amrex::Real > &v, const amrex::Array4< const amrex::Real > &cell_data, const amrex::Array4< const amrex::Real > &cell_prim, const amrex::Array4< amrex::Real > &cell_rhs, const amrex::Array4< amrex::Real > &xflux, const amrex::Array4< amrex::Real > &yflux, const amrex::Array4< amrex::Real > &zflux, const amrex::Array4< const amrex::Real > &z_nd, const amrex::Array4< const amrex::Real > &ax, const amrex::Array4< const amrex::Real > &ay, const amrex::Array4< const amrex::Real > &az, const amrex::Array4< const amrex::Real > &detJ, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv, const amrex::Array4< const amrex::Real > &SmnSmn_a, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v, amrex::Array4< amrex::Real > &hfx_x, amrex::Array4< amrex::Real > &hfx_y, amrex::Array4< amrex::Real > &hfx_z, amrex::Array4< amrex::Real > &qfx1_x, amrex::Array4< amrex::Real > &qfx1_y, amrex::Array4< amrex::Real > &qfx1_z, amrex::Array4< amrex::Real > &qfx2_z, amrex::Array4< amrex::Real > &diss, const amrex::Array4< const amrex::Real > &mu_turb, const SolverChoice &solverChoice, const int level, const amrex::Array4< const amrex::Real > &tm_arr, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > grav_gpu, const amrex::BCRec *bc_ptr, const bool use_most): ERF_Diffusion.H'],['../ERF__DiffusionSrcForState__T_8cpp.html#ab29316749b16c72caa2fe0b7558397c9',1,'DiffusionSrcForState_T(const Box &bx, const Box &domain, int start_comp, int num_comp, const bool &exp_most, const bool &rot_most, const Array4< const Real > &u, const Array4< const Real > &v, const Array4< const Real > &cell_data, const Array4< const Real > &cell_prim, const Array4< Real > &cell_rhs, const Array4< Real > &xflux, const Array4< Real > &yflux, const Array4< Real > &zflux, const Array4< const Real > &z_nd, const Array4< const Real > &ax, const Array4< const Real > &ay, const Array4< const Real > &az, const Array4< const Real > &detJ, const GpuArray< Real, AMREX_SPACEDIM > &cellSizeInv, const Array4< const Real > &SmnSmn_a, const Array4< const Real > &mf_m, const Array4< const Real > &mf_u, const Array4< const Real > &mf_v, Array4< Real > &hfx_x, Array4< Real > &hfx_y, Array4< Real > &hfx_z, Array4< Real > &qfx1_x, Array4< Real > &qfx1_y, Array4< Real > &qfx1_z, Array4< Real > &qfx2_z, Array4< Real > &diss, const Array4< const Real > &mu_turb, const SolverChoice &solverChoice, const int level, const Array4< const Real > &tm_arr, const GpuArray< Real, AMREX_SPACEDIM > grav_gpu, const BCRec *bc_ptr, const bool use_most): ERF_DiffusionSrcForState_T.cpp']]], - ['dim_449',['dim',['../classncutils_1_1NCGroup.html#addc8bbac9a2cfa8d9c49497b7da0310f',1,'ncutils::NCGroup']]], - ['dimid_450',['dimid',['../structncutils_1_1NCDim.html#a1c5560c95be35dbcedaf1390972175f8',1,'ncutils::NCDim']]], - ['directionselector_451',['DirectionSelector',['../structDirectionSelector.html',1,'']]], - ['directionselector_3c_200_20_3e_452',['DirectionSelector< 0 >',['../structDirectionSelector_3_010_01_4.html',1,'']]], - ['directionselector_3c_201_20_3e_453',['DirectionSelector< 1 >',['../structDirectionSelector_3_011_01_4.html',1,'']]], - ['directionselector_3c_202_20_3e_454',['DirectionSelector< 2 >',['../structDirectionSelector_3_012_01_4.html',1,'']]], - ['disk_5fcell_5fcount_455',['disk_cell_count',['../classSimpleAD.html#a4a8f7fe612cdc61b58b386b0b3f61da7',1,'SimpleAD::disk_cell_count()'],['../classGeneralAD.html#a4a6d71d880f30aeb756885ac4e8d2b5b',1,'GeneralAD::disk_cell_count()']]], - ['dispersion_5faer_456',['dispersion_aer',['../structPhysProp_1_1physprop__t.html#adf99574ee8aea212bec426dd42a4a9e4',1,'PhysProp::physprop_t']]], - ['display_457',['display',['../structSpongeChoice.html#a66fd55eceebbe3e97e31325cc55369de',1,'SpongeChoice::display()'],['../structSolverChoice.html#a9d26abef2007eb7c93180b0a6699cf8e',1,'SolverChoice::display()'],['../structAdvChoice.html#a15e63c1b409b5e09359441b5b5d7d00c',1,'AdvChoice::display()'],['../structDiffChoice.html#adc2925cf95fd6058bb83e1748fd1b765',1,'DiffChoice::display()'],['../structTurbChoice.html#ad2a82c43ca82f364c70ae5e61f0cd84f',1,'TurbChoice::display()']]], - ['do_5faerosol_5frad_458',['do_aerosol_rad',['../classRadiation.html#a6a43bd5c228b629042b73e06f8fbcf87',1,'Radiation']]], - ['do_5fcloud_459',['do_cloud',['../structSolverChoice.html#af352bb75ceaeae4ac534d3378fbf393a',1,'SolverChoice']]], - ['do_5fforest_460',['do_forest',['../structSolverChoice.html#a6937b2ada31923a31997430715a43bef',1,'SolverChoice']]], - ['do_5flong_5fwave_5frad_461',['do_long_wave_rad',['../classRadiation.html#afb905ef9ee37afaa882346803dae94c9',1,'Radiation']]], - ['do_5fprecip_462',['do_precip',['../structSolverChoice.html#a766e5884354ed6483704f8257036ee75',1,'SolverChoice']]], - ['do_5fshort_5fwave_5frad_463',['do_short_wave_rad',['../classRadiation.html#ad1177f9f1504cb562fb70b7f454387fc',1,'Radiation']]], - ['do_5fsnow_5foptics_464',['do_snow_optics',['../classRadiation.html#a8c411f9344910aab58b29c4a3bcab401',1,'Radiation']]], - ['docloud_465',['docloud',['../classSAM.html#a77c335e68b7ad8e6069d1318ea673a16',1,'SAM::docloud()'],['../classKessler.html#a7335cec5eabf2a33c8cd274b09863c28',1,'Kessler::docloud()']]], - ['dohirs_466',['dohirs',['../classRadiation.html#aface9778f843db231e142379cffb709c',1,'Radiation']]], - ['domain_5fbc_5ftype_467',['domain_bc_type',['../classERF.html#ae5968f1bed602fa87cdd5cb7905b7e5e',1,'ERF']]], - ['domain_5fbcs_5ftype_468',['domain_bcs_type',['../classERF.html#a574521986a6e403159f83c8b8123ba90',1,'ERF']]], - ['domain_5fbcs_5ftype_5fd_469',['domain_bcs_type_d',['../classERF.html#a8a99e22b1111c803e31b4afd5fcdea60',1,'ERF']]], - ['donelan_470',['DONELAN',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13afbf950ece84b8c4c7ebcf6492db726f7',1,'ABLMost::DONELAN()'],['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0afbf950ece84b8c4c7ebcf6492db726f7',1,'ABLMost::DONELAN()']]], - ['donelan_5fflux_471',['donelan_flux',['../structdonelan__flux.html#a804902863523b5f641c44aadc3602e97',1,'donelan_flux::donelan_flux()'],['../structdonelan__flux.html',1,'donelan_flux']]], - ['donelan_5froughness_472',['Donelan_roughness',['../ERF__MOSTRoughness_8H.html#a5b6ef1e185702e95631d5f22ff728860',1,'ERF_MOSTRoughness.H']]], - ['doprecip_473',['doprecip',['../classKessler.html#a2d8ae6f03c19821ef6279dcadd5cb36e',1,'Kessler::doprecip()'],['../classSAM.html#a54766f324324d579d2591a0bdc60e359',1,'SAM::doprecip()']]], - ['dotproduct_474',['dotProduct',['../classTerrainPoisson.html#ae39163799e9dc745a0f42d223e9568ff',1,'TerrainPoisson']]], - ['dryrad_5faer_475',['dryrad_aer',['../structPhysProp_1_1physprop__t.html#a55622eb338277f3ce9c7d5b774a9c2c5',1,'PhysProp::physprop_t']]], - ['dryscal_5fhoriz_5fadv_5ftype_476',['dryscal_horiz_adv_type',['../structAdvChoice.html#a74a383e01c24980b72b920054ee5c1ab',1,'AdvChoice']]], - ['dryscal_5fhoriz_5fupw_5ffrac_477',['dryscal_horiz_upw_frac',['../structAdvChoice.html#afb0ff64219a9e79d077b1a06da7817ae',1,'AdvChoice']]], - ['dryscal_5fvert_5fadv_5ftype_478',['dryscal_vert_adv_type',['../structAdvChoice.html#add9ddd5d61fc695bd2df0e3818767b78',1,'AdvChoice']]], - ['dryscal_5fvert_5fupw_5ffrac_479',['dryscal_vert_upw_frac',['../structAdvChoice.html#a1fc6421356a6c2ecfea0a46b3928d9cf',1,'AdvChoice']]], - ['dt_480',['dt',['../classRadiation.html#a98ebcca0b6a735bb910aedef14ce9a37',1,'Radiation::dt()'],['../classERF.html#ad34bae243fdb6c3029f5abe4fb4bca2d',1,'ERF::dt()'],['../classKessler.html#a86cf1c45a302d0e4a860860dab3dbe65',1,'Kessler::dt()'],['../classSAM.html#af9ffbd0c3f98c0c5d0a7ac4b1fb3dec9',1,'SAM::dt()']]], - ['dt_5favg_481',['dt_avg',['../classRadiation.html#af65d65db4b84a4afd921db0f10ffa31e',1,'Radiation']]], - ['dt_5fmri_5fratio_482',['dt_mri_ratio',['../classERF.html#a3cf7cb2e51eb7b69cb4079ffc6722459',1,'ERF']]], - ['dtos_483',['dtos',['../classMultiBlockContainer.html#a537ef22d2809607f9d353b912eedffcf',1,'MultiBlockContainer']]], - ['dtype_484',['DType',['../structNDArray.html#a96033b69f69ea0ae537a24288715752d',1,'NDArray']]], - ['dx_485',['dx',['../classPlaneAverage.html#abf7bfae5c1b6fed56ff09fd06368b12c',1,'PlaneAverage']]], - ['dycore_5fhoriz_5fadv_5ftype_486',['dycore_horiz_adv_type',['../structAdvChoice.html#a81152997920406ea2aa97cbb5af2d9b6',1,'AdvChoice']]], - ['dycore_5fhoriz_5fupw_5ffrac_487',['dycore_horiz_upw_frac',['../structAdvChoice.html#abde30f55d66f1716d7459a09001d3f43',1,'AdvChoice']]], - ['dycore_5fvert_5fadv_5ftype_488',['dycore_vert_adv_type',['../structAdvChoice.html#a2dd44749e2d4f224ae1da4f9e53e257a',1,'AdvChoice']]], - ['dycore_5fvert_5fupw_5ffrac_489',['dycore_vert_upw_frac',['../structAdvChoice.html#a48a2a3eb5899f899e202df67fd8bb2e0',1,'AdvChoice']]], - ['dynamicviscosity_490',['dynamicViscosity',['../structDiffChoice.html#abaff02e5f99628d6a91b546f3ad1fae6',1,'DiffChoice']]], - ['dz0_491',['dz0',['../structSolverChoice.html#a0a4f1c55ea1e3a7d50f926ee0d20a21c',1,'SolverChoice']]], - ['dz_5fmin_492',['dz_min',['../classERF.html#a15db5266359edba700f523f16da303a7',1,'ERF']]] + ['datalogname_408',['DataLogName',['../classERF.html#a16e1f6b8bbb05ae738daf2abe626c159',1,'ERF']]], + ['datalogname_409',['datalogname',['../classERF.html#a9248a4eb025c2647e003f838cba52a21',1,'ERF']]], + ['debug_410',['debug',['../structTurbulentPerturbation.html#aa7c1ce943bf06d347d762131ec0c24cf',1,'TurbulentPerturbation']]], + ['def_5farray_411',['def_array',['../classncutils_1_1NCGroup.html#acf969a6598527e2d00a84d35e0522fa1',1,'ncutils::NCGroup']]], + ['def_5fdim_412',['def_dim',['../classncutils_1_1NCGroup.html#a8c9376a217f29012f565a13f131bea84',1,'ncutils::NCGroup']]], + ['def_5fvar_413',['def_var',['../classncutils_1_1NCGroup.html#ae640d6aef18835f643e3cbaacb43e682',1,'ncutils::NCGroup']]], + ['define_414',['Define',['../classSAM.html#aba6460f2d34882d6b512574106e44531',1,'SAM::Define()'],['../classMM5.html#aca75345d5bf1a5ef4ce434047cc70437',1,'MM5::Define()'],['../classNullSurf.html#a5aec888a24181ce049b48ed10817489c',1,'NullSurf::Define()'],['../classSLM.html#aa6b96866fc326fe740b163be0141ff56',1,'SLM::Define()'],['../classEulerianMicrophysics.html#a444c916c5bb1167ea1efc9f2b9595436',1,'EulerianMicrophysics::Define()'],['../classMicrophysics.html#a380240aa9ec93af02a9b27ba1be4172a',1,'Microphysics::Define()'],['../classKessler.html#a5e989e5755fb57a853e2f1f0ec4c49e8',1,'Kessler::Define()'],['../classNullMoist.html#aab112947c592c330b45a2d7e5529ec07',1,'NullMoist::Define()'],['../classLandSurface.html#ae2087847b83c6a9e4453ccaa110134ce',1,'LandSurface::Define()'],['../classERFFillPatcher.html#a3dcdf3322c58c07eec765f6e3413ba68',1,'ERFFillPatcher::Define()']]], + ['define_5fdrag_5ffield_415',['define_drag_field',['../classForestDrag.html#adf4abd455b45d7a38422ffe2dc7b499f',1,'ForestDrag']]], + ['define_5ferffillpatchers_416',['Define_ERFFillPatchers',['../classERF.html#ac0951404aa6802aad7a3be6b7375dfa2',1,'ERF']]], + ['define_5flevel_5fdata_417',['define_level_data',['../classReadBndryPlanes.html#a16ed881bb428b7abb89e4284b356c8d6',1,'ReadBndryPlanes']]], + ['dei_418',['dei',['../classRadiation.html#a5d6b802fde5710034668dec77e7a39a8',1,'Radiation']]], + ['density_5faer_419',['density_aer',['../structPhysProp_1_1physprop__t.html#a8df74558339352f0e8c0031fc3160a09',1,'PhysProp::physprop_t']]], + ['depth_420',['depth',['../classABLMost.html#a38ed37dd984fcc7be3b5ae04b7272459',1,'ABLMost']]], + ['deriv_5foutputs_421',['deriv_outputs',['../classWaterVaporSat.html#a9d72a29e54869f42ec419639d6c3d70f',1,'WaterVaporSat']]], + ['derive_5fdiag_5fprofiles_422',['derive_diag_profiles',['../classERF.html#ab5b66549344d8b04b126fa0ef16c7ca2',1,'ERF']]], + ['derive_5fdiag_5fprofiles_5fstag_423',['derive_diag_profiles_stag',['../classERF.html#a8b93b715895b00e86e7db653d2a7284a',1,'ERF']]], + ['derive_5fstress_5fprofiles_424',['derive_stress_profiles',['../classERF.html#ad7886dcab90f37a8fcc91ede0c68b6cb',1,'ERF']]], + ['derive_5fstress_5fprofiles_5fstag_425',['derive_stress_profiles_stag',['../classERF.html#ae09680325ba108583147eb2e254a266e',1,'ERF']]], + ['derive_5fupwp_426',['derive_upwp',['../classERF.html#af1981699bedbbfd6785f26ca340a74d8',1,'ERF']]], + ['derived_427',['derived',['../namespacederived.html',1,'']]], + ['derived_5fnames_428',['derived_names',['../classERF.html#a9fc0f6e6ca35036d2e3a36dd42e66435',1,'ERF']]], + ['des_429',['des',['../classRadiation.html#a6fb15791b58bf08aea781bc906b3c431',1,'Radiation']]], + ['destag_5fprofiles_430',['destag_profiles',['../classERF.html#a65f19c55c8d3669445866a1c3bbb628d',1,'ERF']]], + ['detj_5fcc_431',['detJ_cc',['../classERF.html#a30f8b851ed29d38695d44cff257f14e6',1,'ERF']]], + ['detj_5fcc_5fnew_432',['detJ_cc_new',['../classERF.html#ae39bf64c5306b1dd939d82d9df728daa',1,'ERF']]], + ['detj_5fcc_5fsrc_433',['detJ_cc_src',['../classERF.html#a9a411e0ea9d9bdbfab957c8081229091',1,'ERF']]], + ['dgnum_434',['dgnum',['../structPhysProp_1_1physprop__t.html#a66b63e7d4250ce345343af372d529193',1,'PhysProp::physprop_t']]], + ['dgnumdry_5fm_435',['dgnumdry_m',['../classMam4__aer.html#a12eaca69207827a3988597c3e2f2bb0e',1,'Mam4_aer']]], + ['dgnumhi_436',['dgnumhi',['../structPhysProp_1_1physprop__t.html#a0a6b0b2e1d1906ac628da5c03c54dd2c',1,'PhysProp::physprop_t']]], + ['dgnumlo_437',['dgnumlo',['../structPhysProp_1_1physprop__t.html#a2e423bf4c825875ea8d9a72ead6c3b20',1,'PhysProp::physprop_t']]], + ['dgnumwet_5fm_438',['dgnumwet_m',['../classMam4__aer.html#a69a1949364f03af84c9e4c12973a5223',1,'Mam4_aer']]], + ['diffchoice_439',['diffChoice',['../structSolverChoice.html#a396122e87a3d15c4ec8666d7dd18c095',1,'SolverChoice']]], + ['diffchoice_440',['DiffChoice',['../structDiffChoice.html',1,'']]], + ['diffelq_441',['diffelq',['../ERF__Constants_8H.html#a4e1c44dade7fcd7648d3e87ba5bba4c1',1,'ERF_Constants.H']]], + ['diffuse_5fke_5f3d_442',['diffuse_KE_3D',['../structTurbChoice.html#a5864f0fe05bcbd45554301ade763d5ca',1,'TurbChoice']]], + ['diffuse_5fmoistvars_443',['diffuse_moistvars',['../structMYNNLevel25.html#af677ab24bae6b1f78751489a8df5b1be',1,'MYNNLevel25']]], + ['diffusionsrcformom_5fn_444',['DiffusionSrcForMom_N',['../ERF__DiffusionSrcForMom__N_8cpp.html#a426fe9fce28e7c29e11b29197e98f6a4',1,'DiffusionSrcForMom_N(const Box &bxx, const Box &bxy, const Box &bxz, const Array4< Real > &rho_u_rhs, const Array4< Real > &rho_v_rhs, const Array4< Real > &rho_w_rhs, const Array4< const Real > &tau11, const Array4< const Real > &tau22, const Array4< const Real > &tau33, const Array4< const Real > &tau12, const Array4< const Real > &tau13, const Array4< const Real > &tau23, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_m, const Array4< const Real > &, const Array4< const Real > &): ERF_DiffusionSrcForMom_N.cpp'],['../ERF__Diffusion_8H.html#a1385ec02c8aa1a6916f0827a359efa2b',1,'DiffusionSrcForMom_N(const amrex::Box &bxx, const amrex::Box &bxy, const amrex::Box &bxz, const amrex::Array4< amrex::Real > &rho_u_rhs, const amrex::Array4< amrex::Real > &rho_v_rhs, const amrex::Array4< amrex::Real > &rho_w_rhs, const amrex::Array4< const amrex::Real > &tau11, const amrex::Array4< const amrex::Real > &tau22, const amrex::Array4< const amrex::Real > &tau33, const amrex::Array4< const amrex::Real > &tau12, const amrex::Array4< const amrex::Real > &tau13, const amrex::Array4< const amrex::Real > &tau23, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v): ERF_Diffusion.H']]], + ['diffusionsrcformom_5ft_445',['DiffusionSrcForMom_T',['../ERF__DiffusionSrcForMom__T_8cpp.html#abd43ffde58dc80eec337c1fa12a0e2cf',1,'DiffusionSrcForMom_T(const Box &bxx, const Box &bxy, const Box &bxz, const Array4< Real > &rho_u_rhs, const Array4< Real > &rho_v_rhs, const Array4< Real > &rho_w_rhs, const Array4< const Real > &tau11, const Array4< const Real > &tau22, const Array4< const Real > &tau33, const Array4< const Real > &tau12, const Array4< const Real > &tau13, const Array4< const Real > &tau21, const Array4< const Real > &tau23, const Array4< const Real > &tau31, const Array4< const Real > &tau32, const Array4< const Real > &detJ, const GpuArray< Real, AMREX_SPACEDIM > &dxInv, const Array4< const Real > &mf_m, const Array4< const Real > &, const Array4< const Real > &): ERF_DiffusionSrcForMom_T.cpp'],['../ERF__Diffusion_8H.html#a9c81dadeb1784c3274f6f8c9a9d1bcb7',1,'DiffusionSrcForMom_T(const amrex::Box &bxx, const amrex::Box &bxy, const amrex::Box &bxz, const amrex::Array4< amrex::Real > &rho_u_rhs, const amrex::Array4< amrex::Real > &rho_v_rhs, const amrex::Array4< amrex::Real > &rho_w_rhs, const amrex::Array4< const amrex::Real > &tau11, const amrex::Array4< const amrex::Real > &tau22, const amrex::Array4< const amrex::Real > &tau33, const amrex::Array4< const amrex::Real > &tau12, const amrex::Array4< const amrex::Real > &tau13, const amrex::Array4< const amrex::Real > &tau21, const amrex::Array4< const amrex::Real > &tau23, const amrex::Array4< const amrex::Real > &tau31, const amrex::Array4< const amrex::Real > &tau32, const amrex::Array4< const amrex::Real > &detJ, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v): ERF_Diffusion.H']]], + ['diffusionsrcforstate_5fn_446',['DiffusionSrcForState_N',['../ERF__Diffusion_8H.html#a31a619f70cd632a82eb50a2863c66f82',1,'DiffusionSrcForState_N(const amrex::Box &bx, const amrex::Box &domain, int start_comp, int num_comp, const bool &exp_most, const amrex::Array4< const amrex::Real > &u, const amrex::Array4< const amrex::Real > &v, const amrex::Array4< const amrex::Real > &cell_data, const amrex::Array4< const amrex::Real > &cell_prim, const amrex::Array4< amrex::Real > &cell_rhs, const amrex::Array4< amrex::Real > &xflux, const amrex::Array4< amrex::Real > &yflux, const amrex::Array4< amrex::Real > &zflux, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &cellSizeInv, const amrex::Array4< const amrex::Real > &SmnSmn_a, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v, amrex::Array4< amrex::Real > &hfx_z, amrex::Array4< amrex::Real > &qfx1_z, amrex::Array4< amrex::Real > &qfx2_z, amrex::Array4< amrex::Real > &diss, const amrex::Array4< const amrex::Real > &mu_turb, const SolverChoice &solverChoice, const int level, const amrex::Array4< const amrex::Real > &tm_arr, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > grav_gpu, const amrex::BCRec *bc_ptr, const bool use_most): ERF_Diffusion.H'],['../ERF__DiffusionSrcForState__N_8cpp.html#a61d842d8a45b6d97948ce19b106bba0a',1,'DiffusionSrcForState_N(const Box &bx, const Box &domain, int start_comp, int num_comp, const bool &exp_most, const Array4< const Real > &u, const Array4< const Real > &v, const Array4< const Real > &cell_data, const Array4< const Real > &cell_prim, const Array4< Real > &cell_rhs, const Array4< Real > &xflux, const Array4< Real > &yflux, const Array4< Real > &zflux, const GpuArray< Real, AMREX_SPACEDIM > &cellSizeInv, const Array4< const Real > &SmnSmn_a, const Array4< const Real > &mf_m, const Array4< const Real > &mf_u, const Array4< const Real > &mf_v, Array4< Real > &hfx_z, Array4< Real > &qfx1_z, Array4< Real > &qfx2_z, Array4< Real > &diss, const Array4< const Real > &mu_turb, const SolverChoice &solverChoice, const int level, const Array4< const Real > &tm_arr, const GpuArray< Real, AMREX_SPACEDIM > grav_gpu, const BCRec *bc_ptr, const bool use_most): ERF_DiffusionSrcForState_N.cpp']]], + ['diffusionsrcforstate_5ft_447',['DiffusionSrcForState_T',['../ERF__Diffusion_8H.html#ae72c4a9e8ca7e9d1c84d96bb7bc9c7d0',1,'DiffusionSrcForState_T(const amrex::Box &bx, const amrex::Box &domain, int start_comp, int num_comp, const bool &exp_most, const bool &rot_most, const amrex::Array4< const amrex::Real > &u, const amrex::Array4< const amrex::Real > &v, const amrex::Array4< const amrex::Real > &cell_data, const amrex::Array4< const amrex::Real > &cell_prim, const amrex::Array4< amrex::Real > &cell_rhs, const amrex::Array4< amrex::Real > &xflux, const amrex::Array4< amrex::Real > &yflux, const amrex::Array4< amrex::Real > &zflux, const amrex::Array4< const amrex::Real > &z_nd, const amrex::Array4< const amrex::Real > &ax, const amrex::Array4< const amrex::Real > &ay, const amrex::Array4< const amrex::Real > &az, const amrex::Array4< const amrex::Real > &detJ, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > &dxInv, const amrex::Array4< const amrex::Real > &SmnSmn_a, const amrex::Array4< const amrex::Real > &mf_m, const amrex::Array4< const amrex::Real > &mf_u, const amrex::Array4< const amrex::Real > &mf_v, amrex::Array4< amrex::Real > &hfx_x, amrex::Array4< amrex::Real > &hfx_y, amrex::Array4< amrex::Real > &hfx_z, amrex::Array4< amrex::Real > &qfx1_x, amrex::Array4< amrex::Real > &qfx1_y, amrex::Array4< amrex::Real > &qfx1_z, amrex::Array4< amrex::Real > &qfx2_z, amrex::Array4< amrex::Real > &diss, const amrex::Array4< const amrex::Real > &mu_turb, const SolverChoice &solverChoice, const int level, const amrex::Array4< const amrex::Real > &tm_arr, const amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > grav_gpu, const amrex::BCRec *bc_ptr, const bool use_most): ERF_Diffusion.H'],['../ERF__DiffusionSrcForState__T_8cpp.html#ab29316749b16c72caa2fe0b7558397c9',1,'DiffusionSrcForState_T(const Box &bx, const Box &domain, int start_comp, int num_comp, const bool &exp_most, const bool &rot_most, const Array4< const Real > &u, const Array4< const Real > &v, const Array4< const Real > &cell_data, const Array4< const Real > &cell_prim, const Array4< Real > &cell_rhs, const Array4< Real > &xflux, const Array4< Real > &yflux, const Array4< Real > &zflux, const Array4< const Real > &z_nd, const Array4< const Real > &ax, const Array4< const Real > &ay, const Array4< const Real > &az, const Array4< const Real > &detJ, const GpuArray< Real, AMREX_SPACEDIM > &cellSizeInv, const Array4< const Real > &SmnSmn_a, const Array4< const Real > &mf_m, const Array4< const Real > &mf_u, const Array4< const Real > &mf_v, Array4< Real > &hfx_x, Array4< Real > &hfx_y, Array4< Real > &hfx_z, Array4< Real > &qfx1_x, Array4< Real > &qfx1_y, Array4< Real > &qfx1_z, Array4< Real > &qfx2_z, Array4< Real > &diss, const Array4< const Real > &mu_turb, const SolverChoice &solverChoice, const int level, const Array4< const Real > &tm_arr, const GpuArray< Real, AMREX_SPACEDIM > grav_gpu, const BCRec *bc_ptr, const bool use_most): ERF_DiffusionSrcForState_T.cpp']]], + ['dim_448',['dim',['../classncutils_1_1NCGroup.html#addc8bbac9a2cfa8d9c49497b7da0310f',1,'ncutils::NCGroup']]], + ['dimid_449',['dimid',['../structncutils_1_1NCDim.html#a1c5560c95be35dbcedaf1390972175f8',1,'ncutils::NCDim']]], + ['directionselector_450',['DirectionSelector',['../structDirectionSelector.html',1,'']]], + ['directionselector_3c_200_20_3e_451',['DirectionSelector< 0 >',['../structDirectionSelector_3_010_01_4.html',1,'']]], + ['directionselector_3c_201_20_3e_452',['DirectionSelector< 1 >',['../structDirectionSelector_3_011_01_4.html',1,'']]], + ['directionselector_3c_202_20_3e_453',['DirectionSelector< 2 >',['../structDirectionSelector_3_012_01_4.html',1,'']]], + ['disk_5fcell_5fcount_454',['disk_cell_count',['../classSimpleAD.html#a4a8f7fe612cdc61b58b386b0b3f61da7',1,'SimpleAD::disk_cell_count()'],['../classGeneralAD.html#a4a6d71d880f30aeb756885ac4e8d2b5b',1,'GeneralAD::disk_cell_count()']]], + ['dispersion_5faer_455',['dispersion_aer',['../structPhysProp_1_1physprop__t.html#adf99574ee8aea212bec426dd42a4a9e4',1,'PhysProp::physprop_t']]], + ['display_456',['display',['../structSpongeChoice.html#a66fd55eceebbe3e97e31325cc55369de',1,'SpongeChoice::display()'],['../structSolverChoice.html#a9d26abef2007eb7c93180b0a6699cf8e',1,'SolverChoice::display()'],['../structAdvChoice.html#a15e63c1b409b5e09359441b5b5d7d00c',1,'AdvChoice::display()'],['../structDiffChoice.html#adc2925cf95fd6058bb83e1748fd1b765',1,'DiffChoice::display()'],['../structTurbChoice.html#ad2a82c43ca82f364c70ae5e61f0cd84f',1,'TurbChoice::display()']]], + ['do_5faerosol_5frad_457',['do_aerosol_rad',['../classRadiation.html#a6a43bd5c228b629042b73e06f8fbcf87',1,'Radiation']]], + ['do_5fcloud_458',['do_cloud',['../structSolverChoice.html#af352bb75ceaeae4ac534d3378fbf393a',1,'SolverChoice']]], + ['do_5fforest_459',['do_forest',['../structSolverChoice.html#a6937b2ada31923a31997430715a43bef',1,'SolverChoice']]], + ['do_5flong_5fwave_5frad_460',['do_long_wave_rad',['../classRadiation.html#afb905ef9ee37afaa882346803dae94c9',1,'Radiation']]], + ['do_5fprecip_461',['do_precip',['../structSolverChoice.html#a766e5884354ed6483704f8257036ee75',1,'SolverChoice']]], + ['do_5fshort_5fwave_5frad_462',['do_short_wave_rad',['../classRadiation.html#ad1177f9f1504cb562fb70b7f454387fc',1,'Radiation']]], + ['do_5fsnow_5foptics_463',['do_snow_optics',['../classRadiation.html#a8c411f9344910aab58b29c4a3bcab401',1,'Radiation']]], + ['docloud_464',['docloud',['../classSAM.html#a77c335e68b7ad8e6069d1318ea673a16',1,'SAM::docloud()'],['../classKessler.html#a7335cec5eabf2a33c8cd274b09863c28',1,'Kessler::docloud()']]], + ['dohirs_465',['dohirs',['../classRadiation.html#aface9778f843db231e142379cffb709c',1,'Radiation']]], + ['domain_5fbc_5ftype_466',['domain_bc_type',['../classERF.html#ae5968f1bed602fa87cdd5cb7905b7e5e',1,'ERF']]], + ['domain_5fbcs_5ftype_467',['domain_bcs_type',['../classERF.html#a574521986a6e403159f83c8b8123ba90',1,'ERF']]], + ['domain_5fbcs_5ftype_5fd_468',['domain_bcs_type_d',['../classERF.html#a8a99e22b1111c803e31b4afd5fcdea60',1,'ERF']]], + ['donelan_469',['DONELAN',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13afbf950ece84b8c4c7ebcf6492db726f7',1,'ABLMost::DONELAN()'],['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0afbf950ece84b8c4c7ebcf6492db726f7',1,'ABLMost::DONELAN()']]], + ['donelan_5fflux_470',['donelan_flux',['../structdonelan__flux.html#a804902863523b5f641c44aadc3602e97',1,'donelan_flux::donelan_flux()'],['../structdonelan__flux.html',1,'donelan_flux']]], + ['donelan_5froughness_471',['Donelan_roughness',['../ERF__MOSTRoughness_8H.html#a5b6ef1e185702e95631d5f22ff728860',1,'ERF_MOSTRoughness.H']]], + ['doprecip_472',['doprecip',['../classKessler.html#a2d8ae6f03c19821ef6279dcadd5cb36e',1,'Kessler::doprecip()'],['../classSAM.html#a54766f324324d579d2591a0bdc60e359',1,'SAM::doprecip()']]], + ['dotproduct_473',['dotProduct',['../classTerrainPoisson.html#ae39163799e9dc745a0f42d223e9568ff',1,'TerrainPoisson']]], + ['dryrad_5faer_474',['dryrad_aer',['../structPhysProp_1_1physprop__t.html#a55622eb338277f3ce9c7d5b774a9c2c5',1,'PhysProp::physprop_t']]], + ['dryscal_5fhoriz_5fadv_5ftype_475',['dryscal_horiz_adv_type',['../structAdvChoice.html#a74a383e01c24980b72b920054ee5c1ab',1,'AdvChoice']]], + ['dryscal_5fhoriz_5fupw_5ffrac_476',['dryscal_horiz_upw_frac',['../structAdvChoice.html#afb0ff64219a9e79d077b1a06da7817ae',1,'AdvChoice']]], + ['dryscal_5fvert_5fadv_5ftype_477',['dryscal_vert_adv_type',['../structAdvChoice.html#add9ddd5d61fc695bd2df0e3818767b78',1,'AdvChoice']]], + ['dryscal_5fvert_5fupw_5ffrac_478',['dryscal_vert_upw_frac',['../structAdvChoice.html#a1fc6421356a6c2ecfea0a46b3928d9cf',1,'AdvChoice']]], + ['dt_479',['dt',['../classRadiation.html#a98ebcca0b6a735bb910aedef14ce9a37',1,'Radiation::dt()'],['../classERF.html#ad34bae243fdb6c3029f5abe4fb4bca2d',1,'ERF::dt()'],['../classKessler.html#a86cf1c45a302d0e4a860860dab3dbe65',1,'Kessler::dt()'],['../classSAM.html#af9ffbd0c3f98c0c5d0a7ac4b1fb3dec9',1,'SAM::dt()']]], + ['dt_5favg_480',['dt_avg',['../classRadiation.html#af65d65db4b84a4afd921db0f10ffa31e',1,'Radiation']]], + ['dt_5fmri_5fratio_481',['dt_mri_ratio',['../classERF.html#a3cf7cb2e51eb7b69cb4079ffc6722459',1,'ERF']]], + ['dtos_482',['dtos',['../classMultiBlockContainer.html#a537ef22d2809607f9d353b912eedffcf',1,'MultiBlockContainer']]], + ['dtype_483',['DType',['../structNDArray.html#a96033b69f69ea0ae537a24288715752d',1,'NDArray']]], + ['dx_484',['dx',['../classPlaneAverage.html#abf7bfae5c1b6fed56ff09fd06368b12c',1,'PlaneAverage']]], + ['dycore_5fhoriz_5fadv_5ftype_485',['dycore_horiz_adv_type',['../structAdvChoice.html#a81152997920406ea2aa97cbb5af2d9b6',1,'AdvChoice']]], + ['dycore_5fhoriz_5fupw_5ffrac_486',['dycore_horiz_upw_frac',['../structAdvChoice.html#abde30f55d66f1716d7459a09001d3f43',1,'AdvChoice']]], + ['dycore_5fvert_5fadv_5ftype_487',['dycore_vert_adv_type',['../structAdvChoice.html#a2dd44749e2d4f224ae1da4f9e53e257a',1,'AdvChoice']]], + ['dycore_5fvert_5fupw_5ffrac_488',['dycore_vert_upw_frac',['../structAdvChoice.html#a48a2a3eb5899f899e202df67fd8bb2e0',1,'AdvChoice']]], + ['dynamicviscosity_489',['dynamicViscosity',['../structDiffChoice.html#abaff02e5f99628d6a91b546f3ad1fae6',1,'DiffChoice']]], + ['dz0_490',['dz0',['../structSolverChoice.html#a0a4f1c55ea1e3a7d50f926ee0d20a21c',1,'SolverChoice']]], + ['dz_5fmin_491',['dz_min',['../classERF.html#a15db5266359edba700f523f16da303a7',1,'ERF']]] ]; diff --git a/search/all_4.js b/search/all_4.js index 8a5dd0a4f..b5baf042b 100644 --- a/search/all_4.js +++ b/search/all_4.js @@ -1,348 +1,348 @@ var searchData= [ - ['ebertcurry_493',['EbertCurry',['../classEbertCurry.html',1,'']]], - ['ec_5fice_5foptics_5flw_494',['ec_ice_optics_lw',['../classEbertCurry.html#ae258a04b9aaba9ca0052793a2d57f05e',1,'EbertCurry']]], - ['ec_5fice_5foptics_5fsw_495',['ec_ice_optics_sw',['../classEbertCurry.html#aed435ba6c3e2c62f6ba2d8111c7c2f08',1,'EbertCurry']]], - ['eccen_496',['eccen',['../classRadiation.html#a62efb2cdbddfca4321d9e866b6a79b11',1,'Radiation']]], - ['eddydiff_497',['EddyDiff',['../namespaceEddyDiff.html',1,'']]], - ['eddydiffs_5flev_498',['eddyDiffs_lev',['../classERF.html#a327d704704abd516be19339cb2d226f9',1,'ERF']]], - ['efficientadvtype_499',['EfficientAdvType',['../ERF__Advection_8H.html#aff14fe9e4f76b499843517b2c41c0fbb',1,'ERF_Advection.H']]], - ['egccoef_500',['egccoef',['../ERF__Constants_8H.html#a65f78c57eaba4f35dc9183cd2f3e66e3',1,'ERF_Constants.H']]], - ['egicoef_501',['egicoef',['../ERF__Constants_8H.html#a6b49f5e9d61881c5a59656453a6c025f',1,'ERF_Constants.H']]], - ['empty_502',['empty',['../classUnionListIF.html#ada33e955e690c4535d78e6db572707d7',1,'UnionListIF']]], - ['energy_20research_20and_20forecasting_3a_20an_20atmospheric_20modeling_20code_503',['Energy Research and Forecasting: An Atmospheric Modeling Code',['../index.html',1,'']]], - ['enter_5fdef_5fmode_504',['enter_def_mode',['../classncutils_1_1NCGroup.html#aef6b6e2be36e6179a001d9873e94df82',1,'ncutils::NCGroup']]], - ['eps_505',['eps',['../structWENO__Z7.html#a5f83e00b8908c86f74e2a4c5ea373090',1,'WENO_Z7::eps()'],['../structadiabatic__wave__coupled.html#a3f907fc7025d3d3f7e44c222e12b4df1',1,'adiabatic_wave_coupled::eps()'],['../structsurface__flux__wave__coupled.html#aee14d25dbf38dc291b9c4900d737e121',1,'surface_flux_wave_coupled::eps()'],['../structsurface__temp__wave__coupled.html#a2a663fad6d183ced2edb1dc99fe104bf',1,'surface_temp_wave_coupled::eps()'],['../structmoeng__flux.html#a3d06eff1aa7d6c357e1245eb8f5b96f7',1,'moeng_flux::eps()'],['../structcustom__flux.html#ae0e2af01151c51f4c335f053a8bb8f17',1,'custom_flux::eps()'],['../structrotate__flux.html#ae2e4dd388a9a609acf27d90fea305e11',1,'rotate_flux::eps()'],['../structMYNNLevel2.html#a2d226d66711e6659f0428210f8283f9d',1,'MYNNLevel2::eps()'],['../structWENO3.html#a5ea04e699e55b168c29b38e9e453660f',1,'WENO3::eps()'],['../structWENO5.html#a0eb3eb8be72f02731cd24f03d5c2b9ca',1,'WENO5::eps()'],['../structWENO7.html#a51bb3b4aafa54396917073e91d53140b',1,'WENO7::eps()'],['../structWENO__Z3.html#a04370c4cf4d845f967ec610ff66f5d2b',1,'WENO_Z3::eps()'],['../structWENO__MZQ3.html#ad02f88cd05b6e31261fb3380887a2099',1,'WENO_MZQ3::eps()'],['../structWENO__Z5.html#ab4cfe75de30306d2462c33b4797fa570',1,'WENO_Z5::eps()']]], - ['epsilo_506',['epsilo',['../ERF__Constants_8H.html#a630c4c3e10ef44d50ca4c6939a59b6a3',1,'ERF_Constants.H']]], - ['erccoef_507',['erccoef',['../ERF__Constants_8H.html#af90fa8b6a26f98067ce125597f35d983',1,'ERF_Constants.H']]], - ['erf_508',['ERF',['../classERF.html#a30129012dd367825e5e4fd1406694f58',1,'ERF::ERF()'],['../classERF.html#a13fc8f3a00573ee7735c3228316164a9',1,'ERF::ERF(ERF &&) noexcept=delete'],['../classERF.html#af4f5db4e6643e9ebc8ffeebcbca3978a',1,'ERF::ERF(const ERF &other)=delete'],['../classERF.html',1,'ERF']]], - ['erf_2ecpp_509',['ERF.cpp',['../ERF_8cpp.html',1,'']]], - ['erf_2eh_510',['ERF.H',['../ERF_8H.html',1,'']]], - ['erf1_511',['erf1',['../classMultiBlockContainer.html#a1ee9fa78e0ade97253f818516df5d83d',1,'MultiBlockContainer']]], - ['erf2_512',['erf2',['../classMultiBlockContainer.html#ac65a89fe2e12cff2c871d641f965e322',1,'MultiBlockContainer']]], - ['erf_5fablmost_2ecpp_513',['ERF_ABLMost.cpp',['../ERF__ABLMost_8cpp.html',1,'']]], - ['erf_5fablmost_2eh_514',['ERF_ABLMost.H',['../ERF__ABLMost_8H.html',1,'']]], - ['erf_5fadd_5fthin_5fbody_5fsources_2ecpp_515',['ERF_add_thin_body_sources.cpp',['../ERF__add__thin__body__sources_8cpp.html',1,'']]], - ['erf_5fadvance_2ecpp_516',['ERF_Advance.cpp',['../ERF__Advance_8cpp.html',1,'']]], - ['erf_5fadvance_5fdycore_2ecpp_517',['ERF_advance_dycore.cpp',['../ERF__advance__dycore_8cpp.html',1,'']]], - ['erf_5fadvance_5flsm_2ecpp_518',['ERF_advance_lsm.cpp',['../ERF__advance__lsm_8cpp.html',1,'']]], - ['erf_5fadvance_5fmicrophysics_2ecpp_519',['ERF_advance_microphysics.cpp',['../ERF__advance__microphysics_8cpp.html',1,'']]], - ['erf_5fadvance_5fradiation_2ecpp_520',['ERF_advance_radiation.cpp',['../ERF__advance__radiation_8cpp.html',1,'']]], - ['erf_5fadvanceewp_2ecpp_521',['ERF_AdvanceEWP.cpp',['../ERF__AdvanceEWP_8cpp.html',1,'']]], - ['erf_5fadvancefitch_2ecpp_522',['ERF_AdvanceFitch.cpp',['../ERF__AdvanceFitch_8cpp.html',1,'']]], - ['erf_5fadvancegeneralad_2ecpp_523',['ERF_AdvanceGeneralAD.cpp',['../ERF__AdvanceGeneralAD_8cpp.html',1,'']]], - ['erf_5fadvancesimplead_2ecpp_524',['ERF_AdvanceSimpleAD.cpp',['../ERF__AdvanceSimpleAD_8cpp.html',1,'']]], - ['erf_5fadvection_2eh_525',['ERF_Advection.H',['../ERF__Advection_8H.html',1,'']]], - ['erf_5fadvectionsrcformom_2ecpp_526',['ERF_AdvectionSrcForMom.cpp',['../ERF__AdvectionSrcForMom_8cpp.html',1,'']]], - ['erf_5fadvectionsrcformom_5fn_2eh_527',['ERF_AdvectionSrcForMom_N.H',['../ERF__AdvectionSrcForMom__N_8H.html',1,'']]], - ['erf_5fadvectionsrcformom_5ft_2eh_528',['ERF_AdvectionSrcForMom_T.H',['../ERF__AdvectionSrcForMom__T_8H.html',1,'']]], - ['erf_5fadvectionsrcforopenbc_2ecpp_529',['ERF_AdvectionSrcForOpenBC.cpp',['../ERF__AdvectionSrcForOpenBC_8cpp.html',1,'']]], - ['erf_5fadvectionsrcforscalars_2eh_530',['ERF_AdvectionSrcForScalars.H',['../ERF__AdvectionSrcForScalars_8H.html',1,'']]], - ['erf_5fadvectionsrcforstate_2ecpp_531',['ERF_AdvectionSrcForState.cpp',['../ERF__AdvectionSrcForState_8cpp.html',1,'']]], - ['erf_5fadvstruct_2eh_532',['ERF_AdvStruct.H',['../ERF__AdvStruct_8H.html',1,'']]], - ['erf_5faero_5frad_5fprops_2ecpp_533',['ERF_Aero_rad_props.cpp',['../ERF__Aero__rad__props_8cpp.html',1,'']]], - ['erf_5faero_5frad_5fprops_2eh_534',['ERF_Aero_rad_props.H',['../ERF__Aero__rad__props_8H.html',1,'']]], - ['erf_5falbedo_2ecpp_535',['ERF_Albedo.cpp',['../ERF__Albedo_8cpp.html',1,'']]], - ['erf_5falbedo_2eh_536',['ERF_Albedo.H',['../ERF__Albedo_8H.html',1,'']]], - ['erf_5fapplyspongezonebcs_2ecpp_537',['ERF_ApplySpongeZoneBCs.cpp',['../ERF__ApplySpongeZoneBCs_8cpp.html',1,'']]], - ['erf_5fapplyspongezonebcs_5freadfromfile_2ecpp_538',['ERF_ApplySpongeZoneBCs_ReadFromFile.cpp',['../ERF__ApplySpongeZoneBCs__ReadFromFile_8cpp.html',1,'']]], - ['erf_5faveragedown_2ecpp_539',['ERF_AverageDown.cpp',['../ERF__AverageDown_8cpp.html',1,'']]], - ['erf_5fbc_540',['ERF_BC',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9',1,'ERF_IndexDefines.H']]], - ['erf_5fboundaryconditions_5fbasestate_2ecpp_541',['ERF_BoundaryConditions_basestate.cpp',['../ERF__BoundaryConditions__basestate_8cpp.html',1,'']]], - ['erf_5fboundaryconditions_5fbndryreg_2ecpp_542',['ERF_BoundaryConditions_bndryreg.cpp',['../ERF__BoundaryConditions__bndryreg_8cpp.html',1,'']]], - ['erf_5fboundaryconditions_5fcons_2ecpp_543',['ERF_BoundaryConditions_cons.cpp',['../ERF__BoundaryConditions__cons_8cpp.html',1,'']]], - ['erf_5fboundaryconditions_5frealbdy_2ecpp_544',['ERF_BoundaryConditions_realbdy.cpp',['../ERF__BoundaryConditions__realbdy_8cpp.html',1,'']]], - ['erf_5fboundaryconditions_5fxvel_2ecpp_545',['ERF_BoundaryConditions_xvel.cpp',['../ERF__BoundaryConditions__xvel_8cpp.html',1,'']]], - ['erf_5fboundaryconditions_5fyvel_2ecpp_546',['ERF_BoundaryConditions_yvel.cpp',['../ERF__BoundaryConditions__yvel_8cpp.html',1,'']]], - ['erf_5fboundaryconditions_5fzvel_2ecpp_547',['ERF_BoundaryConditions_zvel.cpp',['../ERF__BoundaryConditions__zvel_8cpp.html',1,'']]], - ['erf_5fbuoyancy_5futils_2eh_548',['ERF_buoyancy_utils.H',['../ERF__buoyancy__utils_8H.html',1,'']]], - ['erf_5fcheckpoint_2ecpp_549',['ERF_Checkpoint.cpp',['../ERF__Checkpoint_8cpp.html',1,'']]], - ['erf_5fchopgrids_2ecpp_550',['ERF_ChopGrids.cpp',['../ERF__ChopGrids_8cpp.html',1,'']]], - ['erf_5fcloud_5frad_5fprops_2ecpp_551',['ERF_Cloud_rad_props.cpp',['../ERF__Cloud__rad__props_8cpp.html',1,'']]], - ['erf_5fcloud_5frad_5fprops_2eh_552',['ERF_Cloud_rad_props.H',['../ERF__Cloud__rad__props_8H.html',1,'']]], - ['erf_5fcloud_5fsam_2ecpp_553',['ERF_Cloud_SAM.cpp',['../ERF__Cloud__SAM_8cpp.html',1,'']]], - ['erf_5fcompute_5fdivergence_2ecpp_554',['ERF_compute_divergence.cpp',['../ERF__compute__divergence_8cpp.html',1,'']]], - ['erf_5fcomputediffusivitymynn25_2ecpp_555',['ERF_ComputeDiffusivityMYNN25.cpp',['../ERF__ComputeDiffusivityMYNN25_8cpp.html',1,'']]], - ['erf_5fcomputediffusivityysu_2ecpp_556',['ERF_ComputeDiffusivityYSU.cpp',['../ERF__ComputeDiffusivityYSU_8cpp.html',1,'']]], - ['erf_5fcomputestrain_5fn_2ecpp_557',['ERF_ComputeStrain_N.cpp',['../ERF__ComputeStrain__N_8cpp.html',1,'']]], - ['erf_5fcomputestrain_5ft_2ecpp_558',['ERF_ComputeStrain_T.cpp',['../ERF__ComputeStrain__T_8cpp.html',1,'']]], - ['erf_5fcomputestress_5fn_2ecpp_559',['ERF_ComputeStress_N.cpp',['../ERF__ComputeStress__N_8cpp.html',1,'']]], - ['erf_5fcomputestress_5ft_2ecpp_560',['ERF_ComputeStress_T.cpp',['../ERF__ComputeStress__T_8cpp.html',1,'']]], - ['erf_5fcomputetimestep_2ecpp_561',['ERF_ComputeTimestep.cpp',['../ERF__ComputeTimestep_8cpp.html',1,'']]], - ['erf_5fcomputeturbulentviscosity_2ecpp_562',['ERF_ComputeTurbulentViscosity.cpp',['../ERF__ComputeTurbulentViscosity_8cpp.html',1,'']]], - ['erf_5fconsole_5fio_2ecpp_563',['ERF_console_io.cpp',['../ERF__console__io_8cpp.html',1,'']]], - ['erf_5fconstants_2eh_564',['ERF_Constants.H',['../ERF__Constants_8H.html',1,'']]], - ['erf_5fdatastruct_2eh_565',['ERF_DataStruct.H',['../ERF__DataStruct_8H.html',1,'']]], - ['erf_5fderive_2ecpp_566',['ERF_Derive.cpp',['../ERF__Derive_8cpp.html',1,'']]], - ['erf_5fderive_2eh_567',['ERF_Derive.H',['../ERF__Derive_8H.html',1,'']]], - ['erf_5fderke_568',['erf_derKE',['../namespacederived.html#acc3f245c73a0826afc9e7626f12126d3',1,'derived::erf_derKE(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)'],['../namespacederived.html#aeaeabd5f649796984f61651a6733e96b',1,'derived::erf_derKE(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)']]], - ['erf_5fdermagvel_569',['erf_dermagvel',['../namespacederived.html#a5186c6ea33e82af321f529242a615dc2',1,'derived']]], - ['erf_5fdermoisttemp_570',['erf_dermoisttemp',['../namespacederived.html#a7292c8c78a618eb0f6ca6a5356705362',1,'derived::erf_dermoisttemp(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)'],['../namespacederived.html#add1791d7423c133ba6e7ab55975cf34f',1,'derived::erf_dermoisttemp(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)']]], - ['erf_5fdernull_571',['erf_dernull',['../namespacederived.html#a7fb98e12fceaa6f691dfef83db453757',1,'derived::erf_dernull(const Box &, FArrayBox &, int, int, const FArrayBox &, const Geometry &, Real, const int *, const int)'],['../namespacederived.html#a7128ad75cf0f6b317ae8689bd7eb1597',1,'derived::erf_dernull(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)']]], - ['erf_5fderrhodivide_572',['erf_derrhodivide',['../namespacederived.html#a3786c6a8399bc2508bc129337c446af1',1,'derived::erf_derrhodivide(const Box &bx, FArrayBox &derfab, const FArrayBox &datfab, const int scalar_index)'],['../namespacederived.html#a9935603239fe8510b11179da8e76c39c',1,'derived::erf_derrhodivide(const amrex::Box &bx, amrex::FArrayBox &derfab, const amrex::FArrayBox &datfab, const int scalar_index)']]], - ['erf_5fderscalar_573',['erf_derscalar',['../namespacederived.html#a13666be87e55d1759f57322b33f7e495',1,'derived::erf_derscalar(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)'],['../namespacederived.html#a37560f4d3e2c7c10f64d41db2ce76a06',1,'derived::erf_derscalar(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)']]], - ['erf_5fdersoundspeed_574',['erf_dersoundspeed',['../namespacederived.html#abec1266940e40d642fca2aa685b7f314',1,'derived::erf_dersoundspeed(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)'],['../namespacederived.html#afe57e0f13e2e24c73d0ed373a9cd0d09',1,'derived::erf_dersoundspeed(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)']]], - ['erf_5fdertemp_575',['erf_dertemp',['../namespacederived.html#a37ac1508c4001f9f1e38ca507dd15f31',1,'derived::erf_dertemp(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)'],['../namespacederived.html#a8d96f91847cec51636c122ab27a5f8a2',1,'derived::erf_dertemp(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)']]], - ['erf_5fdertheta_576',['erf_dertheta',['../namespacederived.html#af5e075e5b8b2e3964ae6af3f5f06f497',1,'derived::erf_dertheta(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)'],['../namespacederived.html#adc3c787125484205e4fc7cd85c25ab6c',1,'derived::erf_dertheta(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)']]], - ['erf_5fdervortx_577',['erf_dervortx',['../namespacederived.html#a0a37dd4fa4a044e34891e6222d06654c',1,'derived']]], - ['erf_5fdervorty_578',['erf_dervorty',['../namespacederived.html#a2a85aedf7c75ca416dbb931559c4b21e',1,'derived']]], - ['erf_5fdervortz_579',['erf_dervortz',['../namespacederived.html#a8bc196f7dfb365c426b0b7e720e479e2',1,'derived']]], - ['erf_5fdiffstruct_2eh_580',['ERF_DiffStruct.H',['../ERF__DiffStruct_8H.html',1,'']]], - ['erf_5fdiffusion_2eh_581',['ERF_Diffusion.H',['../ERF__Diffusion_8H.html',1,'']]], - ['erf_5fdiffusionsrcformom_5fn_2ecpp_582',['ERF_DiffusionSrcForMom_N.cpp',['../ERF__DiffusionSrcForMom__N_8cpp.html',1,'']]], - ['erf_5fdiffusionsrcformom_5ft_2ecpp_583',['ERF_DiffusionSrcForMom_T.cpp',['../ERF__DiffusionSrcForMom__T_8cpp.html',1,'']]], - ['erf_5fdiffusionsrcforstate_5fn_2ecpp_584',['ERF_DiffusionSrcForState_N.cpp',['../ERF__DiffusionSrcForState__N_8cpp.html',1,'']]], - ['erf_5fdiffusionsrcforstate_5ft_2ecpp_585',['ERF_DiffusionSrcForState_T.cpp',['../ERF__DiffusionSrcForState__T_8cpp.html',1,'']]], - ['erf_5fdirectionselector_2eh_586',['ERF_DirectionSelector.H',['../ERF__DirectionSelector_8H.html',1,'']]], - ['erf_5fdtesati_587',['erf_dtesati',['../ERF__Microphysics__Utils_8H.html#a45320981110c862bac93f657781eb79f',1,'ERF_Microphysics_Utils.H']]], - ['erf_5fdtesatw_588',['erf_dtesatw',['../ERF__Microphysics__Utils_8H.html#a2e94fb836d3c733ebac8263bfa479ca8',1,'ERF_Microphysics_Utils.H']]], - ['erf_5fdtesatw_5fcc_589',['erf_dtesatw_cc',['../ERF__Microphysics__Utils_8H.html#a66e2273b5b2661fa12fea623630afaf8',1,'ERF_Microphysics_Utils.H']]], - ['erf_5fdtqsati_590',['erf_dtqsati',['../ERF__Microphysics__Utils_8H.html#a7baba5d74922033bf93526933a0d77ec',1,'ERF_Microphysics_Utils.H']]], - ['erf_5fdtqsatw_591',['erf_dtqsatw',['../ERF__Microphysics__Utils_8H.html#a41126403c4da6ee876e9e391f3f67699',1,'ERF_Microphysics_Utils.H']]], - ['erf_5feb_5fbox_2ecpp_592',['ERF_eb_box.cpp',['../ERF__eb__box_8cpp.html',1,'']]], - ['erf_5feb_5fcylinder_2ecpp_593',['ERF_eb_cylinder.cpp',['../ERF__eb__cylinder_8cpp.html',1,'']]], - ['erf_5feb_5fif_2eh_594',['ERF_eb_if.H',['../ERF__eb__if_8H.html',1,'']]], - ['erf_5feb_5fregular_2ecpp_595',['ERF_eb_regular.cpp',['../ERF__eb__regular_8cpp.html',1,'']]], - ['erf_5febert_5fcurry_2eh_596',['ERF_Ebert_curry.H',['../ERF__Ebert__curry_8H.html',1,'']]], - ['erf_5feddyviscosity_2eh_597',['ERF_EddyViscosity.H',['../ERF__EddyViscosity_8H.html',1,'']]], - ['erf_5fenforce_5fhse_598',['erf_enforce_hse',['../classERF.html#a5dd85954df2df1edf0adde3c7c6ae48f',1,'ERF']]], - ['erf_5feos_2eh_599',['ERF_EOS.H',['../ERF__EOS_8H.html',1,'']]], - ['erf_5fesati_600',['erf_esati',['../ERF__Microphysics__Utils_8H.html#a4ea516e89f4e87b4ffc305504e8f0bf1',1,'ERF_Microphysics_Utils.H']]], - ['erf_5fesatw_601',['erf_esatw',['../ERF__Microphysics__Utils_8H.html#a16a390366e7e68ca35fdac4cad824428',1,'ERF_Microphysics_Utils.H']]], - ['erf_5fesatw_5fcc_602',['erf_esatw_cc',['../ERF__Microphysics__Utils_8H.html#afac5e7caca80647972b208a0248b2ed8',1,'ERF_Microphysics_Utils.H']]], - ['erf_5feulerianmicrophysics_2eh_603',['ERF_EulerianMicrophysics.H',['../ERF__EulerianMicrophysics_8H.html',1,'']]], - ['erf_5fewp_2eh_604',['ERF_EWP.H',['../ERF__EWP_8H.html',1,'']]], - ['erf_5ffast_5frhs_5fmt_605',['erf_fast_rhs_MT',['../ERF__fast__rhs__MT_8cpp.html#af5d569dbe264703bf1e1c6ae59d14b4c',1,'erf_fast_rhs_MT(int step, int nrk, int level, int finest_level, Vector< MultiFab > &S_slow_rhs, const Vector< MultiFab > &S_prev, Vector< MultiFab > &S_stg_data, const MultiFab &S_stg_prim, const MultiFab &pi_stage, const MultiFab &fast_coeffs, Vector< MultiFab > &S_data, Vector< MultiFab > &S_scratch, const Geometry geom, const Real gravity, const bool use_lagged_delta_rt, std::unique_ptr< MultiFab > &z_t_rk, const MultiFab *z_t_pert, std::unique_ptr< MultiFab > &z_phys_nd_old, std::unique_ptr< MultiFab > &z_phys_nd_new, std::unique_ptr< MultiFab > &z_phys_nd_stg, std::unique_ptr< MultiFab > &detJ_cc_old, std::unique_ptr< MultiFab > &detJ_cc_new, std::unique_ptr< MultiFab > &detJ_cc_stg, const Real dtau, const Real beta_s, const Real facinv, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool): ERF_fast_rhs_MT.cpp'],['../ERF__TI__fast__headers_8H.html#af066cb6138b09ea93e2c0fc35702fb0e',1,'erf_fast_rhs_MT(int step, int nrk, int level, int finest_level, amrex::Vector< amrex::MultiFab > &S_slow_rhs, const amrex::Vector< amrex::MultiFab > &S_prev, amrex::Vector< amrex::MultiFab > &S_stg_data, const amrex::MultiFab &S_stg_prim, const amrex::MultiFab &pi_stage, const amrex::MultiFab &fast_coeffs, amrex::Vector< amrex::MultiFab > &S_data, amrex::Vector< amrex::MultiFab > &S_scratch, const amrex::Geometry geom, const amrex::Real gravity, const bool use_lagged_delta_rt, std::unique_ptr< amrex::MultiFab > &z_t_rk, const amrex::MultiFab *z_t_pert, std::unique_ptr< amrex::MultiFab > &z_phys_nd_old, std::unique_ptr< amrex::MultiFab > &z_phys_nd_new, std::unique_ptr< amrex::MultiFab > &z_phys_nd_stg, std::unique_ptr< amrex::MultiFab > &detJ_cc_old, std::unique_ptr< amrex::MultiFab > &detJ_cc_new, std::unique_ptr< amrex::MultiFab > &detJ_cc_stg, const amrex::Real dtau, const amrex::Real beta_s, const amrex::Real facinv, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v, amrex::YAFluxRegister *fr_as_crse, amrex::YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool l_implicit_substepping): ERF_TI_fast_headers.H']]], - ['erf_5ffast_5frhs_5fmt_2ecpp_606',['ERF_fast_rhs_MT.cpp',['../ERF__fast__rhs__MT_8cpp.html',1,'']]], - ['erf_5ffast_5frhs_5fn_607',['erf_fast_rhs_N',['../ERF__fast__rhs__N_8cpp.html#a5fbcc0fe33b8e8e42f840ad475a092bd',1,'erf_fast_rhs_N(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 &pi_stage, const MultiFab &fast_coeffs, Vector< MultiFab > &S_data, Vector< MultiFab > &S_scratch, const Geometry geom, const Real gravity, const Real dtau, const Real beta_s, const Real facinv, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool l_implicit_substepping): ERF_fast_rhs_N.cpp'],['../ERF__TI__fast__headers_8H.html#a25b4f2c626cbe895f44d04b262cd0938',1,'erf_fast_rhs_N(int step, int nrk, int level, int finest_level, amrex::Vector< amrex::MultiFab > &S_slow_rhs, const amrex::Vector< amrex::MultiFab > &S_prev, amrex::Vector< amrex::MultiFab > &S_stage_data, const amrex::MultiFab &S_stage_prim, const amrex::MultiFab &pi_stage, const amrex::MultiFab &fast_coeffs, amrex::Vector< amrex::MultiFab > &S_data, amrex::Vector< amrex::MultiFab > &S_scratch, const amrex::Geometry geom, const amrex::Real gravity, const amrex::Real dtau, const amrex::Real beta_s, const amrex::Real facinv, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v, amrex::YAFluxRegister *fr_as_crse, amrex::YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool l_implicit_substepping): ERF_TI_fast_headers.H']]], - ['erf_5ffast_5frhs_5fn_2ecpp_608',['ERF_fast_rhs_N.cpp',['../ERF__fast__rhs__N_8cpp.html',1,'']]], - ['erf_5ffast_5frhs_5ft_609',['erf_fast_rhs_T',['../ERF__fast__rhs__T_8cpp.html#a83ebca7dc0d4507076941aa3a971e877',1,'erf_fast_rhs_T(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 &pi_stage, const MultiFab &fast_coeffs, Vector< MultiFab > &S_data, Vector< MultiFab > &S_scratch, const Geometry geom, const Real gravity, std::unique_ptr< MultiFab > &z_phys_nd, std::unique_ptr< MultiFab > &detJ_cc, const Real dtau, const Real beta_s, const Real facinv, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool): ERF_fast_rhs_T.cpp'],['../ERF__TI__fast__headers_8H.html#a8ed4e910b837a4cbbe4d6a7ab8610f51',1,'erf_fast_rhs_T(int step, int nrk, int level, int finest_level, amrex::Vector< amrex::MultiFab > &S_slow_rhs, const amrex::Vector< amrex::MultiFab > &S_prev, amrex::Vector< amrex::MultiFab > &S_stage_data, const amrex::MultiFab &S_stage_prim, const amrex::MultiFab &pi_stage, const amrex::MultiFab &fast_coeffs, amrex::Vector< amrex::MultiFab > &S_data, amrex::Vector< amrex::MultiFab > &S_scratch, const amrex::Geometry geom, const amrex::Real gravity, std::unique_ptr< amrex::MultiFab > &z_phys_nd, std::unique_ptr< amrex::MultiFab > &detJ_cc, const amrex::Real dtau, const amrex::Real beta_s, const amrex::Real facinv, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v, amrex::YAFluxRegister *fr_as_crse, amrex::YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool l_implicit_substepping): ERF_TI_fast_headers.H']]], - ['erf_5ffast_5frhs_5ft_2ecpp_610',['ERF_fast_rhs_T.cpp',['../ERF__fast__rhs__T_8cpp.html',1,'']]], - ['erf_5ffft_5fterrainprecond_2eh_611',['ERF_FFT_TerrainPrecond.H',['../ERF__FFT__TerrainPrecond_8H.html',1,'']]], - ['erf_5ffillbdyccvels_2ecpp_612',['ERF_FillBdyCCVels.cpp',['../ERF__FillBdyCCVels_8cpp.html',1,'']]], - ['erf_5ffillcoarsepatch_2ecpp_613',['ERF_FillCoarsePatch.cpp',['../ERF__FillCoarsePatch_8cpp.html',1,'']]], - ['erf_5ffillintermediatepatch_2ecpp_614',['ERF_FillIntermediatePatch.cpp',['../ERF__FillIntermediatePatch_8cpp.html',1,'']]], - ['erf_5ffillpatch_2ecpp_615',['ERF_FillPatch.cpp',['../ERF__FillPatch_8cpp.html',1,'']]], - ['erf_5ffillpatcher_2ecpp_616',['ERF_FillPatcher.cpp',['../ERF__FillPatcher_8cpp.html',1,'']]], - ['erf_5ffillpatcher_2eh_617',['ERF_FillPatcher.H',['../ERF__FillPatcher_8H.html',1,'']]], - ['erf_5ffinalize_5frrtmgp_2ecpp_618',['ERF_Finalize_rrtmgp.cpp',['../ERF__Finalize__rrtmgp_8cpp.html',1,'']]], - ['erf_5ffitch_2eh_619',['ERF_Fitch.H',['../ERF__Fitch_8H.html',1,'']]], - ['erf_5fflowerif_2eh_620',['ERF_FlowerIF.H',['../ERF__FlowerIF_8H.html',1,'']]], - ['erf_5fforestdrag_2ecpp_621',['ERF_ForestDrag.cpp',['../ERF__ForestDrag_8cpp.html',1,'']]], - ['erf_5fforestdrag_2eh_622',['ERF_ForestDrag.H',['../ERF__ForestDrag_8H.html',1,'']]], - ['erf_5fgammafff_623',['erf_gammafff',['../ERF__Microphysics__Utils_8H.html#abd125e107924437493cbcbac9a97c017',1,'ERF_Microphysics_Utils.H']]], - ['erf_5fgeneralad_2eh_624',['ERF_GeneralAD.H',['../ERF__GeneralAD_8H.html',1,'']]], - ['erf_5fhse_5futils_2eh_625',['ERF_HSE_utils.H',['../ERF__HSE__utils_8H.html',1,'']]], - ['erf_5ficefall_2ecpp_626',['ERF_IceFall.cpp',['../ERF__IceFall_8cpp.html',1,'']]], - ['erf_5findexdefines_2eh_627',['ERF_IndexDefines.H',['../ERF__IndexDefines_8H.html',1,'']]], - ['erf_5finit1d_2ecpp_628',['ERF_init1d.cpp',['../ERF__init1d_8cpp.html',1,'']]], - ['erf_5finit_5fbcs_2ecpp_629',['ERF_init_bcs.cpp',['../ERF__init__bcs_8cpp.html',1,'']]], - ['erf_5finit_5fconstant_5fdensity_5fhse_2eh_630',['ERF_init_constant_density_hse.H',['../ERF__init__constant__density__hse_8H.html',1,'']]], - ['erf_5finit_5fcustom_2ecpp_631',['ERF_init_custom.cpp',['../ERF__init__custom_8cpp.html',1,'']]], - ['erf_5finit_5fdens_5fhse_632',['erf_init_dens_hse',['../classProblemBase.html#aef7d3d9788867d83e6ec8b2c9499de56',1,'ProblemBase::erf_init_dens_hse()'],['../ERF__init__constant__density__hse_8H.html#aa310c5ff8cdad11f3adfeeff0f5ad046',1,'erf_init_dens_hse(amrex::MultiFab &rho_hse, std::unique_ptr< amrex::MultiFab > &, std::unique_ptr< amrex::MultiFab > &, amrex::Geometry const &) override: ERF_init_constant_density_hse.H'],['../ERF__init__density__hse__dry_8H.html#a2e1d042f9d82e4b78d00e99ab25e9311',1,'erf_init_dens_hse(amrex::MultiFab &rho_hse, std::unique_ptr< amrex::MultiFab > &z_phys_nd, std::unique_ptr< amrex::MultiFab > &z_phys_cc, amrex::Geometry const &geom) override: ERF_init_density_hse_dry.H']]], - ['erf_5finit_5fdens_5fhse_5fmoist_633',['erf_init_dens_hse_moist',['../classProblemBase.html#ad1a7277d332001542789e488458096b9',1,'ProblemBase']]], - ['erf_5finit_5fdensity_5fhse_5fdry_2eh_634',['ERF_init_density_hse_dry.H',['../ERF__init__density__hse__dry_8H.html',1,'']]], - ['erf_5finit_5ffrom_5fhse_2ecpp_635',['ERF_init_from_hse.cpp',['../ERF__init__from__hse_8cpp.html',1,'']]], - ['erf_5finit_5ffrom_5finput_5fsounding_2ecpp_636',['ERF_init_from_input_sounding.cpp',['../ERF__init__from__input__sounding_8cpp.html',1,'']]], - ['erf_5finit_5ffrom_5fmetgrid_2ecpp_637',['ERF_init_from_metgrid.cpp',['../ERF__init__from__metgrid_8cpp.html',1,'']]], - ['erf_5finit_5ffrom_5fwrfinput_2ecpp_638',['ERF_init_from_wrfinput.cpp',['../ERF__init__from__wrfinput_8cpp.html',1,'']]], - ['erf_5finit_5fgeowind_2ecpp_639',['ERF_init_geowind.cpp',['../ERF__init__geowind_8cpp.html',1,'']]], - ['erf_5finit_5fkessler_2ecpp_640',['ERF_Init_Kessler.cpp',['../ERF__Init__Kessler_8cpp.html',1,'']]], - ['erf_5finit_5frayleigh_641',['erf_init_rayleigh',['../ERF__init__rayleigh__damping_8H.html#aa0988e9ca7c21c75ca232ea0ee850195',1,'erf_init_rayleigh(): ERF_init_rayleigh_damping.H'],['../classProblemBase.html#aaf5cb14c8033c99df446fd943b1f2216',1,'ProblemBase::erf_init_rayleigh()']]], - ['erf_5finit_5frayleigh_2ecpp_642',['ERF_init_rayleigh.cpp',['../ERF__init__rayleigh_8cpp.html',1,'']]], - ['erf_5finit_5frayleigh_5fdamping_2eh_643',['ERF_init_rayleigh_damping.H',['../ERF__init__rayleigh__damping_8H.html',1,'']]], - ['erf_5finit_5frrtmgp_2ecpp_644',['ERF_Init_rrtmgp.cpp',['../ERF__Init__rrtmgp_8cpp.html',1,'']]], - ['erf_5finit_5fsam_2ecpp_645',['ERF_Init_SAM.cpp',['../ERF__Init__SAM_8cpp.html',1,'']]], - ['erf_5finit_5fsponge_2ecpp_646',['ERF_init_sponge.cpp',['../ERF__init__sponge_8cpp.html',1,'']]], - ['erf_5finit_5fturbpert_2ecpp_647',['ERF_init_TurbPert.cpp',['../ERF__init__TurbPert_8cpp.html',1,'']]], - ['erf_5finit_5funiform_2ecpp_648',['ERF_init_uniform.cpp',['../ERF__init__uniform_8cpp.html',1,'']]], - ['erf_5finit_5fwindfarm_2ecpp_649',['ERF_init_windfarm.cpp',['../ERF__init__windfarm_8cpp.html',1,'']]], - ['erf_5finiteb_2ecpp_650',['ERF_initEB.cpp',['../ERF__initEB_8cpp.html',1,'']]], - ['erf_5finitwindfarm_2ecpp_651',['ERF_InitWindFarm.cpp',['../ERF__InitWindFarm_8cpp.html',1,'']]], - ['erf_5finputsoundingdata_2eh_652',['ERF_InputSoundingData.H',['../ERF__InputSoundingData_8H.html',1,'']]], - ['erf_5finputspongedata_2eh_653',['ERF_InputSpongeData.H',['../ERF__InputSpongeData_8H.html',1,'']]], - ['erf_5finteriorghostcells_2ecpp_654',['ERF_InteriorGhostCells.cpp',['../ERF__InteriorGhostCells_8cpp.html',1,'']]], - ['erf_5finterpolation_2eh_655',['ERF_Interpolation.H',['../ERF__Interpolation_8H.html',1,'']]], - ['erf_5finterpolation_5f1d_2eh_656',['ERF_Interpolation_1D.H',['../ERF__Interpolation__1D_8H.html',1,'']]], - ['erf_5finterpolation_5fupw_2eh_657',['ERF_Interpolation_UPW.H',['../ERF__Interpolation__UPW_8H.html',1,'']]], - ['erf_5finterpolation_5fweno_2eh_658',['ERF_Interpolation_WENO.H',['../ERF__Interpolation__WENO_8H.html',1,'']]], - ['erf_5finterpolation_5fweno_5fz_2eh_659',['ERF_Interpolation_WENO_Z.H',['../ERF__Interpolation__WENO__Z_8H.html',1,'']]], - ['erf_5fkessler_2ecpp_660',['ERF_Kessler.cpp',['../ERF__Kessler_8cpp.html',1,'']]], - ['erf_5fkessler_2eh_661',['ERF_Kessler.H',['../ERF__Kessler_8H.html',1,'']]], - ['erf_5flagrangianmicrophysics_2eh_662',['ERF_LagrangianMicrophysics.H',['../ERF__LagrangianMicrophysics_8H.html',1,'']]], - ['erf_5flandsurface_2eh_663',['ERF_LandSurface.H',['../ERF__LandSurface_8H.html',1,'']]], - ['erf_5flinear_5finterpolate_2eh_664',['ERF_Linear_interpolate.H',['../ERF__Linear__interpolate_8H.html',1,'']]], - ['erf_5fm2005_5feffradius_2eh_665',['ERF_m2005_effradius.H',['../ERF__m2005__effradius_8H.html',1,'']]], - ['erf_5fmake_5fbuoyancy_2ecpp_666',['ERF_make_buoyancy.cpp',['../ERF__make__buoyancy_8cpp.html',1,'']]], - ['erf_5fmake_5ffast_5fcoeffs_2ecpp_667',['ERF_make_fast_coeffs.cpp',['../ERF__make__fast__coeffs_8cpp.html',1,'']]], - ['erf_5fmake_5fmom_5fsources_2ecpp_668',['ERF_make_mom_sources.cpp',['../ERF__make__mom__sources_8cpp.html',1,'']]], - ['erf_5fmake_5fnew_5farrays_2ecpp_669',['ERF_make_new_arrays.cpp',['../ERF__make__new__arrays_8cpp.html',1,'']]], - ['erf_5fmake_5fnew_5flevel_2ecpp_670',['ERF_make_new_level.cpp',['../ERF__make__new__level_8cpp.html',1,'']]], - ['erf_5fmake_5fsources_2ecpp_671',['ERF_make_sources.cpp',['../ERF__make__sources_8cpp.html',1,'']]], - ['erf_5fmake_5ftau_5fterms_672',['erf_make_tau_terms',['../ERF__TI__slow__headers_8H.html#a5664b227e5906334181ecc88eb7aba30',1,'erf_make_tau_terms(int level, int nrk, const amrex::Vector< amrex::BCRec > &domain_bcs_type, std::unique_ptr< amrex::MultiFab > &z_phys_nd, amrex::Vector< amrex::MultiFab > &S_data, const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &zvel, amrex::MultiFab *Tau11, amrex::MultiFab *Tau22, amrex::MultiFab *Tau33, amrex::MultiFab *Tau12, amrex::MultiFab *Tau13, amrex::MultiFab *Tau21, amrex::MultiFab *Tau23, amrex::MultiFab *Tau31, amrex::MultiFab *Tau32, amrex::MultiFab *SmnSmn, amrex::MultiFab *eddyDiffs, const amrex::Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, std::unique_ptr< amrex::MultiFab > &dJ, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v): ERF_TI_slow_headers.H'],['../ERF__make__tau__terms_8cpp.html#a7a7d71e3e796b67737a6931399588ae8',1,'erf_make_tau_terms(int level, int nrk, const Vector< BCRec > &domain_bcs_type_h, std::unique_ptr< MultiFab > &z_phys_nd, Vector< MultiFab > &S_data, const MultiFab &xvel, const MultiFab &yvel, const MultiFab &zvel, MultiFab *Tau11, MultiFab *Tau22, MultiFab *Tau33, MultiFab *Tau12, MultiFab *Tau13, MultiFab *Tau21, MultiFab *Tau23, MultiFab *Tau31, MultiFab *Tau32, MultiFab *SmnSmn, MultiFab *eddyDiffs, const Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, std::unique_ptr< MultiFab > &detJ, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v): ERF_make_tau_terms.cpp']]], - ['erf_5fmake_5ftau_5fterms_2ecpp_673',['ERF_make_tau_terms.cpp',['../ERF__make__tau__terms_8cpp.html',1,'']]], - ['erf_5fmam4_5faero_2eh_674',['ERF_Mam4_aero.H',['../ERF__Mam4__aero_8H.html',1,'']]], - ['erf_5fmam4_5fconstituents_2eh_675',['ERF_Mam4_constituents.H',['../ERF__Mam4__constituents_8H.html',1,'']]], - ['erf_5fmetgrid_5futils_2eh_676',['ERF_Metgrid_utils.H',['../ERF__Metgrid__utils_8H.html',1,'']]], - ['erf_5fmicrophysics_2eh_677',['ERF_Microphysics.H',['../ERF__Microphysics_8H.html',1,'']]], - ['erf_5fmicrophysics_5futils_2eh_678',['ERF_Microphysics_Utils.H',['../ERF__Microphysics__Utils_8H.html',1,'']]], - ['erf_5fmm5_2ecpp_679',['ERF_MM5.cpp',['../ERF__MM5_8cpp.html',1,'']]], - ['erf_5fmm5_2eh_680',['ERF_MM5.H',['../ERF__MM5_8H.html',1,'']]], - ['erf_5fmodal_5faero_5fwateruptake_2eh_681',['ERF_Modal_aero_wateruptake.H',['../ERF__Modal__aero__wateruptake_8H.html',1,'']]], - ['erf_5fmoist_5fset_5frhs_2ecpp_682',['ERF_moist_set_rhs.cpp',['../ERF__moist__set__rhs_8cpp.html',1,'']]], - ['erf_5fmomentumtovelocity_2ecpp_683',['ERF_MomentumToVelocity.cpp',['../ERF__MomentumToVelocity_8cpp.html',1,'']]], - ['erf_5fmostaverage_2ecpp_684',['ERF_MOSTAverage.cpp',['../ERF__MOSTAverage_8cpp.html',1,'']]], - ['erf_5fmostaverage_2eh_685',['ERF_MOSTAverage.H',['../ERF__MOSTAverage_8H.html',1,'']]], - ['erf_5fmostroughness_2eh_686',['ERF_MOSTRoughness.H',['../ERF__MOSTRoughness_8H.html',1,'']]], - ['erf_5fmoststress_2eh_687',['ERF_MOSTStress.H',['../ERF__MOSTStress_8H.html',1,'']]], - ['erf_5fmri_2eh_688',['ERF_MRI.H',['../ERF__MRI_8H.html',1,'']]], - ['erf_5fmultiblockcontainer_2ecpp_689',['ERF_MultiBlockContainer.cpp',['../ERF__MultiBlockContainer_8cpp.html',1,'']]], - ['erf_5fmultiblockcontainer_2eh_690',['ERF_MultiBlockContainer.H',['../ERF__MultiBlockContainer_8H.html',1,'']]], - ['erf_5fmynnstruct_2eh_691',['ERF_MYNNStruct.H',['../ERF__MYNNStruct_8H.html',1,'']]], - ['erf_5fnccheckpoint_2ecpp_692',['ERF_NCCheckpoint.cpp',['../ERF__NCCheckpoint_8cpp.html',1,'']]], - ['erf_5fnccolumnfile_2ecpp_693',['ERF_NCColumnFile.cpp',['../ERF__NCColumnFile_8cpp.html',1,'']]], - ['erf_5fncinterface_2ecpp_694',['ERF_NCInterface.cpp',['../ERF__NCInterface_8cpp.html',1,'']]], - ['erf_5fncinterface_2eh_695',['ERF_NCInterface.H',['../ERF__NCInterface_8H.html',1,'']]], - ['erf_5fncmultifabfile_2ecpp_696',['ERF_NCMultiFabFile.cpp',['../ERF__NCMultiFabFile_8cpp.html',1,'']]], - ['erf_5fncplotfile_2ecpp_697',['ERF_NCPlotFile.cpp',['../ERF__NCPlotFile_8cpp.html',1,'']]], - ['erf_5fncplotfile_2eh_698',['ERF_NCPlotFile.H',['../ERF__NCPlotFile_8H.html',1,'']]], - ['erf_5fncwpsfile_2eh_699',['ERF_NCWpsFile.H',['../ERF__NCWpsFile_8H.html',1,'']]], - ['erf_5fnoah_2ecpp_700',['ERF_NOAH.cpp',['../ERF__NOAH_8cpp.html',1,'']]], - ['erf_5fnoah_2eh_701',['ERF_NOAH.H',['../ERF__NOAH_8H.html',1,'']]], - ['erf_5fnullmoist_2eh_702',['ERF_NullMoist.H',['../ERF__NullMoist_8H.html',1,'']]], - ['erf_5fnullmoistlagrangian_2eh_703',['ERF_NullMoistLagrangian.H',['../ERF__NullMoistLagrangian_8H.html',1,'']]], - ['erf_5fnullsurf_2eh_704',['ERF_NullSurf.H',['../ERF__NullSurf_8H.html',1,'']]], - ['erf_5fnullwindfarm_2eh_705',['ERF_NullWindFarm.H',['../ERF__NullWindFarm_8H.html',1,'']]], - ['erf_5fnumericaldiffusion_2ecpp_706',['ERF_NumericalDiffusion.cpp',['../ERF__NumericalDiffusion_8cpp.html',1,'']]], - ['erf_5fnumericaldiffusion_2eh_707',['ERF_NumericalDiffusion.H',['../ERF__NumericalDiffusion_8H.html',1,'']]], - ['erf_5foptics_2ecpp_708',['ERF_Optics.cpp',['../ERF__Optics_8cpp.html',1,'']]], - ['erf_5foptics_2eh_709',['ERF_Optics.H',['../ERF__Optics_8H.html',1,'']]], - ['erf_5forbit_2ecpp_710',['ERF_Orbit.cpp',['../ERF__Orbit_8cpp.html',1,'']]], - ['erf_5forbit_2eh_711',['ERF_Orbit.H',['../ERF__Orbit_8H.html',1,'']]], - ['erf_5fparameterizations_2eh_712',['ERF_Parameterizations.H',['../ERF__Parameterizations_8H.html',1,'']]], - ['erf_5fparfunctions_2eh_713',['ERF_ParFunctions.H',['../ERF__ParFunctions_8H.html',1,'']]], - ['erf_5fparticledata_2eh_714',['ERF_ParticleData.H',['../ERF__ParticleData_8H.html',1,'']]], - ['erf_5fpblheight_2eh_715',['ERF_PBLHeight.H',['../ERF__PBLHeight_8H.html',1,'']]], - ['erf_5fpblmodels_2eh_716',['ERF_PBLModels.H',['../ERF__PBLModels_8H.html',1,'']]], - ['erf_5fphys_5fprop_2eh_717',['ERF_Phys_prop.H',['../ERF__Phys__prop_8H.html',1,'']]], - ['erf_5fphysbcfunct_2ecpp_718',['ERF_PhysBCFunct.cpp',['../ERF__PhysBCFunct_8cpp.html',1,'']]], - ['erf_5fphysbcfunct_2eh_719',['ERF_PhysBCFunct.H',['../ERF__PhysBCFunct_8H.html',1,'']]], - ['erf_5fplaneaverage_2eh_720',['ERF_PlaneAverage.H',['../ERF__PlaneAverage_8H.html',1,'']]], - ['erf_5fplotfile_2ecpp_721',['ERF_Plotfile.cpp',['../ERF__Plotfile_8cpp.html',1,'']]], - ['erf_5fpoissonsolve_2ecpp_722',['ERF_PoissonSolve.cpp',['../ERF__PoissonSolve_8cpp.html',1,'']]], - ['erf_5fpoissonsolve_5ftb_2ecpp_723',['ERF_PoissonSolve_tb.cpp',['../ERF__PoissonSolve__tb_8cpp.html',1,'']]], - ['erf_5fprecip_2ecpp_724',['ERF_Precip.cpp',['../ERF__Precip_8cpp.html',1,'']]], - ['erf_5fprecipfall_2ecpp_725',['ERF_PrecipFall.cpp',['../ERF__PrecipFall_8cpp.html',1,'']]], - ['erf_5fprob_5fcommon_2eh_726',['ERF_prob_common.H',['../ERF__prob__common_8H.html',1,'']]], - ['erf_5fqsati_727',['erf_qsati',['../ERF__Microphysics__Utils_8H.html#ac39ef2a869ef543f708d5ed7da4754d3',1,'ERF_Microphysics_Utils.H']]], - ['erf_5fqsatw_728',['erf_qsatw',['../ERF__Microphysics__Utils_8H.html#a8e4b0c6ed8b95c2040dc0c9e8fcb8615',1,'ERF_Microphysics_Utils.H']]], - ['erf_5frad_5fconstants_2eh_729',['ERF_Rad_constants.H',['../ERF__Rad__constants_8H.html',1,'']]], - ['erf_5fradiation_2ecpp_730',['ERF_Radiation.cpp',['../ERF__Radiation_8cpp.html',1,'']]], - ['erf_5fradiation_2eh_731',['ERF_Radiation.H',['../ERF__Radiation_8H.html',1,'']]], - ['erf_5fread_5fwaves_2ecpp_732',['ERF_read_waves.cpp',['../ERF__read__waves_8cpp.html',1,'']]], - ['erf_5freadbndryplanes_2ecpp_733',['ERF_ReadBndryPlanes.cpp',['../ERF__ReadBndryPlanes_8cpp.html',1,'']]], - ['erf_5freadbndryplanes_2eh_734',['ERF_ReadBndryPlanes.H',['../ERF__ReadBndryPlanes_8H.html',1,'']]], - ['erf_5freadfrommetgrid_2ecpp_735',['ERF_ReadFromMetgrid.cpp',['../ERF__ReadFromMetgrid_8cpp.html',1,'']]], - ['erf_5freadfromwrfbdy_2ecpp_736',['ERF_ReadFromWRFBdy.cpp',['../ERF__ReadFromWRFBdy_8cpp.html',1,'']]], - ['erf_5freadfromwrfinput_2ecpp_737',['ERF_ReadFromWRFInput.cpp',['../ERF__ReadFromWRFInput_8cpp.html',1,'']]], - ['erf_5frrtmgp_2eh_738',['ERF_Rrtmgp.H',['../ERF__Rrtmgp_8H.html',1,'']]], - ['erf_5frun_5flongwave_5frrtmgp_2ecpp_739',['ERF_Run_longwave_rrtmgp.cpp',['../ERF__Run__longwave__rrtmgp_8cpp.html',1,'']]], - ['erf_5frun_5fshortwave_5frrtmgp_2ecpp_740',['ERF_Run_shortwave_rrtmgp.cpp',['../ERF__Run__shortwave__rrtmgp_8cpp.html',1,'']]], - ['erf_5fsam_2eh_741',['ERF_SAM.H',['../ERF__SAM_8H.html',1,'']]], - ['erf_5fsampledata_2eh_742',['ERF_SampleData.H',['../ERF__SampleData_8H.html',1,'']]], - ['erf_5fsat_5fmethods_2eh_743',['ERF_Sat_methods.H',['../ERF__Sat__methods_8H.html',1,'']]], - ['erf_5fshared_744',['ERF_shared',['../classERF.html#aab5871c91a4d8888c110865e9d35e8b2',1,'ERF']]], - ['erf_5fsimplead_2eh_745',['ERF_SimpleAD.H',['../ERF__SimpleAD_8H.html',1,'']]], - ['erf_5fslingo_2eh_746',['ERF_Slingo.H',['../ERF__Slingo_8H.html',1,'']]], - ['erf_5fslm_2ecpp_747',['ERF_SLM.cpp',['../ERF__SLM_8cpp.html',1,'']]], - ['erf_5fslm_2eh_748',['ERF_SLM.H',['../ERF__SLM_8H.html',1,'']]], - ['erf_5fslow_5frhs_5finc_749',['erf_slow_rhs_inc',['../ERF__TI__slow__headers_8H.html#afd0e57c37da16481cde9d2fe85792cd0',1,'ERF_TI_slow_headers.H']]], - ['erf_5fslow_5frhs_5fpost_750',['erf_slow_rhs_post',['../ERF__TI__slow__headers_8H.html#a5b8b04e54f9f960d4c661a110cbdbcd4',1,'erf_slow_rhs_post(int level, int finest_level, int nrk, amrex::Real dt, int n_qstate, amrex::Vector< amrex::MultiFab > &S_rhs, amrex::Vector< amrex::MultiFab > &S_old, amrex::Vector< amrex::MultiFab > &S_new, amrex::Vector< amrex::MultiFab > &S_data, const amrex::MultiFab &S_prim, amrex::Vector< amrex::MultiFab > &S_scratch, const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &zvel, const amrex::MultiFab &source, const amrex::MultiFab *SmnSmn, const amrex::MultiFab *eddyDiffs, amrex::MultiFab *Hfx1, amrex::MultiFab *Hfx2, amrex::MultiFab *Hfx3, amrex::MultiFab *Q1fx1, amrex::MultiFab *Q1fx2, amrex::MultiFab *Q1fx3, amrex::MultiFab *Q2fx3, amrex::MultiFab *Diss, const amrex::Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const amrex::Gpu::DeviceVector< amrex::BCRec > &domain_bcs_type_d, const amrex::Vector< amrex::BCRec > &domain_bcs_type, std::unique_ptr< amrex::MultiFab > &z_phys_nd, std::unique_ptr< amrex::MultiFab > &ax, std::unique_ptr< amrex::MultiFab > &ay, std::unique_ptr< amrex::MultiFab > &az, std::unique_ptr< amrex::MultiFab > &dJ_old, std::unique_ptr< amrex::MultiFab > &dJ_new, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v, amrex::YAFluxRegister *fr_as_crse, amrex::YAFluxRegister *fr_as_fine): ERF_TI_slow_headers.H'],['../ERF__slow__rhs__post_8cpp.html#ad4185a682dcd69d6a29ce11039296d66',1,'erf_slow_rhs_post(int level, int finest_level, int nrk, Real dt, int n_qstate, Vector< MultiFab > &S_rhs, Vector< MultiFab > &S_old, Vector< MultiFab > &S_new, Vector< MultiFab > &S_data, const MultiFab &S_prim, Vector< MultiFab > &S_scratch, const MultiFab &xvel, const MultiFab &yvel, const MultiFab &, const MultiFab &source, const MultiFab *SmnSmn, const MultiFab *eddyDiffs, MultiFab *Hfx1, MultiFab *Hfx2, MultiFab *Hfx3, MultiFab *Q1fx1, MultiFab *Q1fx2, MultiFab *Q1fx3, MultiFab *Q2fx3, MultiFab *Diss, const Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const Gpu::DeviceVector< BCRec > &domain_bcs_type_d, const Vector< BCRec > &domain_bcs_type_h, std::unique_ptr< MultiFab > &z_phys_nd, std::unique_ptr< MultiFab > &ax, std::unique_ptr< MultiFab > &ay, std::unique_ptr< MultiFab > &az, std::unique_ptr< MultiFab > &detJ, std::unique_ptr< MultiFab > &detJ_new, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine): ERF_slow_rhs_post.cpp']]], - ['erf_5fslow_5frhs_5fpost_2ecpp_751',['ERF_slow_rhs_post.cpp',['../ERF__slow__rhs__post_8cpp.html',1,'']]], - ['erf_5fslow_5frhs_5fpre_752',['erf_slow_rhs_pre',['../ERF__TI__slow__headers_8H.html#a08e56aada7b66b087c1a2b9dc0efe933',1,'erf_slow_rhs_pre(int level, int finest_level, int nrk, amrex::Real dt, amrex::Vector< amrex::MultiFab > &S_rhs, amrex::Vector< amrex::MultiFab > &S_old, amrex::Vector< amrex::MultiFab > &S_data, const amrex::MultiFab &S_prim, amrex::Vector< amrex::MultiFab > &S_scratch, const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &zvel, std::unique_ptr< amrex::MultiFab > &z_t, const amrex::MultiFab &cc_src, const amrex::MultiFab &xmom_src, const amrex::MultiFab &ymom_src, const amrex::MultiFab &zmom_src, const amrex::MultiFab *zmom_crse_rhs, amrex::MultiFab *Tau11, amrex::MultiFab *Tau22, amrex::MultiFab *Tau33, amrex::MultiFab *Tau12, amrex::MultiFab *Tau13, amrex::MultiFab *Tau21, amrex::MultiFab *Tau23, amrex::MultiFab *Tau31, amrex::MultiFab *Tau32, amrex::MultiFab *SmnSmn, amrex::MultiFab *eddyDiffs, amrex::MultiFab *Hfx1, amrex::MultiFab *Hfx2, amrex::MultiFab *Hfx3, amrex::MultiFab *Q1fx1, amrex::MultiFab *Q1fx2, amrex::MultiFab *Q1fx3, amrex::MultiFab *Q2fx3, amrex::MultiFab *Diss, const amrex::Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const amrex::Gpu::DeviceVector< amrex::BCRec > &domain_bcs_type_d, const amrex::Vector< amrex::BCRec > &domain_bcs_type, std::unique_ptr< amrex::MultiFab > &z_phys_nd, std::unique_ptr< amrex::MultiFab > &ax, std::unique_ptr< amrex::MultiFab > &ay, std::unique_ptr< amrex::MultiFab > &az, std::unique_ptr< amrex::MultiFab > &dJ, const amrex::MultiFab *p0, const amrex::MultiFab &pp_inc, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v, amrex::YAFluxRegister *fr_as_crse, amrex::YAFluxRegister *fr_as_fine): ERF_TI_slow_headers.H'],['../ERF__slow__rhs__pre_8cpp.html#a7f9a468e8f9594554d88b4b0b55e8b9f',1,'erf_slow_rhs_pre(int level, int finest_level, int nrk, Real dt, Vector< MultiFab > &S_rhs, Vector< MultiFab > &S_old, Vector< MultiFab > &S_data, const MultiFab &S_prim, Vector< MultiFab > &S_scratch, const MultiFab &xvel, const MultiFab &yvel, const MultiFab &zvel, std::unique_ptr< MultiFab > &z_t_mf, const MultiFab &cc_src, const MultiFab &xmom_src, const MultiFab &ymom_src, const MultiFab &zmom_src, const MultiFab *zmom_crse_rhs, MultiFab *Tau11, MultiFab *Tau22, MultiFab *Tau33, MultiFab *Tau12, MultiFab *Tau13, MultiFab *Tau21, MultiFab *Tau23, MultiFab *Tau31, MultiFab *Tau32, MultiFab *SmnSmn, MultiFab *eddyDiffs, MultiFab *Hfx1, MultiFab *Hfx2, MultiFab *Hfx3, MultiFab *Q1fx1, MultiFab *Q1fx2, MultiFab *Q1fx3, MultiFab *Q2fx3, MultiFab *Diss, const Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const Gpu::DeviceVector< BCRec > &domain_bcs_type_d, const Vector< BCRec > &domain_bcs_type_h, std::unique_ptr< MultiFab > &z_phys_nd, std::unique_ptr< MultiFab > &ax, std::unique_ptr< MultiFab > &ay, std::unique_ptr< MultiFab > &az, std::unique_ptr< MultiFab > &detJ, const MultiFab *p0, const MultiFab &pp_inc, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine): ERF_slow_rhs_pre.cpp']]], - ['erf_5fslow_5frhs_5fpre_2ecpp_753',['ERF_slow_rhs_pre.cpp',['../ERF__slow__rhs__pre_8cpp.html',1,'']]], - ['erf_5fsolve_5fwith_5feb_5fmlmg_2ecpp_754',['ERF_solve_with_EB_mlmg.cpp',['../ERF__solve__with__EB__mlmg_8cpp.html',1,'']]], - ['erf_5fsolve_5fwith_5ffft_2ecpp_755',['ERF_solve_with_fft.cpp',['../ERF__solve__with__fft_8cpp.html',1,'']]], - ['erf_5fsolve_5fwith_5fgmres_2ecpp_756',['ERF_solve_with_gmres.cpp',['../ERF__solve__with__gmres_8cpp.html',1,'']]], - ['erf_5fsolve_5fwith_5fmlmg_2ecpp_757',['ERF_solve_with_mlmg.cpp',['../ERF__solve__with__mlmg_8cpp.html',1,'']]], - ['erf_5fspongestruct_2eh_758',['ERF_SpongeStruct.H',['../ERF__SpongeStruct_8H.html',1,'']]], - ['erf_5fsrc_5fheaders_2eh_759',['ERF_Src_headers.H',['../ERF__Src__headers_8H.html',1,'']]], - ['erf_5ftagging_2ecpp_760',['ERF_Tagging.cpp',['../ERF__Tagging_8cpp.html',1,'']]], - ['erf_5fterrainif_2eh_761',['ERF_TerrainIF.H',['../ERF__TerrainIF_8H.html',1,'']]], - ['erf_5fterrainmetrics_2ecpp_762',['ERF_TerrainMetrics.cpp',['../ERF__TerrainMetrics_8cpp.html',1,'']]], - ['erf_5fterrainmetrics_2eh_763',['ERF_TerrainMetrics.H',['../ERF__TerrainMetrics_8H.html',1,'']]], - ['erf_5fterrainpoisson_2ecpp_764',['ERF_TerrainPoisson.cpp',['../ERF__TerrainPoisson_8cpp.html',1,'']]], - ['erf_5fterrainpoisson_2eh_765',['ERF_TerrainPoisson.H',['../ERF__TerrainPoisson_8H.html',1,'']]], - ['erf_5fterrainpoisson_5f3d_5fk_2eh_766',['ERF_TerrainPoisson_3D_K.H',['../ERF__TerrainPoisson__3D__K_8H.html',1,'']]], - ['erf_5fthetav_2eh_767',['ERF_Thetav.H',['../ERF__Thetav_8H.html',1,'']]], - ['erf_5fti_5ffast_5fheaders_2eh_768',['ERF_TI_fast_headers.H',['../ERF__TI__fast__headers_8H.html',1,'']]], - ['erf_5fti_5fno_5fsubstep_5ffun_2eh_769',['ERF_TI_no_substep_fun.H',['../ERF__TI__no__substep__fun_8H.html',1,'']]], - ['erf_5fti_5fslow_5fheaders_2eh_770',['ERF_TI_slow_headers.H',['../ERF__TI__slow__headers_8H.html',1,'']]], - ['erf_5fti_5fslow_5frhs_5ffun_2eh_771',['ERF_TI_slow_rhs_fun.H',['../ERF__TI__slow__rhs__fun_8H.html',1,'']]], - ['erf_5fti_5fsubstep_5ffun_2eh_772',['ERF_TI_substep_fun.H',['../ERF__TI__substep__fun_8H.html',1,'']]], - ['erf_5fti_5futils_2eh_773',['ERF_TI_utils.H',['../ERF__TI__utils_8H.html',1,'']]], - ['erf_5ftilenoz_2eh_774',['ERF_TileNoZ.H',['../ERF__TileNoZ_8H.html',1,'']]], - ['erf_5ftime_5favg_5fvel_2ecpp_775',['ERF_Time_Avg_Vel.cpp',['../ERF__Time__Avg__Vel_8cpp.html',1,'']]], - ['erf_5ftimeinterpolateddata_2eh_776',['ERF_TimeInterpolatedData.H',['../ERF__TimeInterpolatedData_8H.html',1,'']]], - ['erf_5ftimestep_2ecpp_777',['ERF_TimeStep.cpp',['../ERF__TimeStep_8cpp.html',1,'']]], - ['erf_5fturbpertstruct_2eh_778',['ERF_TurbPertStruct.H',['../ERF__TurbPertStruct_8H.html',1,'']]], - ['erf_5fturbstruct_2eh_779',['ERF_TurbStruct.H',['../ERF__TurbStruct_8H.html',1,'']]], - ['erf_5fupdate_5fkessler_2ecpp_780',['ERF_Update_Kessler.cpp',['../ERF__Update__Kessler_8cpp.html',1,'']]], - ['erf_5fupdate_5fsam_2ecpp_781',['ERF_Update_SAM.cpp',['../ERF__Update__SAM_8cpp.html',1,'']]], - ['erf_5futils_2eh_782',['ERF_Utils.H',['../ERF__Utils_8H.html',1,'']]], - ['erf_5fvelocitytomomentum_2ecpp_783',['ERF_VelocityToMomentum.cpp',['../ERF__VelocityToMomentum_8cpp.html',1,'']]], - ['erf_5fwater_5fvapor_5fsaturation_2eh_784',['ERF_Water_vapor_saturation.H',['../ERF__Water__vapor__saturation_8H.html',1,'']]], - ['erf_5fwindfarm_2eh_785',['ERF_WindFarm.H',['../ERF__WindFarm_8H.html',1,'']]], - ['erf_5fwrite1dprofiles_2ecpp_786',['ERF_Write1DProfiles.cpp',['../ERF__Write1DProfiles_8cpp.html',1,'']]], - ['erf_5fwrite1dprofiles_5fstag_2ecpp_787',['ERF_Write1DProfiles_stag.cpp',['../ERF__Write1DProfiles__stag_8cpp.html',1,'']]], - ['erf_5fwritebndryplanes_2ecpp_788',['ERF_WriteBndryPlanes.cpp',['../ERF__WriteBndryPlanes_8cpp.html',1,'']]], - ['erf_5fwritebndryplanes_2eh_789',['ERF_WriteBndryPlanes.H',['../ERF__WriteBndryPlanes_8H.html',1,'']]], - ['erf_5fwriteebsurface_2ecpp_790',['ERF_writeEBsurface.cpp',['../ERF__writeEBsurface_8cpp.html',1,'']]], - ['erf_5fwritejobinfo_2ecpp_791',['ERF_writeJobInfo.cpp',['../ERF__writeJobInfo_8cpp.html',1,'']]], - ['erf_5fwritescalarprofiles_2ecpp_792',['ERF_WriteScalarProfiles.cpp',['../ERF__WriteScalarProfiles_8cpp.html',1,'']]], - ['erf_5fwstar_2eh_793',['ERF_Wstar.H',['../ERF__Wstar_8H.html',1,'']]], - ['erfbctype_794',['ERFBCType',['../namespaceERFBCType.html',1,'']]], - ['erffillpatcher_795',['ERFFillPatcher',['../classERFFillPatcher.html',1,'ERFFillPatcher'],['../classERFFillPatcher.html#a4236a9ab8003847e327495ff170a9a7a',1,'ERFFillPatcher::ERFFillPatcher()']]], - ['erfpc_2eh_796',['ERFPC.H',['../ERFPC_8H.html',1,'']]], - ['erfpcevolve_2ecpp_797',['ERFPCEvolve.cpp',['../ERFPCEvolve_8cpp.html',1,'']]], - ['erfpcinitializations_2ecpp_798',['ERFPCInitializations.cpp',['../ERFPCInitializations_8cpp.html',1,'']]], - ['erfpcutils_2ecpp_799',['ERFPCUtils.cpp',['../ERFPCUtils_8cpp.html',1,'']]], - ['erfphysbcfunct_5fbase_800',['ERFPhysBCFunct_base',['../classERFPhysBCFunct__base.html#a4ba2333432141d41177dca92464e619d',1,'ERFPhysBCFunct_base::ERFPhysBCFunct_base()'],['../classERFPhysBCFunct__base.html',1,'ERFPhysBCFunct_base']]], - ['erfphysbcfunct_5fcons_801',['ERFPhysBCFunct_cons',['../classERFPhysBCFunct__cons.html#a946d62bb44e2344fac3fe34ed4c27d3a',1,'ERFPhysBCFunct_cons::ERFPhysBCFunct_cons()'],['../classERFPhysBCFunct__cons.html',1,'ERFPhysBCFunct_cons']]], - ['erfphysbcfunct_5fu_802',['ERFPhysBCFunct_u',['../classERFPhysBCFunct__u.html',1,'ERFPhysBCFunct_u'],['../classERFPhysBCFunct__u.html#a02e58c56eb025621156c134d7782e495',1,'ERFPhysBCFunct_u::ERFPhysBCFunct_u()']]], - ['erfphysbcfunct_5fv_803',['ERFPhysBCFunct_v',['../classERFPhysBCFunct__v.html#a6dce68398d0b2711389dda67d222fedc',1,'ERFPhysBCFunct_v::ERFPhysBCFunct_v()'],['../classERFPhysBCFunct__v.html',1,'ERFPhysBCFunct_v']]], - ['erfphysbcfunct_5fw_804',['ERFPhysBCFunct_w',['../classERFPhysBCFunct__w.html',1,'ERFPhysBCFunct_w'],['../classERFPhysBCFunct__w.html#a9a009bc8ab1a9916eaa56702b38e7436',1,'ERFPhysBCFunct_w::ERFPhysBCFunct_w()']]], - ['erfpostprocessbasegrids_805',['ERFPostProcessBaseGrids',['../ERF__Utils_8H.html#aa333d30d88adfbad5d860b704845f857',1,'ERFPostProcessBaseGrids(const amrex::Box &domain, bool decompose_in_z): ERF_Utils.H'],['../ERF__ChopGrids_8cpp.html#a140e3056fee7f1dcd5a295d2efdaf0b2',1,'ERFPostProcessBaseGrids(const Box &domain, bool decompose_in_z): ERF_ChopGrids.cpp']]], - ['erftracers_2ecpp_806',['ERFTracers.cpp',['../ERFTracers_8cpp.html',1,'']]], - ['errorest_807',['ErrorEst',['../classERF.html#a18e6dbbf968b4492e78aa427791620f4',1,'ERF']]], - ['esccoef_808',['esccoef',['../ERF__Constants_8H.html#ac16a7511bec41b7d5a558b5841e8f3b1',1,'ERF_Constants.H']]], - ['esicoef_809',['esicoef',['../ERF__Constants_8H.html#a414035f12e97c86f4e40cb6763c29ddb',1,'ERF_Constants.H']]], - ['esttimestep_810',['estTimeStep',['../classERF.html#a6b1d727e63de2e49aa4f8e00b0dda1d5',1,'ERF']]], - ['eta_5feps_811',['eta_eps',['../structmoeng__flux.html#a67cae16850c061bb189a783159ac6406',1,'moeng_flux::eta_eps()'],['../structdonelan__flux.html#aac38c6d44658be0daa32dc8bd0b29adb',1,'donelan_flux::eta_eps()'],['../structcustom__flux.html#aa04871c3e8d2e06f502cde2404c90be4',1,'custom_flux::eta_eps()']]], - ['eulerianmicrophysics_812',['EulerianMicrophysics',['../classEulerianMicrophysics.html',1,'EulerianMicrophysics'],['../classEulerianMicrophysics.html#a26a985c76efcd1dd68b5c853bbd264f6',1,'EulerianMicrophysics::EulerianMicrophysics(const int &nlev, const MoistureType &a_model_type)'],['../classEulerianMicrophysics.html#af78c2f059431d49deec9f570ada4daaa',1,'EulerianMicrophysics::EulerianMicrophysics()']]], - ['evaluate_813',['Evaluate',['../structCENTERED4.html#ae67620f7c851fbadb31ff439601ac7fe',1,'CENTERED4::Evaluate()'],['../structUPWIND3.html#a247a547b52d1bf118e8a9cb44d46b744',1,'UPWIND3::Evaluate()'],['../structCENTERED2.html#a1f9232868e37a452630ccfa8ec34be91',1,'CENTERED2::Evaluate()'],['../structWENO7.html#a42198ea771144460fff2f08857fa52ee',1,'WENO7::Evaluate()'],['../structUPWIND5.html#a267b7805b0761e01b0532a986307b79d',1,'UPWIND5::Evaluate()'],['../structCENTERED6.html#aacd79f8ed62a166d5f4d44a20d09fc13',1,'CENTERED6::Evaluate()'],['../structUPWINDALL.html#a781c3531bb77c6282c88c9cc3d64c722',1,'UPWINDALL::Evaluate()'],['../structWENO5.html#ae77d5f8032cf91c84551f51170ec9111',1,'WENO5::Evaluate()'],['../structWENO__Z3.html#aa6c2eefc18b5f0365c0357ee4f066080',1,'WENO_Z3::Evaluate()'],['../structWENO__MZQ3.html#a8dcc9655166c1217b7056f244d4cfde2',1,'WENO_MZQ3::Evaluate()'],['../structWENO__Z5.html#a06568f71bdf16e718756dcd66a26fd97',1,'WENO_Z5::Evaluate()'],['../structWENO__Z7.html#a2562b1dcd18d8a2d7f02f3719e98112b',1,'WENO_Z7::Evaluate()'],['../structWENO3.html#a6a48e6b00e04466ca779a2b3ee62770b',1,'WENO3::Evaluate()']]], - ['evapg1_814',['evapg1',['../classSAM.html#a2e241fff555231e1cc87947a624bb5d6',1,'SAM']]], - ['evapg2_815',['evapg2',['../classSAM.html#a3117e23160d027ccb4dacf744a477a40',1,'SAM']]], - ['evapr1_816',['evapr1',['../classSAM.html#a8350a31a9f29bedee48b24bb43d5b0fc',1,'SAM']]], - ['evapr2_817',['evapr2',['../classSAM.html#a0edeaaddf7573079fdc9af1484ce5582',1,'SAM']]], - ['evaps1_818',['evaps1',['../classSAM.html#a56c463cbd313722b567dd88e7ac6fccd',1,'SAM']]], - ['evaps2_819',['evaps2',['../classSAM.html#a8f9e9699afd94d393be846cd26933fd0',1,'SAM']]], - ['evolve_820',['Evolve',['../classERF.html#a0be12798b46f52fa4b5a995f147c3f96',1,'ERF']]], - ['ewp_821',['EWP',['../classEWP.html',1,'EWP'],['../classEWP.html#a4c32d700e8ba91dfbc07c332ad91ca71',1,'EWP::EWP()']]], - ['exit_5fdef_5fmode_822',['exit_def_mode',['../classncutils_1_1NCGroup.html#a3a4ebd106195be96fb41bb3bfde83143',1,'ncutils::NCGroup']]], - ['exp_5finterpol_823',['exp_interpol',['../classPhysProp.html#a9bc40a34bf3b039dd0d8ad87678e23d1',1,'PhysProp']]], - ['expand_5fand_5finterpolate_5f1d_824',['expand_and_interpolate_1d',['../ERF__Interpolation__1D_8H.html#af71b362e58803c8c29aa5127adcf645f',1,'ERF_Interpolation_1D.H']]], - ['expand_5fday_5ffluxes_825',['expand_day_fluxes',['../namespaceinternal.html#a154efe747ea48707745d01843ac5eb71',1,'internal']]], - ['expand_5fyakl1d_5fto_5fmf_826',['expand_yakl1d_to_mf',['../classRadiation.html#a5a43e7644bc6a0d3590bd356384cb0fb',1,'Radiation']]], - ['export_5fsurface_5ffluxes_827',['export_surface_fluxes',['../classRadiation.html#a2115945b42eb2b2c6844049b2edc74ca',1,'Radiation']]], - ['ext_5fcmip6_5fsw_828',['ext_cmip6_sw',['../classAerRadProps.html#acf87aa0fdbfa3b73924a1f7c56088e55',1,'AerRadProps']]], - ['ext_5fdir_829',['ext_dir',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca4b16988b22c277c9f812ddb5fb1539af',1,'ERFBCType']]], - ['ext_5fdir_5fingested_830',['ext_dir_ingested',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca138e8c6c2427dcd78959f3e0e84b3462',1,'ERFBCType']]], - ['ext_5fdir_5fprim_831',['ext_dir_prim',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca52a76d5c6aeb74655f726be3ae8a1eab',1,'ERFBCType']]], - ['ext_5fsw_5fice_832',['ext_sw_ice',['../classCloudRadProps.html#a4664e7123fdc065b7ff40e716453b050',1,'CloudRadProps']]], - ['ext_5fsw_5fliq_833',['ext_sw_liq',['../classCloudRadProps.html#a98a74e616e9952f22102a6d3c3f4af51',1,'CloudRadProps']]], - ['extpsw_834',['extpsw',['../structPhysProp_1_1physprop__t.html#aa86746c3ce43b7a278d78276bbe0d153',1,'PhysProp::physprop_t']]], - ['extrap_5fmethod_5fbndry_835',['extrap_method_bndry',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2ac291677b47a4b2b3276ea6ebf30d6e26',1,'LinInterp']]], - ['extrap_5fmethod_5fcycle_836',['extrap_method_cycle',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2aeec66ba685aaa33115191d8f6bc9c0e6',1,'LinInterp']]], - ['extrap_5fmethod_5fzero_837',['extrap_method_zero',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2aa8778034b0e18c190776623750b945b5',1,'LinInterp']]] + ['ebertcurry_492',['EbertCurry',['../classEbertCurry.html',1,'']]], + ['ec_5fice_5foptics_5flw_493',['ec_ice_optics_lw',['../classEbertCurry.html#ae258a04b9aaba9ca0052793a2d57f05e',1,'EbertCurry']]], + ['ec_5fice_5foptics_5fsw_494',['ec_ice_optics_sw',['../classEbertCurry.html#aed435ba6c3e2c62f6ba2d8111c7c2f08',1,'EbertCurry']]], + ['eccen_495',['eccen',['../classRadiation.html#a62efb2cdbddfca4321d9e866b6a79b11',1,'Radiation']]], + ['eddydiff_496',['EddyDiff',['../namespaceEddyDiff.html',1,'']]], + ['eddydiffs_5flev_497',['eddyDiffs_lev',['../classERF.html#a327d704704abd516be19339cb2d226f9',1,'ERF']]], + ['efficientadvtype_498',['EfficientAdvType',['../ERF__Advection_8H.html#aff14fe9e4f76b499843517b2c41c0fbb',1,'ERF_Advection.H']]], + ['egccoef_499',['egccoef',['../ERF__Constants_8H.html#a65f78c57eaba4f35dc9183cd2f3e66e3',1,'ERF_Constants.H']]], + ['egicoef_500',['egicoef',['../ERF__Constants_8H.html#a6b49f5e9d61881c5a59656453a6c025f',1,'ERF_Constants.H']]], + ['empty_501',['empty',['../classUnionListIF.html#ada33e955e690c4535d78e6db572707d7',1,'UnionListIF']]], + ['energy_20research_20and_20forecasting_3a_20an_20atmospheric_20modeling_20code_502',['Energy Research and Forecasting: An Atmospheric Modeling Code',['../index.html',1,'']]], + ['enter_5fdef_5fmode_503',['enter_def_mode',['../classncutils_1_1NCGroup.html#aef6b6e2be36e6179a001d9873e94df82',1,'ncutils::NCGroup']]], + ['eps_504',['eps',['../structWENO__Z7.html#a5f83e00b8908c86f74e2a4c5ea373090',1,'WENO_Z7::eps()'],['../structadiabatic__wave__coupled.html#a3f907fc7025d3d3f7e44c222e12b4df1',1,'adiabatic_wave_coupled::eps()'],['../structsurface__flux__wave__coupled.html#aee14d25dbf38dc291b9c4900d737e121',1,'surface_flux_wave_coupled::eps()'],['../structsurface__temp__wave__coupled.html#a2a663fad6d183ced2edb1dc99fe104bf',1,'surface_temp_wave_coupled::eps()'],['../structmoeng__flux.html#a3d06eff1aa7d6c357e1245eb8f5b96f7',1,'moeng_flux::eps()'],['../structcustom__flux.html#ae0e2af01151c51f4c335f053a8bb8f17',1,'custom_flux::eps()'],['../structrotate__flux.html#ae2e4dd388a9a609acf27d90fea305e11',1,'rotate_flux::eps()'],['../structMYNNLevel2.html#a2d226d66711e6659f0428210f8283f9d',1,'MYNNLevel2::eps()'],['../structWENO3.html#a5ea04e699e55b168c29b38e9e453660f',1,'WENO3::eps()'],['../structWENO5.html#a0eb3eb8be72f02731cd24f03d5c2b9ca',1,'WENO5::eps()'],['../structWENO7.html#a51bb3b4aafa54396917073e91d53140b',1,'WENO7::eps()'],['../structWENO__Z3.html#a04370c4cf4d845f967ec610ff66f5d2b',1,'WENO_Z3::eps()'],['../structWENO__MZQ3.html#ad02f88cd05b6e31261fb3380887a2099',1,'WENO_MZQ3::eps()'],['../structWENO__Z5.html#ab4cfe75de30306d2462c33b4797fa570',1,'WENO_Z5::eps()']]], + ['epsilo_505',['epsilo',['../ERF__Constants_8H.html#a630c4c3e10ef44d50ca4c6939a59b6a3',1,'ERF_Constants.H']]], + ['erccoef_506',['erccoef',['../ERF__Constants_8H.html#af90fa8b6a26f98067ce125597f35d983',1,'ERF_Constants.H']]], + ['erf_507',['ERF',['../classERF.html#a30129012dd367825e5e4fd1406694f58',1,'ERF::ERF()'],['../classERF.html#a13fc8f3a00573ee7735c3228316164a9',1,'ERF::ERF(ERF &&) noexcept=delete'],['../classERF.html#af4f5db4e6643e9ebc8ffeebcbca3978a',1,'ERF::ERF(const ERF &other)=delete'],['../classERF.html',1,'ERF']]], + ['erf_2ecpp_508',['ERF.cpp',['../ERF_8cpp.html',1,'']]], + ['erf_2eh_509',['ERF.H',['../ERF_8H.html',1,'']]], + ['erf1_510',['erf1',['../classMultiBlockContainer.html#a1ee9fa78e0ade97253f818516df5d83d',1,'MultiBlockContainer']]], + ['erf2_511',['erf2',['../classMultiBlockContainer.html#ac65a89fe2e12cff2c871d641f965e322',1,'MultiBlockContainer']]], + ['erf_5fablmost_2ecpp_512',['ERF_ABLMost.cpp',['../ERF__ABLMost_8cpp.html',1,'']]], + ['erf_5fablmost_2eh_513',['ERF_ABLMost.H',['../ERF__ABLMost_8H.html',1,'']]], + ['erf_5fadd_5fthin_5fbody_5fsources_2ecpp_514',['ERF_add_thin_body_sources.cpp',['../ERF__add__thin__body__sources_8cpp.html',1,'']]], + ['erf_5fadvance_2ecpp_515',['ERF_Advance.cpp',['../ERF__Advance_8cpp.html',1,'']]], + ['erf_5fadvance_5fdycore_2ecpp_516',['ERF_advance_dycore.cpp',['../ERF__advance__dycore_8cpp.html',1,'']]], + ['erf_5fadvance_5flsm_2ecpp_517',['ERF_advance_lsm.cpp',['../ERF__advance__lsm_8cpp.html',1,'']]], + ['erf_5fadvance_5fmicrophysics_2ecpp_518',['ERF_advance_microphysics.cpp',['../ERF__advance__microphysics_8cpp.html',1,'']]], + ['erf_5fadvance_5fradiation_2ecpp_519',['ERF_advance_radiation.cpp',['../ERF__advance__radiation_8cpp.html',1,'']]], + ['erf_5fadvanceewp_2ecpp_520',['ERF_AdvanceEWP.cpp',['../ERF__AdvanceEWP_8cpp.html',1,'']]], + ['erf_5fadvancefitch_2ecpp_521',['ERF_AdvanceFitch.cpp',['../ERF__AdvanceFitch_8cpp.html',1,'']]], + ['erf_5fadvancegeneralad_2ecpp_522',['ERF_AdvanceGeneralAD.cpp',['../ERF__AdvanceGeneralAD_8cpp.html',1,'']]], + ['erf_5fadvancesimplead_2ecpp_523',['ERF_AdvanceSimpleAD.cpp',['../ERF__AdvanceSimpleAD_8cpp.html',1,'']]], + ['erf_5fadvection_2eh_524',['ERF_Advection.H',['../ERF__Advection_8H.html',1,'']]], + ['erf_5fadvectionsrcformom_2ecpp_525',['ERF_AdvectionSrcForMom.cpp',['../ERF__AdvectionSrcForMom_8cpp.html',1,'']]], + ['erf_5fadvectionsrcformom_5fn_2eh_526',['ERF_AdvectionSrcForMom_N.H',['../ERF__AdvectionSrcForMom__N_8H.html',1,'']]], + ['erf_5fadvectionsrcformom_5ft_2eh_527',['ERF_AdvectionSrcForMom_T.H',['../ERF__AdvectionSrcForMom__T_8H.html',1,'']]], + ['erf_5fadvectionsrcforopenbc_2ecpp_528',['ERF_AdvectionSrcForOpenBC.cpp',['../ERF__AdvectionSrcForOpenBC_8cpp.html',1,'']]], + ['erf_5fadvectionsrcforscalars_2eh_529',['ERF_AdvectionSrcForScalars.H',['../ERF__AdvectionSrcForScalars_8H.html',1,'']]], + ['erf_5fadvectionsrcforstate_2ecpp_530',['ERF_AdvectionSrcForState.cpp',['../ERF__AdvectionSrcForState_8cpp.html',1,'']]], + ['erf_5fadvstruct_2eh_531',['ERF_AdvStruct.H',['../ERF__AdvStruct_8H.html',1,'']]], + ['erf_5faero_5frad_5fprops_2ecpp_532',['ERF_Aero_rad_props.cpp',['../ERF__Aero__rad__props_8cpp.html',1,'']]], + ['erf_5faero_5frad_5fprops_2eh_533',['ERF_Aero_rad_props.H',['../ERF__Aero__rad__props_8H.html',1,'']]], + ['erf_5falbedo_2ecpp_534',['ERF_Albedo.cpp',['../ERF__Albedo_8cpp.html',1,'']]], + ['erf_5falbedo_2eh_535',['ERF_Albedo.H',['../ERF__Albedo_8H.html',1,'']]], + ['erf_5fapplyspongezonebcs_2ecpp_536',['ERF_ApplySpongeZoneBCs.cpp',['../ERF__ApplySpongeZoneBCs_8cpp.html',1,'']]], + ['erf_5fapplyspongezonebcs_5freadfromfile_2ecpp_537',['ERF_ApplySpongeZoneBCs_ReadFromFile.cpp',['../ERF__ApplySpongeZoneBCs__ReadFromFile_8cpp.html',1,'']]], + ['erf_5faveragedown_2ecpp_538',['ERF_AverageDown.cpp',['../ERF__AverageDown_8cpp.html',1,'']]], + ['erf_5fbc_539',['ERF_BC',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9',1,'ERF_IndexDefines.H']]], + ['erf_5fboundaryconditions_5fbasestate_2ecpp_540',['ERF_BoundaryConditions_basestate.cpp',['../ERF__BoundaryConditions__basestate_8cpp.html',1,'']]], + ['erf_5fboundaryconditions_5fbndryreg_2ecpp_541',['ERF_BoundaryConditions_bndryreg.cpp',['../ERF__BoundaryConditions__bndryreg_8cpp.html',1,'']]], + ['erf_5fboundaryconditions_5fcons_2ecpp_542',['ERF_BoundaryConditions_cons.cpp',['../ERF__BoundaryConditions__cons_8cpp.html',1,'']]], + ['erf_5fboundaryconditions_5frealbdy_2ecpp_543',['ERF_BoundaryConditions_realbdy.cpp',['../ERF__BoundaryConditions__realbdy_8cpp.html',1,'']]], + ['erf_5fboundaryconditions_5fxvel_2ecpp_544',['ERF_BoundaryConditions_xvel.cpp',['../ERF__BoundaryConditions__xvel_8cpp.html',1,'']]], + ['erf_5fboundaryconditions_5fyvel_2ecpp_545',['ERF_BoundaryConditions_yvel.cpp',['../ERF__BoundaryConditions__yvel_8cpp.html',1,'']]], + ['erf_5fboundaryconditions_5fzvel_2ecpp_546',['ERF_BoundaryConditions_zvel.cpp',['../ERF__BoundaryConditions__zvel_8cpp.html',1,'']]], + ['erf_5fbuoyancy_5futils_2eh_547',['ERF_buoyancy_utils.H',['../ERF__buoyancy__utils_8H.html',1,'']]], + ['erf_5fcheckpoint_2ecpp_548',['ERF_Checkpoint.cpp',['../ERF__Checkpoint_8cpp.html',1,'']]], + ['erf_5fchopgrids_2ecpp_549',['ERF_ChopGrids.cpp',['../ERF__ChopGrids_8cpp.html',1,'']]], + ['erf_5fcloud_5frad_5fprops_2ecpp_550',['ERF_Cloud_rad_props.cpp',['../ERF__Cloud__rad__props_8cpp.html',1,'']]], + ['erf_5fcloud_5frad_5fprops_2eh_551',['ERF_Cloud_rad_props.H',['../ERF__Cloud__rad__props_8H.html',1,'']]], + ['erf_5fcloud_5fsam_2ecpp_552',['ERF_Cloud_SAM.cpp',['../ERF__Cloud__SAM_8cpp.html',1,'']]], + ['erf_5fcompute_5fdivergence_2ecpp_553',['ERF_compute_divergence.cpp',['../ERF__compute__divergence_8cpp.html',1,'']]], + ['erf_5fcomputediffusivitymynn25_2ecpp_554',['ERF_ComputeDiffusivityMYNN25.cpp',['../ERF__ComputeDiffusivityMYNN25_8cpp.html',1,'']]], + ['erf_5fcomputediffusivityysu_2ecpp_555',['ERF_ComputeDiffusivityYSU.cpp',['../ERF__ComputeDiffusivityYSU_8cpp.html',1,'']]], + ['erf_5fcomputestrain_5fn_2ecpp_556',['ERF_ComputeStrain_N.cpp',['../ERF__ComputeStrain__N_8cpp.html',1,'']]], + ['erf_5fcomputestrain_5ft_2ecpp_557',['ERF_ComputeStrain_T.cpp',['../ERF__ComputeStrain__T_8cpp.html',1,'']]], + ['erf_5fcomputestress_5fn_2ecpp_558',['ERF_ComputeStress_N.cpp',['../ERF__ComputeStress__N_8cpp.html',1,'']]], + ['erf_5fcomputestress_5ft_2ecpp_559',['ERF_ComputeStress_T.cpp',['../ERF__ComputeStress__T_8cpp.html',1,'']]], + ['erf_5fcomputetimestep_2ecpp_560',['ERF_ComputeTimestep.cpp',['../ERF__ComputeTimestep_8cpp.html',1,'']]], + ['erf_5fcomputeturbulentviscosity_2ecpp_561',['ERF_ComputeTurbulentViscosity.cpp',['../ERF__ComputeTurbulentViscosity_8cpp.html',1,'']]], + ['erf_5fconsole_5fio_2ecpp_562',['ERF_console_io.cpp',['../ERF__console__io_8cpp.html',1,'']]], + ['erf_5fconstants_2eh_563',['ERF_Constants.H',['../ERF__Constants_8H.html',1,'']]], + ['erf_5fdatastruct_2eh_564',['ERF_DataStruct.H',['../ERF__DataStruct_8H.html',1,'']]], + ['erf_5fderive_2ecpp_565',['ERF_Derive.cpp',['../ERF__Derive_8cpp.html',1,'']]], + ['erf_5fderive_2eh_566',['ERF_Derive.H',['../ERF__Derive_8H.html',1,'']]], + ['erf_5fderke_567',['erf_derKE',['../namespacederived.html#acc3f245c73a0826afc9e7626f12126d3',1,'derived::erf_derKE(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)'],['../namespacederived.html#aeaeabd5f649796984f61651a6733e96b',1,'derived::erf_derKE(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)']]], + ['erf_5fdermagvel_568',['erf_dermagvel',['../namespacederived.html#a5186c6ea33e82af321f529242a615dc2',1,'derived']]], + ['erf_5fdermoisttemp_569',['erf_dermoisttemp',['../namespacederived.html#a7292c8c78a618eb0f6ca6a5356705362',1,'derived::erf_dermoisttemp(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)'],['../namespacederived.html#add1791d7423c133ba6e7ab55975cf34f',1,'derived::erf_dermoisttemp(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)']]], + ['erf_5fdernull_570',['erf_dernull',['../namespacederived.html#a7fb98e12fceaa6f691dfef83db453757',1,'derived::erf_dernull(const Box &, FArrayBox &, int, int, const FArrayBox &, const Geometry &, Real, const int *, const int)'],['../namespacederived.html#a7128ad75cf0f6b317ae8689bd7eb1597',1,'derived::erf_dernull(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)']]], + ['erf_5fderrhodivide_571',['erf_derrhodivide',['../namespacederived.html#a3786c6a8399bc2508bc129337c446af1',1,'derived::erf_derrhodivide(const Box &bx, FArrayBox &derfab, const FArrayBox &datfab, const int scalar_index)'],['../namespacederived.html#a9935603239fe8510b11179da8e76c39c',1,'derived::erf_derrhodivide(const amrex::Box &bx, amrex::FArrayBox &derfab, const amrex::FArrayBox &datfab, const int scalar_index)']]], + ['erf_5fderscalar_572',['erf_derscalar',['../namespacederived.html#a13666be87e55d1759f57322b33f7e495',1,'derived::erf_derscalar(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)'],['../namespacederived.html#a37560f4d3e2c7c10f64d41db2ce76a06',1,'derived::erf_derscalar(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)']]], + ['erf_5fdersoundspeed_573',['erf_dersoundspeed',['../namespacederived.html#abec1266940e40d642fca2aa685b7f314',1,'derived::erf_dersoundspeed(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)'],['../namespacederived.html#afe57e0f13e2e24c73d0ed373a9cd0d09',1,'derived::erf_dersoundspeed(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)']]], + ['erf_5fdertemp_574',['erf_dertemp',['../namespacederived.html#a37ac1508c4001f9f1e38ca507dd15f31',1,'derived::erf_dertemp(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)'],['../namespacederived.html#a8d96f91847cec51636c122ab27a5f8a2',1,'derived::erf_dertemp(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)']]], + ['erf_5fdertheta_575',['erf_dertheta',['../namespacederived.html#af5e075e5b8b2e3964ae6af3f5f06f497',1,'derived::erf_dertheta(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Geometry &geomdata, amrex::Real time, const int *bcrec, const int level)'],['../namespacederived.html#adc3c787125484205e4fc7cd85c25ab6c',1,'derived::erf_dertheta(const Box &bx, FArrayBox &derfab, int, int, const FArrayBox &datfab, const Geometry &, Real, const int *, const int)']]], + ['erf_5fdervortx_576',['erf_dervortx',['../namespacederived.html#a0a37dd4fa4a044e34891e6222d06654c',1,'derived']]], + ['erf_5fdervorty_577',['erf_dervorty',['../namespacederived.html#a2a85aedf7c75ca416dbb931559c4b21e',1,'derived']]], + ['erf_5fdervortz_578',['erf_dervortz',['../namespacederived.html#a8bc196f7dfb365c426b0b7e720e479e2',1,'derived']]], + ['erf_5fdiffstruct_2eh_579',['ERF_DiffStruct.H',['../ERF__DiffStruct_8H.html',1,'']]], + ['erf_5fdiffusion_2eh_580',['ERF_Diffusion.H',['../ERF__Diffusion_8H.html',1,'']]], + ['erf_5fdiffusionsrcformom_5fn_2ecpp_581',['ERF_DiffusionSrcForMom_N.cpp',['../ERF__DiffusionSrcForMom__N_8cpp.html',1,'']]], + ['erf_5fdiffusionsrcformom_5ft_2ecpp_582',['ERF_DiffusionSrcForMom_T.cpp',['../ERF__DiffusionSrcForMom__T_8cpp.html',1,'']]], + ['erf_5fdiffusionsrcforstate_5fn_2ecpp_583',['ERF_DiffusionSrcForState_N.cpp',['../ERF__DiffusionSrcForState__N_8cpp.html',1,'']]], + ['erf_5fdiffusionsrcforstate_5ft_2ecpp_584',['ERF_DiffusionSrcForState_T.cpp',['../ERF__DiffusionSrcForState__T_8cpp.html',1,'']]], + ['erf_5fdirectionselector_2eh_585',['ERF_DirectionSelector.H',['../ERF__DirectionSelector_8H.html',1,'']]], + ['erf_5fdtesati_586',['erf_dtesati',['../ERF__Microphysics__Utils_8H.html#a45320981110c862bac93f657781eb79f',1,'ERF_Microphysics_Utils.H']]], + ['erf_5fdtesatw_587',['erf_dtesatw',['../ERF__Microphysics__Utils_8H.html#a2e94fb836d3c733ebac8263bfa479ca8',1,'ERF_Microphysics_Utils.H']]], + ['erf_5fdtesatw_5fcc_588',['erf_dtesatw_cc',['../ERF__Microphysics__Utils_8H.html#a66e2273b5b2661fa12fea623630afaf8',1,'ERF_Microphysics_Utils.H']]], + ['erf_5fdtqsati_589',['erf_dtqsati',['../ERF__Microphysics__Utils_8H.html#a7baba5d74922033bf93526933a0d77ec',1,'ERF_Microphysics_Utils.H']]], + ['erf_5fdtqsatw_590',['erf_dtqsatw',['../ERF__Microphysics__Utils_8H.html#a41126403c4da6ee876e9e391f3f67699',1,'ERF_Microphysics_Utils.H']]], + ['erf_5feb_5fbox_2ecpp_591',['ERF_eb_box.cpp',['../ERF__eb__box_8cpp.html',1,'']]], + ['erf_5feb_5fcylinder_2ecpp_592',['ERF_eb_cylinder.cpp',['../ERF__eb__cylinder_8cpp.html',1,'']]], + ['erf_5feb_5fif_2eh_593',['ERF_eb_if.H',['../ERF__eb__if_8H.html',1,'']]], + ['erf_5feb_5fregular_2ecpp_594',['ERF_eb_regular.cpp',['../ERF__eb__regular_8cpp.html',1,'']]], + ['erf_5febert_5fcurry_2eh_595',['ERF_Ebert_curry.H',['../ERF__Ebert__curry_8H.html',1,'']]], + ['erf_5feddyviscosity_2eh_596',['ERF_EddyViscosity.H',['../ERF__EddyViscosity_8H.html',1,'']]], + ['erf_5fenforce_5fhse_597',['erf_enforce_hse',['../classERF.html#a5dd85954df2df1edf0adde3c7c6ae48f',1,'ERF']]], + ['erf_5feos_2eh_598',['ERF_EOS.H',['../ERF__EOS_8H.html',1,'']]], + ['erf_5fesati_599',['erf_esati',['../ERF__Microphysics__Utils_8H.html#a4ea516e89f4e87b4ffc305504e8f0bf1',1,'ERF_Microphysics_Utils.H']]], + ['erf_5fesatw_600',['erf_esatw',['../ERF__Microphysics__Utils_8H.html#a16a390366e7e68ca35fdac4cad824428',1,'ERF_Microphysics_Utils.H']]], + ['erf_5fesatw_5fcc_601',['erf_esatw_cc',['../ERF__Microphysics__Utils_8H.html#afac5e7caca80647972b208a0248b2ed8',1,'ERF_Microphysics_Utils.H']]], + ['erf_5feulerianmicrophysics_2eh_602',['ERF_EulerianMicrophysics.H',['../ERF__EulerianMicrophysics_8H.html',1,'']]], + ['erf_5fewp_2eh_603',['ERF_EWP.H',['../ERF__EWP_8H.html',1,'']]], + ['erf_5ffast_5frhs_5fmt_604',['erf_fast_rhs_MT',['../ERF__fast__rhs__MT_8cpp.html#af5d569dbe264703bf1e1c6ae59d14b4c',1,'erf_fast_rhs_MT(int step, int nrk, int level, int finest_level, Vector< MultiFab > &S_slow_rhs, const Vector< MultiFab > &S_prev, Vector< MultiFab > &S_stg_data, const MultiFab &S_stg_prim, const MultiFab &pi_stage, const MultiFab &fast_coeffs, Vector< MultiFab > &S_data, Vector< MultiFab > &S_scratch, const Geometry geom, const Real gravity, const bool use_lagged_delta_rt, std::unique_ptr< MultiFab > &z_t_rk, const MultiFab *z_t_pert, std::unique_ptr< MultiFab > &z_phys_nd_old, std::unique_ptr< MultiFab > &z_phys_nd_new, std::unique_ptr< MultiFab > &z_phys_nd_stg, std::unique_ptr< MultiFab > &detJ_cc_old, std::unique_ptr< MultiFab > &detJ_cc_new, std::unique_ptr< MultiFab > &detJ_cc_stg, const Real dtau, const Real beta_s, const Real facinv, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool): ERF_fast_rhs_MT.cpp'],['../ERF__TI__fast__headers_8H.html#af066cb6138b09ea93e2c0fc35702fb0e',1,'erf_fast_rhs_MT(int step, int nrk, int level, int finest_level, amrex::Vector< amrex::MultiFab > &S_slow_rhs, const amrex::Vector< amrex::MultiFab > &S_prev, amrex::Vector< amrex::MultiFab > &S_stg_data, const amrex::MultiFab &S_stg_prim, const amrex::MultiFab &pi_stage, const amrex::MultiFab &fast_coeffs, amrex::Vector< amrex::MultiFab > &S_data, amrex::Vector< amrex::MultiFab > &S_scratch, const amrex::Geometry geom, const amrex::Real gravity, const bool use_lagged_delta_rt, std::unique_ptr< amrex::MultiFab > &z_t_rk, const amrex::MultiFab *z_t_pert, std::unique_ptr< amrex::MultiFab > &z_phys_nd_old, std::unique_ptr< amrex::MultiFab > &z_phys_nd_new, std::unique_ptr< amrex::MultiFab > &z_phys_nd_stg, std::unique_ptr< amrex::MultiFab > &detJ_cc_old, std::unique_ptr< amrex::MultiFab > &detJ_cc_new, std::unique_ptr< amrex::MultiFab > &detJ_cc_stg, const amrex::Real dtau, const amrex::Real beta_s, const amrex::Real facinv, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v, amrex::YAFluxRegister *fr_as_crse, amrex::YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool l_implicit_substepping): ERF_TI_fast_headers.H']]], + ['erf_5ffast_5frhs_5fmt_2ecpp_605',['ERF_fast_rhs_MT.cpp',['../ERF__fast__rhs__MT_8cpp.html',1,'']]], + ['erf_5ffast_5frhs_5fn_606',['erf_fast_rhs_N',['../ERF__fast__rhs__N_8cpp.html#a5fbcc0fe33b8e8e42f840ad475a092bd',1,'erf_fast_rhs_N(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 &pi_stage, const MultiFab &fast_coeffs, Vector< MultiFab > &S_data, Vector< MultiFab > &S_scratch, const Geometry geom, const Real gravity, const Real dtau, const Real beta_s, const Real facinv, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool l_implicit_substepping): ERF_fast_rhs_N.cpp'],['../ERF__TI__fast__headers_8H.html#a25b4f2c626cbe895f44d04b262cd0938',1,'erf_fast_rhs_N(int step, int nrk, int level, int finest_level, amrex::Vector< amrex::MultiFab > &S_slow_rhs, const amrex::Vector< amrex::MultiFab > &S_prev, amrex::Vector< amrex::MultiFab > &S_stage_data, const amrex::MultiFab &S_stage_prim, const amrex::MultiFab &pi_stage, const amrex::MultiFab &fast_coeffs, amrex::Vector< amrex::MultiFab > &S_data, amrex::Vector< amrex::MultiFab > &S_scratch, const amrex::Geometry geom, const amrex::Real gravity, const amrex::Real dtau, const amrex::Real beta_s, const amrex::Real facinv, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v, amrex::YAFluxRegister *fr_as_crse, amrex::YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool l_implicit_substepping): ERF_TI_fast_headers.H']]], + ['erf_5ffast_5frhs_5fn_2ecpp_607',['ERF_fast_rhs_N.cpp',['../ERF__fast__rhs__N_8cpp.html',1,'']]], + ['erf_5ffast_5frhs_5ft_608',['erf_fast_rhs_T',['../ERF__fast__rhs__T_8cpp.html#a83ebca7dc0d4507076941aa3a971e877',1,'erf_fast_rhs_T(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 &pi_stage, const MultiFab &fast_coeffs, Vector< MultiFab > &S_data, Vector< MultiFab > &S_scratch, const Geometry geom, const Real gravity, std::unique_ptr< MultiFab > &z_phys_nd, std::unique_ptr< MultiFab > &detJ_cc, const Real dtau, const Real beta_s, const Real facinv, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool): ERF_fast_rhs_T.cpp'],['../ERF__TI__fast__headers_8H.html#a8ed4e910b837a4cbbe4d6a7ab8610f51',1,'erf_fast_rhs_T(int step, int nrk, int level, int finest_level, amrex::Vector< amrex::MultiFab > &S_slow_rhs, const amrex::Vector< amrex::MultiFab > &S_prev, amrex::Vector< amrex::MultiFab > &S_stage_data, const amrex::MultiFab &S_stage_prim, const amrex::MultiFab &pi_stage, const amrex::MultiFab &fast_coeffs, amrex::Vector< amrex::MultiFab > &S_data, amrex::Vector< amrex::MultiFab > &S_scratch, const amrex::Geometry geom, const amrex::Real gravity, std::unique_ptr< amrex::MultiFab > &z_phys_nd, std::unique_ptr< amrex::MultiFab > &detJ_cc, const amrex::Real dtau, const amrex::Real beta_s, const amrex::Real facinv, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v, amrex::YAFluxRegister *fr_as_crse, amrex::YAFluxRegister *fr_as_fine, bool l_use_moisture, bool l_reflux, bool l_implicit_substepping): ERF_TI_fast_headers.H']]], + ['erf_5ffast_5frhs_5ft_2ecpp_609',['ERF_fast_rhs_T.cpp',['../ERF__fast__rhs__T_8cpp.html',1,'']]], + ['erf_5ffft_5fterrainprecond_2eh_610',['ERF_FFT_TerrainPrecond.H',['../ERF__FFT__TerrainPrecond_8H.html',1,'']]], + ['erf_5ffillbdyccvels_2ecpp_611',['ERF_FillBdyCCVels.cpp',['../ERF__FillBdyCCVels_8cpp.html',1,'']]], + ['erf_5ffillcoarsepatch_2ecpp_612',['ERF_FillCoarsePatch.cpp',['../ERF__FillCoarsePatch_8cpp.html',1,'']]], + ['erf_5ffillintermediatepatch_2ecpp_613',['ERF_FillIntermediatePatch.cpp',['../ERF__FillIntermediatePatch_8cpp.html',1,'']]], + ['erf_5ffillpatch_2ecpp_614',['ERF_FillPatch.cpp',['../ERF__FillPatch_8cpp.html',1,'']]], + ['erf_5ffillpatcher_2ecpp_615',['ERF_FillPatcher.cpp',['../ERF__FillPatcher_8cpp.html',1,'']]], + ['erf_5ffillpatcher_2eh_616',['ERF_FillPatcher.H',['../ERF__FillPatcher_8H.html',1,'']]], + ['erf_5ffinalize_5frrtmgp_2ecpp_617',['ERF_Finalize_rrtmgp.cpp',['../ERF__Finalize__rrtmgp_8cpp.html',1,'']]], + ['erf_5ffitch_2eh_618',['ERF_Fitch.H',['../ERF__Fitch_8H.html',1,'']]], + ['erf_5fflowerif_2eh_619',['ERF_FlowerIF.H',['../ERF__FlowerIF_8H.html',1,'']]], + ['erf_5fforestdrag_2ecpp_620',['ERF_ForestDrag.cpp',['../ERF__ForestDrag_8cpp.html',1,'']]], + ['erf_5fforestdrag_2eh_621',['ERF_ForestDrag.H',['../ERF__ForestDrag_8H.html',1,'']]], + ['erf_5fgammafff_622',['erf_gammafff',['../ERF__Microphysics__Utils_8H.html#abd125e107924437493cbcbac9a97c017',1,'ERF_Microphysics_Utils.H']]], + ['erf_5fgeneralad_2eh_623',['ERF_GeneralAD.H',['../ERF__GeneralAD_8H.html',1,'']]], + ['erf_5fhse_5futils_2eh_624',['ERF_HSE_utils.H',['../ERF__HSE__utils_8H.html',1,'']]], + ['erf_5ficefall_2ecpp_625',['ERF_IceFall.cpp',['../ERF__IceFall_8cpp.html',1,'']]], + ['erf_5findexdefines_2eh_626',['ERF_IndexDefines.H',['../ERF__IndexDefines_8H.html',1,'']]], + ['erf_5finit1d_2ecpp_627',['ERF_init1d.cpp',['../ERF__init1d_8cpp.html',1,'']]], + ['erf_5finit_5fbcs_2ecpp_628',['ERF_init_bcs.cpp',['../ERF__init__bcs_8cpp.html',1,'']]], + ['erf_5finit_5fconstant_5fdensity_5fhse_2eh_629',['ERF_init_constant_density_hse.H',['../ERF__init__constant__density__hse_8H.html',1,'']]], + ['erf_5finit_5fcustom_2ecpp_630',['ERF_init_custom.cpp',['../ERF__init__custom_8cpp.html',1,'']]], + ['erf_5finit_5fdens_5fhse_631',['erf_init_dens_hse',['../classProblemBase.html#aef7d3d9788867d83e6ec8b2c9499de56',1,'ProblemBase::erf_init_dens_hse()'],['../ERF__init__constant__density__hse_8H.html#aa310c5ff8cdad11f3adfeeff0f5ad046',1,'erf_init_dens_hse(amrex::MultiFab &rho_hse, std::unique_ptr< amrex::MultiFab > &, std::unique_ptr< amrex::MultiFab > &, amrex::Geometry const &) override: ERF_init_constant_density_hse.H'],['../ERF__init__density__hse__dry_8H.html#a2e1d042f9d82e4b78d00e99ab25e9311',1,'erf_init_dens_hse(amrex::MultiFab &rho_hse, std::unique_ptr< amrex::MultiFab > &z_phys_nd, std::unique_ptr< amrex::MultiFab > &z_phys_cc, amrex::Geometry const &geom) override: ERF_init_density_hse_dry.H']]], + ['erf_5finit_5fdens_5fhse_5fmoist_632',['erf_init_dens_hse_moist',['../classProblemBase.html#ad1a7277d332001542789e488458096b9',1,'ProblemBase']]], + ['erf_5finit_5fdensity_5fhse_5fdry_2eh_633',['ERF_init_density_hse_dry.H',['../ERF__init__density__hse__dry_8H.html',1,'']]], + ['erf_5finit_5ffrom_5fhse_2ecpp_634',['ERF_init_from_hse.cpp',['../ERF__init__from__hse_8cpp.html',1,'']]], + ['erf_5finit_5ffrom_5finput_5fsounding_2ecpp_635',['ERF_init_from_input_sounding.cpp',['../ERF__init__from__input__sounding_8cpp.html',1,'']]], + ['erf_5finit_5ffrom_5fmetgrid_2ecpp_636',['ERF_init_from_metgrid.cpp',['../ERF__init__from__metgrid_8cpp.html',1,'']]], + ['erf_5finit_5ffrom_5fwrfinput_2ecpp_637',['ERF_init_from_wrfinput.cpp',['../ERF__init__from__wrfinput_8cpp.html',1,'']]], + ['erf_5finit_5fgeowind_2ecpp_638',['ERF_init_geowind.cpp',['../ERF__init__geowind_8cpp.html',1,'']]], + ['erf_5finit_5fkessler_2ecpp_639',['ERF_Init_Kessler.cpp',['../ERF__Init__Kessler_8cpp.html',1,'']]], + ['erf_5finit_5frayleigh_640',['erf_init_rayleigh',['../ERF__init__rayleigh__damping_8H.html#aa0988e9ca7c21c75ca232ea0ee850195',1,'erf_init_rayleigh(): ERF_init_rayleigh_damping.H'],['../classProblemBase.html#aaf5cb14c8033c99df446fd943b1f2216',1,'ProblemBase::erf_init_rayleigh()']]], + ['erf_5finit_5frayleigh_2ecpp_641',['ERF_init_rayleigh.cpp',['../ERF__init__rayleigh_8cpp.html',1,'']]], + ['erf_5finit_5frayleigh_5fdamping_2eh_642',['ERF_init_rayleigh_damping.H',['../ERF__init__rayleigh__damping_8H.html',1,'']]], + ['erf_5finit_5frrtmgp_2ecpp_643',['ERF_Init_rrtmgp.cpp',['../ERF__Init__rrtmgp_8cpp.html',1,'']]], + ['erf_5finit_5fsam_2ecpp_644',['ERF_Init_SAM.cpp',['../ERF__Init__SAM_8cpp.html',1,'']]], + ['erf_5finit_5fsponge_2ecpp_645',['ERF_init_sponge.cpp',['../ERF__init__sponge_8cpp.html',1,'']]], + ['erf_5finit_5fturbpert_2ecpp_646',['ERF_init_TurbPert.cpp',['../ERF__init__TurbPert_8cpp.html',1,'']]], + ['erf_5finit_5funiform_2ecpp_647',['ERF_init_uniform.cpp',['../ERF__init__uniform_8cpp.html',1,'']]], + ['erf_5finit_5fwindfarm_2ecpp_648',['ERF_init_windfarm.cpp',['../ERF__init__windfarm_8cpp.html',1,'']]], + ['erf_5finiteb_2ecpp_649',['ERF_initEB.cpp',['../ERF__initEB_8cpp.html',1,'']]], + ['erf_5finitwindfarm_2ecpp_650',['ERF_InitWindFarm.cpp',['../ERF__InitWindFarm_8cpp.html',1,'']]], + ['erf_5finputsoundingdata_2eh_651',['ERF_InputSoundingData.H',['../ERF__InputSoundingData_8H.html',1,'']]], + ['erf_5finputspongedata_2eh_652',['ERF_InputSpongeData.H',['../ERF__InputSpongeData_8H.html',1,'']]], + ['erf_5finteriorghostcells_2ecpp_653',['ERF_InteriorGhostCells.cpp',['../ERF__InteriorGhostCells_8cpp.html',1,'']]], + ['erf_5finterpolation_2eh_654',['ERF_Interpolation.H',['../ERF__Interpolation_8H.html',1,'']]], + ['erf_5finterpolation_5f1d_2eh_655',['ERF_Interpolation_1D.H',['../ERF__Interpolation__1D_8H.html',1,'']]], + ['erf_5finterpolation_5fupw_2eh_656',['ERF_Interpolation_UPW.H',['../ERF__Interpolation__UPW_8H.html',1,'']]], + ['erf_5finterpolation_5fweno_2eh_657',['ERF_Interpolation_WENO.H',['../ERF__Interpolation__WENO_8H.html',1,'']]], + ['erf_5finterpolation_5fweno_5fz_2eh_658',['ERF_Interpolation_WENO_Z.H',['../ERF__Interpolation__WENO__Z_8H.html',1,'']]], + ['erf_5fkessler_2ecpp_659',['ERF_Kessler.cpp',['../ERF__Kessler_8cpp.html',1,'']]], + ['erf_5fkessler_2eh_660',['ERF_Kessler.H',['../ERF__Kessler_8H.html',1,'']]], + ['erf_5flagrangianmicrophysics_2eh_661',['ERF_LagrangianMicrophysics.H',['../ERF__LagrangianMicrophysics_8H.html',1,'']]], + ['erf_5flandsurface_2eh_662',['ERF_LandSurface.H',['../ERF__LandSurface_8H.html',1,'']]], + ['erf_5flinear_5finterpolate_2eh_663',['ERF_Linear_interpolate.H',['../ERF__Linear__interpolate_8H.html',1,'']]], + ['erf_5fm2005_5feffradius_2eh_664',['ERF_m2005_effradius.H',['../ERF__m2005__effradius_8H.html',1,'']]], + ['erf_5fmake_5fbuoyancy_2ecpp_665',['ERF_make_buoyancy.cpp',['../ERF__make__buoyancy_8cpp.html',1,'']]], + ['erf_5fmake_5ffast_5fcoeffs_2ecpp_666',['ERF_make_fast_coeffs.cpp',['../ERF__make__fast__coeffs_8cpp.html',1,'']]], + ['erf_5fmake_5fmom_5fsources_2ecpp_667',['ERF_make_mom_sources.cpp',['../ERF__make__mom__sources_8cpp.html',1,'']]], + ['erf_5fmake_5fnew_5farrays_2ecpp_668',['ERF_make_new_arrays.cpp',['../ERF__make__new__arrays_8cpp.html',1,'']]], + ['erf_5fmake_5fnew_5flevel_2ecpp_669',['ERF_make_new_level.cpp',['../ERF__make__new__level_8cpp.html',1,'']]], + ['erf_5fmake_5fsources_2ecpp_670',['ERF_make_sources.cpp',['../ERF__make__sources_8cpp.html',1,'']]], + ['erf_5fmake_5ftau_5fterms_671',['erf_make_tau_terms',['../ERF__TI__slow__headers_8H.html#a5664b227e5906334181ecc88eb7aba30',1,'erf_make_tau_terms(int level, int nrk, const amrex::Vector< amrex::BCRec > &domain_bcs_type, std::unique_ptr< amrex::MultiFab > &z_phys_nd, amrex::Vector< amrex::MultiFab > &S_data, const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &zvel, amrex::MultiFab *Tau11, amrex::MultiFab *Tau22, amrex::MultiFab *Tau33, amrex::MultiFab *Tau12, amrex::MultiFab *Tau13, amrex::MultiFab *Tau21, amrex::MultiFab *Tau23, amrex::MultiFab *Tau31, amrex::MultiFab *Tau32, amrex::MultiFab *SmnSmn, amrex::MultiFab *eddyDiffs, const amrex::Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, std::unique_ptr< amrex::MultiFab > &dJ, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v): ERF_TI_slow_headers.H'],['../ERF__make__tau__terms_8cpp.html#a7a7d71e3e796b67737a6931399588ae8',1,'erf_make_tau_terms(int level, int nrk, const Vector< BCRec > &domain_bcs_type_h, std::unique_ptr< MultiFab > &z_phys_nd, Vector< MultiFab > &S_data, const MultiFab &xvel, const MultiFab &yvel, const MultiFab &zvel, MultiFab *Tau11, MultiFab *Tau22, MultiFab *Tau33, MultiFab *Tau12, MultiFab *Tau13, MultiFab *Tau21, MultiFab *Tau23, MultiFab *Tau31, MultiFab *Tau32, MultiFab *SmnSmn, MultiFab *eddyDiffs, const Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, std::unique_ptr< MultiFab > &detJ, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v): ERF_make_tau_terms.cpp']]], + ['erf_5fmake_5ftau_5fterms_2ecpp_672',['ERF_make_tau_terms.cpp',['../ERF__make__tau__terms_8cpp.html',1,'']]], + ['erf_5fmam4_5faero_2eh_673',['ERF_Mam4_aero.H',['../ERF__Mam4__aero_8H.html',1,'']]], + ['erf_5fmam4_5fconstituents_2eh_674',['ERF_Mam4_constituents.H',['../ERF__Mam4__constituents_8H.html',1,'']]], + ['erf_5fmetgrid_5futils_2eh_675',['ERF_Metgrid_utils.H',['../ERF__Metgrid__utils_8H.html',1,'']]], + ['erf_5fmicrophysics_2eh_676',['ERF_Microphysics.H',['../ERF__Microphysics_8H.html',1,'']]], + ['erf_5fmicrophysics_5futils_2eh_677',['ERF_Microphysics_Utils.H',['../ERF__Microphysics__Utils_8H.html',1,'']]], + ['erf_5fmm5_2ecpp_678',['ERF_MM5.cpp',['../ERF__MM5_8cpp.html',1,'']]], + ['erf_5fmm5_2eh_679',['ERF_MM5.H',['../ERF__MM5_8H.html',1,'']]], + ['erf_5fmodal_5faero_5fwateruptake_2eh_680',['ERF_Modal_aero_wateruptake.H',['../ERF__Modal__aero__wateruptake_8H.html',1,'']]], + ['erf_5fmoist_5fset_5frhs_2ecpp_681',['ERF_moist_set_rhs.cpp',['../ERF__moist__set__rhs_8cpp.html',1,'']]], + ['erf_5fmomentumtovelocity_2ecpp_682',['ERF_MomentumToVelocity.cpp',['../ERF__MomentumToVelocity_8cpp.html',1,'']]], + ['erf_5fmostaverage_2ecpp_683',['ERF_MOSTAverage.cpp',['../ERF__MOSTAverage_8cpp.html',1,'']]], + ['erf_5fmostaverage_2eh_684',['ERF_MOSTAverage.H',['../ERF__MOSTAverage_8H.html',1,'']]], + ['erf_5fmostroughness_2eh_685',['ERF_MOSTRoughness.H',['../ERF__MOSTRoughness_8H.html',1,'']]], + ['erf_5fmoststress_2eh_686',['ERF_MOSTStress.H',['../ERF__MOSTStress_8H.html',1,'']]], + ['erf_5fmri_2eh_687',['ERF_MRI.H',['../ERF__MRI_8H.html',1,'']]], + ['erf_5fmultiblockcontainer_2ecpp_688',['ERF_MultiBlockContainer.cpp',['../ERF__MultiBlockContainer_8cpp.html',1,'']]], + ['erf_5fmultiblockcontainer_2eh_689',['ERF_MultiBlockContainer.H',['../ERF__MultiBlockContainer_8H.html',1,'']]], + ['erf_5fmynnstruct_2eh_690',['ERF_MYNNStruct.H',['../ERF__MYNNStruct_8H.html',1,'']]], + ['erf_5fnccheckpoint_2ecpp_691',['ERF_NCCheckpoint.cpp',['../ERF__NCCheckpoint_8cpp.html',1,'']]], + ['erf_5fnccolumnfile_2ecpp_692',['ERF_NCColumnFile.cpp',['../ERF__NCColumnFile_8cpp.html',1,'']]], + ['erf_5fncinterface_2ecpp_693',['ERF_NCInterface.cpp',['../ERF__NCInterface_8cpp.html',1,'']]], + ['erf_5fncinterface_2eh_694',['ERF_NCInterface.H',['../ERF__NCInterface_8H.html',1,'']]], + ['erf_5fncmultifabfile_2ecpp_695',['ERF_NCMultiFabFile.cpp',['../ERF__NCMultiFabFile_8cpp.html',1,'']]], + ['erf_5fncplotfile_2ecpp_696',['ERF_NCPlotFile.cpp',['../ERF__NCPlotFile_8cpp.html',1,'']]], + ['erf_5fncplotfile_2eh_697',['ERF_NCPlotFile.H',['../ERF__NCPlotFile_8H.html',1,'']]], + ['erf_5fncwpsfile_2eh_698',['ERF_NCWpsFile.H',['../ERF__NCWpsFile_8H.html',1,'']]], + ['erf_5fnoah_2ecpp_699',['ERF_NOAH.cpp',['../ERF__NOAH_8cpp.html',1,'']]], + ['erf_5fnoah_2eh_700',['ERF_NOAH.H',['../ERF__NOAH_8H.html',1,'']]], + ['erf_5fnullmoist_2eh_701',['ERF_NullMoist.H',['../ERF__NullMoist_8H.html',1,'']]], + ['erf_5fnullmoistlagrangian_2eh_702',['ERF_NullMoistLagrangian.H',['../ERF__NullMoistLagrangian_8H.html',1,'']]], + ['erf_5fnullsurf_2eh_703',['ERF_NullSurf.H',['../ERF__NullSurf_8H.html',1,'']]], + ['erf_5fnullwindfarm_2eh_704',['ERF_NullWindFarm.H',['../ERF__NullWindFarm_8H.html',1,'']]], + ['erf_5fnumericaldiffusion_2ecpp_705',['ERF_NumericalDiffusion.cpp',['../ERF__NumericalDiffusion_8cpp.html',1,'']]], + ['erf_5fnumericaldiffusion_2eh_706',['ERF_NumericalDiffusion.H',['../ERF__NumericalDiffusion_8H.html',1,'']]], + ['erf_5foptics_2ecpp_707',['ERF_Optics.cpp',['../ERF__Optics_8cpp.html',1,'']]], + ['erf_5foptics_2eh_708',['ERF_Optics.H',['../ERF__Optics_8H.html',1,'']]], + ['erf_5forbit_2ecpp_709',['ERF_Orbit.cpp',['../ERF__Orbit_8cpp.html',1,'']]], + ['erf_5forbit_2eh_710',['ERF_Orbit.H',['../ERF__Orbit_8H.html',1,'']]], + ['erf_5fparameterizations_2eh_711',['ERF_Parameterizations.H',['../ERF__Parameterizations_8H.html',1,'']]], + ['erf_5fparfunctions_2eh_712',['ERF_ParFunctions.H',['../ERF__ParFunctions_8H.html',1,'']]], + ['erf_5fparticledata_2eh_713',['ERF_ParticleData.H',['../ERF__ParticleData_8H.html',1,'']]], + ['erf_5fpblheight_2eh_714',['ERF_PBLHeight.H',['../ERF__PBLHeight_8H.html',1,'']]], + ['erf_5fpblmodels_2eh_715',['ERF_PBLModels.H',['../ERF__PBLModels_8H.html',1,'']]], + ['erf_5fphys_5fprop_2eh_716',['ERF_Phys_prop.H',['../ERF__Phys__prop_8H.html',1,'']]], + ['erf_5fphysbcfunct_2ecpp_717',['ERF_PhysBCFunct.cpp',['../ERF__PhysBCFunct_8cpp.html',1,'']]], + ['erf_5fphysbcfunct_2eh_718',['ERF_PhysBCFunct.H',['../ERF__PhysBCFunct_8H.html',1,'']]], + ['erf_5fplaneaverage_2eh_719',['ERF_PlaneAverage.H',['../ERF__PlaneAverage_8H.html',1,'']]], + ['erf_5fplotfile_2ecpp_720',['ERF_Plotfile.cpp',['../ERF__Plotfile_8cpp.html',1,'']]], + ['erf_5fpoissonsolve_2ecpp_721',['ERF_PoissonSolve.cpp',['../ERF__PoissonSolve_8cpp.html',1,'']]], + ['erf_5fpoissonsolve_5ftb_2ecpp_722',['ERF_PoissonSolve_tb.cpp',['../ERF__PoissonSolve__tb_8cpp.html',1,'']]], + ['erf_5fprecip_2ecpp_723',['ERF_Precip.cpp',['../ERF__Precip_8cpp.html',1,'']]], + ['erf_5fprecipfall_2ecpp_724',['ERF_PrecipFall.cpp',['../ERF__PrecipFall_8cpp.html',1,'']]], + ['erf_5fprob_5fcommon_2eh_725',['ERF_prob_common.H',['../ERF__prob__common_8H.html',1,'']]], + ['erf_5fqsati_726',['erf_qsati',['../ERF__Microphysics__Utils_8H.html#ac39ef2a869ef543f708d5ed7da4754d3',1,'ERF_Microphysics_Utils.H']]], + ['erf_5fqsatw_727',['erf_qsatw',['../ERF__Microphysics__Utils_8H.html#a8e4b0c6ed8b95c2040dc0c9e8fcb8615',1,'ERF_Microphysics_Utils.H']]], + ['erf_5frad_5fconstants_2eh_728',['ERF_Rad_constants.H',['../ERF__Rad__constants_8H.html',1,'']]], + ['erf_5fradiation_2ecpp_729',['ERF_Radiation.cpp',['../ERF__Radiation_8cpp.html',1,'']]], + ['erf_5fradiation_2eh_730',['ERF_Radiation.H',['../ERF__Radiation_8H.html',1,'']]], + ['erf_5fread_5fwaves_2ecpp_731',['ERF_read_waves.cpp',['../ERF__read__waves_8cpp.html',1,'']]], + ['erf_5freadbndryplanes_2ecpp_732',['ERF_ReadBndryPlanes.cpp',['../ERF__ReadBndryPlanes_8cpp.html',1,'']]], + ['erf_5freadbndryplanes_2eh_733',['ERF_ReadBndryPlanes.H',['../ERF__ReadBndryPlanes_8H.html',1,'']]], + ['erf_5freadfrommetgrid_2ecpp_734',['ERF_ReadFromMetgrid.cpp',['../ERF__ReadFromMetgrid_8cpp.html',1,'']]], + ['erf_5freadfromwrfbdy_2ecpp_735',['ERF_ReadFromWRFBdy.cpp',['../ERF__ReadFromWRFBdy_8cpp.html',1,'']]], + ['erf_5freadfromwrfinput_2ecpp_736',['ERF_ReadFromWRFInput.cpp',['../ERF__ReadFromWRFInput_8cpp.html',1,'']]], + ['erf_5frrtmgp_2eh_737',['ERF_Rrtmgp.H',['../ERF__Rrtmgp_8H.html',1,'']]], + ['erf_5frun_5flongwave_5frrtmgp_2ecpp_738',['ERF_Run_longwave_rrtmgp.cpp',['../ERF__Run__longwave__rrtmgp_8cpp.html',1,'']]], + ['erf_5frun_5fshortwave_5frrtmgp_2ecpp_739',['ERF_Run_shortwave_rrtmgp.cpp',['../ERF__Run__shortwave__rrtmgp_8cpp.html',1,'']]], + ['erf_5fsam_2eh_740',['ERF_SAM.H',['../ERF__SAM_8H.html',1,'']]], + ['erf_5fsampledata_2eh_741',['ERF_SampleData.H',['../ERF__SampleData_8H.html',1,'']]], + ['erf_5fsat_5fmethods_2eh_742',['ERF_Sat_methods.H',['../ERF__Sat__methods_8H.html',1,'']]], + ['erf_5fshared_743',['ERF_shared',['../classERF.html#aab5871c91a4d8888c110865e9d35e8b2',1,'ERF']]], + ['erf_5fsimplead_2eh_744',['ERF_SimpleAD.H',['../ERF__SimpleAD_8H.html',1,'']]], + ['erf_5fslingo_2eh_745',['ERF_Slingo.H',['../ERF__Slingo_8H.html',1,'']]], + ['erf_5fslm_2ecpp_746',['ERF_SLM.cpp',['../ERF__SLM_8cpp.html',1,'']]], + ['erf_5fslm_2eh_747',['ERF_SLM.H',['../ERF__SLM_8H.html',1,'']]], + ['erf_5fslow_5frhs_5finc_748',['erf_slow_rhs_inc',['../ERF__TI__slow__headers_8H.html#afd0e57c37da16481cde9d2fe85792cd0',1,'ERF_TI_slow_headers.H']]], + ['erf_5fslow_5frhs_5fpost_749',['erf_slow_rhs_post',['../ERF__TI__slow__headers_8H.html#a5b8b04e54f9f960d4c661a110cbdbcd4',1,'erf_slow_rhs_post(int level, int finest_level, int nrk, amrex::Real dt, int n_qstate, amrex::Vector< amrex::MultiFab > &S_rhs, amrex::Vector< amrex::MultiFab > &S_old, amrex::Vector< amrex::MultiFab > &S_new, amrex::Vector< amrex::MultiFab > &S_data, const amrex::MultiFab &S_prim, amrex::Vector< amrex::MultiFab > &S_scratch, const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &zvel, const amrex::MultiFab &source, const amrex::MultiFab *SmnSmn, const amrex::MultiFab *eddyDiffs, amrex::MultiFab *Hfx1, amrex::MultiFab *Hfx2, amrex::MultiFab *Hfx3, amrex::MultiFab *Q1fx1, amrex::MultiFab *Q1fx2, amrex::MultiFab *Q1fx3, amrex::MultiFab *Q2fx3, amrex::MultiFab *Diss, const amrex::Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const amrex::Gpu::DeviceVector< amrex::BCRec > &domain_bcs_type_d, const amrex::Vector< amrex::BCRec > &domain_bcs_type, std::unique_ptr< amrex::MultiFab > &z_phys_nd, std::unique_ptr< amrex::MultiFab > &ax, std::unique_ptr< amrex::MultiFab > &ay, std::unique_ptr< amrex::MultiFab > &az, std::unique_ptr< amrex::MultiFab > &dJ_old, std::unique_ptr< amrex::MultiFab > &dJ_new, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v, amrex::YAFluxRegister *fr_as_crse, amrex::YAFluxRegister *fr_as_fine): ERF_TI_slow_headers.H'],['../ERF__slow__rhs__post_8cpp.html#ad4185a682dcd69d6a29ce11039296d66',1,'erf_slow_rhs_post(int level, int finest_level, int nrk, Real dt, int n_qstate, Vector< MultiFab > &S_rhs, Vector< MultiFab > &S_old, Vector< MultiFab > &S_new, Vector< MultiFab > &S_data, const MultiFab &S_prim, Vector< MultiFab > &S_scratch, const MultiFab &xvel, const MultiFab &yvel, const MultiFab &, const MultiFab &source, const MultiFab *SmnSmn, const MultiFab *eddyDiffs, MultiFab *Hfx1, MultiFab *Hfx2, MultiFab *Hfx3, MultiFab *Q1fx1, MultiFab *Q1fx2, MultiFab *Q1fx3, MultiFab *Q2fx3, MultiFab *Diss, const Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const Gpu::DeviceVector< BCRec > &domain_bcs_type_d, const Vector< BCRec > &domain_bcs_type_h, std::unique_ptr< MultiFab > &z_phys_nd, std::unique_ptr< MultiFab > &ax, std::unique_ptr< MultiFab > &ay, std::unique_ptr< MultiFab > &az, std::unique_ptr< MultiFab > &detJ, std::unique_ptr< MultiFab > &detJ_new, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine): ERF_slow_rhs_post.cpp']]], + ['erf_5fslow_5frhs_5fpost_2ecpp_750',['ERF_slow_rhs_post.cpp',['../ERF__slow__rhs__post_8cpp.html',1,'']]], + ['erf_5fslow_5frhs_5fpre_751',['erf_slow_rhs_pre',['../ERF__TI__slow__headers_8H.html#a08e56aada7b66b087c1a2b9dc0efe933',1,'erf_slow_rhs_pre(int level, int finest_level, int nrk, amrex::Real dt, amrex::Vector< amrex::MultiFab > &S_rhs, amrex::Vector< amrex::MultiFab > &S_old, amrex::Vector< amrex::MultiFab > &S_data, const amrex::MultiFab &S_prim, amrex::Vector< amrex::MultiFab > &S_scratch, const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &zvel, std::unique_ptr< amrex::MultiFab > &z_t, const amrex::MultiFab &cc_src, const amrex::MultiFab &xmom_src, const amrex::MultiFab &ymom_src, const amrex::MultiFab &zmom_src, const amrex::MultiFab *zmom_crse_rhs, amrex::MultiFab *Tau11, amrex::MultiFab *Tau22, amrex::MultiFab *Tau33, amrex::MultiFab *Tau12, amrex::MultiFab *Tau13, amrex::MultiFab *Tau21, amrex::MultiFab *Tau23, amrex::MultiFab *Tau31, amrex::MultiFab *Tau32, amrex::MultiFab *SmnSmn, amrex::MultiFab *eddyDiffs, amrex::MultiFab *Hfx1, amrex::MultiFab *Hfx2, amrex::MultiFab *Hfx3, amrex::MultiFab *Q1fx1, amrex::MultiFab *Q1fx2, amrex::MultiFab *Q1fx3, amrex::MultiFab *Q2fx3, amrex::MultiFab *Diss, const amrex::Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const amrex::Gpu::DeviceVector< amrex::BCRec > &domain_bcs_type_d, const amrex::Vector< amrex::BCRec > &domain_bcs_type, std::unique_ptr< amrex::MultiFab > &z_phys_nd, std::unique_ptr< amrex::MultiFab > &ax, std::unique_ptr< amrex::MultiFab > &ay, std::unique_ptr< amrex::MultiFab > &az, std::unique_ptr< amrex::MultiFab > &dJ, const amrex::MultiFab *p0, const amrex::MultiFab &pp_inc, std::unique_ptr< amrex::MultiFab > &mapfac_m, std::unique_ptr< amrex::MultiFab > &mapfac_u, std::unique_ptr< amrex::MultiFab > &mapfac_v, amrex::YAFluxRegister *fr_as_crse, amrex::YAFluxRegister *fr_as_fine): ERF_TI_slow_headers.H'],['../ERF__slow__rhs__pre_8cpp.html#a7f9a468e8f9594554d88b4b0b55e8b9f',1,'erf_slow_rhs_pre(int level, int finest_level, int nrk, Real dt, Vector< MultiFab > &S_rhs, Vector< MultiFab > &S_old, Vector< MultiFab > &S_data, const MultiFab &S_prim, Vector< MultiFab > &S_scratch, const MultiFab &xvel, const MultiFab &yvel, const MultiFab &zvel, std::unique_ptr< MultiFab > &z_t_mf, const MultiFab &cc_src, const MultiFab &xmom_src, const MultiFab &ymom_src, const MultiFab &zmom_src, const MultiFab *zmom_crse_rhs, MultiFab *Tau11, MultiFab *Tau22, MultiFab *Tau33, MultiFab *Tau12, MultiFab *Tau13, MultiFab *Tau21, MultiFab *Tau23, MultiFab *Tau31, MultiFab *Tau32, MultiFab *SmnSmn, MultiFab *eddyDiffs, MultiFab *Hfx1, MultiFab *Hfx2, MultiFab *Hfx3, MultiFab *Q1fx1, MultiFab *Q1fx2, MultiFab *Q1fx3, MultiFab *Q2fx3, MultiFab *Diss, const Geometry geom, const SolverChoice &solverChoice, std::unique_ptr< ABLMost > &most, const Gpu::DeviceVector< BCRec > &domain_bcs_type_d, const Vector< BCRec > &domain_bcs_type_h, std::unique_ptr< MultiFab > &z_phys_nd, std::unique_ptr< MultiFab > &ax, std::unique_ptr< MultiFab > &ay, std::unique_ptr< MultiFab > &az, std::unique_ptr< MultiFab > &detJ, const MultiFab *p0, const MultiFab &pp_inc, std::unique_ptr< MultiFab > &mapfac_m, std::unique_ptr< MultiFab > &mapfac_u, std::unique_ptr< MultiFab > &mapfac_v, YAFluxRegister *fr_as_crse, YAFluxRegister *fr_as_fine): ERF_slow_rhs_pre.cpp']]], + ['erf_5fslow_5frhs_5fpre_2ecpp_752',['ERF_slow_rhs_pre.cpp',['../ERF__slow__rhs__pre_8cpp.html',1,'']]], + ['erf_5fsolve_5fwith_5feb_5fmlmg_2ecpp_753',['ERF_solve_with_EB_mlmg.cpp',['../ERF__solve__with__EB__mlmg_8cpp.html',1,'']]], + ['erf_5fsolve_5fwith_5ffft_2ecpp_754',['ERF_solve_with_fft.cpp',['../ERF__solve__with__fft_8cpp.html',1,'']]], + ['erf_5fsolve_5fwith_5fgmres_2ecpp_755',['ERF_solve_with_gmres.cpp',['../ERF__solve__with__gmres_8cpp.html',1,'']]], + ['erf_5fsolve_5fwith_5fmlmg_2ecpp_756',['ERF_solve_with_mlmg.cpp',['../ERF__solve__with__mlmg_8cpp.html',1,'']]], + ['erf_5fspongestruct_2eh_757',['ERF_SpongeStruct.H',['../ERF__SpongeStruct_8H.html',1,'']]], + ['erf_5fsrc_5fheaders_2eh_758',['ERF_Src_headers.H',['../ERF__Src__headers_8H.html',1,'']]], + ['erf_5ftagging_2ecpp_759',['ERF_Tagging.cpp',['../ERF__Tagging_8cpp.html',1,'']]], + ['erf_5fterrainif_2eh_760',['ERF_TerrainIF.H',['../ERF__TerrainIF_8H.html',1,'']]], + ['erf_5fterrainmetrics_2ecpp_761',['ERF_TerrainMetrics.cpp',['../ERF__TerrainMetrics_8cpp.html',1,'']]], + ['erf_5fterrainmetrics_2eh_762',['ERF_TerrainMetrics.H',['../ERF__TerrainMetrics_8H.html',1,'']]], + ['erf_5fterrainpoisson_2ecpp_763',['ERF_TerrainPoisson.cpp',['../ERF__TerrainPoisson_8cpp.html',1,'']]], + ['erf_5fterrainpoisson_2eh_764',['ERF_TerrainPoisson.H',['../ERF__TerrainPoisson_8H.html',1,'']]], + ['erf_5fterrainpoisson_5f3d_5fk_2eh_765',['ERF_TerrainPoisson_3D_K.H',['../ERF__TerrainPoisson__3D__K_8H.html',1,'']]], + ['erf_5fthetav_2eh_766',['ERF_Thetav.H',['../ERF__Thetav_8H.html',1,'']]], + ['erf_5fti_5ffast_5fheaders_2eh_767',['ERF_TI_fast_headers.H',['../ERF__TI__fast__headers_8H.html',1,'']]], + ['erf_5fti_5fno_5fsubstep_5ffun_2eh_768',['ERF_TI_no_substep_fun.H',['../ERF__TI__no__substep__fun_8H.html',1,'']]], + ['erf_5fti_5fslow_5fheaders_2eh_769',['ERF_TI_slow_headers.H',['../ERF__TI__slow__headers_8H.html',1,'']]], + ['erf_5fti_5fslow_5frhs_5ffun_2eh_770',['ERF_TI_slow_rhs_fun.H',['../ERF__TI__slow__rhs__fun_8H.html',1,'']]], + ['erf_5fti_5fsubstep_5ffun_2eh_771',['ERF_TI_substep_fun.H',['../ERF__TI__substep__fun_8H.html',1,'']]], + ['erf_5fti_5futils_2eh_772',['ERF_TI_utils.H',['../ERF__TI__utils_8H.html',1,'']]], + ['erf_5ftilenoz_2eh_773',['ERF_TileNoZ.H',['../ERF__TileNoZ_8H.html',1,'']]], + ['erf_5ftime_5favg_5fvel_2ecpp_774',['ERF_Time_Avg_Vel.cpp',['../ERF__Time__Avg__Vel_8cpp.html',1,'']]], + ['erf_5ftimeinterpolateddata_2eh_775',['ERF_TimeInterpolatedData.H',['../ERF__TimeInterpolatedData_8H.html',1,'']]], + ['erf_5ftimestep_2ecpp_776',['ERF_TimeStep.cpp',['../ERF__TimeStep_8cpp.html',1,'']]], + ['erf_5fturbpertstruct_2eh_777',['ERF_TurbPertStruct.H',['../ERF__TurbPertStruct_8H.html',1,'']]], + ['erf_5fturbstruct_2eh_778',['ERF_TurbStruct.H',['../ERF__TurbStruct_8H.html',1,'']]], + ['erf_5fupdate_5fkessler_2ecpp_779',['ERF_Update_Kessler.cpp',['../ERF__Update__Kessler_8cpp.html',1,'']]], + ['erf_5fupdate_5fsam_2ecpp_780',['ERF_Update_SAM.cpp',['../ERF__Update__SAM_8cpp.html',1,'']]], + ['erf_5futils_2eh_781',['ERF_Utils.H',['../ERF__Utils_8H.html',1,'']]], + ['erf_5fvelocitytomomentum_2ecpp_782',['ERF_VelocityToMomentum.cpp',['../ERF__VelocityToMomentum_8cpp.html',1,'']]], + ['erf_5fwater_5fvapor_5fsaturation_2eh_783',['ERF_Water_vapor_saturation.H',['../ERF__Water__vapor__saturation_8H.html',1,'']]], + ['erf_5fwindfarm_2eh_784',['ERF_WindFarm.H',['../ERF__WindFarm_8H.html',1,'']]], + ['erf_5fwrite1dprofiles_2ecpp_785',['ERF_Write1DProfiles.cpp',['../ERF__Write1DProfiles_8cpp.html',1,'']]], + ['erf_5fwrite1dprofiles_5fstag_2ecpp_786',['ERF_Write1DProfiles_stag.cpp',['../ERF__Write1DProfiles__stag_8cpp.html',1,'']]], + ['erf_5fwritebndryplanes_2ecpp_787',['ERF_WriteBndryPlanes.cpp',['../ERF__WriteBndryPlanes_8cpp.html',1,'']]], + ['erf_5fwritebndryplanes_2eh_788',['ERF_WriteBndryPlanes.H',['../ERF__WriteBndryPlanes_8H.html',1,'']]], + ['erf_5fwriteebsurface_2ecpp_789',['ERF_writeEBsurface.cpp',['../ERF__writeEBsurface_8cpp.html',1,'']]], + ['erf_5fwritejobinfo_2ecpp_790',['ERF_writeJobInfo.cpp',['../ERF__writeJobInfo_8cpp.html',1,'']]], + ['erf_5fwritescalarprofiles_2ecpp_791',['ERF_WriteScalarProfiles.cpp',['../ERF__WriteScalarProfiles_8cpp.html',1,'']]], + ['erf_5fwstar_2eh_792',['ERF_Wstar.H',['../ERF__Wstar_8H.html',1,'']]], + ['erfbctype_793',['ERFBCType',['../namespaceERFBCType.html',1,'']]], + ['erffillpatcher_794',['ERFFillPatcher',['../classERFFillPatcher.html',1,'ERFFillPatcher'],['../classERFFillPatcher.html#a4236a9ab8003847e327495ff170a9a7a',1,'ERFFillPatcher::ERFFillPatcher()']]], + ['erfpc_2eh_795',['ERFPC.H',['../ERFPC_8H.html',1,'']]], + ['erfpcevolve_2ecpp_796',['ERFPCEvolve.cpp',['../ERFPCEvolve_8cpp.html',1,'']]], + ['erfpcinitializations_2ecpp_797',['ERFPCInitializations.cpp',['../ERFPCInitializations_8cpp.html',1,'']]], + ['erfpcutils_2ecpp_798',['ERFPCUtils.cpp',['../ERFPCUtils_8cpp.html',1,'']]], + ['erfphysbcfunct_5fbase_799',['ERFPhysBCFunct_base',['../classERFPhysBCFunct__base.html#a4ba2333432141d41177dca92464e619d',1,'ERFPhysBCFunct_base::ERFPhysBCFunct_base()'],['../classERFPhysBCFunct__base.html',1,'ERFPhysBCFunct_base']]], + ['erfphysbcfunct_5fcons_800',['ERFPhysBCFunct_cons',['../classERFPhysBCFunct__cons.html#a946d62bb44e2344fac3fe34ed4c27d3a',1,'ERFPhysBCFunct_cons::ERFPhysBCFunct_cons()'],['../classERFPhysBCFunct__cons.html',1,'ERFPhysBCFunct_cons']]], + ['erfphysbcfunct_5fu_801',['ERFPhysBCFunct_u',['../classERFPhysBCFunct__u.html',1,'ERFPhysBCFunct_u'],['../classERFPhysBCFunct__u.html#a02e58c56eb025621156c134d7782e495',1,'ERFPhysBCFunct_u::ERFPhysBCFunct_u()']]], + ['erfphysbcfunct_5fv_802',['ERFPhysBCFunct_v',['../classERFPhysBCFunct__v.html#a6dce68398d0b2711389dda67d222fedc',1,'ERFPhysBCFunct_v::ERFPhysBCFunct_v()'],['../classERFPhysBCFunct__v.html',1,'ERFPhysBCFunct_v']]], + ['erfphysbcfunct_5fw_803',['ERFPhysBCFunct_w',['../classERFPhysBCFunct__w.html',1,'ERFPhysBCFunct_w'],['../classERFPhysBCFunct__w.html#a9a009bc8ab1a9916eaa56702b38e7436',1,'ERFPhysBCFunct_w::ERFPhysBCFunct_w()']]], + ['erfpostprocessbasegrids_804',['ERFPostProcessBaseGrids',['../ERF__Utils_8H.html#aa333d30d88adfbad5d860b704845f857',1,'ERFPostProcessBaseGrids(const amrex::Box &domain, bool decompose_in_z): ERF_Utils.H'],['../ERF__ChopGrids_8cpp.html#a140e3056fee7f1dcd5a295d2efdaf0b2',1,'ERFPostProcessBaseGrids(const Box &domain, bool decompose_in_z): ERF_ChopGrids.cpp']]], + ['erftracers_2ecpp_805',['ERFTracers.cpp',['../ERFTracers_8cpp.html',1,'']]], + ['errorest_806',['ErrorEst',['../classERF.html#a18e6dbbf968b4492e78aa427791620f4',1,'ERF']]], + ['esccoef_807',['esccoef',['../ERF__Constants_8H.html#ac16a7511bec41b7d5a558b5841e8f3b1',1,'ERF_Constants.H']]], + ['esicoef_808',['esicoef',['../ERF__Constants_8H.html#a414035f12e97c86f4e40cb6763c29ddb',1,'ERF_Constants.H']]], + ['esttimestep_809',['estTimeStep',['../classERF.html#a6b1d727e63de2e49aa4f8e00b0dda1d5',1,'ERF']]], + ['eta_5feps_810',['eta_eps',['../structmoeng__flux.html#a67cae16850c061bb189a783159ac6406',1,'moeng_flux::eta_eps()'],['../structdonelan__flux.html#aac38c6d44658be0daa32dc8bd0b29adb',1,'donelan_flux::eta_eps()'],['../structcustom__flux.html#aa04871c3e8d2e06f502cde2404c90be4',1,'custom_flux::eta_eps()']]], + ['eulerianmicrophysics_811',['EulerianMicrophysics',['../classEulerianMicrophysics.html',1,'EulerianMicrophysics'],['../classEulerianMicrophysics.html#a26a985c76efcd1dd68b5c853bbd264f6',1,'EulerianMicrophysics::EulerianMicrophysics(const int &nlev, const MoistureType &a_model_type)'],['../classEulerianMicrophysics.html#af78c2f059431d49deec9f570ada4daaa',1,'EulerianMicrophysics::EulerianMicrophysics()']]], + ['evaluate_812',['Evaluate',['../structCENTERED4.html#ae67620f7c851fbadb31ff439601ac7fe',1,'CENTERED4::Evaluate()'],['../structUPWIND3.html#a247a547b52d1bf118e8a9cb44d46b744',1,'UPWIND3::Evaluate()'],['../structCENTERED2.html#a1f9232868e37a452630ccfa8ec34be91',1,'CENTERED2::Evaluate()'],['../structWENO7.html#a42198ea771144460fff2f08857fa52ee',1,'WENO7::Evaluate()'],['../structUPWIND5.html#a267b7805b0761e01b0532a986307b79d',1,'UPWIND5::Evaluate()'],['../structCENTERED6.html#aacd79f8ed62a166d5f4d44a20d09fc13',1,'CENTERED6::Evaluate()'],['../structUPWINDALL.html#a781c3531bb77c6282c88c9cc3d64c722',1,'UPWINDALL::Evaluate()'],['../structWENO5.html#ae77d5f8032cf91c84551f51170ec9111',1,'WENO5::Evaluate()'],['../structWENO__Z3.html#aa6c2eefc18b5f0365c0357ee4f066080',1,'WENO_Z3::Evaluate()'],['../structWENO__MZQ3.html#a8dcc9655166c1217b7056f244d4cfde2',1,'WENO_MZQ3::Evaluate()'],['../structWENO__Z5.html#a06568f71bdf16e718756dcd66a26fd97',1,'WENO_Z5::Evaluate()'],['../structWENO__Z7.html#a2562b1dcd18d8a2d7f02f3719e98112b',1,'WENO_Z7::Evaluate()'],['../structWENO3.html#a6a48e6b00e04466ca779a2b3ee62770b',1,'WENO3::Evaluate()']]], + ['evapg1_813',['evapg1',['../classSAM.html#a2e241fff555231e1cc87947a624bb5d6',1,'SAM']]], + ['evapg2_814',['evapg2',['../classSAM.html#a3117e23160d027ccb4dacf744a477a40',1,'SAM']]], + ['evapr1_815',['evapr1',['../classSAM.html#a8350a31a9f29bedee48b24bb43d5b0fc',1,'SAM']]], + ['evapr2_816',['evapr2',['../classSAM.html#a0edeaaddf7573079fdc9af1484ce5582',1,'SAM']]], + ['evaps1_817',['evaps1',['../classSAM.html#a56c463cbd313722b567dd88e7ac6fccd',1,'SAM']]], + ['evaps2_818',['evaps2',['../classSAM.html#a8f9e9699afd94d393be846cd26933fd0',1,'SAM']]], + ['evolve_819',['Evolve',['../classERF.html#a0be12798b46f52fa4b5a995f147c3f96',1,'ERF']]], + ['ewp_820',['EWP',['../classEWP.html',1,'EWP'],['../classEWP.html#a4c32d700e8ba91dfbc07c332ad91ca71',1,'EWP::EWP()']]], + ['exit_5fdef_5fmode_821',['exit_def_mode',['../classncutils_1_1NCGroup.html#a3a4ebd106195be96fb41bb3bfde83143',1,'ncutils::NCGroup']]], + ['exp_5finterpol_822',['exp_interpol',['../classPhysProp.html#a9bc40a34bf3b039dd0d8ad87678e23d1',1,'PhysProp']]], + ['expand_5fand_5finterpolate_5f1d_823',['expand_and_interpolate_1d',['../ERF__Interpolation__1D_8H.html#af71b362e58803c8c29aa5127adcf645f',1,'ERF_Interpolation_1D.H']]], + ['expand_5fday_5ffluxes_824',['expand_day_fluxes',['../namespaceinternal.html#a154efe747ea48707745d01843ac5eb71',1,'internal']]], + ['expand_5fyakl1d_5fto_5fmf_825',['expand_yakl1d_to_mf',['../classRadiation.html#a5a43e7644bc6a0d3590bd356384cb0fb',1,'Radiation']]], + ['export_5fsurface_5ffluxes_826',['export_surface_fluxes',['../classRadiation.html#a2115945b42eb2b2c6844049b2edc74ca',1,'Radiation']]], + ['ext_5fcmip6_5fsw_827',['ext_cmip6_sw',['../classAerRadProps.html#acf87aa0fdbfa3b73924a1f7c56088e55',1,'AerRadProps']]], + ['ext_5fdir_828',['ext_dir',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca4b16988b22c277c9f812ddb5fb1539af',1,'ERFBCType']]], + ['ext_5fdir_5fingested_829',['ext_dir_ingested',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca138e8c6c2427dcd78959f3e0e84b3462',1,'ERFBCType']]], + ['ext_5fdir_5fprim_830',['ext_dir_prim',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca52a76d5c6aeb74655f726be3ae8a1eab',1,'ERFBCType']]], + ['ext_5fsw_5fice_831',['ext_sw_ice',['../classCloudRadProps.html#a4664e7123fdc065b7ff40e716453b050',1,'CloudRadProps']]], + ['ext_5fsw_5fliq_832',['ext_sw_liq',['../classCloudRadProps.html#a98a74e616e9952f22102a6d3c3f4af51',1,'CloudRadProps']]], + ['extpsw_833',['extpsw',['../structPhysProp_1_1physprop__t.html#aa86746c3ce43b7a278d78276bbe0d153',1,'PhysProp::physprop_t']]], + ['extrap_5fmethod_5fbndry_834',['extrap_method_bndry',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2ac291677b47a4b2b3276ea6ebf30d6e26',1,'LinInterp']]], + ['extrap_5fmethod_5fcycle_835',['extrap_method_cycle',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2aeec66ba685aaa33115191d8f6bc9c0e6',1,'LinInterp']]], + ['extrap_5fmethod_5fzero_836',['extrap_method_zero',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2aa8778034b0e18c190776623750b945b5',1,'LinInterp']]] ]; diff --git a/search/all_5.js b/search/all_5.js index 028c763a2..f756c48a2 100644 --- a/search/all_5.js +++ b/search/all_5.js @@ -1,21 +1,22 @@ var searchData= [ - ['f_838',['F',['../classF.html',1,'']]], - ['f1_839',['F1',['../structMYNNLevel2.html#a8be91cd073c493f390653b79f0a8706c',1,'MYNNLevel2']]], - ['f1_5factive_840',['f1_active',['../classUnionCIF.html#a2efa596306e1f101538ea7addef01c50',1,'UnionCIF::f1_active()'],['../classIntersectionCIF.html#addd5d1b2d4f051377f8b3b2b2fcc395e',1,'IntersectionCIF::f1_active()']]], - ['f2_841',['F2',['../structMYNNLevel2.html#a195f36a73787dea436d798f20d28ebb3',1,'MYNNLevel2']]], - ['f2_5factive_842',['f2_active',['../classUnionCIF.html#a7a543347d220b1e1345c2af564cc0bd5',1,'UnionCIF::f2_active()'],['../classIntersectionCIF.html#a92f13c010706b380de68596e6ab778ec',1,'IntersectionCIF::f2_active()']]], - ['f_5fslow_843',['F_slow',['../classMRISplitIntegrator.html#a088e107111ca012e026908b0c0b3cef7',1,'MRISplitIntegrator']]], - ['fabptr_844',['FabPtr',['../classSAM.html#a2ffb00984d39bfc39057c68f708774a9',1,'SAM::FabPtr()'],['../classMM5.html#a1c62f3c8eb0010c903b517e6ba49973d',1,'MM5::FabPtr()'],['../classSLM.html#abb12aea2d3e7bcc1e47b81581a9892ba',1,'SLM::FabPtr()'],['../classKessler.html#ad9b9b2f6662807890f9f2b016d6d0d1c',1,'Kessler::FabPtr()']]], - ['fast_5frhs_845',['fast_rhs',['../classMRISplitIntegrator.html#a8f0b8ba2224608975dd1cfae5d811ffb',1,'MRISplitIntegrator']]], - ['fast_5frhs_5ffun_846',['fast_rhs_fun',['../ERF__TI__substep__fun_8H.html#ac6afbd55bf5b7264098d44d9b8928f57',1,'ERF_TI_substep_fun.H']]], - ['field_847',['field',['../classPlaneAverage.html#a027673d7c6dd35a1b45cd1fa8f2b4cb5',1,'PlaneAverage']]], - ['fill_848',['Fill',['../classERFFillPatcher.html#a045ae741822ced1684eddf019cd7f219',1,'ERFFillPatcher']]], - ['fill_5ffab_5ffrom_5farrays_849',['fill_fab_from_arrays',['../ERF__NCWpsFile_8H.html#a64f2a31eac0693c65ffb19e37014426a',1,'ERF_NCWpsFile.H']]], - ['fill_5ffrom_5fbndryregs_850',['fill_from_bndryregs',['../classERF.html#a2135641de33dea5057799569c74cac42',1,'ERF']]], - ['fill_5fnturb_5fmultifab_851',['fill_Nturb_multifab',['../classWindFarm.html#aea0f3ab253607ca28ab0085c9a0865e7',1,'WindFarm']]], - ['fill_5frhs_852',['fill_rhs',['../classERF.html#a76600d7a4a0451c9727d2cc57dae4220',1,'ERF']]], - ['fill_5fsmark_5fmultifab_853',['fill_SMark_multifab',['../classWindFarm.html#ad4c606e93225c44abd0e854081602c2a',1,'WindFarm']]], + ['f_837',['F',['../classF.html',1,'']]], + ['f1_838',['F1',['../structMYNNLevel2.html#a8be91cd073c493f390653b79f0a8706c',1,'MYNNLevel2']]], + ['f1_5factive_839',['f1_active',['../classUnionCIF.html#a2efa596306e1f101538ea7addef01c50',1,'UnionCIF::f1_active()'],['../classIntersectionCIF.html#addd5d1b2d4f051377f8b3b2b2fcc395e',1,'IntersectionCIF::f1_active()']]], + ['f2_840',['F2',['../structMYNNLevel2.html#a195f36a73787dea436d798f20d28ebb3',1,'MYNNLevel2']]], + ['f2_5factive_841',['f2_active',['../classUnionCIF.html#a7a543347d220b1e1345c2af564cc0bd5',1,'UnionCIF::f2_active()'],['../classIntersectionCIF.html#a92f13c010706b380de68596e6ab778ec',1,'IntersectionCIF::f2_active()']]], + ['f_5fslow_842',['F_slow',['../classMRISplitIntegrator.html#a088e107111ca012e026908b0c0b3cef7',1,'MRISplitIntegrator']]], + ['fabptr_843',['FabPtr',['../classSAM.html#a2ffb00984d39bfc39057c68f708774a9',1,'SAM::FabPtr()'],['../classMM5.html#a1c62f3c8eb0010c903b517e6ba49973d',1,'MM5::FabPtr()'],['../classSLM.html#abb12aea2d3e7bcc1e47b81581a9892ba',1,'SLM::FabPtr()'],['../classKessler.html#ad9b9b2f6662807890f9f2b016d6d0d1c',1,'Kessler::FabPtr()']]], + ['fast_5frhs_844',['fast_rhs',['../classMRISplitIntegrator.html#a8f0b8ba2224608975dd1cfae5d811ffb',1,'MRISplitIntegrator']]], + ['fast_5frhs_5ffun_845',['fast_rhs_fun',['../ERF__TI__substep__fun_8H.html#ac6afbd55bf5b7264098d44d9b8928f57',1,'ERF_TI_substep_fun.H']]], + ['field_846',['field',['../classPlaneAverage.html#a027673d7c6dd35a1b45cd1fa8f2b4cb5',1,'PlaneAverage']]], + ['fill_847',['Fill',['../classERFFillPatcher.html#a045ae741822ced1684eddf019cd7f219',1,'ERFFillPatcher']]], + ['fill_5ffab_5ffrom_5farrays_848',['fill_fab_from_arrays',['../ERF__NCWpsFile_8H.html#a64f2a31eac0693c65ffb19e37014426a',1,'ERF_NCWpsFile.H']]], + ['fill_5ffrom_5fbndryregs_849',['fill_from_bndryregs',['../classERF.html#a2135641de33dea5057799569c74cac42',1,'ERF']]], + ['fill_5fnturb_5fmultifab_850',['fill_Nturb_multifab',['../classWindFarm.html#ac57fc0cf5e0666fd8aabbf7863412eb5',1,'WindFarm']]], + ['fill_5frhs_851',['fill_rhs',['../classERF.html#a76600d7a4a0451c9727d2cc57dae4220',1,'ERF']]], + ['fill_5fsmark_5fmultifab_852',['fill_SMark_multifab',['../classWindFarm.html#ad4c606e93225c44abd0e854081602c2a',1,'WindFarm']]], + ['fill_5fsmark_5fmultifab_5fmesoscale_5fmodels_853',['fill_SMark_multifab_mesoscale_models',['../classWindFarm.html#a74983b05c969cace5b73aeae42830d2c',1,'WindFarm']]], ['fillbdyccvels_854',['FillBdyCCVels',['../classERF.html#a19c8017ca1ff0eead61abd7e0ce62232',1,'ERF']]], ['fillcoarsepatch_855',['FillCoarsePatch',['../classERF.html#ac4497025ab94461899960ee067c2c72a',1,'ERF']]], ['fillintermediatepatch_856',['FillIntermediatePatch',['../classERF.html#a5434c771d76cf50e4a0dd9e1b0eb27fc',1,'ERF']]], diff --git a/search/all_7.js b/search/all_7.js index 62e145e41..d9ae3b7ce 100644 --- a/search/all_7.js +++ b/search/all_7.js @@ -26,10 +26,11 @@ var searchData= ['host_5fto_5fdevice_1118',['host_to_device',['../structInputSoundingData.html#a0e0cddb5da1a173092eeaf3c9489dfb8',1,'InputSoundingData']]], ['hseutils_1119',['HSEutils',['../namespaceHSEutils.html',1,'']]], ['hub_5fheight_1120',['hub_height',['../classEWP.html#a2ee471b0dcad3057297b809f4c5141ab',1,'EWP::hub_height()'],['../classFitch.html#ae3af34c6c07fd2d8b9b081b5c7ceb443',1,'Fitch::hub_height()'],['../classGeneralAD.html#ac82bba9c2818ca1e77adb01fdcdcaf66',1,'GeneralAD::hub_height()'],['../classSimpleAD.html#a4c17a08ad746b342bf62d7a1ad93781a',1,'SimpleAD::hub_height()'],['../classWindFarm.html#a6dfd6451498f50c17cb67c386d13ddfb',1,'WindFarm::hub_height()']]], - ['huge_5freal_1121',['huge_real',['../classModalAeroWateruptake.html#a7b99efd9601245afe2274c268afb5305',1,'ModalAeroWateruptake']]], - ['hwave_1122',['Hwave',['../classERF.html#aef05cf88e9e9d2b56112336761493977',1,'ERF']]], - ['hwave_5fonegrid_1123',['Hwave_onegrid',['../classERF.html#a11f2d48d9af9b8f4574975cae06838f1',1,'ERF']]], - ['hygro_5faer_1124',['hygro_aer',['../structPhysProp_1_1physprop__t.html#af60d655c402eb7e47763c631b9432552',1,'PhysProp::physprop_t']]], - ['hygro_5foptics_5finit_1125',['hygro_optics_init',['../classPhysProp.html#a6c73b423727e5d04394d0c030fd217f0',1,'PhysProp']]], - ['hygroscopic_5foptics_5finit_1126',['hygroscopic_optics_init',['../classPhysProp.html#a012aafa0dfffea201ceb407815094ffd',1,'PhysProp']]] + ['hub_5fheight_5fvelocity_1121',['hub_height_velocity',['../classFitch.html#af01d3f69b4f952f91970964d2f498e61',1,'Fitch']]], + ['huge_5freal_1122',['huge_real',['../classModalAeroWateruptake.html#a7b99efd9601245afe2274c268afb5305',1,'ModalAeroWateruptake']]], + ['hwave_1123',['Hwave',['../classERF.html#aef05cf88e9e9d2b56112336761493977',1,'ERF']]], + ['hwave_5fonegrid_1124',['Hwave_onegrid',['../classERF.html#a11f2d48d9af9b8f4574975cae06838f1',1,'ERF']]], + ['hygro_5faer_1125',['hygro_aer',['../structPhysProp_1_1physprop__t.html#af60d655c402eb7e47763c631b9432552',1,'PhysProp::physprop_t']]], + ['hygro_5foptics_5finit_1126',['hygro_optics_init',['../classPhysProp.html#a6c73b423727e5d04394d0c030fd217f0',1,'PhysProp']]], + ['hygroscopic_5foptics_5finit_1127',['hygroscopic_optics_init',['../classPhysProp.html#a012aafa0dfffea201ceb407815094ffd',1,'PhysProp']]] ]; diff --git a/search/all_8.js b/search/all_8.js index ceff898fd..3bc2efb97 100644 --- a/search/all_8.js +++ b/search/all_8.js @@ -1,53 +1,52 @@ var searchData= [ - ['ice_5feffective_5fradius_1127',['ice_effective_radius',['../ERF__Parameterizations_8H.html#adec9d0652512bd8a82a6dcea536c9138',1,'ERF_Parameterizations.H']]], - ['ice_5ffile_1128',['ice_file',['../classCloudRadProps.html#a4bdca9fbb3d26b9b013ea06b9385017e',1,'CloudRadProps']]], - ['ice_5ftau_5fbnd_5flw_1129',['ice_tau_bnd_lw',['../classRadiation.html#ab4092f9e967d5107e1722b0345e31053',1,'Radiation']]], - ['ice_5ftau_5fbnd_5fsw_1130',['ice_tau_bnd_sw',['../classRadiation.html#aba4d37f5325c0d89476eb2595f976bc1',1,'Radiation']]], - ['icecldoptics_1131',['icecldoptics',['../classMamConstituents.html#a45adfa2e9bca7c7a7b0dd807779e94ac',1,'MamConstituents::icecldoptics()'],['../classOptics.html#a357f26f1bf42c917131a48782732ce03',1,'Optics::icecldoptics()']]], - ['icefall_1132',['IceFall',['../classSAM.html#a363b3bb27b6e6cdad8693363b3262419',1,'SAM']]], - ['iceopticsfile_1133',['iceopticsfile',['../classMamConstituents.html#a0e74835fc2592d78facf9e4d9ea36f1c',1,'MamConstituents']]], - ['icesize_5ftable_5fmin_5ftemp_1134',['icesize_table_min_temp',['../classRadConstants.html#ab527187d8cc457be894cb3b4d5f3a22b',1,'RadConstants']]], - ['iciwp_1135',['iciwp',['../classRadiation.html#aa24b1e1de58c5122b78fd6afae5f737b',1,'Radiation']]], - ['iclwp_1136',['iclwp',['../classRadiation.html#a9cedc778ea026393eace9912b4ec8d5b',1,'Radiation']]], - ['icswp_1137',['icswp',['../classRadiation.html#ad2d2f52fdb57d7a44cfb553a3b70d346',1,'Radiation']]], - ['idx_1138',['idx',['../structMamConstituents_1_1gas__t.html#a92407cc5cf2752a7f7626b6f034e2fd3',1,'MamConstituents::gas_t::idx()'],['../structMamConstituents_1_1aerosol__t.html#a417db05e152088ff32fa5ca0ed2fadcc',1,'MamConstituents::aerosol_t::idx()'],['../structMamConstituents_1_1modelist__t.html#a8b01fce25cf4e89d61786dc304af557a',1,'MamConstituents::modelist_t::idx()']]], - ['idx_5flw_5fdiag_1139',['idx_lw_diag',['../classRadConstants.html#a4be67e03614ad60a9a3e5b0a5296a232',1,'RadConstants']]], - ['idx_5fmmr_5fa_1140',['idx_mmr_a',['../structMamConstituents_1_1mode__component__t.html#a5325a6229804cf4ead4edd0ae3365368',1,'MamConstituents::mode_component_t']]], - ['idx_5fmmr_5fc_1141',['idx_mmr_c',['../structMamConstituents_1_1mode__component__t.html#a2068ed3ee6d1c031830fdd74950c9dab',1,'MamConstituents::mode_component_t']]], - ['idx_5fnir_5fdiag_1142',['idx_nir_diag',['../classRadConstants.html#a5eccb1fa499f9f02449912985f70aa8e',1,'RadConstants']]], - ['idx_5fnum_5fa_1143',['idx_num_a',['../structMamConstituents_1_1mode__component__t.html#a27f686068187bef4800b0f50d673f636',1,'MamConstituents::mode_component_t']]], - ['idx_5fnum_5fc_1144',['idx_num_c',['../structMamConstituents_1_1mode__component__t.html#afeac72ae7d7e859f79d4c4c2baf54473',1,'MamConstituents::mode_component_t']]], - ['idx_5fprops_1145',['idx_props',['../structMamConstituents_1_1mode__component__t.html#a7ee6b4be8e5ef923b0f0ac0d56a5ee6c',1,'MamConstituents::mode_component_t::idx_props()'],['../structMamConstituents_1_1modelist__t.html#a1e532f0738a48c0740d4af9f635bef5c',1,'MamConstituents::modelist_t::idx_props()']]], - ['idx_5fsw_5fdiag_1146',['idx_sw_diag',['../classRadConstants.html#aa8d069e0dd3bcec898e914167c02f4ee',1,'RadConstants']]], - ['idx_5fuv_5fdiag_1147',['idx_uv_diag',['../classRadConstants.html#ab6e2774dc2b5fbd26204c95bb601610c',1,'RadConstants']]], - ['igamma_1148',['iGamma',['../ERF__Constants_8H.html#ab24194b3b11ee04368e1087acda6bde7',1,'ERF_Constants.H']]], - ['ihirsfq_1149',['ihirsfq',['../classRadiation.html#aa15d7c4d015604b92db440a1c5b1c988',1,'Radiation']]], - ['imax_1150',['imax',['../classModalAeroWateruptake.html#a5cc5abb758503a218ee7331ce15abf4e',1,'ModalAeroWateruptake']]], - ['impose_5flateral_5fbasestate_5fbcs_1151',['impose_lateral_basestate_bcs',['../classERFPhysBCFunct__base.html#ab2d46cdc32a713b4eb40a5c3552ef947',1,'ERFPhysBCFunct_base']]], - ['impose_5flateral_5fcons_5fbcs_1152',['impose_lateral_cons_bcs',['../classERFPhysBCFunct__cons.html#ac8da4b078a7da0ba4a9adb727d885e58',1,'ERFPhysBCFunct_cons']]], - ['impose_5flateral_5fxvel_5fbcs_1153',['impose_lateral_xvel_bcs',['../classERFPhysBCFunct__u.html#a9b203cbd4f9a1fd40961067424ae5f81',1,'ERFPhysBCFunct_u']]], - ['impose_5flateral_5fyvel_5fbcs_1154',['impose_lateral_yvel_bcs',['../classERFPhysBCFunct__v.html#adee10e9098b1261837e642a76632c141',1,'ERFPhysBCFunct_v']]], - ['impose_5flateral_5fzvel_5fbcs_1155',['impose_lateral_zvel_bcs',['../classERFPhysBCFunct__w.html#a9cd6e53c9598fe025c3c78945c2b1b83',1,'ERFPhysBCFunct_w']]], - ['impose_5fmost_5fbcs_1156',['impose_most_bcs',['../classABLMost.html#aa6c480227398080885f5bd48466c71e0',1,'ABLMost']]], - ['impose_5fvertical_5fbasestate_5fbcs_1157',['impose_vertical_basestate_bcs',['../classERFPhysBCFunct__base.html#a16a0a73ad13172027fc38b4c427f71ff',1,'ERFPhysBCFunct_base']]], - ['impose_5fvertical_5fcons_5fbcs_1158',['impose_vertical_cons_bcs',['../classERFPhysBCFunct__cons.html#a1f0975393eb1c321d84d15734ae8cdf0',1,'ERFPhysBCFunct_cons']]], - ['impose_5fvertical_5fxvel_5fbcs_1159',['impose_vertical_xvel_bcs',['../classERFPhysBCFunct__u.html#afdf8afb39002a2daac0fc16a5db76d17',1,'ERFPhysBCFunct_u']]], - ['impose_5fvertical_5fyvel_5fbcs_1160',['impose_vertical_yvel_bcs',['../classERFPhysBCFunct__v.html#a9e295ac17321f4d577f1d103f6b665a2',1,'ERFPhysBCFunct_v']]], - ['impose_5fvertical_5fzvel_5fbcs_1161',['impose_vertical_zvel_bcs',['../classERFPhysBCFunct__w.html#a9225c49cf092c6eed2bf9bdf1ef4b9cf',1,'ERFPhysBCFunct_w']]], - ['include_5fsubgrid_5fvel_1162',['include_subgrid_vel',['../classMOSTAverage.html#ac3c62b4015d62ae8d1ad85cb6ad651ad',1,'MOSTAverage']]], - ['increment_1163',['increment',['../classTerrainPoisson.html#a675e172f3e8a103807ad776019242fdd',1,'TerrainPoisson']]], - ['inflow_1164',['inflow',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9ad37e67db17cfd059f2852e2673b9e8ef',1,'ERF_IndexDefines.H']]], - ['ingested_5fdensity_1165',['ingested_density',['../classReadBndryPlanes.html#ab54133701e8e086315fa7299257199a2',1,'ReadBndryPlanes']]], - ['ingested_5fke_1166',['ingested_KE',['../classReadBndryPlanes.html#a85a5f25c283db679f67e10167cc6ee5c',1,'ReadBndryPlanes']]], - ['ingested_5fq1_1167',['ingested_q1',['../classReadBndryPlanes.html#a02a0fca675471f10ea6ccb1671ce1cb0',1,'ReadBndryPlanes']]], - ['ingested_5fq2_1168',['ingested_q2',['../classReadBndryPlanes.html#abf22791c2eaf68739ffea26e370724df',1,'ReadBndryPlanes']]], - ['ingested_5fscalar_1169',['ingested_scalar',['../classReadBndryPlanes.html#a6051259f37b0f38a9d74de7b9405dd03',1,'ReadBndryPlanes']]], - ['ingested_5ftheta_1170',['ingested_theta',['../classReadBndryPlanes.html#ac306993497b4e668110e13c4eb7644ff',1,'ReadBndryPlanes']]], - ['ingested_5fvelocity_1171',['ingested_velocity',['../classReadBndryPlanes.html#a906352fe8d793c4360889429d8a5980d',1,'ReadBndryPlanes']]], - ['init_1172',['Init',['../classSLM.html#aef0a4802ed2d86fd1dedad55e51efc88',1,'SLM::Init()'],['../classMicrophysics.html#a4e781e2a953a088477cfc5a1e3691f2e',1,'Microphysics::Init()'],['../classEulerianMicrophysics.html#ac68028f2920ccb380c605099adb7d604',1,'EulerianMicrophysics::Init()']]], - ['init_1173',['init',['../classLinInterp.html#a00b249a492135098785c7cf3d2296a91',1,'LinInterp']]], - ['init_1174',['Init',['../classKessler.html#ab1eaffdd038f2eda89f44f150036a405',1,'Kessler::Init()'],['../classNullMoist.html#a6f526044328db858069e4b6a70fdbdf7',1,'NullMoist::Init()'],['../classSAM.html#a927f4531f9c2452e5b7fc7ab965c5b78',1,'SAM::Init()'],['../classNullSurf.html#a013feb9e94f957304bedbc26b6da16b0',1,'NullSurf::Init()'],['../classNOAH.html#ae0ff47476a81fcce3b170eec23033c27',1,'NOAH::Init()'],['../classMM5.html#a0471ac39485d05623f911cd9fd021b9a',1,'MM5::Init()'],['../classLandSurface.html#aac1216f5c2758361ddc016442f3c67cd',1,'LandSurface::Init()']]], + ['ice_5feffective_5fradius_1128',['ice_effective_radius',['../ERF__Parameterizations_8H.html#adec9d0652512bd8a82a6dcea536c9138',1,'ERF_Parameterizations.H']]], + ['ice_5ffile_1129',['ice_file',['../classCloudRadProps.html#a4bdca9fbb3d26b9b013ea06b9385017e',1,'CloudRadProps']]], + ['ice_5ftau_5fbnd_5flw_1130',['ice_tau_bnd_lw',['../classRadiation.html#ab4092f9e967d5107e1722b0345e31053',1,'Radiation']]], + ['ice_5ftau_5fbnd_5fsw_1131',['ice_tau_bnd_sw',['../classRadiation.html#aba4d37f5325c0d89476eb2595f976bc1',1,'Radiation']]], + ['icecldoptics_1132',['icecldoptics',['../classMamConstituents.html#a45adfa2e9bca7c7a7b0dd807779e94ac',1,'MamConstituents::icecldoptics()'],['../classOptics.html#a357f26f1bf42c917131a48782732ce03',1,'Optics::icecldoptics()']]], + ['icefall_1133',['IceFall',['../classSAM.html#a363b3bb27b6e6cdad8693363b3262419',1,'SAM']]], + ['iceopticsfile_1134',['iceopticsfile',['../classMamConstituents.html#a0e74835fc2592d78facf9e4d9ea36f1c',1,'MamConstituents']]], + ['icesize_5ftable_5fmin_5ftemp_1135',['icesize_table_min_temp',['../classRadConstants.html#ab527187d8cc457be894cb3b4d5f3a22b',1,'RadConstants']]], + ['iciwp_1136',['iciwp',['../classRadiation.html#aa24b1e1de58c5122b78fd6afae5f737b',1,'Radiation']]], + ['iclwp_1137',['iclwp',['../classRadiation.html#a9cedc778ea026393eace9912b4ec8d5b',1,'Radiation']]], + ['icswp_1138',['icswp',['../classRadiation.html#ad2d2f52fdb57d7a44cfb553a3b70d346',1,'Radiation']]], + ['idx_1139',['idx',['../structMamConstituents_1_1gas__t.html#a92407cc5cf2752a7f7626b6f034e2fd3',1,'MamConstituents::gas_t::idx()'],['../structMamConstituents_1_1aerosol__t.html#a417db05e152088ff32fa5ca0ed2fadcc',1,'MamConstituents::aerosol_t::idx()'],['../structMamConstituents_1_1modelist__t.html#a8b01fce25cf4e89d61786dc304af557a',1,'MamConstituents::modelist_t::idx()']]], + ['idx_5flw_5fdiag_1140',['idx_lw_diag',['../classRadConstants.html#a4be67e03614ad60a9a3e5b0a5296a232',1,'RadConstants']]], + ['idx_5fmmr_5fa_1141',['idx_mmr_a',['../structMamConstituents_1_1mode__component__t.html#a5325a6229804cf4ead4edd0ae3365368',1,'MamConstituents::mode_component_t']]], + ['idx_5fmmr_5fc_1142',['idx_mmr_c',['../structMamConstituents_1_1mode__component__t.html#a2068ed3ee6d1c031830fdd74950c9dab',1,'MamConstituents::mode_component_t']]], + ['idx_5fnir_5fdiag_1143',['idx_nir_diag',['../classRadConstants.html#a5eccb1fa499f9f02449912985f70aa8e',1,'RadConstants']]], + ['idx_5fnum_5fa_1144',['idx_num_a',['../structMamConstituents_1_1mode__component__t.html#a27f686068187bef4800b0f50d673f636',1,'MamConstituents::mode_component_t']]], + ['idx_5fnum_5fc_1145',['idx_num_c',['../structMamConstituents_1_1mode__component__t.html#afeac72ae7d7e859f79d4c4c2baf54473',1,'MamConstituents::mode_component_t']]], + ['idx_5fprops_1146',['idx_props',['../structMamConstituents_1_1mode__component__t.html#a7ee6b4be8e5ef923b0f0ac0d56a5ee6c',1,'MamConstituents::mode_component_t::idx_props()'],['../structMamConstituents_1_1modelist__t.html#a1e532f0738a48c0740d4af9f635bef5c',1,'MamConstituents::modelist_t::idx_props()']]], + ['idx_5fsw_5fdiag_1147',['idx_sw_diag',['../classRadConstants.html#aa8d069e0dd3bcec898e914167c02f4ee',1,'RadConstants']]], + ['idx_5fuv_5fdiag_1148',['idx_uv_diag',['../classRadConstants.html#ab6e2774dc2b5fbd26204c95bb601610c',1,'RadConstants']]], + ['igamma_1149',['iGamma',['../ERF__Constants_8H.html#ab24194b3b11ee04368e1087acda6bde7',1,'ERF_Constants.H']]], + ['ihirsfq_1150',['ihirsfq',['../classRadiation.html#aa15d7c4d015604b92db440a1c5b1c988',1,'Radiation']]], + ['imax_1151',['imax',['../classModalAeroWateruptake.html#a5cc5abb758503a218ee7331ce15abf4e',1,'ModalAeroWateruptake']]], + ['impose_5flateral_5fbasestate_5fbcs_1152',['impose_lateral_basestate_bcs',['../classERFPhysBCFunct__base.html#ab2d46cdc32a713b4eb40a5c3552ef947',1,'ERFPhysBCFunct_base']]], + ['impose_5flateral_5fcons_5fbcs_1153',['impose_lateral_cons_bcs',['../classERFPhysBCFunct__cons.html#ac8da4b078a7da0ba4a9adb727d885e58',1,'ERFPhysBCFunct_cons']]], + ['impose_5flateral_5fxvel_5fbcs_1154',['impose_lateral_xvel_bcs',['../classERFPhysBCFunct__u.html#a9b203cbd4f9a1fd40961067424ae5f81',1,'ERFPhysBCFunct_u']]], + ['impose_5flateral_5fyvel_5fbcs_1155',['impose_lateral_yvel_bcs',['../classERFPhysBCFunct__v.html#adee10e9098b1261837e642a76632c141',1,'ERFPhysBCFunct_v']]], + ['impose_5flateral_5fzvel_5fbcs_1156',['impose_lateral_zvel_bcs',['../classERFPhysBCFunct__w.html#a9cd6e53c9598fe025c3c78945c2b1b83',1,'ERFPhysBCFunct_w']]], + ['impose_5fmost_5fbcs_1157',['impose_most_bcs',['../classABLMost.html#aa6c480227398080885f5bd48466c71e0',1,'ABLMost']]], + ['impose_5fvertical_5fbasestate_5fbcs_1158',['impose_vertical_basestate_bcs',['../classERFPhysBCFunct__base.html#a16a0a73ad13172027fc38b4c427f71ff',1,'ERFPhysBCFunct_base']]], + ['impose_5fvertical_5fcons_5fbcs_1159',['impose_vertical_cons_bcs',['../classERFPhysBCFunct__cons.html#a1f0975393eb1c321d84d15734ae8cdf0',1,'ERFPhysBCFunct_cons']]], + ['impose_5fvertical_5fxvel_5fbcs_1160',['impose_vertical_xvel_bcs',['../classERFPhysBCFunct__u.html#afdf8afb39002a2daac0fc16a5db76d17',1,'ERFPhysBCFunct_u']]], + ['impose_5fvertical_5fyvel_5fbcs_1161',['impose_vertical_yvel_bcs',['../classERFPhysBCFunct__v.html#a9e295ac17321f4d577f1d103f6b665a2',1,'ERFPhysBCFunct_v']]], + ['impose_5fvertical_5fzvel_5fbcs_1162',['impose_vertical_zvel_bcs',['../classERFPhysBCFunct__w.html#a9225c49cf092c6eed2bf9bdf1ef4b9cf',1,'ERFPhysBCFunct_w']]], + ['include_5fsubgrid_5fvel_1163',['include_subgrid_vel',['../classMOSTAverage.html#ac3c62b4015d62ae8d1ad85cb6ad651ad',1,'MOSTAverage']]], + ['increment_1164',['increment',['../classTerrainPoisson.html#a675e172f3e8a103807ad776019242fdd',1,'TerrainPoisson']]], + ['inflow_1165',['inflow',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9ad37e67db17cfd059f2852e2673b9e8ef',1,'ERF_IndexDefines.H']]], + ['ingested_5fdensity_1166',['ingested_density',['../classReadBndryPlanes.html#ab54133701e8e086315fa7299257199a2',1,'ReadBndryPlanes']]], + ['ingested_5fke_1167',['ingested_KE',['../classReadBndryPlanes.html#a85a5f25c283db679f67e10167cc6ee5c',1,'ReadBndryPlanes']]], + ['ingested_5fq1_1168',['ingested_q1',['../classReadBndryPlanes.html#a02a0fca675471f10ea6ccb1671ce1cb0',1,'ReadBndryPlanes']]], + ['ingested_5fq2_1169',['ingested_q2',['../classReadBndryPlanes.html#abf22791c2eaf68739ffea26e370724df',1,'ReadBndryPlanes']]], + ['ingested_5fscalar_1170',['ingested_scalar',['../classReadBndryPlanes.html#a6051259f37b0f38a9d74de7b9405dd03',1,'ReadBndryPlanes']]], + ['ingested_5ftheta_1171',['ingested_theta',['../classReadBndryPlanes.html#ac306993497b4e668110e13c4eb7644ff',1,'ReadBndryPlanes']]], + ['ingested_5fvelocity_1172',['ingested_velocity',['../classReadBndryPlanes.html#a906352fe8d793c4360889429d8a5980d',1,'ReadBndryPlanes']]], + ['init_1173',['Init',['../classNullSurf.html#a013feb9e94f957304bedbc26b6da16b0',1,'NullSurf::Init()'],['../classEulerianMicrophysics.html#ac68028f2920ccb380c605099adb7d604',1,'EulerianMicrophysics::Init()'],['../classSLM.html#aef0a4802ed2d86fd1dedad55e51efc88',1,'SLM::Init()'],['../classSAM.html#a927f4531f9c2452e5b7fc7ab965c5b78',1,'SAM::Init()'],['../classMicrophysics.html#a4e781e2a953a088477cfc5a1e3691f2e',1,'Microphysics::Init()'],['../classKessler.html#ab1eaffdd038f2eda89f44f150036a405',1,'Kessler::Init()'],['../classNullMoist.html#a6f526044328db858069e4b6a70fdbdf7',1,'NullMoist::Init()'],['../classNOAH.html#ae0ff47476a81fcce3b170eec23033c27',1,'NOAH::Init()'],['../classMM5.html#a0471ac39485d05623f911cd9fd021b9a',1,'MM5::Init()'],['../classLandSurface.html#aac1216f5c2758361ddc016442f3c67cd',1,'LandSurface::Init()']]], + ['init_1174',['init',['../classLinInterp.html#a00b249a492135098785c7cf3d2296a91',1,'LinInterp']]], ['init1darrays_1175',['init1DArrays',['../classERF.html#a7261c4eb7722af0dfe6cdfb8e2e9e4db',1,'ERF']]], ['init_5fbase_5fparms_1176',['init_base_parms',['../classProblemBase.html#abac6929cfbd9298447e721dfcbe5163f',1,'ProblemBase']]], ['init_5fbase_5fstate_5ffrom_5fmetgrid_1177',['init_base_state_from_metgrid',['../ERF__Metgrid__utils_8H.html#ad127bd2619dfdddcebfb71049433659f',1,'ERF_Metgrid_utils.H']]], diff --git a/search/all_d.js b/search/all_d.js index e7335d9c7..325bf1fbb 100644 --- a/search/all_d.js +++ b/search/all_d.js @@ -1,8 +1,8 @@ var searchData= [ ['n_5fbld_5fsections_1639',['n_bld_sections',['../classWindFarm.html#a9e263152650471997aa43658904bc563',1,'WindFarm']]], - ['n_5fdiag_1640',['n_diag',['../classMam4__aer.html#afe4495578dc4adefe7b2ab2780aee8ee',1,'Mam4_aer']]], - ['n_5fdiag_1641',['N_DIAG',['../classMamConstituents.html#a05b4d113513de18b2e7bbdc4e9cb4dbf',1,'MamConstituents']]], + ['n_5fdiag_1640',['N_DIAG',['../classMamConstituents.html#a05b4d113513de18b2e7bbdc4e9cb4dbf',1,'MamConstituents']]], + ['n_5fdiag_1641',['n_diag',['../classMam4__aer.html#afe4495578dc4adefe7b2ab2780aee8ee',1,'Mam4_aer']]], ['n_5fg_5fd_1642',['n_g_d',['../classCloudRadProps.html#a40e14de999dd323f0cc8db50f46031e8',1,'CloudRadProps']]], ['n_5frad_5fcnst_1643',['n_rad_cnst',['../classMamConstituents.html#a75a27a90ef149368fc0a7676daeb4a84',1,'MamConstituents']]], ['n_5fsounding_5ffiles_1644',['n_sounding_files',['../structInputSoundingData.html#a5655f2f77d75c1b8a2abd92a0b264813',1,'InputSoundingData']]], diff --git a/search/defines_0.js b/search/defines_0.js index 034a15084..091644a06 100644 --- a/search/defines_0.js +++ b/search/defines_0.js @@ -1,4 +1,4 @@ var searchData= [ - ['abort_5ffunc_5347',['abort_func',['../ERF__NCInterface_8cpp.html#aa67f9bcab4a9da3e92f2e2f3b4ec5979',1,'ERF_NCInterface.cpp']]] + ['abort_5ffunc_5349',['abort_func',['../ERF__NCInterface_8cpp.html#aa67f9bcab4a9da3e92f2e2f3b4ec5979',1,'ERF_NCInterface.cpp']]] ]; diff --git a/search/defines_1.js b/search/defines_1.js index 26d838069..e23ecf5a3 100644 --- a/search/defines_1.js +++ b/search/defines_1.js @@ -1,9 +1,9 @@ var searchData= [ - ['nbcvar_5fmax_5348',['NBCVAR_max',['../ERF__IndexDefines_8H.html#a536619efb901de654431f987753ac67c',1,'ERF_IndexDefines.H']]], - ['ndry_5349',['NDRY',['../ERF__IndexDefines_8H.html#a38d6fda9ca3d40309838c64d398b54c1',1,'ERF_IndexDefines.H']]], - ['nmoist_5fmax_5350',['NMOIST_max',['../ERF__IndexDefines_8H.html#abe87e298e9d558e0659a67ad3b9be71f',1,'ERF_IndexDefines.H']]], - ['nprimvar_5fmax_5351',['NPRIMVAR_max',['../ERF__IndexDefines_8H.html#a19169754519601f5fe52ede728af2138',1,'ERF_IndexDefines.H']]], - ['nscalars_5352',['NSCALARS',['../ERF__IndexDefines_8H.html#a6773f201eef9644a5d5b7252f6d95ce9',1,'ERF_IndexDefines.H']]], - ['nvar_5fmax_5353',['NVAR_max',['../ERF__IndexDefines_8H.html#a46e292b965f80d15acfbdc11ffe1e0f0',1,'ERF_IndexDefines.H']]] + ['nbcvar_5fmax_5350',['NBCVAR_max',['../ERF__IndexDefines_8H.html#a536619efb901de654431f987753ac67c',1,'ERF_IndexDefines.H']]], + ['ndry_5351',['NDRY',['../ERF__IndexDefines_8H.html#a38d6fda9ca3d40309838c64d398b54c1',1,'ERF_IndexDefines.H']]], + ['nmoist_5fmax_5352',['NMOIST_max',['../ERF__IndexDefines_8H.html#abe87e298e9d558e0659a67ad3b9be71f',1,'ERF_IndexDefines.H']]], + ['nprimvar_5fmax_5353',['NPRIMVAR_max',['../ERF__IndexDefines_8H.html#a19169754519601f5fe52ede728af2138',1,'ERF_IndexDefines.H']]], + ['nscalars_5354',['NSCALARS',['../ERF__IndexDefines_8H.html#a6773f201eef9644a5d5b7252f6d95ce9',1,'ERF_IndexDefines.H']]], + ['nvar_5fmax_5355',['NVAR_max',['../ERF__IndexDefines_8H.html#a46e292b965f80d15acfbdc11ffe1e0f0',1,'ERF_IndexDefines.H']]] ]; diff --git a/search/defines_2.js b/search/defines_2.js index cef39d50e..b9923f98a 100644 --- a/search/defines_2.js +++ b/search/defines_2.js @@ -1,12 +1,12 @@ var searchData= [ - ['primke_5fcomp_5354',['PrimKE_comp',['../ERF__IndexDefines_8H.html#a9ab6bf01b348d4b7cef99f3655c9dbb2',1,'ERF_IndexDefines.H']]], - ['primq1_5fcomp_5355',['PrimQ1_comp',['../ERF__IndexDefines_8H.html#a046484d86c968f85c3b8e574c1fe3e29',1,'ERF_IndexDefines.H']]], - ['primq2_5fcomp_5356',['PrimQ2_comp',['../ERF__IndexDefines_8H.html#a2564ef35937a97a2a6c90ca51ae7cdf3',1,'ERF_IndexDefines.H']]], - ['primq3_5fcomp_5357',['PrimQ3_comp',['../ERF__IndexDefines_8H.html#ac6f3d51b14f04acc045d644f32375c6d',1,'ERF_IndexDefines.H']]], - ['primq4_5fcomp_5358',['PrimQ4_comp',['../ERF__IndexDefines_8H.html#a2e038955a3c380beab1941e422ef83ea',1,'ERF_IndexDefines.H']]], - ['primq5_5fcomp_5359',['PrimQ5_comp',['../ERF__IndexDefines_8H.html#a7f9c844ee8a2e1930ade0911e8692667',1,'ERF_IndexDefines.H']]], - ['primq6_5fcomp_5360',['PrimQ6_comp',['../ERF__IndexDefines_8H.html#a4d0a4735b7019c88a28b42c3d4787154',1,'ERF_IndexDefines.H']]], - ['primscalar_5fcomp_5361',['PrimScalar_comp',['../ERF__IndexDefines_8H.html#aa9d1308b0d214f7bfbe9b8c11c4176b7',1,'ERF_IndexDefines.H']]], - ['primtheta_5fcomp_5362',['PrimTheta_comp',['../ERF__IndexDefines_8H.html#a8b9c5b827b61f426a3879bc5d2883040',1,'ERF_IndexDefines.H']]] + ['primke_5fcomp_5356',['PrimKE_comp',['../ERF__IndexDefines_8H.html#a9ab6bf01b348d4b7cef99f3655c9dbb2',1,'ERF_IndexDefines.H']]], + ['primq1_5fcomp_5357',['PrimQ1_comp',['../ERF__IndexDefines_8H.html#a046484d86c968f85c3b8e574c1fe3e29',1,'ERF_IndexDefines.H']]], + ['primq2_5fcomp_5358',['PrimQ2_comp',['../ERF__IndexDefines_8H.html#a2564ef35937a97a2a6c90ca51ae7cdf3',1,'ERF_IndexDefines.H']]], + ['primq3_5fcomp_5359',['PrimQ3_comp',['../ERF__IndexDefines_8H.html#ac6f3d51b14f04acc045d644f32375c6d',1,'ERF_IndexDefines.H']]], + ['primq4_5fcomp_5360',['PrimQ4_comp',['../ERF__IndexDefines_8H.html#a2e038955a3c380beab1941e422ef83ea',1,'ERF_IndexDefines.H']]], + ['primq5_5fcomp_5361',['PrimQ5_comp',['../ERF__IndexDefines_8H.html#a7f9c844ee8a2e1930ade0911e8692667',1,'ERF_IndexDefines.H']]], + ['primq6_5fcomp_5362',['PrimQ6_comp',['../ERF__IndexDefines_8H.html#a4d0a4735b7019c88a28b42c3d4787154',1,'ERF_IndexDefines.H']]], + ['primscalar_5fcomp_5363',['PrimScalar_comp',['../ERF__IndexDefines_8H.html#aa9d1308b0d214f7bfbe9b8c11c4176b7',1,'ERF_IndexDefines.H']]], + ['primtheta_5fcomp_5364',['PrimTheta_comp',['../ERF__IndexDefines_8H.html#a8b9c5b827b61f426a3879bc5d2883040',1,'ERF_IndexDefines.H']]] ]; diff --git a/search/defines_3.js b/search/defines_3.js index f1131ee01..3a75e9a3f 100644 --- a/search/defines_3.js +++ b/search/defines_3.js @@ -1,13 +1,13 @@ var searchData= [ - ['rho_5fcomp_5363',['Rho_comp',['../ERF__IndexDefines_8H.html#a27dcc910aeb002a0fd44727954dc0e49',1,'ERF_IndexDefines.H']]], - ['rhoke_5fcomp_5364',['RhoKE_comp',['../ERF__IndexDefines_8H.html#ae15721db2cb4c2ab4732afe226bbba64',1,'ERF_IndexDefines.H']]], - ['rhoq1_5fcomp_5365',['RhoQ1_comp',['../ERF__IndexDefines_8H.html#aa965e9988f14d5d2a5aef4a942168a15',1,'ERF_IndexDefines.H']]], - ['rhoq2_5fcomp_5366',['RhoQ2_comp',['../ERF__IndexDefines_8H.html#a3bf0a4783e82ba30db2b7c0a332c2f16',1,'ERF_IndexDefines.H']]], - ['rhoq3_5fcomp_5367',['RhoQ3_comp',['../ERF__IndexDefines_8H.html#a49fe20d81f4d923a4a6ec4eb1652072b',1,'ERF_IndexDefines.H']]], - ['rhoq4_5fcomp_5368',['RhoQ4_comp',['../ERF__IndexDefines_8H.html#a28c5deab9008c0999c26affeff2fa6da',1,'ERF_IndexDefines.H']]], - ['rhoq5_5fcomp_5369',['RhoQ5_comp',['../ERF__IndexDefines_8H.html#ac46d015fd5b1ee0060bbaf22e79113e7',1,'ERF_IndexDefines.H']]], - ['rhoq6_5fcomp_5370',['RhoQ6_comp',['../ERF__IndexDefines_8H.html#aae057dae5f599b944184a0ecf7801064',1,'ERF_IndexDefines.H']]], - ['rhoscalar_5fcomp_5371',['RhoScalar_comp',['../ERF__IndexDefines_8H.html#a0296f21cd48e5d8236c62ae4ce319b2f',1,'ERF_IndexDefines.H']]], - ['rhotheta_5fcomp_5372',['RhoTheta_comp',['../ERF__IndexDefines_8H.html#a28f96fd04e1ff08fa7a8f53ccde0f877',1,'ERF_IndexDefines.H']]] + ['rho_5fcomp_5365',['Rho_comp',['../ERF__IndexDefines_8H.html#a27dcc910aeb002a0fd44727954dc0e49',1,'ERF_IndexDefines.H']]], + ['rhoke_5fcomp_5366',['RhoKE_comp',['../ERF__IndexDefines_8H.html#ae15721db2cb4c2ab4732afe226bbba64',1,'ERF_IndexDefines.H']]], + ['rhoq1_5fcomp_5367',['RhoQ1_comp',['../ERF__IndexDefines_8H.html#aa965e9988f14d5d2a5aef4a942168a15',1,'ERF_IndexDefines.H']]], + ['rhoq2_5fcomp_5368',['RhoQ2_comp',['../ERF__IndexDefines_8H.html#a3bf0a4783e82ba30db2b7c0a332c2f16',1,'ERF_IndexDefines.H']]], + ['rhoq3_5fcomp_5369',['RhoQ3_comp',['../ERF__IndexDefines_8H.html#a49fe20d81f4d923a4a6ec4eb1652072b',1,'ERF_IndexDefines.H']]], + ['rhoq4_5fcomp_5370',['RhoQ4_comp',['../ERF__IndexDefines_8H.html#a28c5deab9008c0999c26affeff2fa6da',1,'ERF_IndexDefines.H']]], + ['rhoq5_5fcomp_5371',['RhoQ5_comp',['../ERF__IndexDefines_8H.html#ac46d015fd5b1ee0060bbaf22e79113e7',1,'ERF_IndexDefines.H']]], + ['rhoq6_5fcomp_5372',['RhoQ6_comp',['../ERF__IndexDefines_8H.html#aae057dae5f599b944184a0ecf7801064',1,'ERF_IndexDefines.H']]], + ['rhoscalar_5fcomp_5373',['RhoScalar_comp',['../ERF__IndexDefines_8H.html#a0296f21cd48e5d8236c62ae4ce319b2f',1,'ERF_IndexDefines.H']]], + ['rhotheta_5fcomp_5374',['RhoTheta_comp',['../ERF__IndexDefines_8H.html#a28f96fd04e1ff08fa7a8f53ccde0f877',1,'ERF_IndexDefines.H']]] ]; diff --git a/search/defines_4.js b/search/defines_4.js index 5b2059600..332ecfe76 100644 --- a/search/defines_4.js +++ b/search/defines_4.js @@ -1,4 +1,4 @@ var searchData= [ - ['use_5fvolume_5faverage_5373',['USE_VOLUME_AVERAGE',['../ERF__TurbPertStruct_8H.html#a1cd6e2210df20afb1fdec3183cbef7ba',1,'ERF_TurbPertStruct.H']]] + ['use_5fvolume_5faverage_5375',['USE_VOLUME_AVERAGE',['../ERF__TurbPertStruct_8H.html#a1cd6e2210df20afb1fdec3183cbef7ba',1,'ERF_TurbPertStruct.H']]] ]; diff --git a/search/enums_0.js b/search/enums_0.js index 342225afa..a859f6073 100644 --- a/search/enums_0.js +++ b/search/enums_0.js @@ -1,4 +1,4 @@ var searchData= [ - ['advtype_5183',['AdvType',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70',1,'ERF_IndexDefines.H']]] + ['advtype_5185',['AdvType',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70',1,'ERF_IndexDefines.H']]] ]; diff --git a/search/enums_1.js b/search/enums_1.js index 74721da7d..f09580d46 100644 --- a/search/enums_1.js +++ b/search/enums_1.js @@ -1,4 +1,4 @@ var searchData= [ - ['coord_5184',['Coord',['../ERF__DataStruct_8H.html#a627f1f843904477f763577ad1460de01',1,'ERF_DataStruct.H']]] + ['coord_5186',['Coord',['../ERF__DataStruct_8H.html#a627f1f843904477f763577ad1460de01',1,'ERF_DataStruct.H']]] ]; diff --git a/search/enums_2.js b/search/enums_2.js index 483fcc2c9..2c5d9fc62 100644 --- a/search/enums_2.js +++ b/search/enums_2.js @@ -1,4 +1,4 @@ var searchData= [ - ['erf_5fbc_5185',['ERF_BC',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9',1,'ERF_IndexDefines.H']]] + ['erf_5fbc_5187',['ERF_BC',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9',1,'ERF_IndexDefines.H']]] ]; diff --git a/search/enums_3.js b/search/enums_3.js index 5626804c7..4e58cf279 100644 --- a/search/enums_3.js +++ b/search/enums_3.js @@ -1,4 +1,4 @@ var searchData= [ - ['fluxcalctype_5186',['FluxCalcType',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0',1,'ABLMost']]] + ['fluxcalctype_5188',['FluxCalcType',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0',1,'ABLMost']]] ]; diff --git a/search/enums_4.js b/search/enums_4.js index 5da031d52..77f6c695f 100644 --- a/search/enums_4.js +++ b/search/enums_4.js @@ -1,4 +1,4 @@ var searchData= [ - ['interpmethod_5187',['InterpMethod',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2',1,'LinInterp']]] + ['interpmethod_5189',['InterpMethod',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2',1,'LinInterp']]] ]; diff --git a/search/enums_5.js b/search/enums_5.js index 333ba75b3..b746cdaa9 100644 --- a/search/enums_5.js +++ b/search/enums_5.js @@ -1,6 +1,6 @@ var searchData= [ - ['mathematicalbndrytypes_5188',['mathematicalBndryTypes',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01c',1,'ERFBCType']]], - ['molecdifftype_5189',['MolecDiffType',['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735',1,'ERF_DiffStruct.H']]], - ['mynnconfigtype_5190',['MYNNConfigType',['../ERF__MYNNStruct_8H.html#a103de8b695a78549c43fa852d9c4dd25',1,'ERF_MYNNStruct.H']]] + ['mathematicalbndrytypes_5190',['mathematicalBndryTypes',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01c',1,'ERFBCType']]], + ['molecdifftype_5191',['MolecDiffType',['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735',1,'ERF_DiffStruct.H']]], + ['mynnconfigtype_5192',['MYNNConfigType',['../ERF__MYNNStruct_8H.html#a103de8b695a78549c43fa852d9c4dd25',1,'ERF_MYNNStruct.H']]] ]; diff --git a/search/enums_6.js b/search/enums_6.js index 500f48bf7..6a6d06b2b 100644 --- a/search/enums_6.js +++ b/search/enums_6.js @@ -1,4 +1,4 @@ var searchData= [ - ['nc_5fdata_5fdims_5ftype_5191',['NC_Data_Dims_Type',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06',1,'ERF_NCWpsFile.H']]] + ['nc_5fdata_5fdims_5ftype_5193',['NC_Data_Dims_Type',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06',1,'ERF_NCWpsFile.H']]] ]; diff --git a/search/enums_7.js b/search/enums_7.js index ba6d47880..c86506bad 100644 --- a/search/enums_7.js +++ b/search/enums_7.js @@ -1,4 +1,4 @@ var searchData= [ - ['pblheightcalctype_5192',['PBLHeightCalcType',['../classABLMost.html#acf73526a7a2b05be8d48c0af94742841',1,'ABLMost']]] + ['pblheightcalctype_5194',['PBLHeightCalcType',['../classABLMost.html#acf73526a7a2b05be8d48c0af94742841',1,'ABLMost']]] ]; diff --git a/search/enums_8.js b/search/enums_8.js index ad98b6d38..472f2f388 100644 --- a/search/enums_8.js +++ b/search/enums_8.js @@ -1,5 +1,5 @@ var searchData= [ - ['rayleigh_5193',['Rayleigh',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239',1,'ERF_DataStruct.H']]], - ['roughcalctype_5194',['RoughCalcType',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13',1,'ABLMost']]] + ['rayleigh_5195',['Rayleigh',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239',1,'ERF_DataStruct.H']]], + ['roughcalctype_5196',['RoughCalcType',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13',1,'ABLMost']]] ]; diff --git a/search/enums_9.js b/search/enums_9.js index c8e350698..40a52a419 100644 --- a/search/enums_9.js +++ b/search/enums_9.js @@ -1,4 +1,4 @@ var searchData= [ - ['sponge_5195',['Sponge',['../ERF__DataStruct_8H.html#a5bebd9ff4e2455172deca3b399214fcb',1,'ERF_DataStruct.H']]] + ['sponge_5197',['Sponge',['../ERF__DataStruct_8H.html#a5bebd9ff4e2455172deca3b399214fcb',1,'ERF_DataStruct.H']]] ]; diff --git a/search/enums_a.js b/search/enums_a.js index c08ad7abd..fc6361b74 100644 --- a/search/enums_a.js +++ b/search/enums_a.js @@ -1,5 +1,5 @@ var searchData= [ - ['thetacalctype_5196',['ThetaCalcType',['../classABLMost.html#a46fbd9260d2adfa7c18edad6452f9bab',1,'ABLMost']]], - ['type_5197',['Type',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7',1,'SatMethods']]] + ['thetacalctype_5198',['ThetaCalcType',['../classABLMost.html#a46fbd9260d2adfa7c18edad6452f9bab',1,'ABLMost']]], + ['type_5199',['Type',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7',1,'SatMethods']]] ]; diff --git a/search/enums_b.js b/search/enums_b.js index eb1163dd3..a678aed5a 100644 --- a/search/enums_b.js +++ b/search/enums_b.js @@ -1,4 +1,4 @@ var searchData= [ - ['units_5198',['Units',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1',1,'RadConstants']]] + ['units_5200',['Units',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1',1,'RadConstants']]] ]; diff --git a/search/enumvalues_0.js b/search/enumvalues_0.js index ea327629a..e270766a1 100644 --- a/search/enumvalues_0.js +++ b/search/enumvalues_0.js @@ -1,4 +1,4 @@ var searchData= [ - ['adiabatic_5199',['ADIABATIC',['../classABLMost.html#a46fbd9260d2adfa7c18edad6452f9baba10548012f42e962e7945ce998b571c5c',1,'ABLMost']]] + ['adiabatic_5201',['ADIABATIC',['../classABLMost.html#a46fbd9260d2adfa7c18edad6452f9baba10548012f42e962e7945ce998b571c5c',1,'ABLMost']]] ]; diff --git a/search/enumvalues_1.js b/search/enumvalues_1.js index f2607e287..8c416e579 100644 --- a/search/enumvalues_1.js +++ b/search/enumvalues_1.js @@ -1,6 +1,6 @@ var searchData= [ - ['base_5fbc_5200',['base_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa970567f2fd13e49ae300e8d39fd2ae30',1,'BCVars']]], - ['bogus_5201',['bogus',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca5e7251ff4badd9a198c0601a7929b1c4',1,'ERFBCType']]], - ['bolton_5202',['Bolton',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7aad1ba505f7c25afbfb5c6fe45f03789d',1,'SatMethods']]] + ['base_5fbc_5202',['base_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa970567f2fd13e49ae300e8d39fd2ae30',1,'BCVars']]], + ['bogus_5203',['bogus',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca5e7251ff4badd9a198c0601a7929b1c4',1,'ERFBCType']]], + ['bolton_5204',['Bolton',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7aad1ba505f7c25afbfb5c6fe45f03789d',1,'SatMethods']]] ]; diff --git a/search/enumvalues_10.js b/search/enumvalues_10.js index 58a9e2781..b27c809ef 100644 --- a/search/enumvalues_10.js +++ b/search/enumvalues_10.js @@ -1,9 +1,9 @@ var searchData= [ - ['scalar_5fh_5293',['Scalar_h',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea85d322ae06bc4f66f791d4eda0a13ae6',1,'EddyDiff']]], - ['scalar_5fv_5294',['Scalar_v',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea2b82a72be137b3159e7d4945735fcbf5',1,'EddyDiff']]], - ['slip_5fwall_5295',['slip_wall',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a03ee6de9fd100444c5c0567ea01bd538',1,'ERF_IndexDefines.H']]], - ['snow_5faccum_5296',['snow_accum',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a310c28c6a2a5e209f43302921d535af2',1,'MicVar']]], - ['surface_5ftemperature_5297',['SURFACE_TEMPERATURE',['../classABLMost.html#a46fbd9260d2adfa7c18edad6452f9baba317cef85d14b4909f1d76becb00dc0f1',1,'ABLMost']]], - ['symmetry_5298',['symmetry',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a40e712f30d56083318ab20a2402921d2',1,'ERF_IndexDefines.H']]] + ['scalar_5fh_5295',['Scalar_h',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea85d322ae06bc4f66f791d4eda0a13ae6',1,'EddyDiff']]], + ['scalar_5fv_5296',['Scalar_v',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea2b82a72be137b3159e7d4945735fcbf5',1,'EddyDiff']]], + ['slip_5fwall_5297',['slip_wall',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a03ee6de9fd100444c5c0567ea01bd538',1,'ERF_IndexDefines.H']]], + ['snow_5faccum_5298',['snow_accum',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a310c28c6a2a5e209f43302921d535af2',1,'MicVar']]], + ['surface_5ftemperature_5299',['SURFACE_TEMPERATURE',['../classABLMost.html#a46fbd9260d2adfa7c18edad6452f9baba317cef85d14b4909f1d76becb00dc0f1',1,'ABLMost']]], + ['symmetry_5300',['symmetry',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a40e712f30d56083318ab20a2402921d2',1,'ERF_IndexDefines.H']]] ]; diff --git a/search/enumvalues_11.js b/search/enumvalues_11.js index e396b878a..ebf355188 100644 --- a/search/enumvalues_11.js +++ b/search/enumvalues_11.js @@ -1,19 +1,19 @@ var searchData= [ - ['t_5299',['T',['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a1e7df4966430ffdaa4bb7bbd0f8a6d02',1,'WRFBdyVars::T()'],['../namespaceMetGridBdyVars.html#a22bd27d0288d22c74bd7c0bb57b2b89faba8b3d297f43d3f8d507b19ff6e21757',1,'MetGridBdyVars::T()'],['../namespaceRealBdyVars.html#aa4743649b85ade11df23692d7c3947bda8ecd2dbb16824e5c68db7daf2254fc79',1,'RealBdyVars::T()']]], - ['tabs_5300',['tabs',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea7cde81843cd190a3122d7c3912a39b74',1,'MicVar_Kess::tabs()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8aaf3c3122dd3954fe2b19abfc5c27b3dc',1,'MicVar::tabs()']]], - ['th0_5fcomp_5301',['th0_comp',['../namespaceBaseState.html#a6f8dc3597225ea7941dad615e7f22e91aaf394bbf6aa8da56fc479f2ed5a2a372',1,'BaseState']]], - ['theta_5302',['theta',['../namespaceLsmVar__MM5.html#a0c17a1ae9d9db120b8947e6da767cd3baf198df5800148ff3680d005b5fb09c68',1,'LsmVar_MM5::theta()'],['../namespaceLsmVar__SLM.html#a9927bc85abdc2fa6040b222a6c1ddd91a8cbbe7ff58f91759c10f65b097bcfc0f',1,'LsmVar_SLM::theta()'],['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea8e4ed7630edede7500eef0da31218c36',1,'MicVar_Kess::theta()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a96295e93c39d249775ba2498eb3d4fc1',1,'MicVar::theta()']]], - ['theta_5fh_5303',['Theta_h',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ead0cfc6c50b43867895cbc2c02eb2b99a',1,'EddyDiff']]], - ['theta_5fv_5304',['Theta_v',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea0af64d676c5c6f4312eb892f9a7a46cd',1,'EddyDiff']]], - ['thetabar_5305',['thetabar',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239ae41e9f65f26ee3b04db07f2db7f28bdb',1,'ERF_DataStruct.H']]], - ['time_5306',['Time',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06aa76d4ef5f3f6a672bbfab2865563e530',1,'ERF_NCWpsFile.H']]], - ['time_5fbdywidth_5fbt_5fsn_5307',['Time_BdyWidth_BT_SN',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06a2f43039d16fd9942908dc0b55b462b18',1,'ERF_NCWpsFile.H']]], - ['time_5fbdywidth_5fbt_5fwe_5308',['Time_BdyWidth_BT_WE',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06aaa684fa862f886663c11fcad18416550',1,'ERF_NCWpsFile.H']]], - ['time_5fbdywidth_5fsn_5309',['Time_BdyWidth_SN',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06a7d998330c55b56c1e46c449b2e39e89f',1,'ERF_NCWpsFile.H']]], - ['time_5fbdywidth_5fwe_5310',['Time_BdyWidth_WE',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06a1bfaf1bd09d922faf1b4bb0ffb3a6ec3',1,'ERF_NCWpsFile.H']]], - ['time_5fbt_5311',['Time_BT',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06a539ca443eab3c322b2b37046e896dc62',1,'ERF_NCWpsFile.H']]], - ['time_5fbt_5fsn_5fwe_5312',['Time_BT_SN_WE',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06aa3968158227ea04595d4003503cca22b',1,'ERF_NCWpsFile.H']]], - ['time_5fsn_5fwe_5313',['Time_SN_WE',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06a5f93bace93896872075eae75770cadc4',1,'ERF_NCWpsFile.H']]], - ['turb_5flengthscale_5314',['Turb_lengthscale',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea1fd996857fe3699ac7f9454e88d6ae76',1,'EddyDiff']]] + ['t_5301',['T',['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a1e7df4966430ffdaa4bb7bbd0f8a6d02',1,'WRFBdyVars::T()'],['../namespaceMetGridBdyVars.html#a22bd27d0288d22c74bd7c0bb57b2b89faba8b3d297f43d3f8d507b19ff6e21757',1,'MetGridBdyVars::T()'],['../namespaceRealBdyVars.html#aa4743649b85ade11df23692d7c3947bda8ecd2dbb16824e5c68db7daf2254fc79',1,'RealBdyVars::T()']]], + ['tabs_5302',['tabs',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea7cde81843cd190a3122d7c3912a39b74',1,'MicVar_Kess::tabs()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8aaf3c3122dd3954fe2b19abfc5c27b3dc',1,'MicVar::tabs()']]], + ['th0_5fcomp_5303',['th0_comp',['../namespaceBaseState.html#a6f8dc3597225ea7941dad615e7f22e91aaf394bbf6aa8da56fc479f2ed5a2a372',1,'BaseState']]], + ['theta_5304',['theta',['../namespaceLsmVar__MM5.html#a0c17a1ae9d9db120b8947e6da767cd3baf198df5800148ff3680d005b5fb09c68',1,'LsmVar_MM5::theta()'],['../namespaceLsmVar__SLM.html#a9927bc85abdc2fa6040b222a6c1ddd91a8cbbe7ff58f91759c10f65b097bcfc0f',1,'LsmVar_SLM::theta()'],['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea8e4ed7630edede7500eef0da31218c36',1,'MicVar_Kess::theta()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a96295e93c39d249775ba2498eb3d4fc1',1,'MicVar::theta()']]], + ['theta_5fh_5305',['Theta_h',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ead0cfc6c50b43867895cbc2c02eb2b99a',1,'EddyDiff']]], + ['theta_5fv_5306',['Theta_v',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea0af64d676c5c6f4312eb892f9a7a46cd',1,'EddyDiff']]], + ['thetabar_5307',['thetabar',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239ae41e9f65f26ee3b04db07f2db7f28bdb',1,'ERF_DataStruct.H']]], + ['time_5308',['Time',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06aa76d4ef5f3f6a672bbfab2865563e530',1,'ERF_NCWpsFile.H']]], + ['time_5fbdywidth_5fbt_5fsn_5309',['Time_BdyWidth_BT_SN',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06a2f43039d16fd9942908dc0b55b462b18',1,'ERF_NCWpsFile.H']]], + ['time_5fbdywidth_5fbt_5fwe_5310',['Time_BdyWidth_BT_WE',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06aaa684fa862f886663c11fcad18416550',1,'ERF_NCWpsFile.H']]], + ['time_5fbdywidth_5fsn_5311',['Time_BdyWidth_SN',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06a7d998330c55b56c1e46c449b2e39e89f',1,'ERF_NCWpsFile.H']]], + ['time_5fbdywidth_5fwe_5312',['Time_BdyWidth_WE',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06a1bfaf1bd09d922faf1b4bb0ffb3a6ec3',1,'ERF_NCWpsFile.H']]], + ['time_5fbt_5313',['Time_BT',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06a539ca443eab3c322b2b37046e896dc62',1,'ERF_NCWpsFile.H']]], + ['time_5fbt_5fsn_5fwe_5314',['Time_BT_SN_WE',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06aa3968158227ea04595d4003503cca22b',1,'ERF_NCWpsFile.H']]], + ['time_5fsn_5fwe_5315',['Time_SN_WE',['../ERF__NCWpsFile_8H.html#a147911bcb83952a10f7560fd4e9d8f06a5f93bace93896872075eae75770cadc4',1,'ERF_NCWpsFile.H']]], + ['turb_5flengthscale_5316',['Turb_lengthscale',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea1fd996857fe3699ac7f9454e88d6ae76',1,'EddyDiff']]] ]; diff --git a/search/enumvalues_12.js b/search/enumvalues_12.js index 7465579e1..70333fd67 100644 --- a/search/enumvalues_12.js +++ b/search/enumvalues_12.js @@ -1,10 +1,10 @@ var searchData= [ - ['u_5315',['U',['../namespaceRealBdyVars.html#aa4743649b85ade11df23692d7c3947bda18f2b09699f8c7ee3796d766f288f411',1,'RealBdyVars::U()'],['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582aa53bdf551bf25340a362d722eac4ab6f',1,'WRFBdyVars::U()'],['../namespaceMetGridBdyVars.html#a22bd27d0288d22c74bd7c0bb57b2b89fa378f42ee4d721483e332f15a50a6f3ea',1,'MetGridBdyVars::U()']]], - ['ubar_5316',['ubar',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239a3d2cdf8cea6cb933d4ce759c1ff1b948',1,'ERF_DataStruct.H']]], - ['ubar_5fsponge_5317',['ubar_sponge',['../ERF__DataStruct_8H.html#a5bebd9ff4e2455172deca3b399214fcbac159d9fae0d25be7ce907e1feb87cdaa',1,'ERF_DataStruct.H']]], - ['undefined_5318',['undefined',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a5e543256c480ac577d30f76f9120eb74',1,'ERF_IndexDefines.H']]], - ['unknown_5319',['Unknown',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a88183b946cc5f0e8c96b2e66e1c74a7e',1,'ERF_IndexDefines.H']]], - ['upwind_5f3rd_5320',['Upwind_3rd',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a40adf6565c1a31b2c72d8072412d0b9f',1,'ERF_IndexDefines.H']]], - ['upwind_5f5th_5321',['Upwind_5th',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a83aec89012c35752597047c6ebdd983a',1,'ERF_IndexDefines.H']]] + ['u_5317',['U',['../namespaceRealBdyVars.html#aa4743649b85ade11df23692d7c3947bda18f2b09699f8c7ee3796d766f288f411',1,'RealBdyVars::U()'],['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582aa53bdf551bf25340a362d722eac4ab6f',1,'WRFBdyVars::U()'],['../namespaceMetGridBdyVars.html#a22bd27d0288d22c74bd7c0bb57b2b89fa378f42ee4d721483e332f15a50a6f3ea',1,'MetGridBdyVars::U()']]], + ['ubar_5318',['ubar',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239a3d2cdf8cea6cb933d4ce759c1ff1b948',1,'ERF_DataStruct.H']]], + ['ubar_5fsponge_5319',['ubar_sponge',['../ERF__DataStruct_8H.html#a5bebd9ff4e2455172deca3b399214fcbac159d9fae0d25be7ce907e1feb87cdaa',1,'ERF_DataStruct.H']]], + ['undefined_5320',['undefined',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a5e543256c480ac577d30f76f9120eb74',1,'ERF_IndexDefines.H']]], + ['unknown_5321',['Unknown',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a88183b946cc5f0e8c96b2e66e1c74a7e',1,'ERF_IndexDefines.H']]], + ['upwind_5f3rd_5322',['Upwind_3rd',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a40adf6565c1a31b2c72d8072412d0b9f',1,'ERF_IndexDefines.H']]], + ['upwind_5f5th_5323',['Upwind_5th',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a83aec89012c35752597047c6ebdd983a',1,'ERF_IndexDefines.H']]] ]; diff --git a/search/enumvalues_13.js b/search/enumvalues_13.js index bea7411c9..c5410ac7e 100644 --- a/search/enumvalues_13.js +++ b/search/enumvalues_13.js @@ -1,6 +1,6 @@ var searchData= [ - ['v_5322',['V',['../namespaceRealBdyVars.html#aa4743649b85ade11df23692d7c3947bdaeb7c7786202be202372af9778caaa59a',1,'RealBdyVars::V()'],['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a4d00543cd0d6f68475152e954f5dfa43',1,'WRFBdyVars::V()'],['../namespaceMetGridBdyVars.html#a22bd27d0288d22c74bd7c0bb57b2b89fa648d295dcce3682ff094adbee4f946bf',1,'MetGridBdyVars::V()']]], - ['vbar_5323',['vbar',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239acb08c6a1b8bca5e9e4ef6162aef2cfa4',1,'ERF_DataStruct.H']]], - ['vbar_5fsponge_5324',['vbar_sponge',['../ERF__DataStruct_8H.html#a5bebd9ff4e2455172deca3b399214fcbaad1bdec1c0213a18483e81bcb4926964',1,'ERF_DataStruct.H']]] + ['v_5324',['V',['../namespaceRealBdyVars.html#aa4743649b85ade11df23692d7c3947bdaeb7c7786202be202372af9778caaa59a',1,'RealBdyVars::V()'],['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a4d00543cd0d6f68475152e954f5dfa43',1,'WRFBdyVars::V()'],['../namespaceMetGridBdyVars.html#a22bd27d0288d22c74bd7c0bb57b2b89fa648d295dcce3682ff094adbee4f946bf',1,'MetGridBdyVars::V()']]], + ['vbar_5325',['vbar',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239acb08c6a1b8bca5e9e4ef6162aef2cfa4',1,'ERF_DataStruct.H']]], + ['vbar_5fsponge_5326',['vbar_sponge',['../ERF__DataStruct_8H.html#a5bebd9ff4e2455172deca3b399214fcbaad1bdec1c0213a18483e81bcb4926964',1,'ERF_DataStruct.H']]] ]; diff --git a/search/enumvalues_14.js b/search/enumvalues_14.js index 451d1b1ec..ed73318eb 100644 --- a/search/enumvalues_14.js +++ b/search/enumvalues_14.js @@ -1,12 +1,12 @@ var searchData= [ - ['wave_5fcoupled_5325',['WAVE_COUPLED',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13a3e1545d84d0cc7da6edf47adda8a80f9',1,'ABLMost']]], - ['wbar_5326',['wbar',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239a3d8bd6001a2421b06c3ec4e9f2dcdffd',1,'ERF_DataStruct.H']]], - ['weno_5f3_5327',['Weno_3',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70ada35597e5f00fa867fe6e39d651a2195',1,'ERF_IndexDefines.H']]], - ['weno_5f3mzq_5328',['Weno_3MZQ',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70af8b942d20ed08b25df71ea1c87244210',1,'ERF_IndexDefines.H']]], - ['weno_5f3z_5329',['Weno_3Z',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a9c29b64a7627155706a1cd93682b4351',1,'ERF_IndexDefines.H']]], - ['weno_5f5_5330',['Weno_5',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70af2429e8de544f3ebd7c9668e3dbebaa8',1,'ERF_IndexDefines.H']]], - ['weno_5f5z_5331',['Weno_5Z',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70aeb75f5943c7837da80e2048f2b344efc',1,'ERF_IndexDefines.H']]], - ['weno_5f7_5332',['Weno_7',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a3095d588151e351b421893f62411d15e',1,'ERF_IndexDefines.H']]], - ['weno_5f7z_5333',['Weno_7Z',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a6edd20e2cefe2061bec0e1ebbf5c8573',1,'ERF_IndexDefines.H']]] + ['wave_5fcoupled_5327',['WAVE_COUPLED',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13a3e1545d84d0cc7da6edf47adda8a80f9',1,'ABLMost']]], + ['wbar_5328',['wbar',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239a3d8bd6001a2421b06c3ec4e9f2dcdffd',1,'ERF_DataStruct.H']]], + ['weno_5f3_5329',['Weno_3',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70ada35597e5f00fa867fe6e39d651a2195',1,'ERF_IndexDefines.H']]], + ['weno_5f3mzq_5330',['Weno_3MZQ',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70af8b942d20ed08b25df71ea1c87244210',1,'ERF_IndexDefines.H']]], + ['weno_5f3z_5331',['Weno_3Z',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a9c29b64a7627155706a1cd93682b4351',1,'ERF_IndexDefines.H']]], + ['weno_5f5_5332',['Weno_5',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70af2429e8de544f3ebd7c9668e3dbebaa8',1,'ERF_IndexDefines.H']]], + ['weno_5f5z_5333',['Weno_5Z',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70aeb75f5943c7837da80e2048f2b344efc',1,'ERF_IndexDefines.H']]], + ['weno_5f7_5334',['Weno_7',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a3095d588151e351b421893f62411d15e',1,'ERF_IndexDefines.H']]], + ['weno_5f7z_5335',['Weno_7Z',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a6edd20e2cefe2061bec0e1ebbf5c8573',1,'ERF_IndexDefines.H']]] ]; diff --git a/search/enumvalues_15.js b/search/enumvalues_15.js index fa1447045..834777806 100644 --- a/search/enumvalues_15.js +++ b/search/enumvalues_15.js @@ -1,7 +1,7 @@ var searchData= [ - ['x_5334',['x',['../ERF__DataStruct_8H.html#a627f1f843904477f763577ad1460de01a9dd4e461268c8034f5c8564e155c67a6',1,'ERF_DataStruct.H']]], - ['xmom_5335',['xmom',['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daaf661293a5a71ca532c214929b98c0bad',1,'IntVars']]], - ['xvel_5336',['xvel',['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a2a10a6e726515894b07621908abd4c0c',1,'Vars']]], - ['xvel_5fbc_5337',['xvel_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aab1782753c68aaad8632b0a7d575e57f4',1,'BCVars']]] + ['x_5336',['x',['../ERF__DataStruct_8H.html#a627f1f843904477f763577ad1460de01a9dd4e461268c8034f5c8564e155c67a6',1,'ERF_DataStruct.H']]], + ['xmom_5337',['xmom',['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daaf661293a5a71ca532c214929b98c0bad',1,'IntVars']]], + ['xvel_5338',['xvel',['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a2a10a6e726515894b07621908abd4c0c',1,'Vars']]], + ['xvel_5fbc_5339',['xvel_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aab1782753c68aaad8632b0a7d575e57f4',1,'BCVars']]] ]; diff --git a/search/enumvalues_16.js b/search/enumvalues_16.js index 309e5afbc..6d4dcd64c 100644 --- a/search/enumvalues_16.js +++ b/search/enumvalues_16.js @@ -1,8 +1,8 @@ var searchData= [ - ['y_5338',['y',['../ERF__DataStruct_8H.html#a627f1f843904477f763577ad1460de01a415290769594460e2e485922904f345d',1,'ERF_DataStruct.H']]], - ['ymom_5339',['ymom',['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daa2e60798bc45154a8f905b1aa228a24e5',1,'IntVars']]], - ['ysu_5340',['YSU',['../classABLMost.html#acf73526a7a2b05be8d48c0af94742841ad032bccff1ff2e272cc68da5a0de09fe',1,'ABLMost']]], - ['yvel_5341',['yvel',['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a81793b83204cfa56d4683bc676fbbfb6',1,'Vars']]], - ['yvel_5fbc_5342',['yvel_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa98ad22810fdfe9e585bc6481fc12454e',1,'BCVars']]] + ['y_5340',['y',['../ERF__DataStruct_8H.html#a627f1f843904477f763577ad1460de01a415290769594460e2e485922904f345d',1,'ERF_DataStruct.H']]], + ['ymom_5341',['ymom',['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daa2e60798bc45154a8f905b1aa228a24e5',1,'IntVars']]], + ['ysu_5342',['YSU',['../classABLMost.html#acf73526a7a2b05be8d48c0af94742841ad032bccff1ff2e272cc68da5a0de09fe',1,'ABLMost']]], + ['yvel_5343',['yvel',['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a81793b83204cfa56d4683bc676fbbfb6',1,'Vars']]], + ['yvel_5fbc_5344',['yvel_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa98ad22810fdfe9e585bc6481fc12454e',1,'BCVars']]] ]; diff --git a/search/enumvalues_17.js b/search/enumvalues_17.js index 8ff35fa06..7e90d5abc 100644 --- a/search/enumvalues_17.js +++ b/search/enumvalues_17.js @@ -1,7 +1,7 @@ var searchData= [ - ['z_5343',['z',['../ERF__DataStruct_8H.html#a627f1f843904477f763577ad1460de01afbade9e36a3f36d3d676c1b808451dd7',1,'ERF_DataStruct.H']]], - ['zmom_5344',['zmom',['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daaaab25f707cae69bfadac2abcd17a2188',1,'IntVars']]], - ['zvel_5345',['zvel',['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a48ee63b17bc216e9661511c33c68bd8b',1,'Vars']]], - ['zvel_5fbc_5346',['zvel_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa03b35ec9e83f34bb1349a86965d34e34',1,'BCVars']]] + ['z_5345',['z',['../ERF__DataStruct_8H.html#a627f1f843904477f763577ad1460de01afbade9e36a3f36d3d676c1b808451dd7',1,'ERF_DataStruct.H']]], + ['zmom_5346',['zmom',['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daaaab25f707cae69bfadac2abcd17a2188',1,'IntVars']]], + ['zvel_5347',['zvel',['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a48ee63b17bc216e9661511c33c68bd8b',1,'Vars']]], + ['zvel_5fbc_5348',['zvel_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa03b35ec9e83f34bb1349a86965d34e34',1,'BCVars']]] ]; diff --git a/search/enumvalues_2.js b/search/enumvalues_2.js index 20a95215a..8d2806185 100644 --- a/search/enumvalues_2.js +++ b/search/enumvalues_2.js @@ -1,15 +1,15 @@ var searchData= [ - ['centered_5f2nd_5203',['Centered_2nd',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70ada570868919bafaab1776170229a7049',1,'ERF_IndexDefines.H']]], - ['centered_5f4th_5204',['Centered_4th',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a778e0ed47937713eb1c4bedef6b00161',1,'ERF_IndexDefines.H']]], - ['centered_5f6th_5205',['Centered_6th',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a8c9475eb6bfde28e5bcb5230ac2e22a9',1,'ERF_IndexDefines.H']]], - ['centimeter_5206',['centimeter',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1a135cc2d02c99a9ca6a6413cacea93664',1,'RadConstants']]], - ['charnock_5207',['CHARNOCK',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13addbb8213265f3ad773f7af2cb8147062',1,'ABLMost']]], - ['chen2021_5208',['CHEN2021',['../ERF__MYNNStruct_8H.html#a103de8b695a78549c43fa852d9c4dd25abe8de8e777a612742c642b372ab3dc9e',1,'ERF_MYNNStruct.H']]], - ['cons_5209',['cons',['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a47abe072e12c61d29cde15a509a0664b',1,'Vars::cons()'],['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daa2e7100afbf5e7a39371f1cb29f6f570a',1,'IntVars::cons()']]], - ['cons_5fbc_5210',['cons_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aaaf601346b01655b32acf66d07b856aec',1,'BCVars']]], - ['constant_5211',['CONSTANT',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13a8d6b5cada83510220f59e00ce86d4d92',1,'ABLMost']]], - ['constant_5212',['Constant',['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735acb17869fe51048b5a5c4c6106551a255',1,'ERF_DiffStruct.H']]], - ['constantalpha_5213',['ConstantAlpha',['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735a6f0229db491c3b01860363456dc57288',1,'ERF_DiffStruct.H']]], - ['custom_5214',['CUSTOM',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0a72baef04098f035e8a320b03ad197818',1,'ABLMost']]] + ['centered_5f2nd_5205',['Centered_2nd',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70ada570868919bafaab1776170229a7049',1,'ERF_IndexDefines.H']]], + ['centered_5f4th_5206',['Centered_4th',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a778e0ed47937713eb1c4bedef6b00161',1,'ERF_IndexDefines.H']]], + ['centered_5f6th_5207',['Centered_6th',['../ERF__IndexDefines_8H.html#ada2d84e0dbbfb8d748defbf018748a70a8c9475eb6bfde28e5bcb5230ac2e22a9',1,'ERF_IndexDefines.H']]], + ['centimeter_5208',['centimeter',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1a135cc2d02c99a9ca6a6413cacea93664',1,'RadConstants']]], + ['charnock_5209',['CHARNOCK',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13addbb8213265f3ad773f7af2cb8147062',1,'ABLMost']]], + ['chen2021_5210',['CHEN2021',['../ERF__MYNNStruct_8H.html#a103de8b695a78549c43fa852d9c4dd25abe8de8e777a612742c642b372ab3dc9e',1,'ERF_MYNNStruct.H']]], + ['cons_5211',['cons',['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a47abe072e12c61d29cde15a509a0664b',1,'Vars::cons()'],['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daa2e7100afbf5e7a39371f1cb29f6f570a',1,'IntVars::cons()']]], + ['cons_5fbc_5212',['cons_bc',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aaaf601346b01655b32acf66d07b856aec',1,'BCVars']]], + ['constant_5213',['CONSTANT',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13a8d6b5cada83510220f59e00ce86d4d92',1,'ABLMost']]], + ['constant_5214',['Constant',['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735acb17869fe51048b5a5c4c6106551a255',1,'ERF_DiffStruct.H']]], + ['constantalpha_5215',['ConstantAlpha',['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735a6f0229db491c3b01860363456dc57288',1,'ERF_DiffStruct.H']]], + ['custom_5216',['CUSTOM',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0a72baef04098f035e8a320b03ad197818',1,'ABLMost']]] ]; diff --git a/search/enumvalues_3.js b/search/enumvalues_3.js index 976e63096..0da8d5e4c 100644 --- a/search/enumvalues_3.js +++ b/search/enumvalues_3.js @@ -1,4 +1,4 @@ var searchData= [ - ['donelan_5215',['DONELAN',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0afbf950ece84b8c4c7ebcf6492db726f7',1,'ABLMost::DONELAN()'],['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13afbf950ece84b8c4c7ebcf6492db726f7',1,'ABLMost::DONELAN()']]] + ['donelan_5217',['DONELAN',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0afbf950ece84b8c4c7ebcf6492db726f7',1,'ABLMost::DONELAN()'],['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13afbf950ece84b8c4c7ebcf6492db726f7',1,'ABLMost::DONELAN()']]] ]; diff --git a/search/enumvalues_4.js b/search/enumvalues_4.js index b61713af4..17e2fcfdf 100644 --- a/search/enumvalues_4.js +++ b/search/enumvalues_4.js @@ -1,9 +1,9 @@ var searchData= [ - ['ext_5fdir_5216',['ext_dir',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca4b16988b22c277c9f812ddb5fb1539af',1,'ERFBCType']]], - ['ext_5fdir_5fingested_5217',['ext_dir_ingested',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca138e8c6c2427dcd78959f3e0e84b3462',1,'ERFBCType']]], - ['ext_5fdir_5fprim_5218',['ext_dir_prim',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca52a76d5c6aeb74655f726be3ae8a1eab',1,'ERFBCType']]], - ['extrap_5fmethod_5fbndry_5219',['extrap_method_bndry',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2ac291677b47a4b2b3276ea6ebf30d6e26',1,'LinInterp']]], - ['extrap_5fmethod_5fcycle_5220',['extrap_method_cycle',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2aeec66ba685aaa33115191d8f6bc9c0e6',1,'LinInterp']]], - ['extrap_5fmethod_5fzero_5221',['extrap_method_zero',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2aa8778034b0e18c190776623750b945b5',1,'LinInterp']]] + ['ext_5fdir_5218',['ext_dir',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca4b16988b22c277c9f812ddb5fb1539af',1,'ERFBCType']]], + ['ext_5fdir_5fingested_5219',['ext_dir_ingested',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca138e8c6c2427dcd78959f3e0e84b3462',1,'ERFBCType']]], + ['ext_5fdir_5fprim_5220',['ext_dir_prim',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca52a76d5c6aeb74655f726be3ae8a1eab',1,'ERFBCType']]], + ['extrap_5fmethod_5fbndry_5221',['extrap_method_bndry',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2ac291677b47a4b2b3276ea6ebf30d6e26',1,'LinInterp']]], + ['extrap_5fmethod_5fcycle_5222',['extrap_method_cycle',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2aeec66ba685aaa33115191d8f6bc9c0e6',1,'LinInterp']]], + ['extrap_5fmethod_5fzero_5223',['extrap_method_zero',['../classLinInterp.html#a1f3e9aabd558af36cbc7accfc6e523a2aa8778034b0e18c190776623750b945b5',1,'LinInterp']]] ]; diff --git a/search/enumvalues_5.js b/search/enumvalues_5.js index c4fec1da9..3d447a52d 100644 --- a/search/enumvalues_5.js +++ b/search/enumvalues_5.js @@ -1,4 +1,4 @@ var searchData= [ - ['foextrap_5222',['foextrap',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca4a8d85af949a1ce567934e55c69c2846',1,'ERFBCType']]] + ['foextrap_5224',['foextrap',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca4a8d85af949a1ce567934e55c69c2846',1,'ERFBCType']]] ]; diff --git a/search/enumvalues_6.js b/search/enumvalues_6.js index 7dc4917f8..f3215d18a 100644 --- a/search/enumvalues_6.js +++ b/search/enumvalues_6.js @@ -1,5 +1,5 @@ var searchData= [ - ['goffgratch_5223',['GoffGratch',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7ab35ed313acae6ed02218056f81d56455',1,'SatMethods']]], - ['graup_5faccum_5224',['graup_accum',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8aa13fe479c935eca35c9375907e524992',1,'MicVar']]] + ['goffgratch_5225',['GoffGratch',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7ab35ed313acae6ed02218056f81d56455',1,'SatMethods']]], + ['graup_5faccum_5226',['graup_accum',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8aa13fe479c935eca35c9375907e524992',1,'MicVar']]] ]; diff --git a/search/enumvalues_7.js b/search/enumvalues_7.js index 57f3c28dc..bb2789f74 100644 --- a/search/enumvalues_7.js +++ b/search/enumvalues_7.js @@ -1,6 +1,6 @@ var searchData= [ - ['heat_5fflux_5225',['HEAT_FLUX',['../classABLMost.html#a46fbd9260d2adfa7c18edad6452f9babac03b743c56d9316fbd3d327453b22226',1,'ABLMost']]], - ['ho_5foutflow_5226',['ho_outflow',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a7a78e4cea7eaa21ad14a6fa92fbdc549',1,'ERF_IndexDefines.H']]], - ['hoextrapcc_5227',['hoextrapcc',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca71e344f745a7b29eb00c25df691f410d',1,'ERFBCType']]] + ['heat_5fflux_5227',['HEAT_FLUX',['../classABLMost.html#a46fbd9260d2adfa7c18edad6452f9babac03b743c56d9316fbd3d327453b22226',1,'ABLMost']]], + ['ho_5foutflow_5228',['ho_outflow',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a7a78e4cea7eaa21ad14a6fa92fbdc549',1,'ERF_IndexDefines.H']]], + ['hoextrapcc_5229',['hoextrapcc',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca71e344f745a7b29eb00c25df691f410d',1,'ERFBCType']]] ]; diff --git a/search/enumvalues_8.js b/search/enumvalues_8.js index 495618e14..8ebe7f7aa 100644 --- a/search/enumvalues_8.js +++ b/search/enumvalues_8.js @@ -1,7 +1,7 @@ var searchData= [ - ['inflow_5228',['inflow',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9ad37e67db17cfd059f2852e2673b9e8ef',1,'ERF_IndexDefines.H']]], - ['int_5fdir_5229',['int_dir',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca9f18284526a1054d4e7a4783852ead30',1,'ERFBCType']]], - ['inv_5fcm_5230',['inv_cm',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1a8b67eb83509631c60e1fe0a561983f52',1,'RadConstants']]], - ['invalid_5231',['Invalid',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7aacd427431253b9fe6b472b6db3685edb',1,'SatMethods']]] + ['inflow_5230',['inflow',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9ad37e67db17cfd059f2852e2673b9e8ef',1,'ERF_IndexDefines.H']]], + ['int_5fdir_5231',['int_dir',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca9f18284526a1054d4e7a4783852ead30',1,'ERFBCType']]], + ['inv_5fcm_5232',['inv_cm',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1a8b67eb83509631c60e1fe0a561983f52',1,'RadConstants']]], + ['invalid_5233',['Invalid',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7aacd427431253b9fe6b472b6db3685edb',1,'SatMethods']]] ]; diff --git a/search/enumvalues_9.js b/search/enumvalues_9.js index 9e91d2b13..327dc0a2f 100644 --- a/search/enumvalues_9.js +++ b/search/enumvalues_9.js @@ -1,5 +1,5 @@ var searchData= [ - ['ke_5fh_5232',['KE_h',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149eafa0c87454b22a819e328491f78bf6767',1,'EddyDiff']]], - ['ke_5fv_5233',['KE_v',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea937c191d351b2c26cd7ea07878978b94',1,'EddyDiff']]] + ['ke_5fh_5234',['KE_h',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149eafa0c87454b22a819e328491f78bf6767',1,'EddyDiff']]], + ['ke_5fv_5235',['KE_v',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea937c191d351b2c26cd7ea07878978b94',1,'EddyDiff']]] ]; diff --git a/search/enumvalues_a.js b/search/enumvalues_a.js index 8bf8da0c9..c038e968f 100644 --- a/search/enumvalues_a.js +++ b/search/enumvalues_a.js @@ -1,13 +1,13 @@ var searchData= [ - ['meter_5234',['meter',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1a3c6b87cb2d07bd40e9ed24c8729b20bd',1,'RadConstants']]], - ['micrometer_5235',['micrometer',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1aca44c575fbae0e89d6f7764169e03c46',1,'RadConstants']]], - ['modified_5fcharnock_5236',['MODIFIED_CHARNOCK',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13a266bf3048d67b1b3187c0189bc232fde',1,'ABLMost']]], - ['moeng_5237',['MOENG',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0a0525d4394471c332f3c0a497584923d5',1,'ABLMost']]], - ['mom_5fh_5238',['Mom_h',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea2e96e6d5e84e7d7b9857e73159dfbe2b',1,'EddyDiff']]], - ['mom_5fv_5239',['Mom_v',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea61ed124b350a1b26da1bd26aebfa5f82',1,'EddyDiff']]], - ['most_5240',['MOST',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca42d0838b4e8d40ee76fbaf2d55c3402e',1,'ERFBCType::MOST()'],['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a882dd232c0425bb9366544f84f0a7b6c',1,'MOST(): ERF_IndexDefines.H']]], - ['mu_5241',['MU',['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a9d2d300be8f8f15441322fce35c9c92e',1,'WRFBdyVars']]], - ['murphykoop_5242',['MurphyKoop',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7a614be0679f050250e4d5494708d1136a',1,'SatMethods']]], - ['mynn25_5243',['MYNN25',['../classABLMost.html#acf73526a7a2b05be8d48c0af94742841abdeb9a753db1d1f3fe0e944eab1d0601',1,'ABLMost']]] + ['meter_5236',['meter',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1a3c6b87cb2d07bd40e9ed24c8729b20bd',1,'RadConstants']]], + ['micrometer_5237',['micrometer',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1aca44c575fbae0e89d6f7764169e03c46',1,'RadConstants']]], + ['modified_5fcharnock_5238',['MODIFIED_CHARNOCK',['../classABLMost.html#ae825f96c2d098b3e070642a74e6a3f13a266bf3048d67b1b3187c0189bc232fde',1,'ABLMost']]], + ['moeng_5239',['MOENG',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0a0525d4394471c332f3c0a497584923d5',1,'ABLMost']]], + ['mom_5fh_5240',['Mom_h',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea2e96e6d5e84e7d7b9857e73159dfbe2b',1,'EddyDiff']]], + ['mom_5fv_5241',['Mom_v',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea61ed124b350a1b26da1bd26aebfa5f82',1,'EddyDiff']]], + ['most_5242',['MOST',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca42d0838b4e8d40ee76fbaf2d55c3402e',1,'ERFBCType::MOST()'],['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a882dd232c0425bb9366544f84f0a7b6c',1,'MOST(): ERF_IndexDefines.H']]], + ['mu_5243',['MU',['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a9d2d300be8f8f15441322fce35c9c92e',1,'WRFBdyVars']]], + ['murphykoop_5244',['MurphyKoop',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7a614be0679f050250e4d5494708d1136a',1,'SatMethods']]], + ['mynn25_5245',['MYNN25',['../classABLMost.html#acf73526a7a2b05be8d48c0af94742841abdeb9a753db1d1f3fe0e944eab1d0601',1,'ABLMost']]] ]; diff --git a/search/enumvalues_b.js b/search/enumvalues_b.js index f905b3763..5938a1e3c 100644 --- a/search/enumvalues_b.js +++ b/search/enumvalues_b.js @@ -1,15 +1,15 @@ var searchData= [ - ['nanometer_5244',['nanometer',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1a7a267da562dd711a27346968f67cadfe',1,'RadConstants']]], - ['neumann_5245',['neumann',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca0b217c3380adcde8f3cd9b58d949db60',1,'ERFBCType']]], - ['neumann_5fint_5246',['neumann_int',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01caa8e7f5249fea539bf14e97cfba9074d9',1,'ERFBCType']]], - ['nn09_5247',['NN09',['../ERF__MYNNStruct_8H.html#a103de8b695a78549c43fa852d9c4dd25aa2652637c68e16524ab7681e65eea95c',1,'ERF_MYNNStruct.H']]], - ['no_5fslip_5fwall_5248',['no_slip_wall',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9acb8c716b8d9b499d9bc323d8f8a410d3',1,'ERF_IndexDefines.H']]], - ['none_5249',['None',['../classABLMost.html#acf73526a7a2b05be8d48c0af94742841a6adf97f83acf6453d4a6a4b1070f3754',1,'ABLMost::None()'],['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735a6adf97f83acf6453d4a6a4b1070f3754',1,'None(): ERF_DiffStruct.H']]], - ['num_5fcomps_5250',['num_comps',['../namespaceBaseState.html#a6f8dc3597225ea7941dad615e7f22e91a088c1232c30770df1105d3cdf66ee582',1,'BaseState']]], - ['numdiffs_5251',['NumDiffs',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149eaa3900ab375460932d825b615bb532446',1,'EddyDiff']]], - ['numtypes_5252',['NumTypes',['../namespaceRealBdyVars.html#aa4743649b85ade11df23692d7c3947bda642348f19beb023be6cb81f253b41e7e',1,'RealBdyVars::NumTypes()'],['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daa0468f4146b966163a1fe9f4f32a038c8',1,'IntVars::NumTypes()'],['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a5deccaa24d5e74279425d7749f7d1494',1,'Vars::NumTypes()'],['../namespaceMetGridBdyVars.html#a22bd27d0288d22c74bd7c0bb57b2b89fa4f8e93d238957b496990de56dff45193',1,'MetGridBdyVars::NumTypes()'],['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a6d1cade25038e11a813d4b72b651b04c',1,'WRFBdyVars::NumTypes()'],['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa0b88b0a3a03a3e787a7b27717ec64de7',1,'BCVars::NumTypes()']]], - ['numvars_5253',['NumVars',['../namespaceLsmVar__MM5.html#a0c17a1ae9d9db120b8947e6da767cd3ba9295a4d95dbd36001a7b1beaa15e14b9',1,'LsmVar_MM5::NumVars()'],['../namespaceLsmVar__SLM.html#a9927bc85abdc2fa6040b222a6c1ddd91a46379e2639967ccb36fdea0aa7fbda61',1,'LsmVar_SLM::NumVars()'],['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476beacc0e3f4d1137cce9139f79959ac8542b',1,'MicVar_Kess::NumVars()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a0a8da919c111613d4806217dce5cd1e3',1,'MicVar::NumVars()']]], - ['nvars_5254',['nvars',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239a7c3c83d6fcec1f134956c3160adf6e39',1,'ERF_DataStruct.H']]], - ['nvars_5fsponge_5255',['nvars_sponge',['../ERF__DataStruct_8H.html#a5bebd9ff4e2455172deca3b399214fcba7f0566bdfe36c67d532a7e2aca33d9a4',1,'ERF_DataStruct.H']]] + ['nanometer_5246',['nanometer',['../classRadConstants.html#a2de1ff8cbc3cafe6a42e8f884002e4f1a7a267da562dd711a27346968f67cadfe',1,'RadConstants']]], + ['neumann_5247',['neumann',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca0b217c3380adcde8f3cd9b58d949db60',1,'ERFBCType']]], + ['neumann_5fint_5248',['neumann_int',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01caa8e7f5249fea539bf14e97cfba9074d9',1,'ERFBCType']]], + ['nn09_5249',['NN09',['../ERF__MYNNStruct_8H.html#a103de8b695a78549c43fa852d9c4dd25aa2652637c68e16524ab7681e65eea95c',1,'ERF_MYNNStruct.H']]], + ['no_5fslip_5fwall_5250',['no_slip_wall',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9acb8c716b8d9b499d9bc323d8f8a410d3',1,'ERF_IndexDefines.H']]], + ['none_5251',['None',['../classABLMost.html#acf73526a7a2b05be8d48c0af94742841a6adf97f83acf6453d4a6a4b1070f3754',1,'ABLMost::None()'],['../ERF__DiffStruct_8H.html#a84e6bfbbb8e490790c506939b364f735a6adf97f83acf6453d4a6a4b1070f3754',1,'None(): ERF_DiffStruct.H']]], + ['num_5fcomps_5252',['num_comps',['../namespaceBaseState.html#a6f8dc3597225ea7941dad615e7f22e91a088c1232c30770df1105d3cdf66ee582',1,'BaseState']]], + ['numdiffs_5253',['NumDiffs',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149eaa3900ab375460932d825b615bb532446',1,'EddyDiff']]], + ['numtypes_5254',['NumTypes',['../namespaceRealBdyVars.html#aa4743649b85ade11df23692d7c3947bda642348f19beb023be6cb81f253b41e7e',1,'RealBdyVars::NumTypes()'],['../namespaceIntVars.html#afdaa1b64a98a711870ca86f30e7963daa0468f4146b966163a1fe9f4f32a038c8',1,'IntVars::NumTypes()'],['../namespaceVars.html#a161eed9b529c2108b15a09099729c3b9a5deccaa24d5e74279425d7749f7d1494',1,'Vars::NumTypes()'],['../namespaceMetGridBdyVars.html#a22bd27d0288d22c74bd7c0bb57b2b89fa4f8e93d238957b496990de56dff45193',1,'MetGridBdyVars::NumTypes()'],['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a6d1cade25038e11a813d4b72b651b04c',1,'WRFBdyVars::NumTypes()'],['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa0b88b0a3a03a3e787a7b27717ec64de7',1,'BCVars::NumTypes()']]], + ['numvars_5255',['NumVars',['../namespaceLsmVar__MM5.html#a0c17a1ae9d9db120b8947e6da767cd3ba9295a4d95dbd36001a7b1beaa15e14b9',1,'LsmVar_MM5::NumVars()'],['../namespaceLsmVar__SLM.html#a9927bc85abdc2fa6040b222a6c1ddd91a46379e2639967ccb36fdea0aa7fbda61',1,'LsmVar_SLM::NumVars()'],['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476beacc0e3f4d1137cce9139f79959ac8542b',1,'MicVar_Kess::NumVars()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a0a8da919c111613d4806217dce5cd1e3',1,'MicVar::NumVars()']]], + ['nvars_5256',['nvars',['../ERF__DataStruct_8H.html#a3856c8a2f055327ada182186bfd70239a7c3c83d6fcec1f134956c3160adf6e39',1,'ERF_DataStruct.H']]], + ['nvars_5fsponge_5257',['nvars_sponge',['../ERF__DataStruct_8H.html#a5bebd9ff4e2455172deca3b399214fcba7f0566bdfe36c67d532a7e2aca33d9a4',1,'ERF_DataStruct.H']]] ]; diff --git a/search/enumvalues_c.js b/search/enumvalues_c.js index 086676b87..5c683be1a 100644 --- a/search/enumvalues_c.js +++ b/search/enumvalues_c.js @@ -1,7 +1,7 @@ var searchData= [ - ['oldgoffgratch_5256',['OldGoffGratch',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7aebef486906cc4e78c948e4b43f6680db',1,'SatMethods']]], - ['omega_5257',['omega',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a40820295afd4707e596461de893e54ae',1,'MicVar']]], - ['open_5258',['open',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca2b4e1a73027449d9af83a25ed67ae914',1,'ERFBCType::open()'],['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a7cef8a734855777c2a9d0caf42666e69',1,'open(): ERF_IndexDefines.H']]], - ['outflow_5259',['outflow',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9acac0c32caf84a889ec9b2b4cb2d56972',1,'ERF_IndexDefines.H']]] + ['oldgoffgratch_5258',['OldGoffGratch',['../classSatMethods.html#a62096d95f324cd2a3504554437067ef7aebef486906cc4e78c948e4b43f6680db',1,'SatMethods']]], + ['omega_5259',['omega',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a40820295afd4707e596461de893e54ae',1,'MicVar']]], + ['open_5260',['open',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca2b4e1a73027449d9af83a25ed67ae914',1,'ERFBCType::open()'],['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9a7cef8a734855777c2a9d0caf42666e69',1,'open(): ERF_IndexDefines.H']]], + ['outflow_5261',['outflow',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9acac0c32caf84a889ec9b2b4cb2d56972',1,'ERF_IndexDefines.H']]] ]; diff --git a/search/enumvalues_d.js b/search/enumvalues_d.js index cf924f18e..26bef4f9a 100644 --- a/search/enumvalues_d.js +++ b/search/enumvalues_d.js @@ -1,8 +1,8 @@ var searchData= [ - ['p0_5fcomp_5260',['p0_comp',['../namespaceBaseState.html#a6f8dc3597225ea7941dad615e7f22e91aa8253dc5484f2621e0bf8d51d98d635e',1,'BaseState']]], - ['pc_5261',['PC',['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a56079d34fee7d4d15412dfffaa370ad9',1,'WRFBdyVars']]], - ['periodic_5262',['periodic',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9ae6ffdec5e14fce371eb7ae99edebbbee',1,'ERF_IndexDefines.H']]], - ['pi0_5fcomp_5263',['pi0_comp',['../namespaceBaseState.html#a6f8dc3597225ea7941dad615e7f22e91a3d99e10d828f251e465bc2c66062badf',1,'BaseState']]], - ['pres_5264',['pres',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea82dd7c202e6cce14520ac01cfaa4f4ad',1,'MicVar_Kess::pres()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a147204d9af51dec01fb0d95c5cde8d37',1,'MicVar::pres()']]] + ['p0_5fcomp_5262',['p0_comp',['../namespaceBaseState.html#a6f8dc3597225ea7941dad615e7f22e91aa8253dc5484f2621e0bf8d51d98d635e',1,'BaseState']]], + ['pc_5263',['PC',['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a56079d34fee7d4d15412dfffaa370ad9',1,'WRFBdyVars']]], + ['periodic_5264',['periodic',['../ERF__IndexDefines_8H.html#adf340bf1893bad34b2bf452d987d86c9ae6ffdec5e14fce371eb7ae99edebbbee',1,'ERF_IndexDefines.H']]], + ['pi0_5fcomp_5265',['pi0_comp',['../namespaceBaseState.html#a6f8dc3597225ea7941dad615e7f22e91a3d99e10d828f251e465bc2c66062badf',1,'BaseState']]], + ['pres_5266',['pres',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea82dd7c202e6cce14520ac01cfaa4f4ad',1,'MicVar_Kess::pres()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a147204d9af51dec01fb0d95c5cde8d37',1,'MicVar::pres()']]] ]; diff --git a/search/enumvalues_e.js b/search/enumvalues_e.js index 782882bba..3bbfaf25e 100644 --- a/search/enumvalues_e.js +++ b/search/enumvalues_e.js @@ -1,15 +1,15 @@ var searchData= [ - ['q_5fh_5265',['Q_h',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea5bdaa761454a0b6bbfd57ec7f2b41c8f',1,'EddyDiff']]], - ['q_5fv_5266',['Q_v',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea4166b9561a2ef0ad6d1b6d2c34cb9580',1,'EddyDiff']]], - ['qci_5267',['qci',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a1bb53b1131a676fadffc9e0a53c0309a',1,'MicVar']]], - ['qcl_5268',['qcl',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea6b81d3dc642e339490ef9ab50db41a65',1,'MicVar_Kess::qcl()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a9b5910b49731b9337307885dee73e090',1,'MicVar::qcl()']]], - ['qn_5269',['qn',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a62db2b95f840b974246d431152593fb8',1,'MicVar']]], - ['qp_5270',['qp',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea2edc86e05fd080c928faeb1f6f39c701',1,'MicVar_Kess::qp()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8af86a273a88ba038dd1ea798c51ebf8c4',1,'MicVar::qp()']]], - ['qpg_5271',['qpg',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a36203351003064cd3dfd2c84f66c0ea1',1,'MicVar']]], - ['qpr_5272',['qpr',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a1669c627fc476575ea3c391a275d8cd3',1,'MicVar']]], - ['qps_5273',['qps',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8ae960e0fe1fea5fc017938ab2b92757ed',1,'MicVar']]], - ['qt_5274',['qt',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea9f81c8a38dd25b5ae5821d48e8878b03',1,'MicVar_Kess::qt()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a584161f7272862cb35496c7560617286',1,'MicVar::qt()']]], - ['qv_5275',['QV',['../namespaceRealBdyVars.html#aa4743649b85ade11df23692d7c3947bda70da43bc7762a74b799365a54a1c1b2c',1,'RealBdyVars::QV()'],['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a3b5140db1e7e68b5103cb3372b24faf5',1,'WRFBdyVars::QV()'],['../namespaceMetGridBdyVars.html#a22bd27d0288d22c74bd7c0bb57b2b89fa7da9efd84268db8dc519ebf62f34c4c0',1,'MetGridBdyVars::QV()']]], - ['qv_5276',['qv',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476beaf099273d19f4b8cdca199c5177231e35',1,'MicVar_Kess::qv()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a24d3a4784c4c0b3c8ab827a784198261',1,'MicVar::qv()']]] + ['q_5fh_5267',['Q_h',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea5bdaa761454a0b6bbfd57ec7f2b41c8f',1,'EddyDiff']]], + ['q_5fv_5268',['Q_v',['../namespaceEddyDiff.html#a7e7e94a6b49fe20d106a1ea7317d149ea4166b9561a2ef0ad6d1b6d2c34cb9580',1,'EddyDiff']]], + ['qci_5269',['qci',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a1bb53b1131a676fadffc9e0a53c0309a',1,'MicVar']]], + ['qcl_5270',['qcl',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea6b81d3dc642e339490ef9ab50db41a65',1,'MicVar_Kess::qcl()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a9b5910b49731b9337307885dee73e090',1,'MicVar::qcl()']]], + ['qn_5271',['qn',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a62db2b95f840b974246d431152593fb8',1,'MicVar']]], + ['qp_5272',['qp',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea2edc86e05fd080c928faeb1f6f39c701',1,'MicVar_Kess::qp()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8af86a273a88ba038dd1ea798c51ebf8c4',1,'MicVar::qp()']]], + ['qpg_5273',['qpg',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a36203351003064cd3dfd2c84f66c0ea1',1,'MicVar']]], + ['qpr_5274',['qpr',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a1669c627fc476575ea3c391a275d8cd3',1,'MicVar']]], + ['qps_5275',['qps',['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8ae960e0fe1fea5fc017938ab2b92757ed',1,'MicVar']]], + ['qt_5276',['qt',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea9f81c8a38dd25b5ae5821d48e8878b03',1,'MicVar_Kess::qt()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a584161f7272862cb35496c7560617286',1,'MicVar::qt()']]], + ['qv_5277',['QV',['../namespaceRealBdyVars.html#aa4743649b85ade11df23692d7c3947bda70da43bc7762a74b799365a54a1c1b2c',1,'RealBdyVars::QV()'],['../namespaceWRFBdyVars.html#a1582ccc8cbf6a14eab1a5fc48d404582a3b5140db1e7e68b5103cb3372b24faf5',1,'WRFBdyVars::QV()'],['../namespaceMetGridBdyVars.html#a22bd27d0288d22c74bd7c0bb57b2b89fa7da9efd84268db8dc519ebf62f34c4c0',1,'MetGridBdyVars::QV()']]], + ['qv_5278',['qv',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476beaf099273d19f4b8cdca199c5177231e35',1,'MicVar_Kess::qv()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a24d3a4784c4c0b3c8ab827a784198261',1,'MicVar::qv()']]] ]; diff --git a/search/enumvalues_f.js b/search/enumvalues_f.js index df24ad945..15e0e8da3 100644 --- a/search/enumvalues_f.js +++ b/search/enumvalues_f.js @@ -1,19 +1,19 @@ var searchData= [ - ['r0_5fcomp_5277',['r0_comp',['../namespaceBaseState.html#a6f8dc3597225ea7941dad615e7f22e91abc888a343d4fcc4fc4ffb79c6ac7cb93',1,'BaseState']]], - ['rain_5faccum_5278',['rain_accum',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476beaa364685bc5d7f6f41ff14bbaf6ca3fc1',1,'MicVar_Kess::rain_accum()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a710fb698c72c08828c86a3efa6e28614',1,'MicVar::rain_accum()']]], - ['reflect_5feven_5279',['reflect_even',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01cabc47f82507730e1734a2f3bc58893cf9',1,'ERFBCType']]], - ['reflect_5fodd_5280',['reflect_odd',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca41cecdb4487b15207675ae9ee564e705',1,'ERFBCType']]], - ['rho_5281',['rho',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea89de8c3bfc941080efb960e5119fbd61',1,'MicVar_Kess::rho()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a2534fc55b1bd99268d18c38ddd112e53',1,'MicVar::rho()']]], - ['rho_5fbc_5fcomp_5282',['Rho_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa559799ff291d4e692283c4056bac8db1',1,'BCVars']]], - ['rhoke_5fbc_5fcomp_5283',['RhoKE_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa1556c0a3817c6fab60fbb6952cf0124f',1,'BCVars']]], - ['rhoq1_5fbc_5fcomp_5284',['RhoQ1_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa0473174d8328f2bf7f74b84e9047e684',1,'BCVars']]], - ['rhoq2_5fbc_5fcomp_5285',['RhoQ2_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa502372fe4399d381375f39c17301030c',1,'BCVars']]], - ['rhoq3_5fbc_5fcomp_5286',['RhoQ3_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa399697f16f566e3542ea07706b31883a',1,'BCVars']]], - ['rhoq4_5fbc_5fcomp_5287',['RhoQ4_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa13dd5e908f2388d3e0b6851a1c740d6f',1,'BCVars']]], - ['rhoq5_5fbc_5fcomp_5288',['RhoQ5_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aafb78d904a8ca650972e4228605d79f47',1,'BCVars']]], - ['rhoq6_5fbc_5fcomp_5289',['RhoQ6_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa00707393b2277520e45780bfdb471a4b',1,'BCVars']]], - ['rhoscalar_5fbc_5fcomp_5290',['RhoScalar_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa029ef491930290dea3a984ebdb6d6ae4',1,'BCVars']]], - ['rhotheta_5fbc_5fcomp_5291',['RhoTheta_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa417d2de099d125a0f6b3e32cde3733d1',1,'BCVars']]], - ['rotate_5292',['ROTATE',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0a9faf4e337734315fde20af1922cc6f9d',1,'ABLMost']]] + ['r0_5fcomp_5279',['r0_comp',['../namespaceBaseState.html#a6f8dc3597225ea7941dad615e7f22e91abc888a343d4fcc4fc4ffb79c6ac7cb93',1,'BaseState']]], + ['rain_5faccum_5280',['rain_accum',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476beaa364685bc5d7f6f41ff14bbaf6ca3fc1',1,'MicVar_Kess::rain_accum()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a710fb698c72c08828c86a3efa6e28614',1,'MicVar::rain_accum()']]], + ['reflect_5feven_5281',['reflect_even',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01cabc47f82507730e1734a2f3bc58893cf9',1,'ERFBCType']]], + ['reflect_5fodd_5282',['reflect_odd',['../namespaceERFBCType.html#a40fbdd5a379a92debb4bcaaccac6e01ca41cecdb4487b15207675ae9ee564e705',1,'ERFBCType']]], + ['rho_5283',['rho',['../namespaceMicVar__Kess.html#ad6f84c7e649afdd998b2f37ba87476bea89de8c3bfc941080efb960e5119fbd61',1,'MicVar_Kess::rho()'],['../namespaceMicVar.html#a1609c4386a90fb1c27791fa3cd511fa8a2534fc55b1bd99268d18c38ddd112e53',1,'MicVar::rho()']]], + ['rho_5fbc_5fcomp_5284',['Rho_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa559799ff291d4e692283c4056bac8db1',1,'BCVars']]], + ['rhoke_5fbc_5fcomp_5285',['RhoKE_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa1556c0a3817c6fab60fbb6952cf0124f',1,'BCVars']]], + ['rhoq1_5fbc_5fcomp_5286',['RhoQ1_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa0473174d8328f2bf7f74b84e9047e684',1,'BCVars']]], + ['rhoq2_5fbc_5fcomp_5287',['RhoQ2_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa502372fe4399d381375f39c17301030c',1,'BCVars']]], + ['rhoq3_5fbc_5fcomp_5288',['RhoQ3_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa399697f16f566e3542ea07706b31883a',1,'BCVars']]], + ['rhoq4_5fbc_5fcomp_5289',['RhoQ4_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa13dd5e908f2388d3e0b6851a1c740d6f',1,'BCVars']]], + ['rhoq5_5fbc_5fcomp_5290',['RhoQ5_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aafb78d904a8ca650972e4228605d79f47',1,'BCVars']]], + ['rhoq6_5fbc_5fcomp_5291',['RhoQ6_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa00707393b2277520e45780bfdb471a4b',1,'BCVars']]], + ['rhoscalar_5fbc_5fcomp_5292',['RhoScalar_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa029ef491930290dea3a984ebdb6d6ae4',1,'BCVars']]], + ['rhotheta_5fbc_5fcomp_5293',['RhoTheta_bc_comp',['../namespaceBCVars.html#a00367571247ba920989360b94c156f4aa417d2de099d125a0f6b3e32cde3733d1',1,'BCVars']]], + ['rotate_5294',['ROTATE',['../classABLMost.html#a92e41ba7a650b4768aa6bc006b2241e0a9faf4e337734315fde20af1922cc6f9d',1,'ABLMost']]] ]; diff --git a/search/functions_2.js b/search/functions_2.js index 0c859cd01..bb5cb95e5 100644 --- a/search/functions_2.js +++ b/search/functions_2.js @@ -19,7 +19,7 @@ var searchData= ['centered6_3144',['CENTERED6',['../structCENTERED6.html#acedba4c2b029f363a47c32ad0c6f30e8',1,'CENTERED6']]], ['check_5fparams_3145',['check_params',['../structSolverChoice.html#a4c875e5fe0f3dd69fbcc145b7066c766',1,'SolverChoice']]], ['chopgrids2d_3146',['ChopGrids2D',['../ERF__ChopGrids_8cpp.html#a6fe49eeaa200ab6ab8ae0a6e048f3ded',1,'ChopGrids2D(BoxArray &ba, const Box &domain, int target_size): ERF_ChopGrids.cpp'],['../ERF__Utils_8H.html#ae73f998519cf6628e7c4a90cea4cb4f5',1,'ChopGrids2D(amrex::BoxArray &ba, const amrex::Box &domain, int target_size): ERF_Utils.H']]], - ['cif_3147',['CIF',['../classCIF.html#aeda8119c592d6acaf71927b7d8fe3887',1,'CIF::CIF(const CIF &rhs)=default'],['../classCIF.html#aeb3766fcdd40058f9116d815743381c9',1,'CIF::CIF(CIF &&rhs) noexcept=default'],['../classCIF.html#a0e65a3004e88fe6f772690a89a87256f',1,'CIF::CIF(F &&f, bool a_active)']]], + ['cif_3147',['CIF',['../classCIF.html#a0e65a3004e88fe6f772690a89a87256f',1,'CIF::CIF(F &&f, bool a_active)'],['../classCIF.html#aeb3766fcdd40058f9116d815743381c9',1,'CIF::CIF(CIF &&rhs) noexcept=default'],['../classCIF.html#aeda8119c592d6acaf71927b7d8fe3887',1,'CIF::CIF(const CIF &rhs)=default']]], ['clear_3148',['clear',['../structTimeInterpolatedData.html#a68d1abba77684ee584ba484a185a44e2',1,'TimeInterpolatedData']]], ['clearlevel_3149',['ClearLevel',['../classERF.html#ac44e400a7ce68e18fa44e9416cb1344e',1,'ERF']]], ['close_3150',['close',['../classncutils_1_1NCFile.html#af2c4a20c38edb3fae69087a80875b8b9',1,'ncutils::NCFile']]], @@ -31,7 +31,7 @@ var searchData= ['combine_5fproperties_3156',['combine_properties',['../classOptics.html#a6cbf46804754b07ab0ccf03e6db25207',1,'Optics']]], ['compute_5fa_3157',['compute_A',['../ERF__AdvanceFitch_8cpp.html#a7b6c67da0ff16af60b10f434632b06ce',1,'ERF_AdvanceFitch.cpp']]], ['compute_5faijk_3158',['compute_Aijk',['../ERF__AdvanceFitch_8cpp.html#a68e0a40af0744df9f7e79d181225f615',1,'ERF_AdvanceFitch.cpp']]], - ['compute_5faverages_3159',['compute_averages',['../classPlaneAverage.html#a0b4bb610551a2f07eb05b8e8b7d91820',1,'PlaneAverage::compute_averages(const IndexSelector &idxOp, const amrex::MultiFab &mfab)'],['../classPlaneAverage.html#a603aee4caf3a370d06bee77fddb0e33e',1,'PlaneAverage::compute_averages(const IndexSelector &idxOp, const amrex::MultiFab &mfab)'],['../classMOSTAverage.html#a7a28005871bb8abb49f44c3976133a4f',1,'MOSTAverage::compute_averages()']]], + ['compute_5faverages_3159',['compute_averages',['../classPlaneAverage.html#a603aee4caf3a370d06bee77fddb0e33e',1,'PlaneAverage::compute_averages(const IndexSelector &idxOp, const amrex::MultiFab &mfab)'],['../classPlaneAverage.html#a0b4bb610551a2f07eb05b8e8b7d91820',1,'PlaneAverage::compute_averages(const IndexSelector &idxOp, const amrex::MultiFab &mfab)'],['../classMOSTAverage.html#a7a28005871bb8abb49f44c3976133a4f',1,'MOSTAverage::compute_averages()']]], ['compute_5fcoefficients_3160',['Compute_Coefficients',['../classSAM.html#a77dd99de0896cf9f9bf8299c2c80bc40',1,'SAM']]], ['compute_5fdivergence_3161',['compute_divergence',['../classERF.html#a4aaad0c261cb89d575d46083a509dbb9',1,'ERF']]], ['compute_5ffluxes_3162',['compute_fluxes',['../classABLMost.html#a829339fc8e70a5dff8b7c85f3c2e4138',1,'ABLMost']]], @@ -59,19 +59,19 @@ var searchData= ['compute_5fh_5fzeta_5fatkface_3184',['Compute_h_zeta_AtKface',['../ERF__TerrainMetrics_8H.html#a48f57e72ac183fdf1a984f58f3d24ee0',1,'ERF_TerrainMetrics.H']]], ['compute_5finterior_5fghost_5fbxs_5fxy_3185',['compute_interior_ghost_bxs_xy',['../ERF__InteriorGhostCells_8cpp.html#a58aa7f6d6812d4dea186477114d1a47c',1,'compute_interior_ghost_bxs_xy(const Box &bx, const Box &domain, const int &width, const int &set_width, Box &bx_xlo, Box &bx_xhi, Box &bx_ylo, Box &bx_yhi, const IntVect &ng_vect, const bool get_int_ng): ERF_InteriorGhostCells.cpp'],['../ERF__Utils_8H.html#aaa3f051b9681a4e20d0d88b3715d8897',1,'compute_interior_ghost_bxs_xy(const amrex::Box &bx, const amrex::Box &domain, const int &width, const int &set_width, amrex::Box &bx_xlo, amrex::Box &bx_xhi, amrex::Box &bx_ylo, amrex::Box &bx_yhi, const amrex::IntVect &ng_vect=amrex::IntVect(0, 0, 0), const bool get_int_ng=false): ERF_Utils.H']]], ['compute_5fmost_5fbcs_3186',['compute_most_bcs',['../classABLMost.html#ac1b3a987e1f8518eec9552f6b747a4b1',1,'ABLMost::compute_most_bcs(const int &lev, const amrex::Vector< amrex::MultiFab * > &mfs, amrex::MultiFab *xxmom_flux, amrex::MultiFab *yymom_flux, amrex::MultiFab *zzmom_flux, amrex::MultiFab *xymom_flux, amrex::MultiFab *yxmom_flux, amrex::MultiFab *xzmom_flux, amrex::MultiFab *zxmom_flux, amrex::MultiFab *yzmom_flux, amrex::MultiFab *zymom_flux, amrex::MultiFab *xheat_flux, amrex::MultiFab *yheat_flux, amrex::MultiFab *zheat_flux, amrex::MultiFab *xqv_flux, amrex::MultiFab *yqv_flux, amrex::MultiFab *zqv_flux, amrex::MultiFab *z_phys, const FluxCalc &flux_comp)'],['../classABLMost.html#a10ead55e11cc666e966cc68a1d1513b9',1,'ABLMost::compute_most_bcs(const int &lev, const Vector< MultiFab * > &mfs, MultiFab *xxmom_flux, MultiFab *yymom_flux, MultiFab *zzmom_flux, MultiFab *xymom_flux, MultiFab *yxmom_flux, MultiFab *xzmom_flux, MultiFab *zxmom_flux, MultiFab *yzmom_flux, MultiFab *zymom_flux, MultiFab *xheat_flux, MultiFab *yheat_flux, MultiFab *zheat_flux, MultiFab *xqv_flux, MultiFab *yqv_flux, MultiFab *zqv_flux, MultiFab *z_phys, const FluxCalc &flux_comp)']]], - ['compute_5fpblh_3187',['compute_pblh',['../classABLMost.html#af57fb2913f44e158afcc637a342df049',1,'ABLMost::compute_pblh()'],['../structMYNNPBLH.html#a3911e13c78754ba2bf50e3e94f74bba8',1,'MYNNPBLH::compute_pblh()'],['../classABLMost.html#a7f3d29d94d0808b3e0fe083396da8557',1,'ABLMost::compute_pblh()']]], + ['compute_5fpblh_3187',['compute_pblh',['../classABLMost.html#a7f3d29d94d0808b3e0fe083396da8557',1,'ABLMost::compute_pblh()'],['../structMYNNPBLH.html#a3911e13c78754ba2bf50e3e94f74bba8',1,'MYNNPBLH::compute_pblh()'],['../classABLMost.html#af57fb2913f44e158afcc637a342df049',1,'ABLMost::compute_pblh()']]], ['compute_5fplane_5faverages_3188',['compute_plane_averages',['../classMOSTAverage.html#ab85828af24cd22d737931c51862389e4',1,'MOSTAverage']]], - ['compute_5fpower_5foutput_3189',['compute_power_output',['../classSimpleAD.html#ab13cca46ef87d42822ab2228976fc9ed',1,'SimpleAD']]], - ['compute_5fq_5fflux_3190',['compute_q_flux',['../structdonelan__flux.html#adb397919f3dc33f33d8bdc7b99c52efc',1,'donelan_flux::compute_q_flux()'],['../structmoeng__flux.html#a5d40e64bd085af2f4c63cfa1e9e20aa6',1,'moeng_flux::compute_q_flux()'],['../structcustom__flux.html#ae9e13bc10b4594df556671d9a042b48b',1,'custom_flux::compute_q_flux()'],['../structrotate__flux.html#a4a217b139f9bcbfdd615b4decb4c2f17',1,'rotate_flux::compute_q_flux()']]], + ['compute_5fpower_5foutput_3189',['compute_power_output',['../classGeneralAD.html#af6b71032fe0417e12b9aefff0ba2066b',1,'GeneralAD::compute_power_output()'],['../classFitch.html#a1edfa2cd3db9e6aa95130f24307ac623',1,'Fitch::compute_power_output()'],['../classEWP.html#af9cd3be628c58fca164e35db4a559fd9',1,'EWP::compute_power_output()'],['../classSimpleAD.html#ab13cca46ef87d42822ab2228976fc9ed',1,'SimpleAD::compute_power_output()']]], + ['compute_5fq_5fflux_3190',['compute_q_flux',['../structmoeng__flux.html#a5d40e64bd085af2f4c63cfa1e9e20aa6',1,'moeng_flux::compute_q_flux()'],['../structrotate__flux.html#a4a217b139f9bcbfdd615b4decb4c2f17',1,'rotate_flux::compute_q_flux()'],['../structcustom__flux.html#ae9e13bc10b4594df556671d9a042b48b',1,'custom_flux::compute_q_flux()'],['../structdonelan__flux.html#adb397919f3dc33f33d8bdc7b99c52efc',1,'donelan_flux::compute_q_flux()']]], ['compute_5fregion_5faverages_3191',['compute_region_averages',['../classMOSTAverage.html#aaea0b00766b3cdeefd2b54bade8a86bd',1,'MOSTAverage']]], ['compute_5fsource_5fterms_5ffn_5fft_3192',['compute_source_terms_Fn_Ft',['../ERF__AdvanceGeneralAD_8cpp.html#afffd9801c692fcb424381db8ca2dc8f2',1,'ERF_AdvanceGeneralAD.cpp']]], ['compute_5ft_5fflux_3193',['compute_t_flux',['../structrotate__flux.html#a7827a8b9fcf4800189b67242befc1c31',1,'rotate_flux::compute_t_flux()'],['../structcustom__flux.html#abb193ac77724a6452a6068c3b5954081',1,'custom_flux::compute_t_flux()'],['../structdonelan__flux.html#a999e3bdb322d29fcdfbd51047fb32ee0',1,'donelan_flux::compute_t_flux()'],['../structmoeng__flux.html#a946d89f0b1c8287c83bea9ff628bdb1e',1,'moeng_flux::compute_t_flux()']]], - ['compute_5fu_5fflux_3194',['compute_u_flux',['../structrotate__flux.html#ab29d4027d09cb56c8cce2fab327bd758',1,'rotate_flux::compute_u_flux()'],['../structcustom__flux.html#a6ab8b167f190f9b0c4c6adb05acfff40',1,'custom_flux::compute_u_flux()'],['../structdonelan__flux.html#a44a032acc6bd6f42ff90f5a0ac14f4cf',1,'donelan_flux::compute_u_flux()'],['../structmoeng__flux.html#a2451f21fea8f87cec2e5f626c36489cb',1,'moeng_flux::compute_u_flux(const int &i, const int &j, const int &k, const int &icomp, const amrex::Real &dz, const amrex::Real &dz1, const bool &exp_most, const amrex::Array4< const amrex::Real > &eta_arr, const amrex::Array4< const amrex::Real > &cons_arr, const amrex::Array4< const amrex::Real > &velx_arr, const amrex::Array4< const amrex::Real > &vely_arr, const amrex::Array4< const amrex::Real > &umm_arr, const amrex::Array4< const amrex::Real > &um_arr, const amrex::Array4< const amrex::Real > &u_star_arr, const amrex::Array4< amrex::Real > &dest_arr) const']]], - ['compute_5fv_5fflux_3195',['compute_v_flux',['../structmoeng__flux.html#a5ec0786b043f57c8c41edfd677dde8c9',1,'moeng_flux::compute_v_flux()'],['../structdonelan__flux.html#ad2da09025b821f79782fa580010c4df2',1,'donelan_flux::compute_v_flux()'],['../structcustom__flux.html#a2fe8dd883e33e274f6e44f9c0c5cf118',1,'custom_flux::compute_v_flux()'],['../structrotate__flux.html#aca0eb2ba8e9e5fb863297a39ad7cd140',1,'rotate_flux::compute_v_flux()']]], + ['compute_5fu_5fflux_3194',['compute_u_flux',['../structcustom__flux.html#a6ab8b167f190f9b0c4c6adb05acfff40',1,'custom_flux::compute_u_flux()'],['../structmoeng__flux.html#a2451f21fea8f87cec2e5f626c36489cb',1,'moeng_flux::compute_u_flux()'],['../structdonelan__flux.html#a44a032acc6bd6f42ff90f5a0ac14f4cf',1,'donelan_flux::compute_u_flux()'],['../structrotate__flux.html#ab29d4027d09cb56c8cce2fab327bd758',1,'rotate_flux::compute_u_flux()']]], + ['compute_5fv_5fflux_3195',['compute_v_flux',['../structdonelan__flux.html#ad2da09025b821f79782fa580010c4df2',1,'donelan_flux::compute_v_flux()'],['../structrotate__flux.html#aca0eb2ba8e9e5fb863297a39ad7cd140',1,'rotate_flux::compute_v_flux()'],['../structcustom__flux.html#a2fe8dd883e33e274f6e44f9c0c5cf118',1,'custom_flux::compute_v_flux()'],['../structmoeng__flux.html#a5ec0786b043f57c8c41edfd677dde8c9',1,'moeng_flux::compute_v_flux()']]], ['compute_5fvapor_5fpressure_3196',['compute_vapor_pressure',['../ERF__EOS_8H.html#a380a4683a461f710517afc27bc29d46f',1,'ERF_EOS.H']]], ['compute_5fzrel_5fatcellcenter_3197',['Compute_Zrel_AtCellCenter',['../ERF__TerrainMetrics_8H.html#a41f9b3a5604791daf44935b10a55a565',1,'ERF_TerrainMetrics.H']]], - ['computediffusivitymynn25_3198',['ComputeDiffusivityMYNN25',['../ERF__PBLModels_8H.html#af2bea8fffff60778a8e48189b4406a03',1,'ComputeDiffusivityMYNN25(const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &cons_in, amrex::MultiFab &eddyViscosity, const amrex::Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool use_moisture, int level, const amrex::BCRec *bc_ptr, bool, const std::unique_ptr< amrex::MultiFab > &z_phys_nd, const int RhoQv_comp, const int RhoQr_comp): ERF_PBLModels.H'],['../ERF__ComputeDiffusivityMYNN25_8cpp.html#a4b51698073bd67922bc46675fce968cf',1,'ComputeDiffusivityMYNN25(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_moisture, int level, const BCRec *bc_ptr, bool, const std::unique_ptr< MultiFab > &z_phys_nd, const int RhoQv_comp, const int RhoQr_comp): ERF_ComputeDiffusivityMYNN25.cpp']]], - ['computediffusivityysu_3199',['ComputeDiffusivityYSU',['../ERF__PBLModels_8H.html#ace7a2f37421af958b8f63b049b7c0835',1,'ComputeDiffusivityYSU(const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &cons_in, amrex::MultiFab &eddyViscosity, const amrex::Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool use_moisture, int level, const amrex::BCRec *bc_ptr, bool, const std::unique_ptr< amrex::MultiFab > &z_phys_nd): ERF_PBLModels.H'],['../ERF__ComputeDiffusivityYSU_8cpp.html#a22f1a268ea7d16d0817f082a47ffc98a',1,'ComputeDiffusivityYSU(const MultiFab &xvel, const MultiFab &yvel, const MultiFab &cons_in, MultiFab &eddyViscosity, const Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool, int level, const BCRec *bc_ptr, bool, const std::unique_ptr< MultiFab > &z_phys_nd): ERF_ComputeDiffusivityYSU.cpp']]], + ['computediffusivitymynn25_3198',['ComputeDiffusivityMYNN25',['../ERF__ComputeDiffusivityMYNN25_8cpp.html#a4b51698073bd67922bc46675fce968cf',1,'ComputeDiffusivityMYNN25(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_moisture, int level, const BCRec *bc_ptr, bool, const std::unique_ptr< MultiFab > &z_phys_nd, const int RhoQv_comp, const int RhoQr_comp): ERF_ComputeDiffusivityMYNN25.cpp'],['../ERF__PBLModels_8H.html#af2bea8fffff60778a8e48189b4406a03',1,'ComputeDiffusivityMYNN25(const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &cons_in, amrex::MultiFab &eddyViscosity, const amrex::Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool use_moisture, int level, const amrex::BCRec *bc_ptr, bool, const std::unique_ptr< amrex::MultiFab > &z_phys_nd, const int RhoQv_comp, const int RhoQr_comp): ERF_PBLModels.H']]], + ['computediffusivityysu_3199',['ComputeDiffusivityYSU',['../ERF__ComputeDiffusivityYSU_8cpp.html#a22f1a268ea7d16d0817f082a47ffc98a',1,'ComputeDiffusivityYSU(const MultiFab &xvel, const MultiFab &yvel, const MultiFab &cons_in, MultiFab &eddyViscosity, const Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool, int level, const BCRec *bc_ptr, bool, const std::unique_ptr< MultiFab > &z_phys_nd): ERF_ComputeDiffusivityYSU.cpp'],['../ERF__PBLModels_8H.html#ace7a2f37421af958b8f63b049b7c0835',1,'ComputeDiffusivityYSU(const amrex::MultiFab &xvel, const amrex::MultiFab &yvel, const amrex::MultiFab &cons_in, amrex::MultiFab &eddyViscosity, const amrex::Geometry &geom, const TurbChoice &turbChoice, std::unique_ptr< ABLMost > &most, bool use_moisture, int level, const amrex::BCRec *bc_ptr, bool, const std::unique_ptr< amrex::MultiFab > &z_phys_nd): ERF_PBLModels.H']]], ['computedt_3200',['ComputeDt',['../classERF.html#aa38639155e79bab8a0c283aa6e7afa81',1,'ERF']]], ['computefluxes_3201',['ComputeFluxes',['../classSLM.html#aaafd49733163332a7f9616374d103cbb',1,'SLM::ComputeFluxes()'],['../classMM5.html#a109a5f7a252a6ab6c8e5373ca68c32fb',1,'MM5::ComputeFluxes()']]], ['computeghostcells_3202',['ComputeGhostCells',['../classERF.html#ae68b1f54d196d0a4b19716d65a59d4c5',1,'ERF']]], diff --git a/search/functions_5.js b/search/functions_5.js index 32d86ca78..4c4a870ca 100644 --- a/search/functions_5.js +++ b/search/functions_5.js @@ -4,23 +4,24 @@ var searchData= ['fill_3308',['Fill',['../classERFFillPatcher.html#a045ae741822ced1684eddf019cd7f219',1,'ERFFillPatcher']]], ['fill_5ffab_5ffrom_5farrays_3309',['fill_fab_from_arrays',['../ERF__NCWpsFile_8H.html#a64f2a31eac0693c65ffb19e37014426a',1,'ERF_NCWpsFile.H']]], ['fill_5ffrom_5fbndryregs_3310',['fill_from_bndryregs',['../classERF.html#a2135641de33dea5057799569c74cac42',1,'ERF']]], - ['fill_5fnturb_5fmultifab_3311',['fill_Nturb_multifab',['../classWindFarm.html#aea0f3ab253607ca28ab0085c9a0865e7',1,'WindFarm']]], + ['fill_5fnturb_5fmultifab_3311',['fill_Nturb_multifab',['../classWindFarm.html#ac57fc0cf5e0666fd8aabbf7863412eb5',1,'WindFarm']]], ['fill_5frhs_3312',['fill_rhs',['../classERF.html#a76600d7a4a0451c9727d2cc57dae4220',1,'ERF']]], ['fill_5fsmark_5fmultifab_3313',['fill_SMark_multifab',['../classWindFarm.html#ad4c606e93225c44abd0e854081602c2a',1,'WindFarm']]], - ['fillbdyccvels_3314',['FillBdyCCVels',['../classERF.html#a19c8017ca1ff0eead61abd7e0ce62232',1,'ERF']]], - ['fillcoarsepatch_3315',['FillCoarsePatch',['../classERF.html#ac4497025ab94461899960ee067c2c72a',1,'ERF']]], - ['fillintermediatepatch_3316',['FillIntermediatePatch',['../classERF.html#a5434c771d76cf50e4a0dd9e1b0eb27fc',1,'ERF']]], - ['fillpatch_3317',['FillPatch',['../classERF.html#afded764725240c356faffa97dddbe03d',1,'ERF::FillPatch(int lev, amrex::Real time, const amrex::Vector< amrex::MultiFab * > &mfs_vel, bool cons_only=false)'],['../classERF.html#acb10e650516e54568f879e48f81d6187',1,'ERF::FillPatch(int lev, amrex::Real time, const amrex::Vector< amrex::MultiFab * > &mfs_vel, const amrex::Vector< amrex::MultiFab * > &mfs_mom, const amrex::MultiFab &old_base_state, const amrex::MultiFab &new_base_state, bool fillset=true, bool cons_only=false)']]], - ['fillpatchblocks_3318',['FillPatchBlocks',['../classMultiBlockContainer.html#a92e9b71087c94076b01f13b6cb6fcec5',1,'MultiBlockContainer']]], - ['fillrelax_3319',['FillRelax',['../classERFFillPatcher.html#a69bc23658f5c545f654c7ddd0cabb105',1,'ERFFillPatcher']]], - ['fillset_3320',['FillSet',['../classERFFillPatcher.html#ae6ce0e1d59fc62d812c779d536a95c58',1,'ERFFillPatcher']]], - ['finalize_3321',['finalize',['../classRrtmgp.html#aba1f5f9d2655e0df2747c8d8efedecdf',1,'Rrtmgp::finalize()'],['../classOptics.html#ad044034219080c4d8bc696c4c259cb4d',1,'Optics::finalize()']]], - ['find_5fif_5fmarked_3322',['find_if_marked',['../classNullWindFarm.html#a4d117768ddbdf31c864c4bc7eac57c46',1,'NullWindFarm']]], - ['find_5frad_5floc_5findex_3323',['find_rad_loc_index',['../ERF__AdvanceGeneralAD_8cpp.html#aa029813f35aa6d2dd949f67fa313066d',1,'ERF_AdvanceGeneralAD.cpp']]], - ['findsp_3324',['findsp',['../classWaterVaporSat.html#a5030f00a3a80f34dc58025cb42e14aa4',1,'WaterVaporSat']]], - ['fine_5fcompute_5finterior_5fghost_5frhs_3325',['fine_compute_interior_ghost_rhs',['../ERF__InteriorGhostCells_8cpp.html#ae5ff4686584e657be0c2b4a10dd39553',1,'fine_compute_interior_ghost_rhs(const Real &time, const Real &delta_t, const int &width, const int &set_width, const Geometry &geom, ERFFillPatcher *FPr_c, ERFFillPatcher *FPr_u, ERFFillPatcher *FPr_v, ERFFillPatcher *FPr_w, Vector< BCRec > &domain_bcs_type, Vector< MultiFab > &S_rhs_f, Vector< MultiFab > &S_data_f): ERF_InteriorGhostCells.cpp'],['../ERF__Utils_8H.html#a666ef6030bc3baa94198a32754fc65f2',1,'fine_compute_interior_ghost_rhs(const amrex::Real &time, const amrex::Real &delta_t, const int &width, const int &set_width, const amrex::Geometry &geom, ERFFillPatcher *FPr_c, ERFFillPatcher *FPr_u, ERFFillPatcher *FPr_v, ERFFillPatcher *FPr_w, amrex::Vector< amrex::BCRec > &domain_bcs_type, amrex::Vector< amrex::MultiFab > &S_rhs_f, amrex::Vector< amrex::MultiFab > &S_data_f): ERF_Utils.H']]], - ['fitch_3326',['Fitch',['../classFitch.html#a3682b755760d9e2543182ffbc0f3a618',1,'Fitch']]], - ['flowerif_3327',['FlowerIF',['../classFlowerIF.html#ac38f4d1d1e3825fb2009aa292a577b59',1,'FlowerIF']]], - ['forestdrag_3328',['ForestDrag',['../classForestDrag.html#a122891e509293a8cce46fe26ef94caca',1,'ForestDrag']]], - ['full_5fname_3329',['full_name',['../classncutils_1_1NCGroup.html#a56f4429492300eabd16fa0d4bd55b8c7',1,'ncutils::NCGroup']]] + ['fill_5fsmark_5fmultifab_5fmesoscale_5fmodels_3314',['fill_SMark_multifab_mesoscale_models',['../classWindFarm.html#a74983b05c969cace5b73aeae42830d2c',1,'WindFarm']]], + ['fillbdyccvels_3315',['FillBdyCCVels',['../classERF.html#a19c8017ca1ff0eead61abd7e0ce62232',1,'ERF']]], + ['fillcoarsepatch_3316',['FillCoarsePatch',['../classERF.html#ac4497025ab94461899960ee067c2c72a',1,'ERF']]], + ['fillintermediatepatch_3317',['FillIntermediatePatch',['../classERF.html#a5434c771d76cf50e4a0dd9e1b0eb27fc',1,'ERF']]], + ['fillpatch_3318',['FillPatch',['../classERF.html#afded764725240c356faffa97dddbe03d',1,'ERF::FillPatch(int lev, amrex::Real time, const amrex::Vector< amrex::MultiFab * > &mfs_vel, bool cons_only=false)'],['../classERF.html#acb10e650516e54568f879e48f81d6187',1,'ERF::FillPatch(int lev, amrex::Real time, const amrex::Vector< amrex::MultiFab * > &mfs_vel, const amrex::Vector< amrex::MultiFab * > &mfs_mom, const amrex::MultiFab &old_base_state, const amrex::MultiFab &new_base_state, bool fillset=true, bool cons_only=false)']]], + ['fillpatchblocks_3319',['FillPatchBlocks',['../classMultiBlockContainer.html#a92e9b71087c94076b01f13b6cb6fcec5',1,'MultiBlockContainer']]], + ['fillrelax_3320',['FillRelax',['../classERFFillPatcher.html#a69bc23658f5c545f654c7ddd0cabb105',1,'ERFFillPatcher']]], + ['fillset_3321',['FillSet',['../classERFFillPatcher.html#ae6ce0e1d59fc62d812c779d536a95c58',1,'ERFFillPatcher']]], + ['finalize_3322',['finalize',['../classOptics.html#ad044034219080c4d8bc696c4c259cb4d',1,'Optics::finalize()'],['../classRrtmgp.html#aba1f5f9d2655e0df2747c8d8efedecdf',1,'Rrtmgp::finalize()']]], + ['find_5fif_5fmarked_3323',['find_if_marked',['../classNullWindFarm.html#a4d117768ddbdf31c864c4bc7eac57c46',1,'NullWindFarm']]], + ['find_5frad_5floc_5findex_3324',['find_rad_loc_index',['../ERF__AdvanceGeneralAD_8cpp.html#aa029813f35aa6d2dd949f67fa313066d',1,'ERF_AdvanceGeneralAD.cpp']]], + ['findsp_3325',['findsp',['../classWaterVaporSat.html#a5030f00a3a80f34dc58025cb42e14aa4',1,'WaterVaporSat']]], + ['fine_5fcompute_5finterior_5fghost_5frhs_3326',['fine_compute_interior_ghost_rhs',['../ERF__InteriorGhostCells_8cpp.html#ae5ff4686584e657be0c2b4a10dd39553',1,'fine_compute_interior_ghost_rhs(const Real &time, const Real &delta_t, const int &width, const int &set_width, const Geometry &geom, ERFFillPatcher *FPr_c, ERFFillPatcher *FPr_u, ERFFillPatcher *FPr_v, ERFFillPatcher *FPr_w, Vector< BCRec > &domain_bcs_type, Vector< MultiFab > &S_rhs_f, Vector< MultiFab > &S_data_f): ERF_InteriorGhostCells.cpp'],['../ERF__Utils_8H.html#a666ef6030bc3baa94198a32754fc65f2',1,'fine_compute_interior_ghost_rhs(const amrex::Real &time, const amrex::Real &delta_t, const int &width, const int &set_width, const amrex::Geometry &geom, ERFFillPatcher *FPr_c, ERFFillPatcher *FPr_u, ERFFillPatcher *FPr_v, ERFFillPatcher *FPr_w, amrex::Vector< amrex::BCRec > &domain_bcs_type, amrex::Vector< amrex::MultiFab > &S_rhs_f, amrex::Vector< amrex::MultiFab > &S_data_f): ERF_Utils.H']]], + ['fitch_3327',['Fitch',['../classFitch.html#a3682b755760d9e2543182ffbc0f3a618',1,'Fitch']]], + ['flowerif_3328',['FlowerIF',['../classFlowerIF.html#ac38f4d1d1e3825fb2009aa292a577b59',1,'FlowerIF']]], + ['forestdrag_3329',['ForestDrag',['../classForestDrag.html#a122891e509293a8cce46fe26ef94caca',1,'ForestDrag']]], + ['full_5fname_3330',['full_name',['../classncutils_1_1NCGroup.html#a56f4429492300eabd16fa0d4bd55b8c7',1,'ncutils::NCGroup']]] ]; diff --git a/search/functions_6.js b/search/functions_6.js index 9b4f731b7..4cc499d09 100644 --- a/search/functions_6.js +++ b/search/functions_6.js @@ -1,175 +1,175 @@ var searchData= [ - ['gam_5fliquid_5flw_3330',['gam_liquid_lw',['../classCloudRadProps.html#a5772a63dc315f019d951785ebdb9c13d',1,'CloudRadProps']]], - ['gam_5fliquid_5fsw_3331',['gam_liquid_sw',['../classCloudRadProps.html#a2890fa11a8f395809fe215447e339c20',1,'CloudRadProps']]], - ['gammadist_5fliq_5foptics_5flw_3332',['gammadist_liq_optics_lw',['../classCloudRadProps.html#a31a396f1997438a7cbb347767dca311a',1,'CloudRadProps']]], - ['gammadist_5fliq_5foptics_5fsw_3333',['gammadist_liq_optics_sw',['../classCloudRadProps.html#adcaf1c142347cdcd3b761af9c7ee5c56',1,'CloudRadProps']]], - ['gatherkeyvaluepairs_3334',['gatherKeyValuePairs',['../classWindFarm.html#aaa0f45adf2528c2f8c5be67ac4a18e8b',1,'WindFarm']]], - ['generalad_3335',['GeneralAD',['../classGeneralAD.html#a94e69e67c451652660642f85b48de07b',1,'GeneralAD']]], - ['get_3336',['get',['../structncutils_1_1NCVar.html#ab39527f40ff0417de3c1ff8c441ced93',1,'ncutils::NCVar::get(float *) const'],['../structncutils_1_1NCVar.html#a0a7990c37360c27e7ba2fb47617f5255',1,'ncutils::NCVar::get(int *) const'],['../structncutils_1_1NCVar.html#a533478371e0bd09a6f4944bf5fe00684',1,'ncutils::NCVar::get(double *, const std::vector< size_t > &, const std::vector< size_t > &) const'],['../structncutils_1_1NCVar.html#ab3b5bad54cdc792e734690fcb5f4ecec',1,'ncutils::NCVar::get(double *, const std::vector< size_t > &, const std::vector< size_t > &, const std::vector< ptrdiff_t > &) const'],['../structncutils_1_1NCVar.html#ad6fc629cd035e5779e9e891fd37e68ae',1,'ncutils::NCVar::get(float *, const std::vector< size_t > &, const std::vector< size_t > &) const'],['../structncutils_1_1NCVar.html#af036d4858171a98b8a951348a654a36c',1,'ncutils::NCVar::get(float *, const std::vector< size_t > &, const std::vector< size_t > &, const std::vector< ptrdiff_t > &) const'],['../structncutils_1_1NCVar.html#a0a1082e40bee181e99e04ca81311bb70',1,'ncutils::NCVar::get(int *, const std::vector< size_t > &, const std::vector< size_t > &) const'],['../structncutils_1_1NCVar.html#ab994c2ebc61623888b2e3fc6bf399bff',1,'ncutils::NCVar::get(int *, const std::vector< size_t > &, const std::vector< size_t > &, const std::vector< ptrdiff_t > &) const'],['../structncutils_1_1NCVar.html#a7fe596943d518530da29a356d393090d',1,'ncutils::NCVar::get(char *, const std::vector< size_t > &, const std::vector< size_t > &) const'],['../structncutils_1_1NCVar.html#ad73293d8faae951e5f91cc3ba49d0f8c',1,'ncutils::NCVar::get(char *, const std::vector< size_t > &, const std::vector< size_t > &, const std::vector< ptrdiff_t > &) const'],['../structncutils_1_1NCVar.html#ac88fd209afde1f05e4f8f62e4c628bba',1,'ncutils::NCVar::get(double *) const']]], - ['get_5fabsplw_3337',['get_absplw',['../classPhysProp.html#ae5d9c299d02610cebe15c8b214162949',1,'PhysProp']]], - ['get_5fabspsw_3338',['get_abspsw',['../classPhysProp.html#a610235368bd270cf3f484efcfcbf8690',1,'PhysProp']]], - ['get_5faer_5flw_5fabs_3339',['get_aer_lw_abs',['../classMamConstituents.html#a39c17e36a63359f40e0d3d32189aab96',1,'MamConstituents']]], - ['get_5faer_5flw_5fhygro_5fabs_3340',['get_aer_lw_hygro_abs',['../classMamConstituents.html#a0de07ed11529ba2b684aeba702294d03',1,'MamConstituents']]], - ['get_5faer_5fmu_3341',['get_aer_mu',['../classMamConstituents.html#aa5ae6b3a2418d42d2d8e39a35a71a88d',1,'MamConstituents']]], - ['get_5faer_5fopticstype_3342',['get_aer_opticstype',['../classMamConstituents.html#abec0c34aadac9883294cdc35a507856a',1,'MamConstituents']]], - ['get_5faer_5fr_5flw_5fabs_3343',['get_aer_r_lw_abs',['../classMamConstituents.html#acda5a38c4660d35fe7453bddc6106808',1,'MamConstituents']]], - ['get_5faer_5fr_5fsw_5fascat_3344',['get_aer_r_sw_ascat',['../classMamConstituents.html#a0d3f86cd0ffb6e60c4df7ad4ce6a11bc',1,'MamConstituents']]], - ['get_5faer_5fr_5fsw_5fext_3345',['get_aer_r_sw_ext',['../classMamConstituents.html#a2f8b2adaa3a57f55957f3ae733a2d824',1,'MamConstituents']]], - ['get_5faer_5fr_5fsw_5fscat_3346',['get_aer_r_sw_scat',['../classMamConstituents.html#a01578fc8bfc4e59b9d3718fe28f5b618',1,'MamConstituents']]], - ['get_5faer_5frefindex_5faer_5flw_3347',['get_aer_refindex_aer_lw',['../classMamConstituents.html#a93552325254a27f4e30dc863a391c00f',1,'MamConstituents']]], - ['get_5faer_5frefindex_5faer_5fsw_3348',['get_aer_refindex_aer_sw',['../classMamConstituents.html#ab9010182eadd9654fed594e351473f3a',1,'MamConstituents']]], - ['get_5faer_5fsw_5fhygro_5fasm_3349',['get_aer_sw_hygro_asm',['../classMamConstituents.html#aa10ea52298c1c8c1e2761a77e95ecce0',1,'MamConstituents']]], - ['get_5faer_5fsw_5fhygro_5fext_3350',['get_aer_sw_hygro_ext',['../classMamConstituents.html#ab71a35dafa0ad47969c8b313dbcf08e7',1,'MamConstituents']]], - ['get_5faer_5fsw_5fhygro_5fssa_3351',['get_aer_sw_hygro_ssa',['../classMamConstituents.html#ab4b263716e034493d0b8568954f97cf8',1,'MamConstituents']]], - ['get_5faer_5fsw_5fnonhygro_5fascat_3352',['get_aer_sw_nonhygro_ascat',['../classMamConstituents.html#a9b76d886c4a041e4a04632c8826f720f',1,'MamConstituents']]], - ['get_5faer_5fsw_5fnonhygro_5fasm_3353',['get_aer_sw_nonhygro_asm',['../classMamConstituents.html#a8b1568c4a639828008d0355f92461e34',1,'MamConstituents']]], - ['get_5faer_5fsw_5fnonhygro_5fext_3354',['get_aer_sw_nonhygro_ext',['../classMamConstituents.html#a4a957acf92c695c67d59c57549f27e1f',1,'MamConstituents']]], - ['get_5faer_5fsw_5fnonhygro_5fscat_3355',['get_aer_sw_nonhygro_scat',['../classMamConstituents.html#a134c22a50d8162187020229e600d955a',1,'MamConstituents']]], - ['get_5faer_5fsw_5fnonhygro_5fssa_3356',['get_aer_sw_nonhygro_ssa',['../classMamConstituents.html#ab56197f3c64da14398867aa6f8d38183',1,'MamConstituents']]], - ['get_5faername_3357',['get_aername',['../classMamConstituents.html#a45f560dfc8f2f43d113f721748207196',1,'MamConstituents::get_aername()'],['../classPhysProp.html#a79b16991c9e3b083c695283026ad5ec8',1,'PhysProp::get_aername()']]], - ['get_5faero_5fnames_3358',['get_aero_names',['../classMamConstituents.html#a7ad0e1141a6be427a07fbc7ee575d767',1,'MamConstituents']]], - ['get_5fasmpsw_3359',['get_asmpsw',['../classPhysProp.html#ac5dc40de142866db795e2cd06c7629ab',1,'PhysProp']]], - ['get_5fattr_3360',['get_attr',['../structncutils_1_1NCVar.html#aa5b83489bee14205286a757e0789ddbd',1,'ncutils::NCVar::get_attr()'],['../classncutils_1_1NCGroup.html#ac5beadfdf8519b384504dc82f6bdecc5',1,'ncutils::NCGroup::get_attr(const std::string &name, std::vector< int > &value) const'],['../classncutils_1_1NCGroup.html#ac25f1ca78fc2cd66e7b80fdcc30f512f',1,'ncutils::NCGroup::get_attr(const std::string &name, std::vector< float > &value) const'],['../classncutils_1_1NCGroup.html#a0f24e998915e60b177d036595f0f2734',1,'ncutils::NCGroup::get_attr(const std::string &name, std::vector< double > &value) const'],['../classncutils_1_1NCGroup.html#a2f10bc405d66f794c4e8a8fd71dc718d',1,'ncutils::NCGroup::get_attr(const std::string &name) const'],['../structncutils_1_1NCVar.html#a720f935c1949f56e31eb057dbc1e7ea6',1,'ncutils::NCVar::get_attr(const std::string &name, std::vector< int > &value) const'],['../structncutils_1_1NCVar.html#af09b0c94dceb8666a7be0d6167bfc4b4',1,'ncutils::NCVar::get_attr(const std::string &name, std::vector< float > &value) const'],['../structncutils_1_1NCVar.html#a774b3bda4e9dc903ecfa35af38e863c6',1,'ncutils::NCVar::get_attr(const std::string &name) const']]], - ['get_5faverage_3361',['get_average',['../classMOSTAverage.html#aa52cd2c83e24eef47d6a409b7bcf4c81',1,'MOSTAverage']]], - ['get_5fblade_5fairfoil_5fspec_3362',['get_blade_airfoil_spec',['../classNullWindFarm.html#abc6967908665ee89bd0546d24ef6f2a6',1,'NullWindFarm']]], - ['get_5fblade_5fspec_3363',['get_blade_spec',['../classNullWindFarm.html#ac88481b8d5d1cf63fabe89edee9cc8cd',1,'NullWindFarm']]], - ['get_5fcloud_5foptics_5flw_3364',['get_cloud_optics_lw',['../classOptics.html#af5f3fa679301f0ead8b8155626b2e710',1,'Optics']]], - ['get_5fcloud_5foptics_5fsw_3365',['get_cloud_optics_sw',['../classOptics.html#aee82856b88240c428aefc6f47bf9500c',1,'Optics']]], - ['get_5fdata_3366',['get_data',['../structNDArray.html#aa1c5762c2de2f4286d4f341b618df1e5',1,'NDArray']]], - ['get_5fdata_5fptr_3367',['Get_Data_Ptr',['../classLandSurface.html#af125bc0c5860b3564afdfce10ec253ea',1,'LandSurface']]], - ['get_5fdata_5fsize_3368',['Get_Data_Size',['../classLandSurface.html#a2652af07555cc98d15d3516371fa42e6',1,'LandSurface']]], - ['get_5fdensity_5faer_3369',['get_density_aer',['../classMamConstituents.html#a7e8f938768431f79e7816950449f8e1d',1,'MamConstituents::get_density_aer()'],['../classPhysProp.html#adb91fa4653cd03d2eefbab2e6577500c',1,'PhysProp::get_density_aer(int &id, real &density_aer) const']]], - ['get_5fdgnum_3370',['get_dgnum',['../classPhysProp.html#a3cc2840e071eae998f97139436d6fee7',1,'PhysProp']]], - ['get_5fdgnumhi_3371',['get_dgnumhi',['../classPhysProp.html#afeca92e20ff289545c11f63419805ab6',1,'PhysProp']]], - ['get_5fdgnumlo_3372',['get_dgnumlo',['../classPhysProp.html#af7c5da49376c0082a11ea77ac0368fc3',1,'PhysProp']]], - ['get_5fdispersion_5faer_3373',['get_dispersion_aer',['../classMamConstituents.html#a91e1af3f8fe81cd67b9442679c983d70',1,'MamConstituents::get_dispersion_aer()'],['../classPhysProp.html#ab4d9d3e81d7f582b89f42d1d8c2c360f',1,'PhysProp::get_dispersion_aer()']]], - ['get_5fdrag_5ffield_3374',['get_drag_field',['../classForestDrag.html#abbfaec28be888963879442d65e61839c',1,'ForestDrag']]], - ['get_5fdryrad_5faer_3375',['get_dryrad_aer',['../classMamConstituents.html#abb8a46935c06e23274d3c33b9d1f443b',1,'MamConstituents::get_dryrad_aer()'],['../classPhysProp.html#ab3828a02687668e5cd1ff46dab659ed7',1,'PhysProp::get_dryrad_aer(int &id, real &dryrad_aer) const']]], - ['get_5fextpsw_3376',['get_extpsw',['../classPhysProp.html#a671b14d041b5e71b62aff2904fbcf203',1,'PhysProp']]], - ['get_5fflux_5fptr_3377',['Get_Flux_Ptr',['../classLandSurface.html#a967a4b0772dc721d0242d38613ac430e',1,'LandSurface']]], - ['get_5fgas_5fnames_3378',['get_gas_names',['../classMamConstituents.html#a737daa041cc666d79764053a35175a15',1,'MamConstituents']]], - ['get_5fgas_5fvmr_3379',['get_gas_vmr',['../classRadiation.html#a17087b1575e1d891f0617b22ca78bec3',1,'Radiation']]], - ['get_5fgpoint_5fbands_5flw_3380',['get_gpoint_bands_lw',['../classRrtmgp.html#a3599409b29ca122c0ac8e360097d6551',1,'Rrtmgp']]], - ['get_5fgpoint_5fbands_5fsw_3381',['get_gpoint_bands_sw',['../classRrtmgp.html#a731fae99697b1f9f94847726d59fb77e',1,'Rrtmgp']]], - ['get_5fhygro_5faer_3382',['get_hygro_aer',['../classMamConstituents.html#a31022a0fcf609baace2c55378a1e74a9',1,'MamConstituents::get_hygro_aer()'],['../classPhysProp.html#a5808428f8d4a9c4f118e52a46ba1f9d0',1,'PhysProp::get_hygro_aer()']]], - ['get_5fhygro_5frad_5fprops_3383',['get_hygro_rad_props',['../classAerRadProps.html#a6a1e71160911bbc52d09bdbd73acb219',1,'AerRadProps']]], - ['get_5fline_5fmfs_3384',['get_line_mfs',['../structLineSampler.html#a290c3f1bc30a85e67ca18f2bbd3e2cdf',1,'LineSampler']]], - ['get_5flmask_3385',['get_lmask',['../classABLMost.html#a48a21c911803192130c2472c89b72c72',1,'ABLMost']]], - ['get_5flsm_5fgeom_3386',['Get_Lsm_Geom',['../classLandSurface.html#a368a57f198d060805dcd615677366c3c',1,'LandSurface']]], - ['get_5flsm_5ftsurf_3387',['get_lsm_tsurf',['../classABLMost.html#ae28fd8a21f4b514875c24fe4b8e85081',1,'ABLMost']]], - ['get_5flw_5fabs_3388',['get_lw_abs',['../classPhysProp.html#af7d8981c1033f1eb0e48168e0d52c572',1,'PhysProp']]], - ['get_5flw_5fhygro_5fabs_3389',['get_lw_hygro_abs',['../classPhysProp.html#a30f4cd3f9cfc6e7e69c5e5c732f0d7be',1,'PhysProp']]], - ['get_5flw_5fspectral_5fboundaries_3390',['get_lw_spectral_boundaries',['../classRadConstants.html#a242b8b89c7cd6415af91e2bc35a5fd58',1,'RadConstants']]], - ['get_5flw_5fspectral_5fmidpoints_3391',['get_lw_spectral_midpoints',['../classRadConstants.html#a1ac73a96f506a7f16b7fd7500e1fa592',1,'RadConstants']]], - ['get_5fmac_5favg_3392',['get_mac_avg',['../classABLMost.html#af26cdc6b8c162c14b2db32eb395f0565',1,'ABLMost']]], - ['get_5fmam_5fdensity_5faer_3393',['get_mam_density_aer',['../classMamConstituents.html#aaff13adc5b53a73c3247e33451b3889c',1,'MamConstituents']]], - ['get_5fmam_5fhygro_5faer_3394',['get_mam_hygro_aer',['../classMamConstituents.html#ad55d7f5b5933d5586271523a02ac2d55',1,'MamConstituents']]], - ['get_5fmam_5fprops_3395',['get_mam_props',['../classMamConstituents.html#a7c3b6e3de312e64999a8465e89ff66e0',1,'MamConstituents::get_mam_props(int list_idx, int mode_idx, int spec_idx, real &density_aer, std::string &spectype, real &hygro_aer, real1d &refindex_real_aer_sw, real1d &refindex_im_aer_sw) const'],['../classMamConstituents.html#a85d32d9bc9d6b9931debba102cdbfd5c',1,'MamConstituents::get_mam_props(int list_idx, int mode_idx, int spec_idx, real &density_aer) const']]], - ['get_5fmam_5fprops_5flw_3396',['get_mam_props_lw',['../classMamConstituents.html#aaf6b7130c9c8322fdf76384d13e8a2e5',1,'MamConstituents']]], - ['get_5fmam_5fprops_5fsw_3397',['get_mam_props_sw',['../classMamConstituents.html#aff2f99c0ce814bed40bf8256e68e9c2c',1,'MamConstituents']]], - ['get_5fmax_5ftemperature_3398',['get_max_temperature',['../classRrtmgp.html#a54d681da78a4c643e44de12c096429b1',1,'Rrtmgp']]], - ['get_5fmin_5ftemperature_3399',['get_min_temperature',['../classRrtmgp.html#a9f2ab92b47552998f259e3e8cfd1ae25',1,'Rrtmgp']]], - ['get_5fmode_5fnspec_3400',['get_mode_nspec',['../classMamConstituents.html#a4741e14c61b6fb2dbac43af6c9aeec4a',1,'MamConstituents']]], - ['get_5fmode_5fprops_3401',['get_mode_props',['../classMamConstituents.html#adc3ace4b56e9fe92cae40983334c52d3',1,'MamConstituents::get_mode_props(int list_idx, int mode_idx, real &sigmag, real &rhcrystal, real &rhdeliques) const'],['../classMamConstituents.html#adeecb1b611d4a93bbeec8458eb28531b',1,'MamConstituents::get_mode_props(int list_idx, int mode_idx, real &sigmag, real2d &refrtablw, real2d &refitablw, real4d &absplw) const'],['../classMamConstituents.html#a41ac833b93f17975d4767ce1fa423a54',1,'MamConstituents::get_mode_props(int list_idx, int mode_idx, real &sigmag, real2d &refrtabsw, real2d &refitabsw, real4d &extpsw, real4d &abspsw, real4d &asmpsw) const'],['../classMamConstituents.html#a1139674e487977095e719a5d3206d00f',1,'MamConstituents::get_mode_props(int list_idx, int mode_idx, int &ncoef, int &prefr, int &prefi) const'],['../classMamConstituents.html#a5b6614e45aaf28a941c327285fd1cf62',1,'MamConstituents::get_mode_props(int list_idx, int mode_idx, real &dgnum, real &dgnumhi, real &dgnumlo, real &sigmag) const']]], - ['get_5fmu_3402',['get_mu',['../classPhysProp.html#a5b078a171f29ecd73946aadf4024beeb',1,'PhysProp']]], - ['get_5fmu_5flambda_5fweights_3403',['get_mu_lambda_weights',['../classCloudRadProps.html#ab5a9764068553f94a590310ff990a97d',1,'CloudRadProps']]], - ['get_5fnaero_3404',['get_naero',['../classMamConstituents.html#aec2a842a29c81c329c98202e33c74740',1,'MamConstituents']]], - ['get_5fnband_5flw_3405',['get_nband_lw',['../classRrtmgp.html#a63713fbd29d350a8d26ba7cd745439f8',1,'Rrtmgp']]], - ['get_5fnband_5fsw_3406',['get_nband_sw',['../classRrtmgp.html#a3d2da27814d96e130b6f0486b36fc6e9',1,'Rrtmgp']]], - ['get_5fncoef_3407',['get_ncoef',['../classPhysProp.html#a93fd04f58151457c6df91467cb97cb7a',1,'PhysProp']]], - ['get_5fngas_3408',['get_ngas',['../classMamConstituents.html#a9f278742417afa46505432a0d243e8ea',1,'MamConstituents']]], - ['get_5fngpt_5flw_3409',['get_ngpt_lw',['../classRrtmgp.html#a208b68626f3d16b530e053f6f0d99d56',1,'Rrtmgp']]], - ['get_5fngpt_5fsw_3410',['get_ngpt_sw',['../classRrtmgp.html#a6f4be82ac30aabe0107060413c7bd9a1',1,'Rrtmgp']]], - ['get_5fnmodes_3411',['get_nmodes',['../classMamConstituents.html#ab6dd677adef9ea89d15a8f1795cb4904',1,'MamConstituents']]], - ['get_5fnonhygro_5frad_5fprops_3412',['get_nonhygro_rad_props',['../classAerRadProps.html#af6e6827c17d2247b72337a35875ea0e0',1,'AerRadProps']]], - ['get_5fnum_5fto_5fmass_5faer_3413',['get_num_to_mass_aer',['../classMamConstituents.html#a22531d4c0d7c79629e9ef32e3e42b2e3',1,'MamConstituents::get_num_to_mass_aer()'],['../classPhysProp.html#ad29374a68385062f7fb8becc4606cf7b',1,'PhysProp::get_num_to_mass_aer()']]], - ['get_5fnumber_5fsw_5fbands_3414',['get_number_sw_bands',['../classRadConstants.html#afefd717015853c1a0f91ac4f5284702c',1,'RadConstants']]], - ['get_5folen_3415',['get_olen',['../classABLMost.html#aef7480dbb43cafff3be93a95240c1ec3',1,'ABLMost']]], - ['get_5fopticstype_3416',['get_opticstype',['../classPhysProp.html#a61a4b378d133e890ff2b354f94ef5b37',1,'PhysProp']]], - ['get_5fpb_5fmag_3417',['get_pb_mag',['../structTurbulentPerturbation.html#a237c085bf6fa265eef471d19bbca613f',1,'TurbulentPerturbation']]], - ['get_5fpb_5fnetzero_3418',['get_pb_netZero',['../structTurbulentPerturbation.html#aa8a048ec67a9e110cef012105dd615cf',1,'TurbulentPerturbation']]], - ['get_5fpblh_3419',['get_pblh',['../classABLMost.html#aaac1902b108e37bf0508306cb171c6ad',1,'ABLMost']]], - ['get_5fplane_5fmfs_3420',['get_plane_mfs',['../structPlaneSampler.html#a68ea5715d34cefd4d9a2c2cbc38114f2',1,'PlaneSampler']]], - ['get_5fprefi_3421',['get_prefi',['../classPhysProp.html#af1803621d0f45e015e831171dd91255e',1,'PhysProp']]], - ['get_5fprefr_3422',['get_prefr',['../classPhysProp.html#a1c586690e59a32d4775a2c665bb999f4',1,'PhysProp']]], - ['get_5fprojection_5fbc_3423',['get_projection_bc',['../classERF.html#a57580311d47c9fd5e27ba156d287c169',1,'ERF']]], - ['get_5fq_5fstar_3424',['get_q_star',['../classABLMost.html#a5468d40c9751664279c940369c8040dd',1,'ABLMost']]], - ['get_5fqmoist_5fptr_3425',['Get_Qmoist_Ptr',['../classEulerianMicrophysics.html#a416981f230a126387b9a664a5a241e9c',1,'EulerianMicrophysics::Get_Qmoist_Ptr()'],['../classMicrophysics.html#a8edecc53bfdfd0d916d37e3584ebb9ff',1,'Microphysics::Get_Qmoist_Ptr()']]], - ['get_5fqmoist_5frestart_5fvars_3426',['Get_Qmoist_Restart_Vars',['../classEulerianMicrophysics.html#a0bf4ba2dccc3aa4f2c462162ad54d1fc',1,'EulerianMicrophysics::Get_Qmoist_Restart_Vars()'],['../classMicrophysics.html#a96e15433c5277151700438dc2f6fba6f',1,'Microphysics::Get_Qmoist_Restart_Vars()']]], - ['get_5fqmoist_5fsize_3427',['Get_Qmoist_Size',['../classEulerianMicrophysics.html#ad4983e19f621a55ad7d942c881215c72',1,'EulerianMicrophysics::Get_Qmoist_Size()'],['../classMicrophysics.html#a069e6013efb78d268394868d0cfc6382',1,'Microphysics::Get_Qmoist_Size()']]], - ['get_5fqstate_5fsize_3428',['Get_Qstate_Size',['../classEulerianMicrophysics.html#a3e973738b4e0bbaa7269ab2395322929',1,'EulerianMicrophysics::Get_Qstate_Size()'],['../classMicrophysics.html#a72f6091687c014c5be34275b0975d194',1,'Microphysics::Get_Qstate_Size()']]], - ['get_5fr_5flw_5fabs_3429',['get_r_lw_abs',['../classPhysProp.html#a4021cec87565fb8d2f83d246764b207c',1,'PhysProp']]], - ['get_5fr_5fsw_5fascat_3430',['get_r_sw_ascat',['../classPhysProp.html#aecc133d246b9b4b8abdb9fa421e55f97',1,'PhysProp']]], - ['get_5fr_5fsw_5fext_3431',['get_r_sw_ext',['../classPhysProp.html#a1320880e1247f0a01dcbb9ae3816c99c',1,'PhysProp']]], - ['get_5fr_5fsw_5fscat_3432',['get_r_sw_scat',['../classPhysProp.html#aa702f18a2ac818d9d7e0766cf2869bcf',1,'PhysProp']]], - ['get_5fref_5fim_5faer_5flw_3433',['get_ref_im_aer_lw',['../classPhysProp.html#a7d6616b7a8f6620f73398bf070dfa1dc',1,'PhysProp']]], - ['get_5fref_5fim_5faer_5fsw_3434',['get_ref_im_aer_sw',['../classPhysProp.html#a2d4a11394149074c3162c5a590f21c06',1,'PhysProp']]], - ['get_5fref_5freal_5faer_5flw_3435',['get_ref_real_aer_lw',['../classPhysProp.html#a4fbfb5110a6a66802698c216c1bac1fb',1,'PhysProp']]], - ['get_5fref_5freal_5faer_5fsw_3436',['get_ref_real_aer_sw',['../classPhysProp.html#a18e492337d988412b003d05ef4e80d7c',1,'PhysProp']]], - ['get_5fref_5fsolar_5fband_5firrad_3437',['get_ref_solar_band_irrad',['../classRadConstants.html#ae7b4458f5981571e705ec1e0bfce7958',1,'RadConstants']]], - ['get_5fref_5ftotal_5fsolar_5firrad_3438',['get_ref_total_solar_irrad',['../classRadConstants.html#a424fcb301777b7ff20173ad5e04ce9c7',1,'RadConstants']]], - ['get_5frefitablw_3439',['get_refitablw',['../classPhysProp.html#a4b98c131872d1f67c1abb1223764d187',1,'PhysProp']]], - ['get_5frefitabsw_3440',['get_refitabsw',['../classPhysProp.html#ad453eea02a9062b10dd761c0056e2bb1',1,'PhysProp']]], - ['get_5frefrtablw_3441',['get_refrtablw',['../classPhysProp.html#aa1b3a919cc5f3d8eb4256191e16c0e67',1,'PhysProp']]], - ['get_5frefrtabsw_3442',['get_refrtabsw',['../classPhysProp.html#ac36ae2fa2fc99bbe00584c1a2019872a',1,'PhysProp']]], - ['get_5frhcrystal_3443',['get_rhcrystal',['../classPhysProp.html#aed30118f34b9185873ef6081ca8d6bc5',1,'PhysProp']]], - ['get_5frhdeliques_3444',['get_rhdeliques',['../classPhysProp.html#acb14a6112ce9896ae00e331897a2349c',1,'PhysProp']]], - ['get_5frhs_3445',['get_rhs',['../classMRISplitIntegrator.html#aaf865e066a3c327ff296c99cd0566373',1,'MRISplitIntegrator']]], - ['get_5fsample_5fdata_3446',['get_sample_data',['../classSampleData.html#a53dbcbfeb5eddba81c85ccf581536a9b',1,'SampleData']]], - ['get_5fsigmag_3447',['get_sigmag',['../classPhysProp.html#a379fe355eb015655be603356966f57fd',1,'PhysProp']]], - ['get_5fslow_5ffast_5ftimestep_5fratio_3448',['get_slow_fast_timestep_ratio',['../classMRISplitIntegrator.html#aba63019a6ac3ea9135772dcd91f49c86',1,'MRISplitIntegrator']]], - ['get_5fsolar_5fband_5ffraction_5firrad_3449',['get_solar_band_fraction_irrad',['../classRadConstants.html#ab017176abc1bf3d9b8f3f4250d75b77d',1,'RadConstants']]], - ['get_5fsourcefile_3450',['get_sourcefile',['../classPhysProp.html#a1ea9a18d70b78eac77cb1b35beb4c6d7',1,'PhysProp']]], - ['get_5fsw_5fhygro_5fasm_3451',['get_sw_hygro_asm',['../classPhysProp.html#af40202fdb4c7bf65c229ff85f48e4927',1,'PhysProp']]], - ['get_5fsw_5fhygro_5fext_3452',['get_sw_hygro_ext',['../classPhysProp.html#a9f8a60becbd6e1c5be14e6e42c043552',1,'PhysProp']]], - ['get_5fsw_5fhygro_5fssa_3453',['get_sw_hygro_ssa',['../classPhysProp.html#a8a18207db0b0c00b2f3ab728762fcee4',1,'PhysProp']]], - ['get_5fsw_5fnonhygro_5fascat_3454',['get_sw_nonhygro_ascat',['../classPhysProp.html#aa76012e67298ec9e2a682f4e1ae4406e',1,'PhysProp']]], - ['get_5fsw_5fnonhygro_5fasm_3455',['get_sw_nonhygro_asm',['../classPhysProp.html#a5f7966a98bc34562f868a85081520fc7',1,'PhysProp']]], - ['get_5fsw_5fnonhygro_5fext_3456',['get_sw_nonhygro_ext',['../classPhysProp.html#a15220c4ef45d858fe3dddb9ed1c14879',1,'PhysProp']]], - ['get_5fsw_5fnonhygro_5fscat_3457',['get_sw_nonhygro_scat',['../classPhysProp.html#a1b7539cc5e72663a669fd912b006a2ea',1,'PhysProp']]], - ['get_5fsw_5fnonhygro_5fssa_3458',['get_sw_nonhygro_ssa',['../classPhysProp.html#a07b254998ca2806c8c307529c2596ef8',1,'PhysProp']]], - ['get_5fsw_5fspectral_5fboundaries_3459',['get_sw_spectral_boundaries',['../classRadConstants.html#a7d32f7699c2933c60da5163952bfc4cb',1,'RadConstants']]], - ['get_5fsw_5fspectral_5fmidpoints_3460',['get_sw_spectral_midpoints',['../classRadConstants.html#adbfa470ed64a37cb47761a3a8a4678b7',1,'RadConstants']]], - ['get_5ft_5fstar_3461',['get_t_star',['../classABLMost.html#a108ee0811499e80c9d3226bb20da6973',1,'ABLMost']]], - ['get_5ft_5fsurf_3462',['get_t_surf',['../classABLMost.html#aca21d4f7aae064515bfec992b263d6d2',1,'ABLMost']]], - ['get_5ftime_3463',['get_time',['../structTimeInterpolatedData.html#a5b5af3383ee7cba684df54a2cb704d09',1,'TimeInterpolatedData']]], - ['get_5fturb_5fdisk_5fangle_3464',['get_turb_disk_angle',['../classNullWindFarm.html#ac1242356bf27b796b89bea7db82e724b',1,'NullWindFarm']]], - ['get_5fturb_5floc_3465',['get_turb_loc',['../classNullWindFarm.html#a85f4b30a21138dce73af7ea3769d5580',1,'NullWindFarm']]], - ['get_5fturb_5fspec_3466',['get_turb_spec',['../classNullWindFarm.html#a11fd7bf185b205f71197da8ba41edfb6',1,'NullWindFarm']]], - ['get_5fturb_5fspec_5fextra_3467',['get_turb_spec_extra',['../classNullWindFarm.html#a77d2fbe9dc6053701fa98acf5c5c8b25',1,'NullWindFarm']]], - ['get_5fu_5fstar_3468',['get_u_star',['../classABLMost.html#a0890b6ae8c80d8888effa040af808df0',1,'ABLMost']]], - ['get_5fvar_3469',['get_var',['../structTimeInterpolatedData.html#a65f3edf3f03a779a931f5c58bd438602',1,'TimeInterpolatedData']]], - ['get_5fvarname_3470',['Get_VarName',['../classLandSurface.html#a0e04fe7c9b1f9025e8f4458c4522b1d5',1,'LandSurface']]], - ['get_5fvname_3471',['get_vname',['../structNDArray.html#a4d7550e3c00d13d8397f1cfbdfd2ab48',1,'NDArray']]], - ['get_5fvolcanic_5frad_5fprops_3472',['get_volcanic_rad_props',['../classAerRadProps.html#a74842fff81711719376fc035b86dc1a7',1,'AerRadProps']]], - ['get_5fvolcanic_5fradius_5frad_5fprops_3473',['get_volcanic_radius_rad_props',['../classAerRadProps.html#a55507a56c5808f7480e42f4369cbf5a7',1,'AerRadProps']]], - ['get_5fvshape_3474',['get_vshape',['../structNDArray.html#ad839c3c65bd755311afb6f0dad08f336',1,'NDArray']]], - ['get_5fw_5fstar_3475',['get_w_star',['../classABLMost.html#a9ea0efa20ea7a0dfd12ccc8c13c7f5fd',1,'ABLMost']]], - ['get_5fz0_3476',['get_z0',['../classABLMost.html#a626a97f944cb297c966a2ff7ce0bad97',1,'ABLMost']]], - ['get_5fzref_3477',['get_zref',['../classABLMost.html#ae638411093a2d3cc6cc525d4d7efa7ed',1,'ABLMost::get_zref()'],['../classMOSTAverage.html#a5b590fcba4d5d99178a0f8de14a1f174',1,'MOSTAverage::get_zref()']]], - ['getadvfluxreg_3478',['getAdvFluxReg',['../classERF.html#a4d6d990d8111c170692b1e9cc0e918b8',1,'ERF']]], - ['getcputime_3479',['getCPUTime',['../classERF.html#ae0597da6edf955cd138e52fd00380ff2',1,'ERF']]], - ['getdpdrgivenconstanttheta_3480',['getdPdRgivenConstantTheta',['../ERF__EOS_8H.html#a91cb501e961a0d0a6a3c62b5c36702cd',1,'ERF_EOS.H']]], - ['getepochtime_3481',['getEpochTime',['../ERF__NCWpsFile_8H.html#a370a1cca0113b3529a59c031ff71ffb8',1,'ERF_NCWpsFile.H']]], - ['getexnergivenp_3482',['getExnergivenP',['../ERF__EOS_8H.html#ab415ab4061cbbea05723267a0bf82c6b',1,'ERF_EOS.H']]], - ['getexnergivenrth_3483',['getExnergivenRTh',['../ERF__EOS_8H.html#a24b76fd72f051dc593840f006d79fd1a',1,'ERF_EOS.H']]], - ['getfluxes_3484',['getFluxes',['../classTerrainPoisson.html#ab2c2fee50d531c3bcc1f0c92d548e3a6',1,'TerrainPoisson']]], - ['getindexbox_3485',['getIndexBox',['../structPlaneSampler.html#a1f71b67544dbc9c4cba7d11bc5e5b45d',1,'PlaneSampler']]], - ['getindx_3486',['getIndx',['../structDirectionSelector.html#a3950b636303028f398441fdc43d66dba',1,'DirectionSelector::getIndx()'],['../structDirectionSelector_3_010_01_4.html#a74c1bd1dca28b374962977ab8e32595e',1,'DirectionSelector< 0 >::getIndx()'],['../structDirectionSelector_3_011_01_4.html#ae5631c2b7917d2bc7cb479a266a61834',1,'DirectionSelector< 1 >::getIndx()'],['../structDirectionSelector_3_012_01_4.html#a5708ddb92c7d49cc9ba821f978251160',1,'DirectionSelector< 2 >::getIndx()']]], - ['getmask_3487',['GetMask',['../classERFFillPatcher.html#a2c0b26e7da60e74734191617c50754e1',1,'ERFFillPatcher']]], - ['getpgivenrth_3488',['getPgivenRTh',['../ERF__EOS_8H.html#a08354ab110fb9e873bce9250b4f4b46e',1,'ERF_EOS.H']]], - ['getrelaxmaskval_3489',['GetRelaxMaskVal',['../classERFFillPatcher.html#ae36410e2a848977e145b29c755ac8b5d',1,'ERFFillPatcher']]], - ['getrhogiventandpress_3490',['getRhogivenTandPress',['../ERF__EOS_8H.html#ad5b95b0051794b77cd7538c45fbb3b71',1,'ERF_EOS.H']]], - ['getrhogiventhetapress_3491',['getRhogivenThetaPress',['../ERF__EOS_8H.html#a3ee1ea27d3b9f25afcc603f3e5b17955',1,'ERF_EOS.H']]], - ['getrhothetagivenp_3492',['getRhoThetagivenP',['../ERF__EOS_8H.html#a3cc0ee7727b26e21a97acfc2ad2e6d4d',1,'ERF_EOS.H']]], - ['getsetmaskval_3493',['GetSetMaskVal',['../classERFFillPatcher.html#aa1dd4ccdd7812057d8ee529015e3750d',1,'ERFFillPatcher']]], - ['gettgivenpandth_3494',['getTgivenPandTh',['../ERF__EOS_8H.html#ae76d3ce3486d0e450849c56159f2dbd4',1,'ERF_EOS.H']]], - ['gettgivenrandrth_3495',['getTgivenRandRTh',['../ERF__EOS_8H.html#a65cf1718b7a1fcc56cb16685642543da',1,'ERF_EOS.H']]], - ['getthgivenpandt_3496',['getThgivenPandT',['../ERF__EOS_8H.html#acd37b404bbf95073ffef2a1003dc56c5',1,'ERF_EOS.H']]], - ['getthgivenrandt_3497',['getThgivenRandT',['../ERF__EOS_8H.html#ad0e28e4df049e6e34fa4a973dd446506',1,'ERF_EOS.H']]], - ['goffgratch_5fsvp_5fice_3498',['GoffGratch_svp_ice',['../classSatMethods.html#a9e929b8ac05dbeaa78dc158159f84758',1,'SatMethods']]], - ['goffgratch_5fsvp_5fwater_3499',['GoffGratch_svp_water',['../classSatMethods.html#a264a283910d028a29c374900fc03017f',1,'SatMethods']]], - ['gotonextline_3500',['GotoNextLine',['../classERF.html#aaee255b031e63bd9b5807f6612739dbd',1,'ERF']]], - ['group_3501',['group',['../classncutils_1_1NCGroup.html#a757c592cddc2272a86033fe888232333',1,'ncutils::NCGroup']]] + ['gam_5fliquid_5flw_3331',['gam_liquid_lw',['../classCloudRadProps.html#a5772a63dc315f019d951785ebdb9c13d',1,'CloudRadProps']]], + ['gam_5fliquid_5fsw_3332',['gam_liquid_sw',['../classCloudRadProps.html#a2890fa11a8f395809fe215447e339c20',1,'CloudRadProps']]], + ['gammadist_5fliq_5foptics_5flw_3333',['gammadist_liq_optics_lw',['../classCloudRadProps.html#a31a396f1997438a7cbb347767dca311a',1,'CloudRadProps']]], + ['gammadist_5fliq_5foptics_5fsw_3334',['gammadist_liq_optics_sw',['../classCloudRadProps.html#adcaf1c142347cdcd3b761af9c7ee5c56',1,'CloudRadProps']]], + ['gatherkeyvaluepairs_3335',['gatherKeyValuePairs',['../classWindFarm.html#aaa0f45adf2528c2f8c5be67ac4a18e8b',1,'WindFarm']]], + ['generalad_3336',['GeneralAD',['../classGeneralAD.html#a94e69e67c451652660642f85b48de07b',1,'GeneralAD']]], + ['get_3337',['get',['../structncutils_1_1NCVar.html#ab39527f40ff0417de3c1ff8c441ced93',1,'ncutils::NCVar::get(float *) const'],['../structncutils_1_1NCVar.html#a0a7990c37360c27e7ba2fb47617f5255',1,'ncutils::NCVar::get(int *) const'],['../structncutils_1_1NCVar.html#a533478371e0bd09a6f4944bf5fe00684',1,'ncutils::NCVar::get(double *, const std::vector< size_t > &, const std::vector< size_t > &) const'],['../structncutils_1_1NCVar.html#ab3b5bad54cdc792e734690fcb5f4ecec',1,'ncutils::NCVar::get(double *, const std::vector< size_t > &, const std::vector< size_t > &, const std::vector< ptrdiff_t > &) const'],['../structncutils_1_1NCVar.html#ad6fc629cd035e5779e9e891fd37e68ae',1,'ncutils::NCVar::get(float *, const std::vector< size_t > &, const std::vector< size_t > &) const'],['../structncutils_1_1NCVar.html#af036d4858171a98b8a951348a654a36c',1,'ncutils::NCVar::get(float *, const std::vector< size_t > &, const std::vector< size_t > &, const std::vector< ptrdiff_t > &) const'],['../structncutils_1_1NCVar.html#a0a1082e40bee181e99e04ca81311bb70',1,'ncutils::NCVar::get(int *, const std::vector< size_t > &, const std::vector< size_t > &) const'],['../structncutils_1_1NCVar.html#ab994c2ebc61623888b2e3fc6bf399bff',1,'ncutils::NCVar::get(int *, const std::vector< size_t > &, const std::vector< size_t > &, const std::vector< ptrdiff_t > &) const'],['../structncutils_1_1NCVar.html#a7fe596943d518530da29a356d393090d',1,'ncutils::NCVar::get(char *, const std::vector< size_t > &, const std::vector< size_t > &) const'],['../structncutils_1_1NCVar.html#ad73293d8faae951e5f91cc3ba49d0f8c',1,'ncutils::NCVar::get(char *, const std::vector< size_t > &, const std::vector< size_t > &, const std::vector< ptrdiff_t > &) const'],['../structncutils_1_1NCVar.html#ac88fd209afde1f05e4f8f62e4c628bba',1,'ncutils::NCVar::get(double *) const']]], + ['get_5fabsplw_3338',['get_absplw',['../classPhysProp.html#ae5d9c299d02610cebe15c8b214162949',1,'PhysProp']]], + ['get_5fabspsw_3339',['get_abspsw',['../classPhysProp.html#a610235368bd270cf3f484efcfcbf8690',1,'PhysProp']]], + ['get_5faer_5flw_5fabs_3340',['get_aer_lw_abs',['../classMamConstituents.html#a39c17e36a63359f40e0d3d32189aab96',1,'MamConstituents']]], + ['get_5faer_5flw_5fhygro_5fabs_3341',['get_aer_lw_hygro_abs',['../classMamConstituents.html#a0de07ed11529ba2b684aeba702294d03',1,'MamConstituents']]], + ['get_5faer_5fmu_3342',['get_aer_mu',['../classMamConstituents.html#aa5ae6b3a2418d42d2d8e39a35a71a88d',1,'MamConstituents']]], + ['get_5faer_5fopticstype_3343',['get_aer_opticstype',['../classMamConstituents.html#abec0c34aadac9883294cdc35a507856a',1,'MamConstituents']]], + ['get_5faer_5fr_5flw_5fabs_3344',['get_aer_r_lw_abs',['../classMamConstituents.html#acda5a38c4660d35fe7453bddc6106808',1,'MamConstituents']]], + ['get_5faer_5fr_5fsw_5fascat_3345',['get_aer_r_sw_ascat',['../classMamConstituents.html#a0d3f86cd0ffb6e60c4df7ad4ce6a11bc',1,'MamConstituents']]], + ['get_5faer_5fr_5fsw_5fext_3346',['get_aer_r_sw_ext',['../classMamConstituents.html#a2f8b2adaa3a57f55957f3ae733a2d824',1,'MamConstituents']]], + ['get_5faer_5fr_5fsw_5fscat_3347',['get_aer_r_sw_scat',['../classMamConstituents.html#a01578fc8bfc4e59b9d3718fe28f5b618',1,'MamConstituents']]], + ['get_5faer_5frefindex_5faer_5flw_3348',['get_aer_refindex_aer_lw',['../classMamConstituents.html#a93552325254a27f4e30dc863a391c00f',1,'MamConstituents']]], + ['get_5faer_5frefindex_5faer_5fsw_3349',['get_aer_refindex_aer_sw',['../classMamConstituents.html#ab9010182eadd9654fed594e351473f3a',1,'MamConstituents']]], + ['get_5faer_5fsw_5fhygro_5fasm_3350',['get_aer_sw_hygro_asm',['../classMamConstituents.html#aa10ea52298c1c8c1e2761a77e95ecce0',1,'MamConstituents']]], + ['get_5faer_5fsw_5fhygro_5fext_3351',['get_aer_sw_hygro_ext',['../classMamConstituents.html#ab71a35dafa0ad47969c8b313dbcf08e7',1,'MamConstituents']]], + ['get_5faer_5fsw_5fhygro_5fssa_3352',['get_aer_sw_hygro_ssa',['../classMamConstituents.html#ab4b263716e034493d0b8568954f97cf8',1,'MamConstituents']]], + ['get_5faer_5fsw_5fnonhygro_5fascat_3353',['get_aer_sw_nonhygro_ascat',['../classMamConstituents.html#a9b76d886c4a041e4a04632c8826f720f',1,'MamConstituents']]], + ['get_5faer_5fsw_5fnonhygro_5fasm_3354',['get_aer_sw_nonhygro_asm',['../classMamConstituents.html#a8b1568c4a639828008d0355f92461e34',1,'MamConstituents']]], + ['get_5faer_5fsw_5fnonhygro_5fext_3355',['get_aer_sw_nonhygro_ext',['../classMamConstituents.html#a4a957acf92c695c67d59c57549f27e1f',1,'MamConstituents']]], + ['get_5faer_5fsw_5fnonhygro_5fscat_3356',['get_aer_sw_nonhygro_scat',['../classMamConstituents.html#a134c22a50d8162187020229e600d955a',1,'MamConstituents']]], + ['get_5faer_5fsw_5fnonhygro_5fssa_3357',['get_aer_sw_nonhygro_ssa',['../classMamConstituents.html#ab56197f3c64da14398867aa6f8d38183',1,'MamConstituents']]], + ['get_5faername_3358',['get_aername',['../classMamConstituents.html#a45f560dfc8f2f43d113f721748207196',1,'MamConstituents::get_aername()'],['../classPhysProp.html#a79b16991c9e3b083c695283026ad5ec8',1,'PhysProp::get_aername()']]], + ['get_5faero_5fnames_3359',['get_aero_names',['../classMamConstituents.html#a7ad0e1141a6be427a07fbc7ee575d767',1,'MamConstituents']]], + ['get_5fasmpsw_3360',['get_asmpsw',['../classPhysProp.html#ac5dc40de142866db795e2cd06c7629ab',1,'PhysProp']]], + ['get_5fattr_3361',['get_attr',['../structncutils_1_1NCVar.html#aa5b83489bee14205286a757e0789ddbd',1,'ncutils::NCVar::get_attr()'],['../classncutils_1_1NCGroup.html#ac5beadfdf8519b384504dc82f6bdecc5',1,'ncutils::NCGroup::get_attr(const std::string &name, std::vector< int > &value) const'],['../classncutils_1_1NCGroup.html#ac25f1ca78fc2cd66e7b80fdcc30f512f',1,'ncutils::NCGroup::get_attr(const std::string &name, std::vector< float > &value) const'],['../classncutils_1_1NCGroup.html#a0f24e998915e60b177d036595f0f2734',1,'ncutils::NCGroup::get_attr(const std::string &name, std::vector< double > &value) const'],['../classncutils_1_1NCGroup.html#a2f10bc405d66f794c4e8a8fd71dc718d',1,'ncutils::NCGroup::get_attr(const std::string &name) const'],['../structncutils_1_1NCVar.html#a720f935c1949f56e31eb057dbc1e7ea6',1,'ncutils::NCVar::get_attr(const std::string &name, std::vector< int > &value) const'],['../structncutils_1_1NCVar.html#af09b0c94dceb8666a7be0d6167bfc4b4',1,'ncutils::NCVar::get_attr(const std::string &name, std::vector< float > &value) const'],['../structncutils_1_1NCVar.html#a774b3bda4e9dc903ecfa35af38e863c6',1,'ncutils::NCVar::get_attr(const std::string &name) const']]], + ['get_5faverage_3362',['get_average',['../classMOSTAverage.html#aa52cd2c83e24eef47d6a409b7bcf4c81',1,'MOSTAverage']]], + ['get_5fblade_5fairfoil_5fspec_3363',['get_blade_airfoil_spec',['../classNullWindFarm.html#abc6967908665ee89bd0546d24ef6f2a6',1,'NullWindFarm']]], + ['get_5fblade_5fspec_3364',['get_blade_spec',['../classNullWindFarm.html#ac88481b8d5d1cf63fabe89edee9cc8cd',1,'NullWindFarm']]], + ['get_5fcloud_5foptics_5flw_3365',['get_cloud_optics_lw',['../classOptics.html#af5f3fa679301f0ead8b8155626b2e710',1,'Optics']]], + ['get_5fcloud_5foptics_5fsw_3366',['get_cloud_optics_sw',['../classOptics.html#aee82856b88240c428aefc6f47bf9500c',1,'Optics']]], + ['get_5fdata_3367',['get_data',['../structNDArray.html#aa1c5762c2de2f4286d4f341b618df1e5',1,'NDArray']]], + ['get_5fdata_5fptr_3368',['Get_Data_Ptr',['../classLandSurface.html#af125bc0c5860b3564afdfce10ec253ea',1,'LandSurface']]], + ['get_5fdata_5fsize_3369',['Get_Data_Size',['../classLandSurface.html#a2652af07555cc98d15d3516371fa42e6',1,'LandSurface']]], + ['get_5fdensity_5faer_3370',['get_density_aer',['../classMamConstituents.html#a7e8f938768431f79e7816950449f8e1d',1,'MamConstituents::get_density_aer()'],['../classPhysProp.html#adb91fa4653cd03d2eefbab2e6577500c',1,'PhysProp::get_density_aer(int &id, real &density_aer) const']]], + ['get_5fdgnum_3371',['get_dgnum',['../classPhysProp.html#a3cc2840e071eae998f97139436d6fee7',1,'PhysProp']]], + ['get_5fdgnumhi_3372',['get_dgnumhi',['../classPhysProp.html#afeca92e20ff289545c11f63419805ab6',1,'PhysProp']]], + ['get_5fdgnumlo_3373',['get_dgnumlo',['../classPhysProp.html#af7c5da49376c0082a11ea77ac0368fc3',1,'PhysProp']]], + ['get_5fdispersion_5faer_3374',['get_dispersion_aer',['../classMamConstituents.html#a91e1af3f8fe81cd67b9442679c983d70',1,'MamConstituents::get_dispersion_aer()'],['../classPhysProp.html#ab4d9d3e81d7f582b89f42d1d8c2c360f',1,'PhysProp::get_dispersion_aer()']]], + ['get_5fdrag_5ffield_3375',['get_drag_field',['../classForestDrag.html#abbfaec28be888963879442d65e61839c',1,'ForestDrag']]], + ['get_5fdryrad_5faer_3376',['get_dryrad_aer',['../classMamConstituents.html#abb8a46935c06e23274d3c33b9d1f443b',1,'MamConstituents::get_dryrad_aer()'],['../classPhysProp.html#ab3828a02687668e5cd1ff46dab659ed7',1,'PhysProp::get_dryrad_aer(int &id, real &dryrad_aer) const']]], + ['get_5fextpsw_3377',['get_extpsw',['../classPhysProp.html#a671b14d041b5e71b62aff2904fbcf203',1,'PhysProp']]], + ['get_5fflux_5fptr_3378',['Get_Flux_Ptr',['../classLandSurface.html#a967a4b0772dc721d0242d38613ac430e',1,'LandSurface']]], + ['get_5fgas_5fnames_3379',['get_gas_names',['../classMamConstituents.html#a737daa041cc666d79764053a35175a15',1,'MamConstituents']]], + ['get_5fgas_5fvmr_3380',['get_gas_vmr',['../classRadiation.html#a17087b1575e1d891f0617b22ca78bec3',1,'Radiation']]], + ['get_5fgpoint_5fbands_5flw_3381',['get_gpoint_bands_lw',['../classRrtmgp.html#a3599409b29ca122c0ac8e360097d6551',1,'Rrtmgp']]], + ['get_5fgpoint_5fbands_5fsw_3382',['get_gpoint_bands_sw',['../classRrtmgp.html#a731fae99697b1f9f94847726d59fb77e',1,'Rrtmgp']]], + ['get_5fhygro_5faer_3383',['get_hygro_aer',['../classMamConstituents.html#a31022a0fcf609baace2c55378a1e74a9',1,'MamConstituents::get_hygro_aer()'],['../classPhysProp.html#a5808428f8d4a9c4f118e52a46ba1f9d0',1,'PhysProp::get_hygro_aer()']]], + ['get_5fhygro_5frad_5fprops_3384',['get_hygro_rad_props',['../classAerRadProps.html#a6a1e71160911bbc52d09bdbd73acb219',1,'AerRadProps']]], + ['get_5fline_5fmfs_3385',['get_line_mfs',['../structLineSampler.html#a290c3f1bc30a85e67ca18f2bbd3e2cdf',1,'LineSampler']]], + ['get_5flmask_3386',['get_lmask',['../classABLMost.html#a48a21c911803192130c2472c89b72c72',1,'ABLMost']]], + ['get_5flsm_5fgeom_3387',['Get_Lsm_Geom',['../classLandSurface.html#a368a57f198d060805dcd615677366c3c',1,'LandSurface']]], + ['get_5flsm_5ftsurf_3388',['get_lsm_tsurf',['../classABLMost.html#ae28fd8a21f4b514875c24fe4b8e85081',1,'ABLMost']]], + ['get_5flw_5fabs_3389',['get_lw_abs',['../classPhysProp.html#af7d8981c1033f1eb0e48168e0d52c572',1,'PhysProp']]], + ['get_5flw_5fhygro_5fabs_3390',['get_lw_hygro_abs',['../classPhysProp.html#a30f4cd3f9cfc6e7e69c5e5c732f0d7be',1,'PhysProp']]], + ['get_5flw_5fspectral_5fboundaries_3391',['get_lw_spectral_boundaries',['../classRadConstants.html#a242b8b89c7cd6415af91e2bc35a5fd58',1,'RadConstants']]], + ['get_5flw_5fspectral_5fmidpoints_3392',['get_lw_spectral_midpoints',['../classRadConstants.html#a1ac73a96f506a7f16b7fd7500e1fa592',1,'RadConstants']]], + ['get_5fmac_5favg_3393',['get_mac_avg',['../classABLMost.html#af26cdc6b8c162c14b2db32eb395f0565',1,'ABLMost']]], + ['get_5fmam_5fdensity_5faer_3394',['get_mam_density_aer',['../classMamConstituents.html#aaff13adc5b53a73c3247e33451b3889c',1,'MamConstituents']]], + ['get_5fmam_5fhygro_5faer_3395',['get_mam_hygro_aer',['../classMamConstituents.html#ad55d7f5b5933d5586271523a02ac2d55',1,'MamConstituents']]], + ['get_5fmam_5fprops_3396',['get_mam_props',['../classMamConstituents.html#a7c3b6e3de312e64999a8465e89ff66e0',1,'MamConstituents::get_mam_props(int list_idx, int mode_idx, int spec_idx, real &density_aer, std::string &spectype, real &hygro_aer, real1d &refindex_real_aer_sw, real1d &refindex_im_aer_sw) const'],['../classMamConstituents.html#a85d32d9bc9d6b9931debba102cdbfd5c',1,'MamConstituents::get_mam_props(int list_idx, int mode_idx, int spec_idx, real &density_aer) const']]], + ['get_5fmam_5fprops_5flw_3397',['get_mam_props_lw',['../classMamConstituents.html#aaf6b7130c9c8322fdf76384d13e8a2e5',1,'MamConstituents']]], + ['get_5fmam_5fprops_5fsw_3398',['get_mam_props_sw',['../classMamConstituents.html#aff2f99c0ce814bed40bf8256e68e9c2c',1,'MamConstituents']]], + ['get_5fmax_5ftemperature_3399',['get_max_temperature',['../classRrtmgp.html#a54d681da78a4c643e44de12c096429b1',1,'Rrtmgp']]], + ['get_5fmin_5ftemperature_3400',['get_min_temperature',['../classRrtmgp.html#a9f2ab92b47552998f259e3e8cfd1ae25',1,'Rrtmgp']]], + ['get_5fmode_5fnspec_3401',['get_mode_nspec',['../classMamConstituents.html#a4741e14c61b6fb2dbac43af6c9aeec4a',1,'MamConstituents']]], + ['get_5fmode_5fprops_3402',['get_mode_props',['../classMamConstituents.html#adc3ace4b56e9fe92cae40983334c52d3',1,'MamConstituents::get_mode_props(int list_idx, int mode_idx, real &sigmag, real &rhcrystal, real &rhdeliques) const'],['../classMamConstituents.html#adeecb1b611d4a93bbeec8458eb28531b',1,'MamConstituents::get_mode_props(int list_idx, int mode_idx, real &sigmag, real2d &refrtablw, real2d &refitablw, real4d &absplw) const'],['../classMamConstituents.html#a41ac833b93f17975d4767ce1fa423a54',1,'MamConstituents::get_mode_props(int list_idx, int mode_idx, real &sigmag, real2d &refrtabsw, real2d &refitabsw, real4d &extpsw, real4d &abspsw, real4d &asmpsw) const'],['../classMamConstituents.html#a1139674e487977095e719a5d3206d00f',1,'MamConstituents::get_mode_props(int list_idx, int mode_idx, int &ncoef, int &prefr, int &prefi) const'],['../classMamConstituents.html#a5b6614e45aaf28a941c327285fd1cf62',1,'MamConstituents::get_mode_props(int list_idx, int mode_idx, real &dgnum, real &dgnumhi, real &dgnumlo, real &sigmag) const']]], + ['get_5fmu_3403',['get_mu',['../classPhysProp.html#a5b078a171f29ecd73946aadf4024beeb',1,'PhysProp']]], + ['get_5fmu_5flambda_5fweights_3404',['get_mu_lambda_weights',['../classCloudRadProps.html#ab5a9764068553f94a590310ff990a97d',1,'CloudRadProps']]], + ['get_5fnaero_3405',['get_naero',['../classMamConstituents.html#aec2a842a29c81c329c98202e33c74740',1,'MamConstituents']]], + ['get_5fnband_5flw_3406',['get_nband_lw',['../classRrtmgp.html#a63713fbd29d350a8d26ba7cd745439f8',1,'Rrtmgp']]], + ['get_5fnband_5fsw_3407',['get_nband_sw',['../classRrtmgp.html#a3d2da27814d96e130b6f0486b36fc6e9',1,'Rrtmgp']]], + ['get_5fncoef_3408',['get_ncoef',['../classPhysProp.html#a93fd04f58151457c6df91467cb97cb7a',1,'PhysProp']]], + ['get_5fngas_3409',['get_ngas',['../classMamConstituents.html#a9f278742417afa46505432a0d243e8ea',1,'MamConstituents']]], + ['get_5fngpt_5flw_3410',['get_ngpt_lw',['../classRrtmgp.html#a208b68626f3d16b530e053f6f0d99d56',1,'Rrtmgp']]], + ['get_5fngpt_5fsw_3411',['get_ngpt_sw',['../classRrtmgp.html#a6f4be82ac30aabe0107060413c7bd9a1',1,'Rrtmgp']]], + ['get_5fnmodes_3412',['get_nmodes',['../classMamConstituents.html#ab6dd677adef9ea89d15a8f1795cb4904',1,'MamConstituents']]], + ['get_5fnonhygro_5frad_5fprops_3413',['get_nonhygro_rad_props',['../classAerRadProps.html#af6e6827c17d2247b72337a35875ea0e0',1,'AerRadProps']]], + ['get_5fnum_5fto_5fmass_5faer_3414',['get_num_to_mass_aer',['../classMamConstituents.html#a22531d4c0d7c79629e9ef32e3e42b2e3',1,'MamConstituents::get_num_to_mass_aer()'],['../classPhysProp.html#ad29374a68385062f7fb8becc4606cf7b',1,'PhysProp::get_num_to_mass_aer()']]], + ['get_5fnumber_5fsw_5fbands_3415',['get_number_sw_bands',['../classRadConstants.html#afefd717015853c1a0f91ac4f5284702c',1,'RadConstants']]], + ['get_5folen_3416',['get_olen',['../classABLMost.html#aef7480dbb43cafff3be93a95240c1ec3',1,'ABLMost']]], + ['get_5fopticstype_3417',['get_opticstype',['../classPhysProp.html#a61a4b378d133e890ff2b354f94ef5b37',1,'PhysProp']]], + ['get_5fpb_5fmag_3418',['get_pb_mag',['../structTurbulentPerturbation.html#a237c085bf6fa265eef471d19bbca613f',1,'TurbulentPerturbation']]], + ['get_5fpb_5fnetzero_3419',['get_pb_netZero',['../structTurbulentPerturbation.html#aa8a048ec67a9e110cef012105dd615cf',1,'TurbulentPerturbation']]], + ['get_5fpblh_3420',['get_pblh',['../classABLMost.html#aaac1902b108e37bf0508306cb171c6ad',1,'ABLMost']]], + ['get_5fplane_5fmfs_3421',['get_plane_mfs',['../structPlaneSampler.html#a68ea5715d34cefd4d9a2c2cbc38114f2',1,'PlaneSampler']]], + ['get_5fprefi_3422',['get_prefi',['../classPhysProp.html#af1803621d0f45e015e831171dd91255e',1,'PhysProp']]], + ['get_5fprefr_3423',['get_prefr',['../classPhysProp.html#a1c586690e59a32d4775a2c665bb999f4',1,'PhysProp']]], + ['get_5fprojection_5fbc_3424',['get_projection_bc',['../classERF.html#a57580311d47c9fd5e27ba156d287c169',1,'ERF']]], + ['get_5fq_5fstar_3425',['get_q_star',['../classABLMost.html#a5468d40c9751664279c940369c8040dd',1,'ABLMost']]], + ['get_5fqmoist_5fptr_3426',['Get_Qmoist_Ptr',['../classEulerianMicrophysics.html#a416981f230a126387b9a664a5a241e9c',1,'EulerianMicrophysics::Get_Qmoist_Ptr()'],['../classMicrophysics.html#a8edecc53bfdfd0d916d37e3584ebb9ff',1,'Microphysics::Get_Qmoist_Ptr()']]], + ['get_5fqmoist_5frestart_5fvars_3427',['Get_Qmoist_Restart_Vars',['../classEulerianMicrophysics.html#a0bf4ba2dccc3aa4f2c462162ad54d1fc',1,'EulerianMicrophysics::Get_Qmoist_Restart_Vars()'],['../classMicrophysics.html#a96e15433c5277151700438dc2f6fba6f',1,'Microphysics::Get_Qmoist_Restart_Vars()']]], + ['get_5fqmoist_5fsize_3428',['Get_Qmoist_Size',['../classEulerianMicrophysics.html#ad4983e19f621a55ad7d942c881215c72',1,'EulerianMicrophysics::Get_Qmoist_Size()'],['../classMicrophysics.html#a069e6013efb78d268394868d0cfc6382',1,'Microphysics::Get_Qmoist_Size()']]], + ['get_5fqstate_5fsize_3429',['Get_Qstate_Size',['../classEulerianMicrophysics.html#a3e973738b4e0bbaa7269ab2395322929',1,'EulerianMicrophysics::Get_Qstate_Size()'],['../classMicrophysics.html#a72f6091687c014c5be34275b0975d194',1,'Microphysics::Get_Qstate_Size()']]], + ['get_5fr_5flw_5fabs_3430',['get_r_lw_abs',['../classPhysProp.html#a4021cec87565fb8d2f83d246764b207c',1,'PhysProp']]], + ['get_5fr_5fsw_5fascat_3431',['get_r_sw_ascat',['../classPhysProp.html#aecc133d246b9b4b8abdb9fa421e55f97',1,'PhysProp']]], + ['get_5fr_5fsw_5fext_3432',['get_r_sw_ext',['../classPhysProp.html#a1320880e1247f0a01dcbb9ae3816c99c',1,'PhysProp']]], + ['get_5fr_5fsw_5fscat_3433',['get_r_sw_scat',['../classPhysProp.html#aa702f18a2ac818d9d7e0766cf2869bcf',1,'PhysProp']]], + ['get_5fref_5fim_5faer_5flw_3434',['get_ref_im_aer_lw',['../classPhysProp.html#a7d6616b7a8f6620f73398bf070dfa1dc',1,'PhysProp']]], + ['get_5fref_5fim_5faer_5fsw_3435',['get_ref_im_aer_sw',['../classPhysProp.html#a2d4a11394149074c3162c5a590f21c06',1,'PhysProp']]], + ['get_5fref_5freal_5faer_5flw_3436',['get_ref_real_aer_lw',['../classPhysProp.html#a4fbfb5110a6a66802698c216c1bac1fb',1,'PhysProp']]], + ['get_5fref_5freal_5faer_5fsw_3437',['get_ref_real_aer_sw',['../classPhysProp.html#a18e492337d988412b003d05ef4e80d7c',1,'PhysProp']]], + ['get_5fref_5fsolar_5fband_5firrad_3438',['get_ref_solar_band_irrad',['../classRadConstants.html#ae7b4458f5981571e705ec1e0bfce7958',1,'RadConstants']]], + ['get_5fref_5ftotal_5fsolar_5firrad_3439',['get_ref_total_solar_irrad',['../classRadConstants.html#a424fcb301777b7ff20173ad5e04ce9c7',1,'RadConstants']]], + ['get_5frefitablw_3440',['get_refitablw',['../classPhysProp.html#a4b98c131872d1f67c1abb1223764d187',1,'PhysProp']]], + ['get_5frefitabsw_3441',['get_refitabsw',['../classPhysProp.html#ad453eea02a9062b10dd761c0056e2bb1',1,'PhysProp']]], + ['get_5frefrtablw_3442',['get_refrtablw',['../classPhysProp.html#aa1b3a919cc5f3d8eb4256191e16c0e67',1,'PhysProp']]], + ['get_5frefrtabsw_3443',['get_refrtabsw',['../classPhysProp.html#ac36ae2fa2fc99bbe00584c1a2019872a',1,'PhysProp']]], + ['get_5frhcrystal_3444',['get_rhcrystal',['../classPhysProp.html#aed30118f34b9185873ef6081ca8d6bc5',1,'PhysProp']]], + ['get_5frhdeliques_3445',['get_rhdeliques',['../classPhysProp.html#acb14a6112ce9896ae00e331897a2349c',1,'PhysProp']]], + ['get_5frhs_3446',['get_rhs',['../classMRISplitIntegrator.html#aaf865e066a3c327ff296c99cd0566373',1,'MRISplitIntegrator']]], + ['get_5fsample_5fdata_3447',['get_sample_data',['../classSampleData.html#a53dbcbfeb5eddba81c85ccf581536a9b',1,'SampleData']]], + ['get_5fsigmag_3448',['get_sigmag',['../classPhysProp.html#a379fe355eb015655be603356966f57fd',1,'PhysProp']]], + ['get_5fslow_5ffast_5ftimestep_5fratio_3449',['get_slow_fast_timestep_ratio',['../classMRISplitIntegrator.html#aba63019a6ac3ea9135772dcd91f49c86',1,'MRISplitIntegrator']]], + ['get_5fsolar_5fband_5ffraction_5firrad_3450',['get_solar_band_fraction_irrad',['../classRadConstants.html#ab017176abc1bf3d9b8f3f4250d75b77d',1,'RadConstants']]], + ['get_5fsourcefile_3451',['get_sourcefile',['../classPhysProp.html#a1ea9a18d70b78eac77cb1b35beb4c6d7',1,'PhysProp']]], + ['get_5fsw_5fhygro_5fasm_3452',['get_sw_hygro_asm',['../classPhysProp.html#af40202fdb4c7bf65c229ff85f48e4927',1,'PhysProp']]], + ['get_5fsw_5fhygro_5fext_3453',['get_sw_hygro_ext',['../classPhysProp.html#a9f8a60becbd6e1c5be14e6e42c043552',1,'PhysProp']]], + ['get_5fsw_5fhygro_5fssa_3454',['get_sw_hygro_ssa',['../classPhysProp.html#a8a18207db0b0c00b2f3ab728762fcee4',1,'PhysProp']]], + ['get_5fsw_5fnonhygro_5fascat_3455',['get_sw_nonhygro_ascat',['../classPhysProp.html#aa76012e67298ec9e2a682f4e1ae4406e',1,'PhysProp']]], + ['get_5fsw_5fnonhygro_5fasm_3456',['get_sw_nonhygro_asm',['../classPhysProp.html#a5f7966a98bc34562f868a85081520fc7',1,'PhysProp']]], + ['get_5fsw_5fnonhygro_5fext_3457',['get_sw_nonhygro_ext',['../classPhysProp.html#a15220c4ef45d858fe3dddb9ed1c14879',1,'PhysProp']]], + ['get_5fsw_5fnonhygro_5fscat_3458',['get_sw_nonhygro_scat',['../classPhysProp.html#a1b7539cc5e72663a669fd912b006a2ea',1,'PhysProp']]], + ['get_5fsw_5fnonhygro_5fssa_3459',['get_sw_nonhygro_ssa',['../classPhysProp.html#a07b254998ca2806c8c307529c2596ef8',1,'PhysProp']]], + ['get_5fsw_5fspectral_5fboundaries_3460',['get_sw_spectral_boundaries',['../classRadConstants.html#a7d32f7699c2933c60da5163952bfc4cb',1,'RadConstants']]], + ['get_5fsw_5fspectral_5fmidpoints_3461',['get_sw_spectral_midpoints',['../classRadConstants.html#adbfa470ed64a37cb47761a3a8a4678b7',1,'RadConstants']]], + ['get_5ft_5fstar_3462',['get_t_star',['../classABLMost.html#a108ee0811499e80c9d3226bb20da6973',1,'ABLMost']]], + ['get_5ft_5fsurf_3463',['get_t_surf',['../classABLMost.html#aca21d4f7aae064515bfec992b263d6d2',1,'ABLMost']]], + ['get_5ftime_3464',['get_time',['../structTimeInterpolatedData.html#a5b5af3383ee7cba684df54a2cb704d09',1,'TimeInterpolatedData']]], + ['get_5fturb_5fdisk_5fangle_3465',['get_turb_disk_angle',['../classNullWindFarm.html#ac1242356bf27b796b89bea7db82e724b',1,'NullWindFarm']]], + ['get_5fturb_5floc_3466',['get_turb_loc',['../classNullWindFarm.html#a85f4b30a21138dce73af7ea3769d5580',1,'NullWindFarm']]], + ['get_5fturb_5fspec_3467',['get_turb_spec',['../classNullWindFarm.html#a11fd7bf185b205f71197da8ba41edfb6',1,'NullWindFarm']]], + ['get_5fturb_5fspec_5fextra_3468',['get_turb_spec_extra',['../classNullWindFarm.html#a77d2fbe9dc6053701fa98acf5c5c8b25',1,'NullWindFarm']]], + ['get_5fu_5fstar_3469',['get_u_star',['../classABLMost.html#a0890b6ae8c80d8888effa040af808df0',1,'ABLMost']]], + ['get_5fvar_3470',['get_var',['../structTimeInterpolatedData.html#a65f3edf3f03a779a931f5c58bd438602',1,'TimeInterpolatedData']]], + ['get_5fvarname_3471',['Get_VarName',['../classLandSurface.html#a0e04fe7c9b1f9025e8f4458c4522b1d5',1,'LandSurface']]], + ['get_5fvname_3472',['get_vname',['../structNDArray.html#a4d7550e3c00d13d8397f1cfbdfd2ab48',1,'NDArray']]], + ['get_5fvolcanic_5frad_5fprops_3473',['get_volcanic_rad_props',['../classAerRadProps.html#a74842fff81711719376fc035b86dc1a7',1,'AerRadProps']]], + ['get_5fvolcanic_5fradius_5frad_5fprops_3474',['get_volcanic_radius_rad_props',['../classAerRadProps.html#a55507a56c5808f7480e42f4369cbf5a7',1,'AerRadProps']]], + ['get_5fvshape_3475',['get_vshape',['../structNDArray.html#ad839c3c65bd755311afb6f0dad08f336',1,'NDArray']]], + ['get_5fw_5fstar_3476',['get_w_star',['../classABLMost.html#a9ea0efa20ea7a0dfd12ccc8c13c7f5fd',1,'ABLMost']]], + ['get_5fz0_3477',['get_z0',['../classABLMost.html#a626a97f944cb297c966a2ff7ce0bad97',1,'ABLMost']]], + ['get_5fzref_3478',['get_zref',['../classABLMost.html#ae638411093a2d3cc6cc525d4d7efa7ed',1,'ABLMost::get_zref()'],['../classMOSTAverage.html#a5b590fcba4d5d99178a0f8de14a1f174',1,'MOSTAverage::get_zref()']]], + ['getadvfluxreg_3479',['getAdvFluxReg',['../classERF.html#a4d6d990d8111c170692b1e9cc0e918b8',1,'ERF']]], + ['getcputime_3480',['getCPUTime',['../classERF.html#ae0597da6edf955cd138e52fd00380ff2',1,'ERF']]], + ['getdpdrgivenconstanttheta_3481',['getdPdRgivenConstantTheta',['../ERF__EOS_8H.html#a91cb501e961a0d0a6a3c62b5c36702cd',1,'ERF_EOS.H']]], + ['getepochtime_3482',['getEpochTime',['../ERF__NCWpsFile_8H.html#a370a1cca0113b3529a59c031ff71ffb8',1,'ERF_NCWpsFile.H']]], + ['getexnergivenp_3483',['getExnergivenP',['../ERF__EOS_8H.html#ab415ab4061cbbea05723267a0bf82c6b',1,'ERF_EOS.H']]], + ['getexnergivenrth_3484',['getExnergivenRTh',['../ERF__EOS_8H.html#a24b76fd72f051dc593840f006d79fd1a',1,'ERF_EOS.H']]], + ['getfluxes_3485',['getFluxes',['../classTerrainPoisson.html#ab2c2fee50d531c3bcc1f0c92d548e3a6',1,'TerrainPoisson']]], + ['getindexbox_3486',['getIndexBox',['../structPlaneSampler.html#a1f71b67544dbc9c4cba7d11bc5e5b45d',1,'PlaneSampler']]], + ['getindx_3487',['getIndx',['../structDirectionSelector.html#a3950b636303028f398441fdc43d66dba',1,'DirectionSelector::getIndx()'],['../structDirectionSelector_3_010_01_4.html#a74c1bd1dca28b374962977ab8e32595e',1,'DirectionSelector< 0 >::getIndx()'],['../structDirectionSelector_3_011_01_4.html#ae5631c2b7917d2bc7cb479a266a61834',1,'DirectionSelector< 1 >::getIndx()'],['../structDirectionSelector_3_012_01_4.html#a5708ddb92c7d49cc9ba821f978251160',1,'DirectionSelector< 2 >::getIndx()']]], + ['getmask_3488',['GetMask',['../classERFFillPatcher.html#a2c0b26e7da60e74734191617c50754e1',1,'ERFFillPatcher']]], + ['getpgivenrth_3489',['getPgivenRTh',['../ERF__EOS_8H.html#a08354ab110fb9e873bce9250b4f4b46e',1,'ERF_EOS.H']]], + ['getrelaxmaskval_3490',['GetRelaxMaskVal',['../classERFFillPatcher.html#ae36410e2a848977e145b29c755ac8b5d',1,'ERFFillPatcher']]], + ['getrhogiventandpress_3491',['getRhogivenTandPress',['../ERF__EOS_8H.html#ad5b95b0051794b77cd7538c45fbb3b71',1,'ERF_EOS.H']]], + ['getrhogiventhetapress_3492',['getRhogivenThetaPress',['../ERF__EOS_8H.html#a3ee1ea27d3b9f25afcc603f3e5b17955',1,'ERF_EOS.H']]], + ['getrhothetagivenp_3493',['getRhoThetagivenP',['../ERF__EOS_8H.html#a3cc0ee7727b26e21a97acfc2ad2e6d4d',1,'ERF_EOS.H']]], + ['getsetmaskval_3494',['GetSetMaskVal',['../classERFFillPatcher.html#aa1dd4ccdd7812057d8ee529015e3750d',1,'ERFFillPatcher']]], + ['gettgivenpandth_3495',['getTgivenPandTh',['../ERF__EOS_8H.html#ae76d3ce3486d0e450849c56159f2dbd4',1,'ERF_EOS.H']]], + ['gettgivenrandrth_3496',['getTgivenRandRTh',['../ERF__EOS_8H.html#a65cf1718b7a1fcc56cb16685642543da',1,'ERF_EOS.H']]], + ['getthgivenpandt_3497',['getThgivenPandT',['../ERF__EOS_8H.html#acd37b404bbf95073ffef2a1003dc56c5',1,'ERF_EOS.H']]], + ['getthgivenrandt_3498',['getThgivenRandT',['../ERF__EOS_8H.html#ad0e28e4df049e6e34fa4a973dd446506',1,'ERF_EOS.H']]], + ['goffgratch_5fsvp_5fice_3499',['GoffGratch_svp_ice',['../classSatMethods.html#a9e929b8ac05dbeaa78dc158159f84758',1,'SatMethods']]], + ['goffgratch_5fsvp_5fwater_3500',['GoffGratch_svp_water',['../classSatMethods.html#a264a283910d028a29c374900fc03017f',1,'SatMethods']]], + ['gotonextline_3501',['GotoNextLine',['../classERF.html#aaee255b031e63bd9b5807f6612739dbd',1,'ERF']]], + ['group_3502',['group',['../classncutils_1_1NCGroup.html#a757c592cddc2272a86033fe888232333',1,'ncutils::NCGroup']]] ]; diff --git a/search/functions_7.js b/search/functions_7.js index 7b2680023..fa99ccd1a 100644 --- a/search/functions_7.js +++ b/search/functions_7.js @@ -1,11 +1,11 @@ var searchData= [ - ['has_5fattr_3502',['has_attr',['../structncutils_1_1NCVar.html#a0a4ddce55f60e3accbaf02441b6484cf',1,'ncutils::NCVar::has_attr()'],['../classncutils_1_1NCGroup.html#a1bfb961e66e7c635ae92cee3f8cdeeac',1,'ncutils::NCGroup::has_attr(const std::string &) const']]], - ['has_5fdim_3503',['has_dim',['../classncutils_1_1NCGroup.html#ac233f0c14bd6b340fcd5a14da53b5042',1,'ncutils::NCGroup']]], - ['has_5fgroup_3504',['has_group',['../classncutils_1_1NCGroup.html#a00ea1ccd06adafc43396239ec842b23f',1,'ncutils::NCGroup']]], - ['has_5fvar_3505',['has_var',['../classncutils_1_1NCGroup.html#aaad218c7ea51b515386d5f1ce8a90192',1,'ncutils::NCGroup']]], - ['have_5fvariable_5fsea_5froughness_3506',['have_variable_sea_roughness',['../classABLMost.html#a4c4d9a950ce5f1115f701100795ac405',1,'ABLMost']]], - ['host_5fto_5fdevice_3507',['host_to_device',['../structInputSoundingData.html#a0e0cddb5da1a173092eeaf3c9489dfb8',1,'InputSoundingData']]], - ['hygro_5foptics_5finit_3508',['hygro_optics_init',['../classPhysProp.html#a6c73b423727e5d04394d0c030fd217f0',1,'PhysProp']]], - ['hygroscopic_5foptics_5finit_3509',['hygroscopic_optics_init',['../classPhysProp.html#a012aafa0dfffea201ceb407815094ffd',1,'PhysProp']]] + ['has_5fattr_3503',['has_attr',['../structncutils_1_1NCVar.html#a0a4ddce55f60e3accbaf02441b6484cf',1,'ncutils::NCVar::has_attr()'],['../classncutils_1_1NCGroup.html#a1bfb961e66e7c635ae92cee3f8cdeeac',1,'ncutils::NCGroup::has_attr(const std::string &) const']]], + ['has_5fdim_3504',['has_dim',['../classncutils_1_1NCGroup.html#ac233f0c14bd6b340fcd5a14da53b5042',1,'ncutils::NCGroup']]], + ['has_5fgroup_3505',['has_group',['../classncutils_1_1NCGroup.html#a00ea1ccd06adafc43396239ec842b23f',1,'ncutils::NCGroup']]], + ['has_5fvar_3506',['has_var',['../classncutils_1_1NCGroup.html#aaad218c7ea51b515386d5f1ce8a90192',1,'ncutils::NCGroup']]], + ['have_5fvariable_5fsea_5froughness_3507',['have_variable_sea_roughness',['../classABLMost.html#a4c4d9a950ce5f1115f701100795ac405',1,'ABLMost']]], + ['host_5fto_5fdevice_3508',['host_to_device',['../structInputSoundingData.html#a0e0cddb5da1a173092eeaf3c9489dfb8',1,'InputSoundingData']]], + ['hygro_5foptics_5finit_3509',['hygro_optics_init',['../classPhysProp.html#a6c73b423727e5d04394d0c030fd217f0',1,'PhysProp']]], + ['hygroscopic_5foptics_5finit_3510',['hygroscopic_optics_init',['../classPhysProp.html#a012aafa0dfffea201ceb407815094ffd',1,'PhysProp']]] ]; diff --git a/search/functions_8.js b/search/functions_8.js index 294cfebcf..37395a10e 100644 --- a/search/functions_8.js +++ b/search/functions_8.js @@ -1,29 +1,28 @@ var searchData= [ - ['ice_5feffective_5fradius_3510',['ice_effective_radius',['../ERF__Parameterizations_8H.html#adec9d0652512bd8a82a6dcea536c9138',1,'ERF_Parameterizations.H']]], - ['icefall_3511',['IceFall',['../classSAM.html#a363b3bb27b6e6cdad8693363b3262419',1,'SAM']]], - ['impose_5flateral_5fbasestate_5fbcs_3512',['impose_lateral_basestate_bcs',['../classERFPhysBCFunct__base.html#ab2d46cdc32a713b4eb40a5c3552ef947',1,'ERFPhysBCFunct_base']]], - ['impose_5flateral_5fcons_5fbcs_3513',['impose_lateral_cons_bcs',['../classERFPhysBCFunct__cons.html#ac8da4b078a7da0ba4a9adb727d885e58',1,'ERFPhysBCFunct_cons']]], - ['impose_5flateral_5fxvel_5fbcs_3514',['impose_lateral_xvel_bcs',['../classERFPhysBCFunct__u.html#a9b203cbd4f9a1fd40961067424ae5f81',1,'ERFPhysBCFunct_u']]], - ['impose_5flateral_5fyvel_5fbcs_3515',['impose_lateral_yvel_bcs',['../classERFPhysBCFunct__v.html#adee10e9098b1261837e642a76632c141',1,'ERFPhysBCFunct_v']]], - ['impose_5flateral_5fzvel_5fbcs_3516',['impose_lateral_zvel_bcs',['../classERFPhysBCFunct__w.html#a9cd6e53c9598fe025c3c78945c2b1b83',1,'ERFPhysBCFunct_w']]], - ['impose_5fmost_5fbcs_3517',['impose_most_bcs',['../classABLMost.html#aa6c480227398080885f5bd48466c71e0',1,'ABLMost']]], - ['impose_5fvertical_5fbasestate_5fbcs_3518',['impose_vertical_basestate_bcs',['../classERFPhysBCFunct__base.html#a16a0a73ad13172027fc38b4c427f71ff',1,'ERFPhysBCFunct_base']]], - ['impose_5fvertical_5fcons_5fbcs_3519',['impose_vertical_cons_bcs',['../classERFPhysBCFunct__cons.html#a1f0975393eb1c321d84d15734ae8cdf0',1,'ERFPhysBCFunct_cons']]], - ['impose_5fvertical_5fxvel_5fbcs_3520',['impose_vertical_xvel_bcs',['../classERFPhysBCFunct__u.html#afdf8afb39002a2daac0fc16a5db76d17',1,'ERFPhysBCFunct_u']]], - ['impose_5fvertical_5fyvel_5fbcs_3521',['impose_vertical_yvel_bcs',['../classERFPhysBCFunct__v.html#a9e295ac17321f4d577f1d103f6b665a2',1,'ERFPhysBCFunct_v']]], - ['impose_5fvertical_5fzvel_5fbcs_3522',['impose_vertical_zvel_bcs',['../classERFPhysBCFunct__w.html#a9225c49cf092c6eed2bf9bdf1ef4b9cf',1,'ERFPhysBCFunct_w']]], - ['increment_3523',['increment',['../classTerrainPoisson.html#a675e172f3e8a103807ad776019242fdd',1,'TerrainPoisson']]], - ['ingested_5fdensity_3524',['ingested_density',['../classReadBndryPlanes.html#ab54133701e8e086315fa7299257199a2',1,'ReadBndryPlanes']]], - ['ingested_5fke_3525',['ingested_KE',['../classReadBndryPlanes.html#a85a5f25c283db679f67e10167cc6ee5c',1,'ReadBndryPlanes']]], - ['ingested_5fq1_3526',['ingested_q1',['../classReadBndryPlanes.html#a02a0fca675471f10ea6ccb1671ce1cb0',1,'ReadBndryPlanes']]], - ['ingested_5fq2_3527',['ingested_q2',['../classReadBndryPlanes.html#abf22791c2eaf68739ffea26e370724df',1,'ReadBndryPlanes']]], - ['ingested_5fscalar_3528',['ingested_scalar',['../classReadBndryPlanes.html#a6051259f37b0f38a9d74de7b9405dd03',1,'ReadBndryPlanes']]], - ['ingested_5ftheta_3529',['ingested_theta',['../classReadBndryPlanes.html#ac306993497b4e668110e13c4eb7644ff',1,'ReadBndryPlanes']]], - ['ingested_5fvelocity_3530',['ingested_velocity',['../classReadBndryPlanes.html#a906352fe8d793c4360889429d8a5980d',1,'ReadBndryPlanes']]], - ['init_3531',['Init',['../classSLM.html#aef0a4802ed2d86fd1dedad55e51efc88',1,'SLM']]], - ['init_3532',['init',['../classLinInterp.html#a00b249a492135098785c7cf3d2296a91',1,'LinInterp']]], - ['init_3533',['Init',['../classSAM.html#a927f4531f9c2452e5b7fc7ab965c5b78',1,'SAM::Init()'],['../classNullMoist.html#a6f526044328db858069e4b6a70fdbdf7',1,'NullMoist::Init()'],['../classKessler.html#ab1eaffdd038f2eda89f44f150036a405',1,'Kessler::Init()'],['../classMicrophysics.html#a4e781e2a953a088477cfc5a1e3691f2e',1,'Microphysics::Init()'],['../classEulerianMicrophysics.html#ac68028f2920ccb380c605099adb7d604',1,'EulerianMicrophysics::Init()'],['../classNullSurf.html#a013feb9e94f957304bedbc26b6da16b0',1,'NullSurf::Init()'],['../classNOAH.html#ae0ff47476a81fcce3b170eec23033c27',1,'NOAH::Init()'],['../classMM5.html#a0471ac39485d05623f911cd9fd021b9a',1,'MM5::Init()'],['../classLandSurface.html#aac1216f5c2758361ddc016442f3c67cd',1,'LandSurface::Init()']]], + ['ice_5feffective_5fradius_3511',['ice_effective_radius',['../ERF__Parameterizations_8H.html#adec9d0652512bd8a82a6dcea536c9138',1,'ERF_Parameterizations.H']]], + ['icefall_3512',['IceFall',['../classSAM.html#a363b3bb27b6e6cdad8693363b3262419',1,'SAM']]], + ['impose_5flateral_5fbasestate_5fbcs_3513',['impose_lateral_basestate_bcs',['../classERFPhysBCFunct__base.html#ab2d46cdc32a713b4eb40a5c3552ef947',1,'ERFPhysBCFunct_base']]], + ['impose_5flateral_5fcons_5fbcs_3514',['impose_lateral_cons_bcs',['../classERFPhysBCFunct__cons.html#ac8da4b078a7da0ba4a9adb727d885e58',1,'ERFPhysBCFunct_cons']]], + ['impose_5flateral_5fxvel_5fbcs_3515',['impose_lateral_xvel_bcs',['../classERFPhysBCFunct__u.html#a9b203cbd4f9a1fd40961067424ae5f81',1,'ERFPhysBCFunct_u']]], + ['impose_5flateral_5fyvel_5fbcs_3516',['impose_lateral_yvel_bcs',['../classERFPhysBCFunct__v.html#adee10e9098b1261837e642a76632c141',1,'ERFPhysBCFunct_v']]], + ['impose_5flateral_5fzvel_5fbcs_3517',['impose_lateral_zvel_bcs',['../classERFPhysBCFunct__w.html#a9cd6e53c9598fe025c3c78945c2b1b83',1,'ERFPhysBCFunct_w']]], + ['impose_5fmost_5fbcs_3518',['impose_most_bcs',['../classABLMost.html#aa6c480227398080885f5bd48466c71e0',1,'ABLMost']]], + ['impose_5fvertical_5fbasestate_5fbcs_3519',['impose_vertical_basestate_bcs',['../classERFPhysBCFunct__base.html#a16a0a73ad13172027fc38b4c427f71ff',1,'ERFPhysBCFunct_base']]], + ['impose_5fvertical_5fcons_5fbcs_3520',['impose_vertical_cons_bcs',['../classERFPhysBCFunct__cons.html#a1f0975393eb1c321d84d15734ae8cdf0',1,'ERFPhysBCFunct_cons']]], + ['impose_5fvertical_5fxvel_5fbcs_3521',['impose_vertical_xvel_bcs',['../classERFPhysBCFunct__u.html#afdf8afb39002a2daac0fc16a5db76d17',1,'ERFPhysBCFunct_u']]], + ['impose_5fvertical_5fyvel_5fbcs_3522',['impose_vertical_yvel_bcs',['../classERFPhysBCFunct__v.html#a9e295ac17321f4d577f1d103f6b665a2',1,'ERFPhysBCFunct_v']]], + ['impose_5fvertical_5fzvel_5fbcs_3523',['impose_vertical_zvel_bcs',['../classERFPhysBCFunct__w.html#a9225c49cf092c6eed2bf9bdf1ef4b9cf',1,'ERFPhysBCFunct_w']]], + ['increment_3524',['increment',['../classTerrainPoisson.html#a675e172f3e8a103807ad776019242fdd',1,'TerrainPoisson']]], + ['ingested_5fdensity_3525',['ingested_density',['../classReadBndryPlanes.html#ab54133701e8e086315fa7299257199a2',1,'ReadBndryPlanes']]], + ['ingested_5fke_3526',['ingested_KE',['../classReadBndryPlanes.html#a85a5f25c283db679f67e10167cc6ee5c',1,'ReadBndryPlanes']]], + ['ingested_5fq1_3527',['ingested_q1',['../classReadBndryPlanes.html#a02a0fca675471f10ea6ccb1671ce1cb0',1,'ReadBndryPlanes']]], + ['ingested_5fq2_3528',['ingested_q2',['../classReadBndryPlanes.html#abf22791c2eaf68739ffea26e370724df',1,'ReadBndryPlanes']]], + ['ingested_5fscalar_3529',['ingested_scalar',['../classReadBndryPlanes.html#a6051259f37b0f38a9d74de7b9405dd03',1,'ReadBndryPlanes']]], + ['ingested_5ftheta_3530',['ingested_theta',['../classReadBndryPlanes.html#ac306993497b4e668110e13c4eb7644ff',1,'ReadBndryPlanes']]], + ['ingested_5fvelocity_3531',['ingested_velocity',['../classReadBndryPlanes.html#a906352fe8d793c4360889429d8a5980d',1,'ReadBndryPlanes']]], + ['init_3532',['Init',['../classNullSurf.html#a013feb9e94f957304bedbc26b6da16b0',1,'NullSurf::Init()'],['../classSAM.html#a927f4531f9c2452e5b7fc7ab965c5b78',1,'SAM::Init()'],['../classNullMoist.html#a6f526044328db858069e4b6a70fdbdf7',1,'NullMoist::Init()'],['../classKessler.html#ab1eaffdd038f2eda89f44f150036a405',1,'Kessler::Init()'],['../classMicrophysics.html#a4e781e2a953a088477cfc5a1e3691f2e',1,'Microphysics::Init()'],['../classEulerianMicrophysics.html#ac68028f2920ccb380c605099adb7d604',1,'EulerianMicrophysics::Init()'],['../classSLM.html#aef0a4802ed2d86fd1dedad55e51efc88',1,'SLM::Init()'],['../classNOAH.html#ae0ff47476a81fcce3b170eec23033c27',1,'NOAH::Init()'],['../classMM5.html#a0471ac39485d05623f911cd9fd021b9a',1,'MM5::Init()'],['../classLandSurface.html#aac1216f5c2758361ddc016442f3c67cd',1,'LandSurface::Init()']]], + ['init_3533',['init',['../classLinInterp.html#a00b249a492135098785c7cf3d2296a91',1,'LinInterp']]], ['init1darrays_3534',['init1DArrays',['../classERF.html#a7261c4eb7722af0dfe6cdfb8e2e9e4db',1,'ERF']]], ['init_5fbase_5fparms_3535',['init_base_parms',['../classProblemBase.html#abac6929cfbd9298447e721dfcbe5163f',1,'ProblemBase']]], ['init_5fbase_5fstate_5ffrom_5fmetgrid_3536',['init_base_state_from_metgrid',['../ERF__Metgrid__utils_8H.html#ad127bd2619dfdddcebfb71049433659f',1,'ERF_Metgrid_utils.H']]], diff --git a/search/pages_0.js b/search/pages_0.js index aefefdee4..c2aa85394 100644 --- a/search/pages_0.js +++ b/search/pages_0.js @@ -1,4 +1,4 @@ var searchData= [ - ['energy_20research_20and_20forecasting_3a_20an_20atmospheric_20modeling_20code_5374',['Energy Research and Forecasting: An Atmospheric Modeling Code',['../index.html',1,'']]] + ['energy_20research_20and_20forecasting_3a_20an_20atmospheric_20modeling_20code_5376',['Energy Research and Forecasting: An Atmospheric Modeling Code',['../index.html',1,'']]] ]; diff --git a/search/typedefs_0.js b/search/typedefs_0.js index d34859592..f804dbf5a 100644 --- a/search/typedefs_0.js +++ b/search/typedefs_0.js @@ -1,4 +1,4 @@ var searchData= [ - ['bctype_5173',['BCType',['../ERF__solve__with__EB__mlmg_8cpp.html#ad583385d33cdb5a9c28bf474b72cad1c',1,'BCType(): ERF_solve_with_EB_mlmg.cpp'],['../ERF__solve__with__mlmg_8cpp.html#ad583385d33cdb5a9c28bf474b72cad1c',1,'BCType(): ERF_solve_with_mlmg.cpp']]] + ['bctype_5175',['BCType',['../ERF__solve__with__EB__mlmg_8cpp.html#ad583385d33cdb5a9c28bf474b72cad1c',1,'BCType(): ERF_solve_with_EB_mlmg.cpp'],['../ERF__solve__with__mlmg_8cpp.html#ad583385d33cdb5a9c28bf474b72cad1c',1,'BCType(): ERF_solve_with_mlmg.cpp']]] ]; diff --git a/search/typedefs_1.js b/search/typedefs_1.js index 55c5d59a7..77fdf3cc1 100644 --- a/search/typedefs_1.js +++ b/search/typedefs_1.js @@ -1,4 +1,4 @@ var searchData= [ - ['dtype_5174',['DType',['../structNDArray.html#a96033b69f69ea0ae537a24288715752d',1,'NDArray']]] + ['dtype_5176',['DType',['../structNDArray.html#a96033b69f69ea0ae537a24288715752d',1,'NDArray']]] ]; diff --git a/search/typedefs_2.js b/search/typedefs_2.js index 340a83598..d7abe10a1 100644 --- a/search/typedefs_2.js +++ b/search/typedefs_2.js @@ -1,4 +1,4 @@ var searchData= [ - ['fabptr_5175',['FabPtr',['../classMM5.html#a1c62f3c8eb0010c903b517e6ba49973d',1,'MM5::FabPtr()'],['../classSLM.html#abb12aea2d3e7bcc1e47b81581a9892ba',1,'SLM::FabPtr()'],['../classKessler.html#ad9b9b2f6662807890f9f2b016d6d0d1c',1,'Kessler::FabPtr()'],['../classSAM.html#a2ffb00984d39bfc39057c68f708774a9',1,'SAM::FabPtr()']]] + ['fabptr_5177',['FabPtr',['../classMM5.html#a1c62f3c8eb0010c903b517e6ba49973d',1,'MM5::FabPtr()'],['../classSLM.html#abb12aea2d3e7bcc1e47b81581a9892ba',1,'SLM::FabPtr()'],['../classKessler.html#ad9b9b2f6662807890f9f2b016d6d0d1c',1,'Kessler::FabPtr()'],['../classSAM.html#a2ffb00984d39bfc39057c68f708774a9',1,'SAM::FabPtr()']]] ]; diff --git a/search/typedefs_3.js b/search/typedefs_3.js index 194a0abbd..f77d05cbf 100644 --- a/search/typedefs_3.js +++ b/search/typedefs_3.js @@ -1,4 +1,4 @@ var searchData= [ - ['planevector_5176',['PlaneVector',['../ERF__NCWpsFile_8H.html#a60014a8d74bed0d5ae984e600c68dc85',1,'PlaneVector(): ERF_NCWpsFile.H'],['../ERF__ReadBndryPlanes_8H.html#a60014a8d74bed0d5ae984e600c68dc85',1,'PlaneVector(): ERF_ReadBndryPlanes.H']]] + ['planevector_5178',['PlaneVector',['../ERF__NCWpsFile_8H.html#a60014a8d74bed0d5ae984e600c68dc85',1,'PlaneVector(): ERF_NCWpsFile.H'],['../ERF__ReadBndryPlanes_8H.html#a60014a8d74bed0d5ae984e600c68dc85',1,'PlaneVector(): ERF_ReadBndryPlanes.H']]] ]; diff --git a/search/typedefs_4.js b/search/typedefs_4.js index ce943b383..42527fe19 100644 --- a/search/typedefs_4.js +++ b/search/typedefs_4.js @@ -1,5 +1,5 @@ var searchData= [ - ['rt_5177',['RT',['../classTerrainPoisson.html#a8b28ebe7d558fc2ce19d674e33f78fec',1,'TerrainPoisson']]], - ['rtype_5178',['RType',['../structncutils_1_1NCDType.html#a079bbf4314ad09362b5c8124670c821f',1,'ncutils::NCDType']]] + ['rt_5179',['RT',['../classTerrainPoisson.html#a8b28ebe7d558fc2ce19d674e33f78fec',1,'TerrainPoisson']]], + ['rtype_5180',['RType',['../structncutils_1_1NCDType.html#a079bbf4314ad09362b5c8124670c821f',1,'ncutils::NCDType']]] ]; diff --git a/search/typedefs_5.js b/search/typedefs_5.js index 979353a4e..0c9073144 100644 --- a/search/typedefs_5.js +++ b/search/typedefs_5.js @@ -1,4 +1,4 @@ var searchData= [ - ['t_5179',['T',['../classamrex_1_1FFT_1_1PoissonTerrainPrecond.html#ab1e71d06328d046d89eca8c2745b8eb8',1,'amrex::FFT::PoissonTerrainPrecond']]] + ['t_5181',['T',['../classamrex_1_1FFT_1_1PoissonTerrainPrecond.html#ab1e71d06328d046d89eca8c2745b8eb8',1,'amrex::FFT::PoissonTerrainPrecond']]] ]; diff --git a/search/typedefs_6.js b/search/typedefs_6.js index 27ceb2949..5de2aee5c 100644 --- a/search/typedefs_6.js +++ b/search/typedefs_6.js @@ -1,4 +1,4 @@ var searchData= [ - ['xdir_5180',['XDir',['../ERF__DirectionSelector_8H.html#a68edfbe7326d0d1476e796beb668072f',1,'ERF_DirectionSelector.H']]] + ['xdir_5182',['XDir',['../ERF__DirectionSelector_8H.html#a68edfbe7326d0d1476e796beb668072f',1,'ERF_DirectionSelector.H']]] ]; diff --git a/search/typedefs_7.js b/search/typedefs_7.js index efa0cb342..192119c86 100644 --- a/search/typedefs_7.js +++ b/search/typedefs_7.js @@ -1,4 +1,4 @@ var searchData= [ - ['ydir_5181',['YDir',['../ERF__DirectionSelector_8H.html#a92990a19f43dc3cbbbd630362d1ece71',1,'ERF_DirectionSelector.H']]] + ['ydir_5183',['YDir',['../ERF__DirectionSelector_8H.html#a92990a19f43dc3cbbbd630362d1ece71',1,'ERF_DirectionSelector.H']]] ]; diff --git a/search/typedefs_8.js b/search/typedefs_8.js index 5312bef71..9adc08607 100644 --- a/search/typedefs_8.js +++ b/search/typedefs_8.js @@ -1,4 +1,4 @@ var searchData= [ - ['zdir_5182',['ZDir',['../ERF__DirectionSelector_8H.html#aca321ed7fddfe43ff7549b4632a3c0d1',1,'ERF_DirectionSelector.H']]] + ['zdir_5184',['ZDir',['../ERF__DirectionSelector_8H.html#aca321ed7fddfe43ff7549b4632a3c0d1',1,'ERF_DirectionSelector.H']]] ]; diff --git a/search/variables_10.js b/search/variables_10.js index 6a6f7e308..09836bce2 100644 --- a/search/variables_10.js +++ b/search/variables_10.js @@ -1,26 +1,26 @@ var searchData= [ - ['q_5fstar_4810',['q_star',['../classABLMost.html#a0630def935d5ca0d24160b9b9567f3e1',1,'ABLMost']]], - ['qaerwat_5fm_4811',['qaerwat_m',['../classMam4__aer.html#a0f94d150e77cc227c30e434a851f7d52',1,'Mam4_aer']]], - ['qc_4812',['qc',['../classRadiation.html#abc0bc2362396171354decd80be18dde1',1,'Radiation']]], - ['qci0_4813',['qci0',['../ERF__Constants_8H.html#a1aa289f72f87789e664357396befb8eb',1,'ERF_Constants.H']]], - ['qcw0_4814',['qcw0',['../ERF__Constants_8H.html#a86f34aeefa355fa0d6d0cca8f033a878',1,'ERF_Constants.H']]], - ['qi_4815',['qi',['../classRadiation.html#a86954a9c03e7c7eb9cd610b4e533b27e',1,'Radiation']]], - ['qmoist_4816',['qmoist',['../classERF.html#ae00126a9c2738bf6a6cbbe77321c9cfc',1,'ERF']]], - ['qn_4817',['qn',['../classRadiation.html#a913e1b4a5c5ddf093f81c6a6c7051035',1,'Radiation']]], - ['qn1d_4818',['qn1d',['../classSAM.html#a9fafcc2e5b063f7ccb94e2cc78324d35',1,'SAM']]], - ['qp_5fthreshold_4819',['qp_threshold',['../ERF__Constants_8H.html#a956656dbad95153bb8d3f0e42fa3d356',1,'ERF_Constants.H']]], - ['qr_5fprim_4820',['Qr_prim',['../classERF.html#a57d8432920785f8e58cf11a3232d76b5',1,'ERF']]], - ['qrad_5fsrc_4821',['qrad_src',['../classRadiation.html#a687fe7137c6cb0b0040addeb90249a0c',1,'Radiation']]], - ['qrl_4822',['qrl',['../classRadiation.html#a20fc801b4852279dafb58e95bc728338',1,'Radiation']]], - ['qrlc_4823',['qrlc',['../classRadiation.html#a3308c21539f43b459729b9b02652dd01',1,'Radiation']]], - ['qrs_4824',['qrs',['../classRadiation.html#a9eaa967e3b5556ce43d07e48d3e0c66f',1,'Radiation']]], - ['qrsc_4825',['qrsc',['../classRadiation.html#abb3bb540832d451a76367e441df528a0',1,'Radiation']]], - ['qt_4826',['qt',['../classAerRadProps.html#a837035712a214f1b8daf7a4d30727e6d',1,'AerRadProps::qt()'],['../classRadiation.html#aa3961f0a2837a89f1d08dd5aba2ed056',1,'Radiation::qt()']]], - ['qt1d_4827',['qt1d',['../classSAM.html#aaa3dd79bbd6ac41ae1170d003b1a423d',1,'SAM']]], - ['qv1d_4828',['qv1d',['../classSAM.html#a65e2ba7cb72946a8af2e7541b072e3ba',1,'SAM']]], - ['qv_5finp_5fsound_4829',['qv_inp_sound',['../structInputSoundingData.html#aa6507429847a67925f1c7562f1c71553',1,'InputSoundingData']]], - ['qv_5finp_5fsound_5fd_4830',['qv_inp_sound_d',['../structInputSoundingData.html#a67548fa005d65ea767bf10dce34b5562',1,'InputSoundingData']]], - ['qv_5fprim_4831',['Qv_prim',['../classERF.html#a521d1faf157e3bccc86c0f26ee923576',1,'ERF']]], - ['qv_5fref_5finp_5fsound_4832',['qv_ref_inp_sound',['../structInputSoundingData.html#a9cb5ab7b69363eca08231b634e94e109',1,'InputSoundingData']]] + ['q_5fstar_4812',['q_star',['../classABLMost.html#a0630def935d5ca0d24160b9b9567f3e1',1,'ABLMost']]], + ['qaerwat_5fm_4813',['qaerwat_m',['../classMam4__aer.html#a0f94d150e77cc227c30e434a851f7d52',1,'Mam4_aer']]], + ['qc_4814',['qc',['../classRadiation.html#abc0bc2362396171354decd80be18dde1',1,'Radiation']]], + ['qci0_4815',['qci0',['../ERF__Constants_8H.html#a1aa289f72f87789e664357396befb8eb',1,'ERF_Constants.H']]], + ['qcw0_4816',['qcw0',['../ERF__Constants_8H.html#a86f34aeefa355fa0d6d0cca8f033a878',1,'ERF_Constants.H']]], + ['qi_4817',['qi',['../classRadiation.html#a86954a9c03e7c7eb9cd610b4e533b27e',1,'Radiation']]], + ['qmoist_4818',['qmoist',['../classERF.html#ae00126a9c2738bf6a6cbbe77321c9cfc',1,'ERF']]], + ['qn_4819',['qn',['../classRadiation.html#a913e1b4a5c5ddf093f81c6a6c7051035',1,'Radiation']]], + ['qn1d_4820',['qn1d',['../classSAM.html#a9fafcc2e5b063f7ccb94e2cc78324d35',1,'SAM']]], + ['qp_5fthreshold_4821',['qp_threshold',['../ERF__Constants_8H.html#a956656dbad95153bb8d3f0e42fa3d356',1,'ERF_Constants.H']]], + ['qr_5fprim_4822',['Qr_prim',['../classERF.html#a57d8432920785f8e58cf11a3232d76b5',1,'ERF']]], + ['qrad_5fsrc_4823',['qrad_src',['../classRadiation.html#a687fe7137c6cb0b0040addeb90249a0c',1,'Radiation']]], + ['qrl_4824',['qrl',['../classRadiation.html#a20fc801b4852279dafb58e95bc728338',1,'Radiation']]], + ['qrlc_4825',['qrlc',['../classRadiation.html#a3308c21539f43b459729b9b02652dd01',1,'Radiation']]], + ['qrs_4826',['qrs',['../classRadiation.html#a9eaa967e3b5556ce43d07e48d3e0c66f',1,'Radiation']]], + ['qrsc_4827',['qrsc',['../classRadiation.html#abb3bb540832d451a76367e441df528a0',1,'Radiation']]], + ['qt_4828',['qt',['../classAerRadProps.html#a837035712a214f1b8daf7a4d30727e6d',1,'AerRadProps::qt()'],['../classRadiation.html#aa3961f0a2837a89f1d08dd5aba2ed056',1,'Radiation::qt()']]], + ['qt1d_4829',['qt1d',['../classSAM.html#aaa3dd79bbd6ac41ae1170d003b1a423d',1,'SAM']]], + ['qv1d_4830',['qv1d',['../classSAM.html#a65e2ba7cb72946a8af2e7541b072e3ba',1,'SAM']]], + ['qv_5finp_5fsound_4831',['qv_inp_sound',['../structInputSoundingData.html#aa6507429847a67925f1c7562f1c71553',1,'InputSoundingData']]], + ['qv_5finp_5fsound_5fd_4832',['qv_inp_sound_d',['../structInputSoundingData.html#a67548fa005d65ea767bf10dce34b5562',1,'InputSoundingData']]], + ['qv_5fprim_4833',['Qv_prim',['../classERF.html#a521d1faf157e3bccc86c0f26ee923576',1,'ERF']]], + ['qv_5fref_5finp_5fsound_4834',['qv_ref_inp_sound',['../structInputSoundingData.html#a9cb5ab7b69363eca08231b634e94e109',1,'InputSoundingData']]] ]; diff --git a/search/variables_11.js b/search/variables_11.js index cc0ce9bbb..243535eac 100644 --- a/search/variables_11.js +++ b/search/variables_11.js @@ -1,83 +1,83 @@ var searchData= [ - ['r_5fd_4833',['R_d',['../ERF__Constants_8H.html#aeb133d0ac46d639050313ce36187e870',1,'ERF_Constants.H']]], - ['r_5flw_5fabs_4834',['r_lw_abs',['../structPhysProp_1_1physprop__t.html#af41dfd624f5e565f0435e9bef6182ba5',1,'PhysProp::physprop_t']]], - ['r_5fsw_5fascat_4835',['r_sw_ascat',['../structPhysProp_1_1physprop__t.html#a8f237360219885a558fb5c5bfeb5c015',1,'PhysProp::physprop_t']]], - ['r_5fsw_5fext_4836',['r_sw_ext',['../structPhysProp_1_1physprop__t.html#a2c8b9cd5f27f8c039d9ec76d665f08bc',1,'PhysProp::physprop_t']]], - ['r_5fsw_5fscat_4837',['r_sw_scat',['../structPhysProp_1_1physprop__t.html#ad3d6e9851177a676ab13788002e83bc0',1,'PhysProp::physprop_t']]], - ['r_5fv_4838',['R_v',['../ERF__Constants_8H.html#a0ab59ff21ef0b178fde0843394f5674a',1,'ERF_Constants.H']]], - ['radiation_4839',['radiation',['../classRadiation.html#adbdd39584f1836cc21a816a7ee7098bb',1,'Radiation']]], - ['rair_4840',['rair',['../ERF__Constants_8H.html#a864e81eb46f4207f25cb52e5046c23b8',1,'ERF_Constants.H']]], - ['rank_5foffsets_4841',['rank_offsets',['../classRadiation.html#a41e89e9dd4b961aeedde124d9f33aead',1,'Radiation']]], - ['rayleigh_5fdamp_5ft_4842',['rayleigh_damp_T',['../structSolverChoice.html#a06a0dd1c8f7c1ed73a4f8d24b6b31cdf',1,'SolverChoice']]], - ['rayleigh_5fdamp_5fu_4843',['rayleigh_damp_U',['../structSolverChoice.html#a5aed4016dd7d17a2d2904c60af59ae9d',1,'SolverChoice']]], - ['rayleigh_5fdamp_5fv_4844',['rayleigh_damp_V',['../structSolverChoice.html#a1bae456f7b26e8ed50d78ce1af1b5ef0',1,'SolverChoice']]], - ['rayleigh_5fdamp_5fw_4845',['rayleigh_damp_W',['../structSolverChoice.html#abf35af2e52f5c1197264d895396ca59c',1,'SolverChoice']]], - ['rayleigh_5fdampcoef_4846',['rayleigh_dampcoef',['../structSolverChoice.html#af5219ce0c2a4f7ab4481e3fdabd3af8e',1,'SolverChoice']]], - ['rayleigh_5fzdamp_4847',['rayleigh_zdamp',['../structSolverChoice.html#a29517ec608149342f25aa89f18204fac',1,'SolverChoice']]], - ['rayleigh_5fztop_4848',['rayleigh_ztop',['../structSolverChoice.html#a5ffe405695bf4304d2ea61be6efaca1c',1,'SolverChoice']]], - ['rd_5fon_5frv_4849',['Rd_on_Rv',['../ERF__Constants_8H.html#a212cca9324fcc25708184de9d9c7a07e',1,'ERF_Constants.H']]], - ['rdocp_4850',['rdOcp',['../structSolverChoice.html#a2e1ef762ee1dc1bd3d4cbd08125c758a',1,'SolverChoice']]], - ['real_4851',['Real',['../structncutils_1_1NCDType.html#a7a5be35daa7dbb2cc72507cc4b5a422c',1,'ncutils::NCDType']]], - ['real_5fset_5fwidth_4852',['real_set_width',['../classERF.html#acab120bb9324e7298534d765c447d703',1,'ERF']]], - ['real_5fwidth_4853',['real_width',['../classERF.html#abb15119348ad5399947bc8883084b230',1,'ERF']]], - ['ref_5fcounted_4854',['ref_counted',['../structNDArray.html#a8a0bbff40020f6aea23346ac656bf972',1,'NDArray']]], - ['ref_5ftags_4855',['ref_tags',['../classERF.html#ac81b3dfd7c6f21ba8479834e2ff1e652',1,'ERF']]], - ['refindex_5fim_5faer_5flw_4856',['refindex_im_aer_lw',['../structPhysProp_1_1physprop__t.html#a2b3656af3ed847bc9e0c7a5bfc1d64e0',1,'PhysProp::physprop_t']]], - ['refindex_5fim_5faer_5fsw_4857',['refindex_im_aer_sw',['../structPhysProp_1_1physprop__t.html#a01444396cbb69da2b50af017fef7b8e3',1,'PhysProp::physprop_t']]], - ['refindex_5freal_5faer_5flw_4858',['refindex_real_aer_lw',['../structPhysProp_1_1physprop__t.html#aa6b86d69efca7951eac318ef0a407acf',1,'PhysProp::physprop_t']]], - ['refindex_5freal_5faer_5fsw_4859',['refindex_real_aer_sw',['../structPhysProp_1_1physprop__t.html#a39ec574c71085ec5a6aa268b3b752a23',1,'PhysProp::physprop_t']]], - ['refitablw_4860',['refitablw',['../structPhysProp_1_1physprop__t.html#a8c8ef5042c0b53fa05d1d97a49de3833',1,'PhysProp::physprop_t']]], - ['refitabsw_4861',['refitabsw',['../structPhysProp_1_1physprop__t.html#a7a536b72896ed7e80fe3b13d990bce61',1,'PhysProp::physprop_t']]], - ['refrtablw_4862',['refrtablw',['../structPhysProp_1_1physprop__t.html#accf672f5038e149841b092ffb9ee1ba1',1,'PhysProp::physprop_t']]], - ['refrtabsw_4863',['refrtabsw',['../structPhysProp_1_1physprop__t.html#a2cb505dd76f365687ee5e33a22a14e9b',1,'PhysProp::physprop_t']]], - ['regrid_5fint_4864',['regrid_int',['../classERF.html#a3937527f96c81674fa38dc34ed24f3f5',1,'ERF']]], - ['rei_4865',['rei',['../classRadiation.html#a145c41f0bcb2d103df37c30a5202340e',1,'Radiation']]], - ['rel_4866',['rel',['../classRadiation.html#a95d771d1d4157cb2640e6657b1af9937',1,'Radiation']]], - ['restart_5fchkfile_4867',['restart_chkfile',['../classERF.html#a8e758060d3dede9694fbfcabddc17169',1,'ERF']]], - ['restart_5ftype_4868',['restart_type',['../classERF.html#a30a0b9e3a037c71580d1feb3b30a8258',1,'ERF']]], - ['retab_4869',['retab',['../classRadConstants.html#af93f09fe2ad546b17aff927963cf90d1',1,'RadConstants']]], - ['rf1_4870',['Rf1',['../structMYNNLevel2.html#a296d16ed3e332da46763edb04a2ba326',1,'MYNNLevel2']]], - ['rf2_4871',['Rf2',['../structMYNNLevel2.html#a2c96a00a9adfdf0247139127ec62e75a',1,'MYNNLevel2']]], - ['rfc_4872',['Rfc',['../structMYNNLevel2.html#adf860e39bf0bada5d9f10d92282f3e1c',1,'MYNNLevel2']]], - ['rga_4873',['rga',['../ERF__Constants_8H.html#a379aa3c3394d67b78990663a36ed5285',1,'ERF_Constants.H']]], - ['rh20_4874',['rh20',['../ERF__Constants_8H.html#ade17c0f300126a2fd0829d0e1a553512',1,'ERF_Constants.H']]], - ['rhcrystal_4875',['rhcrystal',['../structPhysProp_1_1physprop__t.html#aedb70926e32d7aaa6655f0a417acb18d',1,'PhysProp::physprop_t']]], - ['rhdeliques_4876',['rhdeliques',['../structPhysProp_1_1physprop__t.html#a136a646945382e1e7808b61ec9c648fe',1,'PhysProp::physprop_t']]], - ['rho0_5ftrans_4877',['rho0_trans',['../structDiffChoice.html#a4df179b6e7d84efc89a22ac5900f98c8',1,'DiffChoice']]], - ['rho1d_4878',['rho1d',['../classSAM.html#a0853b1a3a4ec94178ca208ea594fc455',1,'SAM']]], - ['rho_5f0_4879',['rho_0',['../structProbParmDefaults.html#af75997d9e4a94ab3b221657799ef720f',1,'ProbParmDefaults']]], - ['rho_5finp_5fsound_5fd_4880',['rho_inp_sound_d',['../structInputSoundingData.html#a749f99cf96305b40d55beb3d5d98bb93',1,'InputSoundingData']]], - ['rhoalpha_5fc_4881',['rhoAlpha_C',['../structDiffChoice.html#a553bdd290d667cca9699ed37f86f7e22',1,'DiffChoice']]], - ['rhoalpha_5ft_4882',['rhoAlpha_T',['../structDiffChoice.html#a574cf6ad397fd50169cafe025c9da5f3',1,'DiffChoice']]], - ['rhod_5finteg_4883',['rhod_integ',['../structInputSoundingData.html#a401b589250214e7bb84555050c5b6657',1,'InputSoundingData']]], - ['rhog_4884',['rhog',['../ERF__Constants_8H.html#a00c6555efa1735f66b36929196ff6b98',1,'ERF_Constants.H']]], - ['rhoh2o_4885',['rhoh2o',['../ERF__Constants_8H.html#a404d50fe6660930b74e3b191e2088754',1,'ERF_Constants.H']]], - ['rhoqr_5fcomp_4886',['RhoQr_comp',['../structSolverChoice.html#a1d9237205fd632dcde1599511f203131',1,'SolverChoice']]], - ['rhoqv_5fcomp_4887',['RhoQv_comp',['../structSolverChoice.html#a9ac649bbebc73403e291d2af180d4061',1,'SolverChoice']]], - ['rhor_4888',['rhor',['../ERF__Constants_8H.html#ad6e28022b74cd595f282e2cc97c2c0d8',1,'ERF_Constants.H']]], - ['rhos_4889',['rhos',['../ERF__Constants_8H.html#ac0e05183a58d4400f06346d18371218f',1,'ERF_Constants.H']]], - ['rhs_4890',['rhs',['../classMRISplitIntegrator.html#ab0f2e5848bf5e8f4959b6f990cb73053',1,'MRISplitIntegrator']]], - ['ri1_4891',['Ri1',['../structMYNNLevel2.html#a9db4e0ee0f3a124e8d702e806a361ef3',1,'MYNNLevel2']]], - ['ri2_4892',['Ri2',['../structMYNNLevel2.html#a7363ba486b0015097a4ce5d3dc47c87d',1,'MYNNLevel2']]], - ['ri3_4893',['Ri3',['../structMYNNLevel2.html#a324abb3040e8337972d976fa6689bab5',1,'MYNNLevel2']]], - ['rotor_5frad_4894',['rotor_rad',['../classWindFarm.html#ad0925f54be32d71ae431a2078afee91b',1,'WindFarm::rotor_rad()'],['../classEWP.html#ac89ee08eabbf2cc7a64a7908a449f016',1,'EWP::rotor_rad()'],['../classFitch.html#aadaedef0e6f0ac149483ee6b4d8b1a4e',1,'Fitch::rotor_rad()'],['../classGeneralAD.html#a5c234bf71184a01e624baf9f9247b3d5',1,'GeneralAD::rotor_rad()'],['../classSimpleAD.html#a04490ef9f591e86588c5bb7870c1b77f',1,'SimpleAD::rotor_rad()']]], - ['rotor_5frpm_4895',['rotor_RPM',['../classWindFarm.html#ae10dbee3f3d8b126e52df83ea97d57b1',1,'WindFarm::rotor_RPM()'],['../classGeneralAD.html#aeddf04c6e2386ba28aac00e2124c39a5',1,'GeneralAD::rotor_RPM()']]], - ['rough_5ftype_5fland_4896',['rough_type_land',['../classABLMost.html#ab052d62a07e8765a6de67264d05aff37',1,'ABLMost']]], - ['rough_5ftype_5fsea_4897',['rough_type_sea',['../classABLMost.html#ab5041b7c6a15b759a8f33dadd1a67e92',1,'ABLMost']]], - ['rrtmg_5flw_5fcloudsim_5fband_4898',['rrtmg_lw_cloudsim_band',['../classRadConstants.html#aef2395d6f1bbed699fd4033b9c3104b8',1,'RadConstants']]], - ['rrtmg_5fsw_5fcloudsim_5fband_4899',['rrtmg_sw_cloudsim_band',['../classRadConstants.html#acd093dbcb244a162598bc23658a3f5d0',1,'RadConstants']]], - ['rrtmg_5fto_5frrtmgp_4900',['rrtmg_to_rrtmgp',['../classRadiation.html#a343cbb13362229a43f02df3a95eaa0ea',1,'Radiation']]], - ['rrtmgp_5fcoefficients_5ffile_5flw_4901',['rrtmgp_coefficients_file_lw',['../classRadiation.html#a0f24e2a14bfa218815d6d602374b6f0b',1,'Radiation']]], - ['rrtmgp_5fcoefficients_5ffile_5fname_5flw_4902',['rrtmgp_coefficients_file_name_lw',['../classRadiation.html#a9adc323a74a713f43a9952b3601d7f85',1,'Radiation']]], - ['rrtmgp_5fcoefficients_5ffile_5fname_5fsw_4903',['rrtmgp_coefficients_file_name_sw',['../classRadiation.html#ae6df86058b5dda6cb7b32e48f08f92f9',1,'Radiation']]], - ['rrtmgp_5fcoefficients_5ffile_5fsw_4904',['rrtmgp_coefficients_file_sw',['../classRadiation.html#a8b27a952d1ceb83c174a5d30f6198230',1,'Radiation']]], - ['rrtmgp_5fdata_5fpath_4905',['rrtmgp_data_path',['../classRadiation.html#a054782cce0873bc799bf8a3fdda6a1fb',1,'Radiation']]], - ['rrtmgp_5fenable_5ftemperature_5fwarnings_4906',['rrtmgp_enable_temperature_warnings',['../classRadiation.html#a4959db25c75a67b8166635413aae4888',1,'Radiation']]], - ['ru_5fnew_4907',['rU_new',['../classERF.html#a01f3db32272f53dc68025f0a98195e57',1,'ERF']]], - ['ru_5fold_4908',['rU_old',['../classERF.html#a6eecc44323f77917c95869928284f61d',1,'ERF']]], - ['rv_5fnew_4909',['rV_new',['../classERF.html#a54e37988486ef96e55e84bd8e91bb688',1,'ERF']]], - ['rv_5fold_4910',['rV_old',['../classERF.html#aeb64e3b4def989ce68d873aefeed5e0e',1,'ERF']]], - ['rw_5fnew_4911',['rW_new',['../classERF.html#aa46c0b0d20525aed10f447923e54dde7',1,'ERF']]], - ['rw_5fold_4912',['rW_old',['../classERF.html#ac1fa56ec90f44e3cdf487af46804163f',1,'ERF']]] + ['r_5fd_4835',['R_d',['../ERF__Constants_8H.html#aeb133d0ac46d639050313ce36187e870',1,'ERF_Constants.H']]], + ['r_5flw_5fabs_4836',['r_lw_abs',['../structPhysProp_1_1physprop__t.html#af41dfd624f5e565f0435e9bef6182ba5',1,'PhysProp::physprop_t']]], + ['r_5fsw_5fascat_4837',['r_sw_ascat',['../structPhysProp_1_1physprop__t.html#a8f237360219885a558fb5c5bfeb5c015',1,'PhysProp::physprop_t']]], + ['r_5fsw_5fext_4838',['r_sw_ext',['../structPhysProp_1_1physprop__t.html#a2c8b9cd5f27f8c039d9ec76d665f08bc',1,'PhysProp::physprop_t']]], + ['r_5fsw_5fscat_4839',['r_sw_scat',['../structPhysProp_1_1physprop__t.html#ad3d6e9851177a676ab13788002e83bc0',1,'PhysProp::physprop_t']]], + ['r_5fv_4840',['R_v',['../ERF__Constants_8H.html#a0ab59ff21ef0b178fde0843394f5674a',1,'ERF_Constants.H']]], + ['radiation_4841',['radiation',['../classRadiation.html#adbdd39584f1836cc21a816a7ee7098bb',1,'Radiation']]], + ['rair_4842',['rair',['../ERF__Constants_8H.html#a864e81eb46f4207f25cb52e5046c23b8',1,'ERF_Constants.H']]], + ['rank_5foffsets_4843',['rank_offsets',['../classRadiation.html#a41e89e9dd4b961aeedde124d9f33aead',1,'Radiation']]], + ['rayleigh_5fdamp_5ft_4844',['rayleigh_damp_T',['../structSolverChoice.html#a06a0dd1c8f7c1ed73a4f8d24b6b31cdf',1,'SolverChoice']]], + ['rayleigh_5fdamp_5fu_4845',['rayleigh_damp_U',['../structSolverChoice.html#a5aed4016dd7d17a2d2904c60af59ae9d',1,'SolverChoice']]], + ['rayleigh_5fdamp_5fv_4846',['rayleigh_damp_V',['../structSolverChoice.html#a1bae456f7b26e8ed50d78ce1af1b5ef0',1,'SolverChoice']]], + ['rayleigh_5fdamp_5fw_4847',['rayleigh_damp_W',['../structSolverChoice.html#abf35af2e52f5c1197264d895396ca59c',1,'SolverChoice']]], + ['rayleigh_5fdampcoef_4848',['rayleigh_dampcoef',['../structSolverChoice.html#af5219ce0c2a4f7ab4481e3fdabd3af8e',1,'SolverChoice']]], + ['rayleigh_5fzdamp_4849',['rayleigh_zdamp',['../structSolverChoice.html#a29517ec608149342f25aa89f18204fac',1,'SolverChoice']]], + ['rayleigh_5fztop_4850',['rayleigh_ztop',['../structSolverChoice.html#a5ffe405695bf4304d2ea61be6efaca1c',1,'SolverChoice']]], + ['rd_5fon_5frv_4851',['Rd_on_Rv',['../ERF__Constants_8H.html#a212cca9324fcc25708184de9d9c7a07e',1,'ERF_Constants.H']]], + ['rdocp_4852',['rdOcp',['../structSolverChoice.html#a2e1ef762ee1dc1bd3d4cbd08125c758a',1,'SolverChoice']]], + ['real_4853',['Real',['../structncutils_1_1NCDType.html#a7a5be35daa7dbb2cc72507cc4b5a422c',1,'ncutils::NCDType']]], + ['real_5fset_5fwidth_4854',['real_set_width',['../classERF.html#acab120bb9324e7298534d765c447d703',1,'ERF']]], + ['real_5fwidth_4855',['real_width',['../classERF.html#abb15119348ad5399947bc8883084b230',1,'ERF']]], + ['ref_5fcounted_4856',['ref_counted',['../structNDArray.html#a8a0bbff40020f6aea23346ac656bf972',1,'NDArray']]], + ['ref_5ftags_4857',['ref_tags',['../classERF.html#ac81b3dfd7c6f21ba8479834e2ff1e652',1,'ERF']]], + ['refindex_5fim_5faer_5flw_4858',['refindex_im_aer_lw',['../structPhysProp_1_1physprop__t.html#a2b3656af3ed847bc9e0c7a5bfc1d64e0',1,'PhysProp::physprop_t']]], + ['refindex_5fim_5faer_5fsw_4859',['refindex_im_aer_sw',['../structPhysProp_1_1physprop__t.html#a01444396cbb69da2b50af017fef7b8e3',1,'PhysProp::physprop_t']]], + ['refindex_5freal_5faer_5flw_4860',['refindex_real_aer_lw',['../structPhysProp_1_1physprop__t.html#aa6b86d69efca7951eac318ef0a407acf',1,'PhysProp::physprop_t']]], + ['refindex_5freal_5faer_5fsw_4861',['refindex_real_aer_sw',['../structPhysProp_1_1physprop__t.html#a39ec574c71085ec5a6aa268b3b752a23',1,'PhysProp::physprop_t']]], + ['refitablw_4862',['refitablw',['../structPhysProp_1_1physprop__t.html#a8c8ef5042c0b53fa05d1d97a49de3833',1,'PhysProp::physprop_t']]], + ['refitabsw_4863',['refitabsw',['../structPhysProp_1_1physprop__t.html#a7a536b72896ed7e80fe3b13d990bce61',1,'PhysProp::physprop_t']]], + ['refrtablw_4864',['refrtablw',['../structPhysProp_1_1physprop__t.html#accf672f5038e149841b092ffb9ee1ba1',1,'PhysProp::physprop_t']]], + ['refrtabsw_4865',['refrtabsw',['../structPhysProp_1_1physprop__t.html#a2cb505dd76f365687ee5e33a22a14e9b',1,'PhysProp::physprop_t']]], + ['regrid_5fint_4866',['regrid_int',['../classERF.html#a3937527f96c81674fa38dc34ed24f3f5',1,'ERF']]], + ['rei_4867',['rei',['../classRadiation.html#a145c41f0bcb2d103df37c30a5202340e',1,'Radiation']]], + ['rel_4868',['rel',['../classRadiation.html#a95d771d1d4157cb2640e6657b1af9937',1,'Radiation']]], + ['restart_5fchkfile_4869',['restart_chkfile',['../classERF.html#a8e758060d3dede9694fbfcabddc17169',1,'ERF']]], + ['restart_5ftype_4870',['restart_type',['../classERF.html#a30a0b9e3a037c71580d1feb3b30a8258',1,'ERF']]], + ['retab_4871',['retab',['../classRadConstants.html#af93f09fe2ad546b17aff927963cf90d1',1,'RadConstants']]], + ['rf1_4872',['Rf1',['../structMYNNLevel2.html#a296d16ed3e332da46763edb04a2ba326',1,'MYNNLevel2']]], + ['rf2_4873',['Rf2',['../structMYNNLevel2.html#a2c96a00a9adfdf0247139127ec62e75a',1,'MYNNLevel2']]], + ['rfc_4874',['Rfc',['../structMYNNLevel2.html#adf860e39bf0bada5d9f10d92282f3e1c',1,'MYNNLevel2']]], + ['rga_4875',['rga',['../ERF__Constants_8H.html#a379aa3c3394d67b78990663a36ed5285',1,'ERF_Constants.H']]], + ['rh20_4876',['rh20',['../ERF__Constants_8H.html#ade17c0f300126a2fd0829d0e1a553512',1,'ERF_Constants.H']]], + ['rhcrystal_4877',['rhcrystal',['../structPhysProp_1_1physprop__t.html#aedb70926e32d7aaa6655f0a417acb18d',1,'PhysProp::physprop_t']]], + ['rhdeliques_4878',['rhdeliques',['../structPhysProp_1_1physprop__t.html#a136a646945382e1e7808b61ec9c648fe',1,'PhysProp::physprop_t']]], + ['rho0_5ftrans_4879',['rho0_trans',['../structDiffChoice.html#a4df179b6e7d84efc89a22ac5900f98c8',1,'DiffChoice']]], + ['rho1d_4880',['rho1d',['../classSAM.html#a0853b1a3a4ec94178ca208ea594fc455',1,'SAM']]], + ['rho_5f0_4881',['rho_0',['../structProbParmDefaults.html#af75997d9e4a94ab3b221657799ef720f',1,'ProbParmDefaults']]], + ['rho_5finp_5fsound_5fd_4882',['rho_inp_sound_d',['../structInputSoundingData.html#a749f99cf96305b40d55beb3d5d98bb93',1,'InputSoundingData']]], + ['rhoalpha_5fc_4883',['rhoAlpha_C',['../structDiffChoice.html#a553bdd290d667cca9699ed37f86f7e22',1,'DiffChoice']]], + ['rhoalpha_5ft_4884',['rhoAlpha_T',['../structDiffChoice.html#a574cf6ad397fd50169cafe025c9da5f3',1,'DiffChoice']]], + ['rhod_5finteg_4885',['rhod_integ',['../structInputSoundingData.html#a401b589250214e7bb84555050c5b6657',1,'InputSoundingData']]], + ['rhog_4886',['rhog',['../ERF__Constants_8H.html#a00c6555efa1735f66b36929196ff6b98',1,'ERF_Constants.H']]], + ['rhoh2o_4887',['rhoh2o',['../ERF__Constants_8H.html#a404d50fe6660930b74e3b191e2088754',1,'ERF_Constants.H']]], + ['rhoqr_5fcomp_4888',['RhoQr_comp',['../structSolverChoice.html#a1d9237205fd632dcde1599511f203131',1,'SolverChoice']]], + ['rhoqv_5fcomp_4889',['RhoQv_comp',['../structSolverChoice.html#a9ac649bbebc73403e291d2af180d4061',1,'SolverChoice']]], + ['rhor_4890',['rhor',['../ERF__Constants_8H.html#ad6e28022b74cd595f282e2cc97c2c0d8',1,'ERF_Constants.H']]], + ['rhos_4891',['rhos',['../ERF__Constants_8H.html#ac0e05183a58d4400f06346d18371218f',1,'ERF_Constants.H']]], + ['rhs_4892',['rhs',['../classMRISplitIntegrator.html#ab0f2e5848bf5e8f4959b6f990cb73053',1,'MRISplitIntegrator']]], + ['ri1_4893',['Ri1',['../structMYNNLevel2.html#a9db4e0ee0f3a124e8d702e806a361ef3',1,'MYNNLevel2']]], + ['ri2_4894',['Ri2',['../structMYNNLevel2.html#a7363ba486b0015097a4ce5d3dc47c87d',1,'MYNNLevel2']]], + ['ri3_4895',['Ri3',['../structMYNNLevel2.html#a324abb3040e8337972d976fa6689bab5',1,'MYNNLevel2']]], + ['rotor_5frad_4896',['rotor_rad',['../classWindFarm.html#ad0925f54be32d71ae431a2078afee91b',1,'WindFarm::rotor_rad()'],['../classEWP.html#ac89ee08eabbf2cc7a64a7908a449f016',1,'EWP::rotor_rad()'],['../classFitch.html#aadaedef0e6f0ac149483ee6b4d8b1a4e',1,'Fitch::rotor_rad()'],['../classGeneralAD.html#a5c234bf71184a01e624baf9f9247b3d5',1,'GeneralAD::rotor_rad()'],['../classSimpleAD.html#a04490ef9f591e86588c5bb7870c1b77f',1,'SimpleAD::rotor_rad()']]], + ['rotor_5frpm_4897',['rotor_RPM',['../classWindFarm.html#ae10dbee3f3d8b126e52df83ea97d57b1',1,'WindFarm::rotor_RPM()'],['../classGeneralAD.html#aeddf04c6e2386ba28aac00e2124c39a5',1,'GeneralAD::rotor_RPM()']]], + ['rough_5ftype_5fland_4898',['rough_type_land',['../classABLMost.html#ab052d62a07e8765a6de67264d05aff37',1,'ABLMost']]], + ['rough_5ftype_5fsea_4899',['rough_type_sea',['../classABLMost.html#ab5041b7c6a15b759a8f33dadd1a67e92',1,'ABLMost']]], + ['rrtmg_5flw_5fcloudsim_5fband_4900',['rrtmg_lw_cloudsim_band',['../classRadConstants.html#aef2395d6f1bbed699fd4033b9c3104b8',1,'RadConstants']]], + ['rrtmg_5fsw_5fcloudsim_5fband_4901',['rrtmg_sw_cloudsim_band',['../classRadConstants.html#acd093dbcb244a162598bc23658a3f5d0',1,'RadConstants']]], + ['rrtmg_5fto_5frrtmgp_4902',['rrtmg_to_rrtmgp',['../classRadiation.html#a343cbb13362229a43f02df3a95eaa0ea',1,'Radiation']]], + ['rrtmgp_5fcoefficients_5ffile_5flw_4903',['rrtmgp_coefficients_file_lw',['../classRadiation.html#a0f24e2a14bfa218815d6d602374b6f0b',1,'Radiation']]], + ['rrtmgp_5fcoefficients_5ffile_5fname_5flw_4904',['rrtmgp_coefficients_file_name_lw',['../classRadiation.html#a9adc323a74a713f43a9952b3601d7f85',1,'Radiation']]], + ['rrtmgp_5fcoefficients_5ffile_5fname_5fsw_4905',['rrtmgp_coefficients_file_name_sw',['../classRadiation.html#ae6df86058b5dda6cb7b32e48f08f92f9',1,'Radiation']]], + ['rrtmgp_5fcoefficients_5ffile_5fsw_4906',['rrtmgp_coefficients_file_sw',['../classRadiation.html#a8b27a952d1ceb83c174a5d30f6198230',1,'Radiation']]], + ['rrtmgp_5fdata_5fpath_4907',['rrtmgp_data_path',['../classRadiation.html#a054782cce0873bc799bf8a3fdda6a1fb',1,'Radiation']]], + ['rrtmgp_5fenable_5ftemperature_5fwarnings_4908',['rrtmgp_enable_temperature_warnings',['../classRadiation.html#a4959db25c75a67b8166635413aae4888',1,'Radiation']]], + ['ru_5fnew_4909',['rU_new',['../classERF.html#a01f3db32272f53dc68025f0a98195e57',1,'ERF']]], + ['ru_5fold_4910',['rU_old',['../classERF.html#a6eecc44323f77917c95869928284f61d',1,'ERF']]], + ['rv_5fnew_4911',['rV_new',['../classERF.html#a54e37988486ef96e55e84bd8e91bb688',1,'ERF']]], + ['rv_5fold_4912',['rV_old',['../classERF.html#aeb64e3b4def989ce68d873aefeed5e0e',1,'ERF']]], + ['rw_5fnew_4913',['rW_new',['../classERF.html#aa46c0b0d20525aed10f447923e54dde7',1,'ERF']]], + ['rw_5fold_4914',['rW_old',['../classERF.html#ac1fa56ec90f44e3cdf487af46804163f',1,'ERF']]] ]; diff --git a/search/variables_12.js b/search/variables_12.js index eaffbc3e7..92dc73d6b 100644 --- a/search/variables_12.js +++ b/search/variables_12.js @@ -1,89 +1,89 @@ var searchData= [ - ['s_5fscratch_4913',['S_scratch',['../classMRISplitIntegrator.html#a6bcdee4380cd503256cb460b558184aa',1,'MRISplitIntegrator']]], - ['s_5fsum_4914',['S_sum',['../classMRISplitIntegrator.html#ad570588876d21506bc7232884841cab1',1,'MRISplitIntegrator']]], - ['sampleline_4915',['sampleline',['../classERF.html#a0fa1582bb13357895d2aba91b695624a',1,'ERF']]], - ['samplelinelog_4916',['samplelinelog',['../classERF.html#a4990f1796b65ec8ee602f177a66afc3e',1,'ERF']]], - ['samplelinelogname_4917',['samplelinelogname',['../classERF.html#a0553967f1131860bb8ecb47c0f192eaa',1,'ERF']]], - ['samplepoint_4918',['samplepoint',['../classERF.html#ae8a57b7fbf5a67c99d04b7d4f43ad100',1,'ERF']]], - ['sampleptlog_4919',['sampleptlog',['../classERF.html#a9737ddb0de6b9e8a5b17c109d5ad3e08',1,'ERF']]], - ['sampleptlogname_4920',['sampleptlogname',['../classERF.html#a8fbfa8bb47c0a3b53e244081aa1e8ad3',1,'ERF']]], - ['sampler_5finterval_4921',['sampler_interval',['../classERF.html#ad13532a7eebe8a7473dfe5ed9a828fe8',1,'ERF']]], - ['sampler_5fper_4922',['sampler_per',['../classERF.html#a8bfff875038f8c24055067117e192960',1,'ERF']]], - ['sampling_5fdistance_5fby_5fd_4923',['sampling_distance_by_D',['../structSolverChoice.html#a9029114db3f1983d2d720210dcf87c69',1,'SolverChoice']]], - ['sbl_5fdamp_4924',['sbl_damp',['../structMYNNPBLH.html#adf4c7c74040b1b560b509f1c035edd32',1,'MYNNPBLH']]], - ['sbl_5flim_4925',['sbl_lim',['../structMYNNPBLH.html#a12e1467dfe07775e2ef9c8a57ae473ad',1,'MYNNPBLH']]], - ['sc_5ft_4926',['Sc_t',['../structTurbChoice.html#aed763f56a6349187c9c0c0e4c952d05a',1,'TurbChoice']]], - ['sc_5ft_5finv_4927',['Sc_t_inv',['../structTurbChoice.html#a2daa4d23f9d89ee777a0d0fbd43196b6',1,'TurbChoice']]], - ['scalefactor_4928',['scalefactor',['../classEbertCurry.html#ab8edf44ffa6bd8f71ad9748b92928072',1,'EbertCurry']]], - ['sfs_5fdiss_5flev_4929',['SFS_diss_lev',['../classERF.html#a6e1ad417e3bd062468d74830b65911fb',1,'ERF']]], - ['sfs_5fhfx1_5flev_4930',['SFS_hfx1_lev',['../classERF.html#a25174b4ae6cfcac8f7d183ce5c9fe67b',1,'ERF']]], - ['sfs_5fhfx2_5flev_4931',['SFS_hfx2_lev',['../classERF.html#acb607b2e675b45fdcabc09b640ce5ae2',1,'ERF']]], - ['sfs_5fhfx3_5flev_4932',['SFS_hfx3_lev',['../classERF.html#a1a2e3faf5dd90ad2f9ded28b486f3b46',1,'ERF']]], - ['sfs_5fq1fx1_5flev_4933',['SFS_q1fx1_lev',['../classERF.html#ae0316d5ae567a2da8439d204bace12ce',1,'ERF']]], - ['sfs_5fq1fx2_5flev_4934',['SFS_q1fx2_lev',['../classERF.html#a53fab1172ec3f01356355f8cda0919fe',1,'ERF']]], - ['sfs_5fq1fx3_5flev_4935',['SFS_q1fx3_lev',['../classERF.html#a101ceb89b1a249efeea3f4e8052bc8c0',1,'ERF']]], - ['sfs_5fq2fx3_5flev_4936',['SFS_q2fx3_lev',['../classERF.html#a3ea10ef7383e594b6ee5e7a9ad67607b',1,'ERF']]], - ['sfuns_4937',['sfuns',['../structadiabatic.html#a6c7e923e1a01f0f0408829081a6b215c',1,'adiabatic::sfuns()'],['../structsurface__temp__wave__coupled.html#abf85e6ffabb9974a13bc03e6f7d11e96',1,'surface_temp_wave_coupled::sfuns()'],['../structsurface__temp__donelan.html#a236c8eeebacbe63a2d87e101a90c70dc',1,'surface_temp_donelan::sfuns()'],['../structsurface__temp__mod__charnock.html#a1f329567f9dbb2f1f7a09e32603c9964',1,'surface_temp_mod_charnock::sfuns()'],['../structsurface__temp__charnock.html#ad7008c8f849acb706853f7aa39cda24d',1,'surface_temp_charnock::sfuns()'],['../structsurface__temp.html#a66e248c3558685f25206441914e8dfbf',1,'surface_temp::sfuns()'],['../structsurface__flux__wave__coupled.html#a91a27aa83da28c6bed01137ad0619b45',1,'surface_flux_wave_coupled::sfuns()'],['../structsurface__flux__donelan.html#acbf1958c05bd1da59200cff1bffec3ab',1,'surface_flux_donelan::sfuns()'],['../structsurface__flux__charnock.html#a4501ca4ecf49dccd6a1a914af03e1ed1',1,'surface_flux_charnock::sfuns()'],['../structsurface__flux.html#a01e8827b2f7e84c4d72496993822d806',1,'surface_flux::sfuns()'],['../structadiabatic__wave__coupled.html#ab5f4ad8ae9907cf15e3eba1129ea1375',1,'adiabatic_wave_coupled::sfuns()'],['../structadiabatic__donelan.html#a190709c5c95b8f0eae6b8b2e89bac0ab',1,'adiabatic_donelan::sfuns()'],['../structadiabatic__mod__charnock.html#a66df1185e73be51b2bb72b55e70b64cd',1,'adiabatic_mod_charnock::sfuns()'],['../structadiabatic__charnock.html#ad4c4fe599c1b8692fa8ef8346866c349',1,'adiabatic_charnock::sfuns()'],['../structsurface__flux__mod__charnock.html#adb4a96d510f1e437c9efc41ba5fd16f9',1,'surface_flux_mod_charnock::sfuns()']]], - ['shape_4938',['shape',['../structNDArray.html#a99d704051dda7b5635b12cbe785d7bb5',1,'NDArray']]], - ['shmax_4939',['SHmax',['../structMYNNLevel25.html#a1f85d50fe35885cc85198ca50d0e9bd6',1,'MYNNLevel25']]], - ['shmin_4940',['SHmin',['../structMYNNLevel25.html#a7e65668ebad061e4f91fee27dc041208',1,'MYNNLevel25']]], - ['sigma_5fk_4941',['sigma_k',['../structTurbChoice.html#a0bb2b38f64a12b0b50552e05dee629e7',1,'TurbChoice']]], - ['sigmag_4942',['sigmag',['../structPhysProp_1_1physprop__t.html#a3f78f2921f22ba1912926ef62da7b19f',1,'PhysProp::physprop_t']]], - ['sinphi_4943',['sinphi',['../structSolverChoice.html#a6426e150ba9c1ba2e14151228bf6ffaf',1,'SolverChoice']]], - ['slow_5ffast_5ftimestep_5fratio_4944',['slow_fast_timestep_ratio',['../classMRISplitIntegrator.html#ac627f7a16fd409d33916eeccb9ab3c3f',1,'MRISplitIntegrator']]], - ['slow_5frhs_5ffun_5finc_4945',['slow_rhs_fun_inc',['../ERF__TI__slow__rhs__fun_8H.html#a8508b96780544287c9879a450cb1b3dd',1,'ERF_TI_slow_rhs_fun.H']]], - ['slow_5frhs_5ffun_5fpost_4946',['slow_rhs_fun_post',['../ERF__TI__slow__rhs__fun_8H.html#af460c930508105e92f60fd868d23ebcf',1,'ERF_TI_slow_rhs_fun.H']]], - ['slow_5frhs_5ffun_5fpre_4947',['slow_rhs_fun_pre',['../ERF__TI__slow__rhs__fun_8H.html#a963142d364408ee1775dbef20383b244',1,'ERF_TI_slow_rhs_fun.H']]], - ['slow_5frhs_5finc_4948',['slow_rhs_inc',['../classMRISplitIntegrator.html#a8549e46229b347585323bcc079b483f8',1,'MRISplitIntegrator']]], - ['slow_5frhs_5fpost_4949',['slow_rhs_post',['../classMRISplitIntegrator.html#a168352ef9fbddab9850fc5d1686d3e66',1,'MRISplitIntegrator']]], - ['slow_5frhs_5fpre_4950',['slow_rhs_pre',['../classMRISplitIntegrator.html#a51f92090a883eae0fa605c4a0a033311',1,'MRISplitIntegrator']]], - ['smmax_4951',['SMmax',['../structMYNNLevel25.html#a183889654d8da15f165f6385f05bb5ba',1,'MYNNLevel25']]], - ['smmin_4952',['SMmin',['../structMYNNLevel25.html#ac7e13ad757f1bdcc4d92f3065cf34931',1,'MYNNLevel25']]], - ['smnsmn_5flev_4953',['SmnSmn_lev',['../classERF.html#a9faaa96a7c270d2b2b062d9f30f19711',1,'ERF']]], - ['snw_5ftau_5fbnd_5flw_4954',['snw_tau_bnd_lw',['../classRadiation.html#a6bfa4de58353a68895bb2b8cc76a51a7',1,'Radiation']]], - ['snw_5ftau_5fbnd_5fsw_4955',['snw_tau_bnd_sw',['../classRadiation.html#aeb53acfe330d00c93b5402ef48867470',1,'Radiation']]], - ['solar_5fref_5fband_5firradiance_4956',['solar_ref_band_irradiance',['../classRadConstants.html#a08249d3010b2b85d35732b90d970cdf9',1,'RadConstants']]], - ['solverchoice_4957',['solverChoice',['../classERF.html#a32dd48049e8acbe95decdd4b01b782c4',1,'ERF']]], - ['source_4958',['source',['../structMamConstituents_1_1gas__t.html#a619486c07ea85c8a1f1866b98e3f58f8',1,'MamConstituents::gas_t::source()'],['../structMamConstituents_1_1aerosol__t.html#ab48037e47876a2ed6f26eb592a62d789',1,'MamConstituents::aerosol_t::source()']]], - ['source_5fmmr_5fa_4959',['source_mmr_a',['../structMamConstituents_1_1mode__component__t.html#a1414bee3812094600db773ce95ba57be',1,'MamConstituents::mode_component_t']]], - ['source_5fmmr_5fc_4960',['source_mmr_c',['../structMamConstituents_1_1mode__component__t.html#a69feca853d0ca8cae0a8fae58f4858e2',1,'MamConstituents::mode_component_t']]], - ['source_5fnum_5fa_4961',['source_num_a',['../structMamConstituents_1_1mode__component__t.html#ae1cdc979f1e678c3ea8bd5263e849153',1,'MamConstituents::mode_component_t']]], - ['source_5fnum_5fc_4962',['source_num_c',['../structMamConstituents_1_1mode__component__t.html#a349533043289a158d59b2ffd39d95378',1,'MamConstituents::mode_component_t']]], - ['sourcefile_4963',['sourcefile',['../structPhysProp_1_1physprop__t.html#a3e3968847760816c03052a8b76da1a13',1,'PhysProp::physprop_t']]], - ['spec_5ftype_5fnames_4964',['spec_type_names',['../classMamConstituents.html#a2a3c67427c13fc60d592017076ddc8ce',1,'MamConstituents']]], - ['spectralflux_4965',['spectralflux',['../classRadiation.html#a65e0577b3ffe9a808731650c75941674',1,'Radiation']]], - ['sponge_5fdensity_4966',['sponge_density',['../structSpongeChoice.html#adb74ee3cbc24251272d6ad5fafdb885d',1,'SpongeChoice']]], - ['sponge_5fstrength_4967',['sponge_strength',['../structSpongeChoice.html#a48f4b8a95b93cf8fa36d00d355757a1e',1,'SpongeChoice']]], - ['sponge_5ftype_4968',['sponge_type',['../structSpongeChoice.html#a1a41f754595d713df32583f0b0fa606e',1,'SpongeChoice::sponge_type()'],['../classERF.html#a6c570cbcb63ba3b0b09557537310ea46',1,'ERF::sponge_type()']]], - ['sponge_5fx_5fvelocity_4969',['sponge_x_velocity',['../structSpongeChoice.html#aad5ca098e341c3f76dc8420daeb8b629',1,'SpongeChoice']]], - ['sponge_5fy_5fvelocity_4970',['sponge_y_velocity',['../structSpongeChoice.html#a13c70085162f73a4b6c36f7161be7260',1,'SpongeChoice']]], - ['sponge_5fz_5fvelocity_4971',['sponge_z_velocity',['../structSpongeChoice.html#a830ff63e204ed6c9dd381fd2baa1b33e',1,'SpongeChoice']]], - ['spongechoice_4972',['spongeChoice',['../structSolverChoice.html#ac066852f06a6409e1638f59868b7c57d',1,'SolverChoice']]], - ['ssa_5fcmip6_5fsw_4973',['ssa_cmip6_sw',['../classAerRadProps.html#a0690511bbea6225a4afa365c4c153f0c',1,'AerRadProps']]], - ['ssa_5fsw_5fice_4974',['ssa_sw_ice',['../classCloudRadProps.html#a65b15fc94853bc17e04f24926155b7c5',1,'CloudRadProps']]], - ['ssa_5fsw_5fliq_4975',['ssa_sw_liq',['../classCloudRadProps.html#a6a070723376d30c2d64c808898faebfb',1,'CloudRadProps']]], - ['sst_5flev_4976',['sst_lev',['../classERF.html#a5a5395054a212d8f3fc577562c14b66e',1,'ERF']]], - ['start_5ftime_4977',['start_time',['../classERF.html#aa0c07f31b23d977646b8161e5473fab5',1,'ERF']]], - ['startcputime_4978',['startCPUTime',['../classERF.html#a6d00e1cb76bfbcbada173e092b6accf3',1,'ERF']]], - ['stop_5ftime_4979',['stop_time',['../classERF.html#a405556a52bef334ab68294c1a540e107',1,'ERF']]], - ['stretched_5fdz_5fd_4980',['stretched_dz_d',['../classERF.html#a6600f30f1043a4c5e62b5cdd05f0a99f',1,'ERF']]], - ['stretched_5fdz_5fh_4981',['stretched_dz_h',['../classERF.html#ad0981b0ff70e6d78acbb7769f7a142b7',1,'ERF']]], - ['substepping_5ftype_4982',['substepping_type',['../structSolverChoice.html#a7c414e2fb7c53479a2d21bb3a2d4099e',1,'SolverChoice']]], - ['sum_5finterval_4983',['sum_interval',['../classERF.html#a5232e98479611a24fe97994640c61faa',1,'ERF']]], - ['sum_5fper_4984',['sum_per',['../classERF.html#a1cf2ba396f4404724824516da4c4a084',1,'ERF']]], - ['surf_5fheating_5frate_4985',['surf_heating_rate',['../classABLMost.html#a39402ac3794b9a218289cd0d4adec670',1,'ABLMost']]], - ['surf_5ftemp_4986',['surf_temp',['../classABLMost.html#a73621a1b429f2e910a29adac72b7c581',1,'ABLMost']]], - ['surf_5ftemp_5fflux_4987',['surf_temp_flux',['../structmost__data.html#af1d069399319831cf4ae17fba1dda19f',1,'most_data::surf_temp_flux()'],['../classABLMost.html#a98390481d302c2a2c7346bf2328305a8',1,'ABLMost::surf_temp_flux()']]], - ['sw_5fband_5fmidpoints_4988',['sw_band_midpoints',['../classRadiation.html#a8ed843e3e2bb03d388b0c3ab869b1dba',1,'Radiation']]], - ['sw_5ffluxes_5fallsky_4989',['sw_fluxes_allsky',['../classRadiation.html#abab5871c8109d6445f9c9f8e1713c8e4',1,'Radiation']]], - ['sw_5ffluxes_5fclrsky_4990',['sw_fluxes_clrsky',['../classRadiation.html#a8ac40edc77ac51d941c954c15bb9dbf5',1,'Radiation']]], - ['sw_5fhygro_5fasm_4991',['sw_hygro_asm',['../structPhysProp_1_1physprop__t.html#ae7278f6fb1910558af27c7ff79b18fa0',1,'PhysProp::physprop_t']]], - ['sw_5fhygro_5fext_4992',['sw_hygro_ext',['../structPhysProp_1_1physprop__t.html#aff3fc87f8134cab71058c4372ddb853f',1,'PhysProp::physprop_t']]], - ['sw_5fhygro_5fssa_4993',['sw_hygro_ssa',['../structPhysProp_1_1physprop__t.html#ae326430d60fa6170ccbebccb10b8a86a',1,'PhysProp::physprop_t']]], - ['sw_5fnonhygro_5fascat_4994',['sw_nonhygro_ascat',['../structPhysProp_1_1physprop__t.html#a4789a50f02b5f5cdee6a284cc782eed9',1,'PhysProp::physprop_t']]], - ['sw_5fnonhygro_5fasm_4995',['sw_nonhygro_asm',['../structPhysProp_1_1physprop__t.html#a744ddbbe6c903be22244e84cbc85c567',1,'PhysProp::physprop_t']]], - ['sw_5fnonhygro_5fext_4996',['sw_nonhygro_ext',['../structPhysProp_1_1physprop__t.html#a3b762bb10073922aba1fdc89e8f4d412',1,'PhysProp::physprop_t']]], - ['sw_5fnonhygro_5fscat_4997',['sw_nonhygro_scat',['../structPhysProp_1_1physprop__t.html#abbcc9ba3c0f329c98e7ba078f2ebf1dc',1,'PhysProp::physprop_t']]], - ['sw_5fnonhygro_5fssa_4998',['sw_nonhygro_ssa',['../structPhysProp_1_1physprop__t.html#aad14342b28b8939c5ae115605318ed02',1,'PhysProp::physprop_t']]] + ['s_5fscratch_4915',['S_scratch',['../classMRISplitIntegrator.html#a6bcdee4380cd503256cb460b558184aa',1,'MRISplitIntegrator']]], + ['s_5fsum_4916',['S_sum',['../classMRISplitIntegrator.html#ad570588876d21506bc7232884841cab1',1,'MRISplitIntegrator']]], + ['sampleline_4917',['sampleline',['../classERF.html#a0fa1582bb13357895d2aba91b695624a',1,'ERF']]], + ['samplelinelog_4918',['samplelinelog',['../classERF.html#a4990f1796b65ec8ee602f177a66afc3e',1,'ERF']]], + ['samplelinelogname_4919',['samplelinelogname',['../classERF.html#a0553967f1131860bb8ecb47c0f192eaa',1,'ERF']]], + ['samplepoint_4920',['samplepoint',['../classERF.html#ae8a57b7fbf5a67c99d04b7d4f43ad100',1,'ERF']]], + ['sampleptlog_4921',['sampleptlog',['../classERF.html#a9737ddb0de6b9e8a5b17c109d5ad3e08',1,'ERF']]], + ['sampleptlogname_4922',['sampleptlogname',['../classERF.html#a8fbfa8bb47c0a3b53e244081aa1e8ad3',1,'ERF']]], + ['sampler_5finterval_4923',['sampler_interval',['../classERF.html#ad13532a7eebe8a7473dfe5ed9a828fe8',1,'ERF']]], + ['sampler_5fper_4924',['sampler_per',['../classERF.html#a8bfff875038f8c24055067117e192960',1,'ERF']]], + ['sampling_5fdistance_5fby_5fd_4925',['sampling_distance_by_D',['../structSolverChoice.html#a9029114db3f1983d2d720210dcf87c69',1,'SolverChoice']]], + ['sbl_5fdamp_4926',['sbl_damp',['../structMYNNPBLH.html#adf4c7c74040b1b560b509f1c035edd32',1,'MYNNPBLH']]], + ['sbl_5flim_4927',['sbl_lim',['../structMYNNPBLH.html#a12e1467dfe07775e2ef9c8a57ae473ad',1,'MYNNPBLH']]], + ['sc_5ft_4928',['Sc_t',['../structTurbChoice.html#aed763f56a6349187c9c0c0e4c952d05a',1,'TurbChoice']]], + ['sc_5ft_5finv_4929',['Sc_t_inv',['../structTurbChoice.html#a2daa4d23f9d89ee777a0d0fbd43196b6',1,'TurbChoice']]], + ['scalefactor_4930',['scalefactor',['../classEbertCurry.html#ab8edf44ffa6bd8f71ad9748b92928072',1,'EbertCurry']]], + ['sfs_5fdiss_5flev_4931',['SFS_diss_lev',['../classERF.html#a6e1ad417e3bd062468d74830b65911fb',1,'ERF']]], + ['sfs_5fhfx1_5flev_4932',['SFS_hfx1_lev',['../classERF.html#a25174b4ae6cfcac8f7d183ce5c9fe67b',1,'ERF']]], + ['sfs_5fhfx2_5flev_4933',['SFS_hfx2_lev',['../classERF.html#acb607b2e675b45fdcabc09b640ce5ae2',1,'ERF']]], + ['sfs_5fhfx3_5flev_4934',['SFS_hfx3_lev',['../classERF.html#a1a2e3faf5dd90ad2f9ded28b486f3b46',1,'ERF']]], + ['sfs_5fq1fx1_5flev_4935',['SFS_q1fx1_lev',['../classERF.html#ae0316d5ae567a2da8439d204bace12ce',1,'ERF']]], + ['sfs_5fq1fx2_5flev_4936',['SFS_q1fx2_lev',['../classERF.html#a53fab1172ec3f01356355f8cda0919fe',1,'ERF']]], + ['sfs_5fq1fx3_5flev_4937',['SFS_q1fx3_lev',['../classERF.html#a101ceb89b1a249efeea3f4e8052bc8c0',1,'ERF']]], + ['sfs_5fq2fx3_5flev_4938',['SFS_q2fx3_lev',['../classERF.html#a3ea10ef7383e594b6ee5e7a9ad67607b',1,'ERF']]], + ['sfuns_4939',['sfuns',['../structadiabatic.html#a6c7e923e1a01f0f0408829081a6b215c',1,'adiabatic::sfuns()'],['../structsurface__temp__wave__coupled.html#abf85e6ffabb9974a13bc03e6f7d11e96',1,'surface_temp_wave_coupled::sfuns()'],['../structsurface__temp__donelan.html#a236c8eeebacbe63a2d87e101a90c70dc',1,'surface_temp_donelan::sfuns()'],['../structsurface__temp__mod__charnock.html#a1f329567f9dbb2f1f7a09e32603c9964',1,'surface_temp_mod_charnock::sfuns()'],['../structsurface__temp__charnock.html#ad7008c8f849acb706853f7aa39cda24d',1,'surface_temp_charnock::sfuns()'],['../structsurface__temp.html#a66e248c3558685f25206441914e8dfbf',1,'surface_temp::sfuns()'],['../structsurface__flux__wave__coupled.html#a91a27aa83da28c6bed01137ad0619b45',1,'surface_flux_wave_coupled::sfuns()'],['../structsurface__flux__donelan.html#acbf1958c05bd1da59200cff1bffec3ab',1,'surface_flux_donelan::sfuns()'],['../structsurface__flux__charnock.html#a4501ca4ecf49dccd6a1a914af03e1ed1',1,'surface_flux_charnock::sfuns()'],['../structsurface__flux.html#a01e8827b2f7e84c4d72496993822d806',1,'surface_flux::sfuns()'],['../structadiabatic__wave__coupled.html#ab5f4ad8ae9907cf15e3eba1129ea1375',1,'adiabatic_wave_coupled::sfuns()'],['../structadiabatic__donelan.html#a190709c5c95b8f0eae6b8b2e89bac0ab',1,'adiabatic_donelan::sfuns()'],['../structadiabatic__mod__charnock.html#a66df1185e73be51b2bb72b55e70b64cd',1,'adiabatic_mod_charnock::sfuns()'],['../structadiabatic__charnock.html#ad4c4fe599c1b8692fa8ef8346866c349',1,'adiabatic_charnock::sfuns()'],['../structsurface__flux__mod__charnock.html#adb4a96d510f1e437c9efc41ba5fd16f9',1,'surface_flux_mod_charnock::sfuns()']]], + ['shape_4940',['shape',['../structNDArray.html#a99d704051dda7b5635b12cbe785d7bb5',1,'NDArray']]], + ['shmax_4941',['SHmax',['../structMYNNLevel25.html#a1f85d50fe35885cc85198ca50d0e9bd6',1,'MYNNLevel25']]], + ['shmin_4942',['SHmin',['../structMYNNLevel25.html#a7e65668ebad061e4f91fee27dc041208',1,'MYNNLevel25']]], + ['sigma_5fk_4943',['sigma_k',['../structTurbChoice.html#a0bb2b38f64a12b0b50552e05dee629e7',1,'TurbChoice']]], + ['sigmag_4944',['sigmag',['../structPhysProp_1_1physprop__t.html#a3f78f2921f22ba1912926ef62da7b19f',1,'PhysProp::physprop_t']]], + ['sinphi_4945',['sinphi',['../structSolverChoice.html#a6426e150ba9c1ba2e14151228bf6ffaf',1,'SolverChoice']]], + ['slow_5ffast_5ftimestep_5fratio_4946',['slow_fast_timestep_ratio',['../classMRISplitIntegrator.html#ac627f7a16fd409d33916eeccb9ab3c3f',1,'MRISplitIntegrator']]], + ['slow_5frhs_5ffun_5finc_4947',['slow_rhs_fun_inc',['../ERF__TI__slow__rhs__fun_8H.html#a8508b96780544287c9879a450cb1b3dd',1,'ERF_TI_slow_rhs_fun.H']]], + ['slow_5frhs_5ffun_5fpost_4948',['slow_rhs_fun_post',['../ERF__TI__slow__rhs__fun_8H.html#af460c930508105e92f60fd868d23ebcf',1,'ERF_TI_slow_rhs_fun.H']]], + ['slow_5frhs_5ffun_5fpre_4949',['slow_rhs_fun_pre',['../ERF__TI__slow__rhs__fun_8H.html#a963142d364408ee1775dbef20383b244',1,'ERF_TI_slow_rhs_fun.H']]], + ['slow_5frhs_5finc_4950',['slow_rhs_inc',['../classMRISplitIntegrator.html#a8549e46229b347585323bcc079b483f8',1,'MRISplitIntegrator']]], + ['slow_5frhs_5fpost_4951',['slow_rhs_post',['../classMRISplitIntegrator.html#a168352ef9fbddab9850fc5d1686d3e66',1,'MRISplitIntegrator']]], + ['slow_5frhs_5fpre_4952',['slow_rhs_pre',['../classMRISplitIntegrator.html#a51f92090a883eae0fa605c4a0a033311',1,'MRISplitIntegrator']]], + ['smmax_4953',['SMmax',['../structMYNNLevel25.html#a183889654d8da15f165f6385f05bb5ba',1,'MYNNLevel25']]], + ['smmin_4954',['SMmin',['../structMYNNLevel25.html#ac7e13ad757f1bdcc4d92f3065cf34931',1,'MYNNLevel25']]], + ['smnsmn_5flev_4955',['SmnSmn_lev',['../classERF.html#a9faaa96a7c270d2b2b062d9f30f19711',1,'ERF']]], + ['snw_5ftau_5fbnd_5flw_4956',['snw_tau_bnd_lw',['../classRadiation.html#a6bfa4de58353a68895bb2b8cc76a51a7',1,'Radiation']]], + ['snw_5ftau_5fbnd_5fsw_4957',['snw_tau_bnd_sw',['../classRadiation.html#aeb53acfe330d00c93b5402ef48867470',1,'Radiation']]], + ['solar_5fref_5fband_5firradiance_4958',['solar_ref_band_irradiance',['../classRadConstants.html#a08249d3010b2b85d35732b90d970cdf9',1,'RadConstants']]], + ['solverchoice_4959',['solverChoice',['../classERF.html#a32dd48049e8acbe95decdd4b01b782c4',1,'ERF']]], + ['source_4960',['source',['../structMamConstituents_1_1gas__t.html#a619486c07ea85c8a1f1866b98e3f58f8',1,'MamConstituents::gas_t::source()'],['../structMamConstituents_1_1aerosol__t.html#ab48037e47876a2ed6f26eb592a62d789',1,'MamConstituents::aerosol_t::source()']]], + ['source_5fmmr_5fa_4961',['source_mmr_a',['../structMamConstituents_1_1mode__component__t.html#a1414bee3812094600db773ce95ba57be',1,'MamConstituents::mode_component_t']]], + ['source_5fmmr_5fc_4962',['source_mmr_c',['../structMamConstituents_1_1mode__component__t.html#a69feca853d0ca8cae0a8fae58f4858e2',1,'MamConstituents::mode_component_t']]], + ['source_5fnum_5fa_4963',['source_num_a',['../structMamConstituents_1_1mode__component__t.html#ae1cdc979f1e678c3ea8bd5263e849153',1,'MamConstituents::mode_component_t']]], + ['source_5fnum_5fc_4964',['source_num_c',['../structMamConstituents_1_1mode__component__t.html#a349533043289a158d59b2ffd39d95378',1,'MamConstituents::mode_component_t']]], + ['sourcefile_4965',['sourcefile',['../structPhysProp_1_1physprop__t.html#a3e3968847760816c03052a8b76da1a13',1,'PhysProp::physprop_t']]], + ['spec_5ftype_5fnames_4966',['spec_type_names',['../classMamConstituents.html#a2a3c67427c13fc60d592017076ddc8ce',1,'MamConstituents']]], + ['spectralflux_4967',['spectralflux',['../classRadiation.html#a65e0577b3ffe9a808731650c75941674',1,'Radiation']]], + ['sponge_5fdensity_4968',['sponge_density',['../structSpongeChoice.html#adb74ee3cbc24251272d6ad5fafdb885d',1,'SpongeChoice']]], + ['sponge_5fstrength_4969',['sponge_strength',['../structSpongeChoice.html#a48f4b8a95b93cf8fa36d00d355757a1e',1,'SpongeChoice']]], + ['sponge_5ftype_4970',['sponge_type',['../structSpongeChoice.html#a1a41f754595d713df32583f0b0fa606e',1,'SpongeChoice::sponge_type()'],['../classERF.html#a6c570cbcb63ba3b0b09557537310ea46',1,'ERF::sponge_type()']]], + ['sponge_5fx_5fvelocity_4971',['sponge_x_velocity',['../structSpongeChoice.html#aad5ca098e341c3f76dc8420daeb8b629',1,'SpongeChoice']]], + ['sponge_5fy_5fvelocity_4972',['sponge_y_velocity',['../structSpongeChoice.html#a13c70085162f73a4b6c36f7161be7260',1,'SpongeChoice']]], + ['sponge_5fz_5fvelocity_4973',['sponge_z_velocity',['../structSpongeChoice.html#a830ff63e204ed6c9dd381fd2baa1b33e',1,'SpongeChoice']]], + ['spongechoice_4974',['spongeChoice',['../structSolverChoice.html#ac066852f06a6409e1638f59868b7c57d',1,'SolverChoice']]], + ['ssa_5fcmip6_5fsw_4975',['ssa_cmip6_sw',['../classAerRadProps.html#a0690511bbea6225a4afa365c4c153f0c',1,'AerRadProps']]], + ['ssa_5fsw_5fice_4976',['ssa_sw_ice',['../classCloudRadProps.html#a65b15fc94853bc17e04f24926155b7c5',1,'CloudRadProps']]], + ['ssa_5fsw_5fliq_4977',['ssa_sw_liq',['../classCloudRadProps.html#a6a070723376d30c2d64c808898faebfb',1,'CloudRadProps']]], + ['sst_5flev_4978',['sst_lev',['../classERF.html#a5a5395054a212d8f3fc577562c14b66e',1,'ERF']]], + ['start_5ftime_4979',['start_time',['../classERF.html#aa0c07f31b23d977646b8161e5473fab5',1,'ERF']]], + ['startcputime_4980',['startCPUTime',['../classERF.html#a6d00e1cb76bfbcbada173e092b6accf3',1,'ERF']]], + ['stop_5ftime_4981',['stop_time',['../classERF.html#a405556a52bef334ab68294c1a540e107',1,'ERF']]], + ['stretched_5fdz_5fd_4982',['stretched_dz_d',['../classERF.html#a6600f30f1043a4c5e62b5cdd05f0a99f',1,'ERF']]], + ['stretched_5fdz_5fh_4983',['stretched_dz_h',['../classERF.html#ad0981b0ff70e6d78acbb7769f7a142b7',1,'ERF']]], + ['substepping_5ftype_4984',['substepping_type',['../structSolverChoice.html#a7c414e2fb7c53479a2d21bb3a2d4099e',1,'SolverChoice']]], + ['sum_5finterval_4985',['sum_interval',['../classERF.html#a5232e98479611a24fe97994640c61faa',1,'ERF']]], + ['sum_5fper_4986',['sum_per',['../classERF.html#a1cf2ba396f4404724824516da4c4a084',1,'ERF']]], + ['surf_5fheating_5frate_4987',['surf_heating_rate',['../classABLMost.html#a39402ac3794b9a218289cd0d4adec670',1,'ABLMost']]], + ['surf_5ftemp_4988',['surf_temp',['../classABLMost.html#a73621a1b429f2e910a29adac72b7c581',1,'ABLMost']]], + ['surf_5ftemp_5fflux_4989',['surf_temp_flux',['../structmost__data.html#af1d069399319831cf4ae17fba1dda19f',1,'most_data::surf_temp_flux()'],['../classABLMost.html#a98390481d302c2a2c7346bf2328305a8',1,'ABLMost::surf_temp_flux()']]], + ['sw_5fband_5fmidpoints_4990',['sw_band_midpoints',['../classRadiation.html#a8ed843e3e2bb03d388b0c3ab869b1dba',1,'Radiation']]], + ['sw_5ffluxes_5fallsky_4991',['sw_fluxes_allsky',['../classRadiation.html#abab5871c8109d6445f9c9f8e1713c8e4',1,'Radiation']]], + ['sw_5ffluxes_5fclrsky_4992',['sw_fluxes_clrsky',['../classRadiation.html#a8ac40edc77ac51d941c954c15bb9dbf5',1,'Radiation']]], + ['sw_5fhygro_5fasm_4993',['sw_hygro_asm',['../structPhysProp_1_1physprop__t.html#ae7278f6fb1910558af27c7ff79b18fa0',1,'PhysProp::physprop_t']]], + ['sw_5fhygro_5fext_4994',['sw_hygro_ext',['../structPhysProp_1_1physprop__t.html#aff3fc87f8134cab71058c4372ddb853f',1,'PhysProp::physprop_t']]], + ['sw_5fhygro_5fssa_4995',['sw_hygro_ssa',['../structPhysProp_1_1physprop__t.html#ae326430d60fa6170ccbebccb10b8a86a',1,'PhysProp::physprop_t']]], + ['sw_5fnonhygro_5fascat_4996',['sw_nonhygro_ascat',['../structPhysProp_1_1physprop__t.html#a4789a50f02b5f5cdee6a284cc782eed9',1,'PhysProp::physprop_t']]], + ['sw_5fnonhygro_5fasm_4997',['sw_nonhygro_asm',['../structPhysProp_1_1physprop__t.html#a744ddbbe6c903be22244e84cbc85c567',1,'PhysProp::physprop_t']]], + ['sw_5fnonhygro_5fext_4998',['sw_nonhygro_ext',['../structPhysProp_1_1physprop__t.html#a3b762bb10073922aba1fdc89e8f4d412',1,'PhysProp::physprop_t']]], + ['sw_5fnonhygro_5fscat_4999',['sw_nonhygro_scat',['../structPhysProp_1_1physprop__t.html#abbcc9ba3c0f329c98e7ba078f2ebf1dc',1,'PhysProp::physprop_t']]], + ['sw_5fnonhygro_5fssa_5000',['sw_nonhygro_ssa',['../structPhysProp_1_1physprop__t.html#aad14342b28b8939c5ae115605318ed02',1,'PhysProp::physprop_t']]] ]; diff --git a/search/variables_13.js b/search/variables_13.js index 20fcfdc59..7f5ae2810 100644 --- a/search/variables_13.js +++ b/search/variables_13.js @@ -1,79 +1,79 @@ var searchData= [ - ['t_5f0_4999',['T_0',['../structProbParmDefaults.html#a16db7fa78b123f2a956bacbce26f32c6',1,'ProbParmDefaults']]], - ['t_5favg_5fcnt_5000',['t_avg_cnt',['../classERF.html#a6837423e9248e923fcaa1987b59d8160',1,'ERF']]], - ['t_5fnew_5001',['t_new',['../classERF.html#a65741b6379d273c19a25cf48bb947614',1,'ERF']]], - ['t_5fold_5002',['t_old',['../classERF.html#a7085d7d5fc94a0f84efc06957267d58e',1,'ERF']]], - ['t_5fstar_5003',['t_star',['../classABLMost.html#ac9d90016f196c3861d225132e8b6a921',1,'ABLMost']]], - ['t_5fstore_5004',['T_store',['../classMRISplitIntegrator.html#a10fa09211f3b0a6b7357ab79dbadbb80',1,'MRISplitIntegrator']]], - ['t_5fsurf_5005',['t_surf',['../classABLMost.html#a1f488836fca7c3da2bed67c63a94951b',1,'ABLMost']]], - ['tabs1d_5006',['tabs1d',['../classSAM.html#aee5da977a069c0b9cb98d150027f746c',1,'SAM']]], - ['target_5fbox_5007',['target_box',['../classWriteBndryPlanes.html#a4d7d2b3b5b1c823b905ae3042bb62379',1,'WriteBndryPlanes']]], - ['tau11_5flev_5008',['Tau11_lev',['../classERF.html#aeb9348353b2415d023d8f52c293cad7e',1,'ERF']]], - ['tau12_5flev_5009',['Tau12_lev',['../classERF.html#ad8c2eca71737b102cc5cf75f97c6bd63',1,'ERF']]], - ['tau13_5flev_5010',['Tau13_lev',['../classERF.html#a5392e6104804d799b3fd943dfe390766',1,'ERF']]], - ['tau21_5flev_5011',['Tau21_lev',['../classERF.html#a547864dc0347f4620feb99ed564acb4d',1,'ERF']]], - ['tau22_5flev_5012',['Tau22_lev',['../classERF.html#afb4294f848d86e4aefb74848bb71047e',1,'ERF']]], - ['tau23_5flev_5013',['Tau23_lev',['../classERF.html#a03a4ad7368c1c98b492cd9d9fec9cbc5',1,'ERF']]], - ['tau31_5flev_5014',['Tau31_lev',['../classERF.html#a203e7334296218672e36bab93174e146',1,'ERF']]], - ['tau32_5flev_5015',['Tau32_lev',['../classERF.html#aa650bf1f6885b179fd8d4c24b48668cb',1,'ERF']]], - ['tau33_5flev_5016',['Tau33_lev',['../classERF.html#a60a185c47f07bf4fb537a15d5a226d8a',1,'ERF']]], - ['tau_5fnudging_5017',['tau_nudging',['../structInputSoundingData.html#a5c190ab2ffec63277427ed6c92d4f53f',1,'InputSoundingData']]], - ['tbgmax_5018',['tbgmax',['../ERF__Constants_8H.html#a2b4ea8a29735038e49703c7f8c1f20c8',1,'ERF_Constants.H']]], - ['tbgmin_5019',['tbgmin',['../ERF__Constants_8H.html#abf1e890912f1117211516f13b27ed2e8',1,'ERF_Constants.H']]], - ['tboil_5020',['tboil',['../ERF__Constants_8H.html#a123bd9756d4f11bae80bb918f88cbd3f',1,'ERF_Constants.H']]], - ['temp_5021',['temp',['../classAerRadProps.html#a0a03391413de1fcd9ea2550fea907b33',1,'AerRadProps']]], - ['terrain_5fis_5fflat_5022',['terrain_is_flat',['../structSolverChoice.html#ae6a90725e04ca6fe634ec44fb347f5ff',1,'SolverChoice']]], - ['terrain_5ftype_5023',['terrain_type',['../structSolverChoice.html#ab734eb0a5147b93dc6590038b6decc60',1,'SolverChoice']]], - ['test_5fmapfactor_5024',['test_mapfactor',['../structSolverChoice.html#a9c7942f6ef7cf05115f35702097cf107',1,'SolverChoice']]], - ['tgrmax_5025',['tgrmax',['../ERF__Constants_8H.html#ab24d300166813654b7d8adb31bc71938',1,'ERF_Constants.H']]], - ['tgrmin_5026',['tgrmin',['../ERF__Constants_8H.html#afb7d1700c60728d56ef525934fe6a098',1,'ERF_Constants.H']]], - ['therco_5027',['therco',['../ERF__Constants_8H.html#a583248545708b1481d513f2c9621f0ba',1,'ERF_Constants.H']]], - ['theta_5fincr_5fland_5028',['theta_incr_land',['../structMYNNPBLH.html#a16169bdfadcc27219d7c6dde54ef6bd9',1,'MYNNPBLH']]], - ['theta_5fincr_5fwater_5029',['theta_incr_water',['../structMYNNPBLH.html#ad830dc7c3282256b729ad09b8cc0572e',1,'MYNNPBLH']]], - ['theta_5finp_5fsound_5030',['theta_inp_sound',['../structInputSoundingData.html#a7cde9c67da9ade1d385047732b106943',1,'InputSoundingData']]], - ['theta_5finp_5fsound_5fd_5031',['theta_inp_sound_d',['../structInputSoundingData.html#a00054ef7905b250d663dd8c9d69a112e',1,'InputSoundingData']]], - ['theta_5fprim_5032',['Theta_prim',['../classERF.html#a71629ae2fda396472198691b75d83b2e',1,'ERF']]], - ['theta_5fref_5033',['theta_ref',['../structTurbChoice.html#aeb3c184b540858407426a606327fba3a',1,'TurbChoice']]], - ['theta_5fref_5finp_5fsound_5034',['theta_ref_inp_sound',['../structInputSoundingData.html#a15782809644a4daa0e8de9c3cc4c346a',1,'InputSoundingData']]], - ['theta_5ftype_5035',['theta_type',['../classABLMost.html#a7d1394fa01c8c29b20dfb790c0f3ec6b',1,'ABLMost']]], - ['thetamin_5fheight_5036',['thetamin_height',['../structMYNNPBLH.html#aa607f6576c6029c132a0f7b33aec72f1',1,'MYNNPBLH']]], - ['thin_5fxforce_5037',['thin_xforce',['../classERF.html#a5b9b8d719a87a6940f611c6a30e8ccf5',1,'ERF']]], - ['thin_5fyforce_5038',['thin_yforce',['../classERF.html#a18c1142552120bbd22987f34995ee939',1,'ERF']]], - ['thin_5fzforce_5039',['thin_zforce',['../classERF.html#a56a23d298bc66218bf257d0e793e341f',1,'ERF']]], - ['third_5040',['third',['../classModalAeroWateruptake.html#a77bdba258f0d10234a98a54a39a5fb7f',1,'ModalAeroWateruptake']]], - ['thrust_5fcoeff_5041',['thrust_coeff',['../classSimpleAD.html#a0d915eaf360210453a081a2b721d0fa0',1,'SimpleAD::thrust_coeff()'],['../classWindFarm.html#a8d5e6333f2f9f8e36dfd4766ad171b84',1,'WindFarm::thrust_coeff()'],['../classEWP.html#a9cdc57dc5a1a63c4a4e62ba85dffecc4',1,'EWP::thrust_coeff()'],['../classFitch.html#a7cafd25264dba6194d42285153683f34',1,'Fitch::thrust_coeff()'],['../classGeneralAD.html#a45f8887ce8907918ceebf0a804eaffea',1,'GeneralAD::thrust_coeff()']]], - ['thrust_5fcoeff_5fstanding_5042',['thrust_coeff_standing',['../classWindFarm.html#ab8d68a72cf4346074daf47f825eff105',1,'WindFarm::thrust_coeff_standing()'],['../classEWP.html#a22f50393881ced019cae2a74ee04cdea',1,'EWP::thrust_coeff_standing()'],['../classFitch.html#adc5df318361103709d0fa5421358e29d',1,'Fitch::thrust_coeff_standing()'],['../classGeneralAD.html#ad96abbb1f20b4ea0abf49d0fb88b289a',1,'GeneralAD::thrust_coeff_standing()'],['../classSimpleAD.html#a1665d726556fc42558e77fe94e732d43',1,'SimpleAD::thrust_coeff_standing()']]], - ['time_5favg_5fvel_5043',['time_avg_vel',['../structSolverChoice.html#af3119a4089367206db9fc3a17664e874',1,'SolverChoice']]], - ['timestep_5044',['timestep',['../classMRISplitIntegrator.html#a3f21bedf222ce95136d4889012401612',1,'MRISplitIntegrator']]], - ['tint_5045',['tint',['../classRadiation.html#a76bb14b6a6eafd04ffad69f50547be41',1,'Radiation']]], - ['tmax_5046',['tmax',['../classWaterVaporSat.html#a8e168a8ca074d530d7afe596739270b4',1,'WaterVaporSat']]], - ['tmelt_5047',['tmelt',['../ERF__Constants_8H.html#a764526b482e006cd52004d3f53467b57',1,'ERF_Constants.H']]], - ['tmid_5048',['tmid',['../classRadiation.html#ac1ed1e73ee4f8832a699967c8354bd6e',1,'Radiation']]], - ['tmin_5049',['tmin',['../classWaterVaporSat.html#ac7a0c53f3985416b26f43135e25accca',1,'WaterVaporSat']]], - ['tol_5050',['TOL',['../namespaceHSEutils.html#aace33d14958f235a111e6cead400a61e',1,'HSEutils']]], - ['tol_5051',['tol',['../structadiabatic__mod__charnock.html#a8a007e09d416f6879b7ba68c7e4ac29e',1,'adiabatic_mod_charnock::tol()'],['../structWENO__Z7.html#ab5d1630a2cd0f731c932a981f7c43e6f',1,'WENO_Z7::tol()'],['../structWENO__Z5.html#af5daab47aa96e124f3bf0508489e3017',1,'WENO_Z5::tol()'],['../structWENO__MZQ3.html#af1d30022fe1ebe59529f45843dff3ae5',1,'WENO_MZQ3::tol()'],['../structWENO__Z3.html#aec489e3be4dbc31eb46b729b8510fdfc',1,'WENO_Z3::tol()'],['../structWENO7.html#ab892b0bcfa15175a4791c64e222be320',1,'WENO7::tol()'],['../structWENO5.html#a99f8a8620164e0e1460c7bce55ec3b02',1,'WENO5::tol()'],['../structsurface__temp__wave__coupled.html#a3715864e9c6bfdc6e4556925d0fc48fa',1,'surface_temp_wave_coupled::tol()'],['../structsurface__flux__wave__coupled.html#a928bb0b9a4141fc6452c6f83fbec58aa',1,'surface_flux_wave_coupled::tol()'],['../structsurface__flux__donelan.html#a5c30fb789d7f02cb9533948d32011947',1,'surface_flux_donelan::tol()'],['../structsurface__flux__mod__charnock.html#ac01a07a59f56ff6683dd9942b4d500ba',1,'surface_flux_mod_charnock::tol()'],['../structsurface__flux__charnock.html#a08529386a7d5012684c818249a7d76ba',1,'surface_flux_charnock::tol()'],['../structsurface__flux.html#abd16b92a75ae384f9fe490b59f046b6a',1,'surface_flux::tol()'],['../structadiabatic__wave__coupled.html#ad18802ec131991fbaaebfb80a1a12d07',1,'adiabatic_wave_coupled::tol()'],['../structadiabatic__donelan.html#aaba2ad764346c1a35eacc4b89c993bea',1,'adiabatic_donelan::tol()'],['../structadiabatic__charnock.html#abb822b2278b8cd500c6fb0fb0a028709',1,'adiabatic_charnock::tol()'],['../structWENO3.html#aa09b52432a69d89bef16a06015252661',1,'WENO3::tol()'],['../structsurface__temp__donelan.html#ab39f101456f06c4711711f1db2cb2751',1,'surface_temp_donelan::tol()'],['../structsurface__temp__mod__charnock.html#a77dc7e5a012fbe6066fa21f57145c938',1,'surface_temp_mod_charnock::tol()'],['../structsurface__temp__charnock.html#ab1cdc86ca25ac91cb375348372f2ddf1',1,'surface_temp_charnock::tol()'],['../structsurface__temp.html#a7c4031cfb8cbb020115ee7fae12ddb05',1,'surface_temp::tol()']]], - ['top_5flev_5052',['top_lev',['../classAerRadProps.html#a83216edbd2d57b575f1869df38a1b668',1,'AerRadProps::top_lev()'],['../classMam4__aer.html#ae15e0c356e4fed002069ecd5d8bb33af',1,'Mam4_aer::top_lev()']]], - ['tpi_5fboxdim_5053',['tpi_boxDim',['../structTurbulentPerturbation.html#ab90f89bf4bf3d497f88c27d1b92f3d39',1,'TurbulentPerturbation']]], - ['tpi_5fdirection_5054',['tpi_direction',['../structTurbulentPerturbation.html#af2a72d18ce8c0f5bc011d3682ad93e0f',1,'TurbulentPerturbation']]], - ['tpi_5fhpb_5055',['tpi_Hpb',['../structTurbulentPerturbation.html#aef47959ab81660b54f583a7304816ef4',1,'TurbulentPerturbation']]], - ['tpi_5flayers_5056',['tpi_layers',['../structTurbulentPerturbation.html#a17f060634e44ba5701cc1febba23c915',1,'TurbulentPerturbation']]], - ['tpi_5flpb_5057',['tpi_Lpb',['../structTurbulentPerturbation.html#a22bb01b7314fa13bdfc1966456f5deed',1,'TurbulentPerturbation']]], - ['tpi_5flref_5058',['tpi_lref',['../structTurbulentPerturbation.html#ab3db22cfce521750d46e44ed93c49bb8',1,'TurbulentPerturbation']]], - ['tpi_5fnet_5fbuoyant_5059',['tpi_net_buoyant',['../structTurbulentPerturbation.html#adaf88736c8d43a23f8bb3eb8065f0b84',1,'TurbulentPerturbation']]], - ['tpi_5fnondim_5060',['tpi_nonDim',['../structTurbulentPerturbation.html#abe0155dd9b530c537b1f639ab4dc8691',1,'TurbulentPerturbation']]], - ['tpi_5foffset_5061',['tpi_offset',['../structTurbulentPerturbation.html#a7bcb39c84b03deefaa166c89f22c229c',1,'TurbulentPerturbation']]], - ['tpi_5fpert_5fadjust_5062',['tpi_pert_adjust',['../structTurbulentPerturbation.html#aa4e6ee511ae71277885d87f5aa2ddad3',1,'TurbulentPerturbation']]], - ['tpi_5fti_5063',['tpi_Ti',['../structTurbulentPerturbation.html#aa2c2e894fc858d8cdaa9cde0092e896e',1,'TurbulentPerturbation']]], - ['tpi_5ftinf_5064',['tpi_Tinf',['../structTurbulentPerturbation.html#a20940c88c5c2f6ef1b90d1984867777a',1,'TurbulentPerturbation']]], - ['tpi_5fwpb_5065',['tpi_Wpb',['../structTurbulentPerturbation.html#a21d9b84c0b8eac4d49ae5ca764247442',1,'TurbulentPerturbation']]], - ['tprmax_5066',['tprmax',['../ERF__Constants_8H.html#a06a70c05086650ead098e2994ad1bd43',1,'ERF_Constants.H']]], - ['tprmin_5067',['tprmin',['../ERF__Constants_8H.html#a9180d622aa39d89312941eba03fa1347',1,'ERF_Constants.H']]], - ['ttrice_5068',['ttrice',['../ERF__Constants_8H.html#a9b3da60e1e65429fe546d18c9c926105',1,'ERF_Constants.H']]], - ['turb_5fdisk_5fangle_5069',['turb_disk_angle',['../classSimpleAD.html#addf5c9255c895e8d29bc85a02a662844',1,'SimpleAD::turb_disk_angle()'],['../classGeneralAD.html#ad5945bec35f72c63369436bf3edce069',1,'GeneralAD::turb_disk_angle()'],['../structSolverChoice.html#addcff0f25c6925df38673747b4dea91e',1,'SolverChoice::turb_disk_angle()']]], - ['turb_5findex_5070',['turb_index',['../classWindFarm.html#af3061fab41eb0d20c97164376cc370dc',1,'WindFarm']]], - ['turbchoice_5071',['turbChoice',['../structSolverChoice.html#aa53b017d79e0067923180a0aa59367b4',1,'SolverChoice']]], - ['turbpert_5072',['turbPert',['../classERF.html#ac1b9cce4a3c1736c4af78f6b0e2143ce',1,'ERF']]], - ['type_5073',['type',['../structMamConstituents_1_1mode__component__t.html#a96f5cdd50364b1e2760b1cb4e88cd153',1,'MamConstituents::mode_component_t']]], - ['types_5074',['types',['../structMamConstituents_1_1modes__t.html#aea58b375f13ddc20860b2bd2a183899b',1,'MamConstituents::modes_t']]] + ['t_5f0_5001',['T_0',['../structProbParmDefaults.html#a16db7fa78b123f2a956bacbce26f32c6',1,'ProbParmDefaults']]], + ['t_5favg_5fcnt_5002',['t_avg_cnt',['../classERF.html#a6837423e9248e923fcaa1987b59d8160',1,'ERF']]], + ['t_5fnew_5003',['t_new',['../classERF.html#a65741b6379d273c19a25cf48bb947614',1,'ERF']]], + ['t_5fold_5004',['t_old',['../classERF.html#a7085d7d5fc94a0f84efc06957267d58e',1,'ERF']]], + ['t_5fstar_5005',['t_star',['../classABLMost.html#ac9d90016f196c3861d225132e8b6a921',1,'ABLMost']]], + ['t_5fstore_5006',['T_store',['../classMRISplitIntegrator.html#a10fa09211f3b0a6b7357ab79dbadbb80',1,'MRISplitIntegrator']]], + ['t_5fsurf_5007',['t_surf',['../classABLMost.html#a1f488836fca7c3da2bed67c63a94951b',1,'ABLMost']]], + ['tabs1d_5008',['tabs1d',['../classSAM.html#aee5da977a069c0b9cb98d150027f746c',1,'SAM']]], + ['target_5fbox_5009',['target_box',['../classWriteBndryPlanes.html#a4d7d2b3b5b1c823b905ae3042bb62379',1,'WriteBndryPlanes']]], + ['tau11_5flev_5010',['Tau11_lev',['../classERF.html#aeb9348353b2415d023d8f52c293cad7e',1,'ERF']]], + ['tau12_5flev_5011',['Tau12_lev',['../classERF.html#ad8c2eca71737b102cc5cf75f97c6bd63',1,'ERF']]], + ['tau13_5flev_5012',['Tau13_lev',['../classERF.html#a5392e6104804d799b3fd943dfe390766',1,'ERF']]], + ['tau21_5flev_5013',['Tau21_lev',['../classERF.html#a547864dc0347f4620feb99ed564acb4d',1,'ERF']]], + ['tau22_5flev_5014',['Tau22_lev',['../classERF.html#afb4294f848d86e4aefb74848bb71047e',1,'ERF']]], + ['tau23_5flev_5015',['Tau23_lev',['../classERF.html#a03a4ad7368c1c98b492cd9d9fec9cbc5',1,'ERF']]], + ['tau31_5flev_5016',['Tau31_lev',['../classERF.html#a203e7334296218672e36bab93174e146',1,'ERF']]], + ['tau32_5flev_5017',['Tau32_lev',['../classERF.html#aa650bf1f6885b179fd8d4c24b48668cb',1,'ERF']]], + ['tau33_5flev_5018',['Tau33_lev',['../classERF.html#a60a185c47f07bf4fb537a15d5a226d8a',1,'ERF']]], + ['tau_5fnudging_5019',['tau_nudging',['../structInputSoundingData.html#a5c190ab2ffec63277427ed6c92d4f53f',1,'InputSoundingData']]], + ['tbgmax_5020',['tbgmax',['../ERF__Constants_8H.html#a2b4ea8a29735038e49703c7f8c1f20c8',1,'ERF_Constants.H']]], + ['tbgmin_5021',['tbgmin',['../ERF__Constants_8H.html#abf1e890912f1117211516f13b27ed2e8',1,'ERF_Constants.H']]], + ['tboil_5022',['tboil',['../ERF__Constants_8H.html#a123bd9756d4f11bae80bb918f88cbd3f',1,'ERF_Constants.H']]], + ['temp_5023',['temp',['../classAerRadProps.html#a0a03391413de1fcd9ea2550fea907b33',1,'AerRadProps']]], + ['terrain_5fis_5fflat_5024',['terrain_is_flat',['../structSolverChoice.html#ae6a90725e04ca6fe634ec44fb347f5ff',1,'SolverChoice']]], + ['terrain_5ftype_5025',['terrain_type',['../structSolverChoice.html#ab734eb0a5147b93dc6590038b6decc60',1,'SolverChoice']]], + ['test_5fmapfactor_5026',['test_mapfactor',['../structSolverChoice.html#a9c7942f6ef7cf05115f35702097cf107',1,'SolverChoice']]], + ['tgrmax_5027',['tgrmax',['../ERF__Constants_8H.html#ab24d300166813654b7d8adb31bc71938',1,'ERF_Constants.H']]], + ['tgrmin_5028',['tgrmin',['../ERF__Constants_8H.html#afb7d1700c60728d56ef525934fe6a098',1,'ERF_Constants.H']]], + ['therco_5029',['therco',['../ERF__Constants_8H.html#a583248545708b1481d513f2c9621f0ba',1,'ERF_Constants.H']]], + ['theta_5fincr_5fland_5030',['theta_incr_land',['../structMYNNPBLH.html#a16169bdfadcc27219d7c6dde54ef6bd9',1,'MYNNPBLH']]], + ['theta_5fincr_5fwater_5031',['theta_incr_water',['../structMYNNPBLH.html#ad830dc7c3282256b729ad09b8cc0572e',1,'MYNNPBLH']]], + ['theta_5finp_5fsound_5032',['theta_inp_sound',['../structInputSoundingData.html#a7cde9c67da9ade1d385047732b106943',1,'InputSoundingData']]], + ['theta_5finp_5fsound_5fd_5033',['theta_inp_sound_d',['../structInputSoundingData.html#a00054ef7905b250d663dd8c9d69a112e',1,'InputSoundingData']]], + ['theta_5fprim_5034',['Theta_prim',['../classERF.html#a71629ae2fda396472198691b75d83b2e',1,'ERF']]], + ['theta_5fref_5035',['theta_ref',['../structTurbChoice.html#aeb3c184b540858407426a606327fba3a',1,'TurbChoice']]], + ['theta_5fref_5finp_5fsound_5036',['theta_ref_inp_sound',['../structInputSoundingData.html#a15782809644a4daa0e8de9c3cc4c346a',1,'InputSoundingData']]], + ['theta_5ftype_5037',['theta_type',['../classABLMost.html#a7d1394fa01c8c29b20dfb790c0f3ec6b',1,'ABLMost']]], + ['thetamin_5fheight_5038',['thetamin_height',['../structMYNNPBLH.html#aa607f6576c6029c132a0f7b33aec72f1',1,'MYNNPBLH']]], + ['thin_5fxforce_5039',['thin_xforce',['../classERF.html#a5b9b8d719a87a6940f611c6a30e8ccf5',1,'ERF']]], + ['thin_5fyforce_5040',['thin_yforce',['../classERF.html#a18c1142552120bbd22987f34995ee939',1,'ERF']]], + ['thin_5fzforce_5041',['thin_zforce',['../classERF.html#a56a23d298bc66218bf257d0e793e341f',1,'ERF']]], + ['third_5042',['third',['../classModalAeroWateruptake.html#a77bdba258f0d10234a98a54a39a5fb7f',1,'ModalAeroWateruptake']]], + ['thrust_5fcoeff_5043',['thrust_coeff',['../classSimpleAD.html#a0d915eaf360210453a081a2b721d0fa0',1,'SimpleAD::thrust_coeff()'],['../classWindFarm.html#a8d5e6333f2f9f8e36dfd4766ad171b84',1,'WindFarm::thrust_coeff()'],['../classEWP.html#a9cdc57dc5a1a63c4a4e62ba85dffecc4',1,'EWP::thrust_coeff()'],['../classFitch.html#a7cafd25264dba6194d42285153683f34',1,'Fitch::thrust_coeff()'],['../classGeneralAD.html#a45f8887ce8907918ceebf0a804eaffea',1,'GeneralAD::thrust_coeff()']]], + ['thrust_5fcoeff_5fstanding_5044',['thrust_coeff_standing',['../classWindFarm.html#ab8d68a72cf4346074daf47f825eff105',1,'WindFarm::thrust_coeff_standing()'],['../classEWP.html#a22f50393881ced019cae2a74ee04cdea',1,'EWP::thrust_coeff_standing()'],['../classFitch.html#adc5df318361103709d0fa5421358e29d',1,'Fitch::thrust_coeff_standing()'],['../classGeneralAD.html#ad96abbb1f20b4ea0abf49d0fb88b289a',1,'GeneralAD::thrust_coeff_standing()'],['../classSimpleAD.html#a1665d726556fc42558e77fe94e732d43',1,'SimpleAD::thrust_coeff_standing()']]], + ['time_5favg_5fvel_5045',['time_avg_vel',['../structSolverChoice.html#af3119a4089367206db9fc3a17664e874',1,'SolverChoice']]], + ['timestep_5046',['timestep',['../classMRISplitIntegrator.html#a3f21bedf222ce95136d4889012401612',1,'MRISplitIntegrator']]], + ['tint_5047',['tint',['../classRadiation.html#a76bb14b6a6eafd04ffad69f50547be41',1,'Radiation']]], + ['tmax_5048',['tmax',['../classWaterVaporSat.html#a8e168a8ca074d530d7afe596739270b4',1,'WaterVaporSat']]], + ['tmelt_5049',['tmelt',['../ERF__Constants_8H.html#a764526b482e006cd52004d3f53467b57',1,'ERF_Constants.H']]], + ['tmid_5050',['tmid',['../classRadiation.html#ac1ed1e73ee4f8832a699967c8354bd6e',1,'Radiation']]], + ['tmin_5051',['tmin',['../classWaterVaporSat.html#ac7a0c53f3985416b26f43135e25accca',1,'WaterVaporSat']]], + ['tol_5052',['TOL',['../namespaceHSEutils.html#aace33d14958f235a111e6cead400a61e',1,'HSEutils']]], + ['tol_5053',['tol',['../structadiabatic__mod__charnock.html#a8a007e09d416f6879b7ba68c7e4ac29e',1,'adiabatic_mod_charnock::tol()'],['../structWENO__Z7.html#ab5d1630a2cd0f731c932a981f7c43e6f',1,'WENO_Z7::tol()'],['../structWENO__Z5.html#af5daab47aa96e124f3bf0508489e3017',1,'WENO_Z5::tol()'],['../structWENO__MZQ3.html#af1d30022fe1ebe59529f45843dff3ae5',1,'WENO_MZQ3::tol()'],['../structWENO__Z3.html#aec489e3be4dbc31eb46b729b8510fdfc',1,'WENO_Z3::tol()'],['../structWENO7.html#ab892b0bcfa15175a4791c64e222be320',1,'WENO7::tol()'],['../structWENO5.html#a99f8a8620164e0e1460c7bce55ec3b02',1,'WENO5::tol()'],['../structsurface__temp__wave__coupled.html#a3715864e9c6bfdc6e4556925d0fc48fa',1,'surface_temp_wave_coupled::tol()'],['../structsurface__flux__wave__coupled.html#a928bb0b9a4141fc6452c6f83fbec58aa',1,'surface_flux_wave_coupled::tol()'],['../structsurface__flux__donelan.html#a5c30fb789d7f02cb9533948d32011947',1,'surface_flux_donelan::tol()'],['../structsurface__flux__mod__charnock.html#ac01a07a59f56ff6683dd9942b4d500ba',1,'surface_flux_mod_charnock::tol()'],['../structsurface__flux__charnock.html#a08529386a7d5012684c818249a7d76ba',1,'surface_flux_charnock::tol()'],['../structsurface__flux.html#abd16b92a75ae384f9fe490b59f046b6a',1,'surface_flux::tol()'],['../structadiabatic__wave__coupled.html#ad18802ec131991fbaaebfb80a1a12d07',1,'adiabatic_wave_coupled::tol()'],['../structadiabatic__donelan.html#aaba2ad764346c1a35eacc4b89c993bea',1,'adiabatic_donelan::tol()'],['../structadiabatic__charnock.html#abb822b2278b8cd500c6fb0fb0a028709',1,'adiabatic_charnock::tol()'],['../structWENO3.html#aa09b52432a69d89bef16a06015252661',1,'WENO3::tol()'],['../structsurface__temp__donelan.html#ab39f101456f06c4711711f1db2cb2751',1,'surface_temp_donelan::tol()'],['../structsurface__temp__mod__charnock.html#a77dc7e5a012fbe6066fa21f57145c938',1,'surface_temp_mod_charnock::tol()'],['../structsurface__temp__charnock.html#ab1cdc86ca25ac91cb375348372f2ddf1',1,'surface_temp_charnock::tol()'],['../structsurface__temp.html#a7c4031cfb8cbb020115ee7fae12ddb05',1,'surface_temp::tol()']]], + ['top_5flev_5054',['top_lev',['../classAerRadProps.html#a83216edbd2d57b575f1869df38a1b668',1,'AerRadProps::top_lev()'],['../classMam4__aer.html#ae15e0c356e4fed002069ecd5d8bb33af',1,'Mam4_aer::top_lev()']]], + ['tpi_5fboxdim_5055',['tpi_boxDim',['../structTurbulentPerturbation.html#ab90f89bf4bf3d497f88c27d1b92f3d39',1,'TurbulentPerturbation']]], + ['tpi_5fdirection_5056',['tpi_direction',['../structTurbulentPerturbation.html#af2a72d18ce8c0f5bc011d3682ad93e0f',1,'TurbulentPerturbation']]], + ['tpi_5fhpb_5057',['tpi_Hpb',['../structTurbulentPerturbation.html#aef47959ab81660b54f583a7304816ef4',1,'TurbulentPerturbation']]], + ['tpi_5flayers_5058',['tpi_layers',['../structTurbulentPerturbation.html#a17f060634e44ba5701cc1febba23c915',1,'TurbulentPerturbation']]], + ['tpi_5flpb_5059',['tpi_Lpb',['../structTurbulentPerturbation.html#a22bb01b7314fa13bdfc1966456f5deed',1,'TurbulentPerturbation']]], + ['tpi_5flref_5060',['tpi_lref',['../structTurbulentPerturbation.html#ab3db22cfce521750d46e44ed93c49bb8',1,'TurbulentPerturbation']]], + ['tpi_5fnet_5fbuoyant_5061',['tpi_net_buoyant',['../structTurbulentPerturbation.html#adaf88736c8d43a23f8bb3eb8065f0b84',1,'TurbulentPerturbation']]], + ['tpi_5fnondim_5062',['tpi_nonDim',['../structTurbulentPerturbation.html#abe0155dd9b530c537b1f639ab4dc8691',1,'TurbulentPerturbation']]], + ['tpi_5foffset_5063',['tpi_offset',['../structTurbulentPerturbation.html#a7bcb39c84b03deefaa166c89f22c229c',1,'TurbulentPerturbation']]], + ['tpi_5fpert_5fadjust_5064',['tpi_pert_adjust',['../structTurbulentPerturbation.html#aa4e6ee511ae71277885d87f5aa2ddad3',1,'TurbulentPerturbation']]], + ['tpi_5fti_5065',['tpi_Ti',['../structTurbulentPerturbation.html#aa2c2e894fc858d8cdaa9cde0092e896e',1,'TurbulentPerturbation']]], + ['tpi_5ftinf_5066',['tpi_Tinf',['../structTurbulentPerturbation.html#a20940c88c5c2f6ef1b90d1984867777a',1,'TurbulentPerturbation']]], + ['tpi_5fwpb_5067',['tpi_Wpb',['../structTurbulentPerturbation.html#a21d9b84c0b8eac4d49ae5ca764247442',1,'TurbulentPerturbation']]], + ['tprmax_5068',['tprmax',['../ERF__Constants_8H.html#a06a70c05086650ead098e2994ad1bd43',1,'ERF_Constants.H']]], + ['tprmin_5069',['tprmin',['../ERF__Constants_8H.html#a9180d622aa39d89312941eba03fa1347',1,'ERF_Constants.H']]], + ['ttrice_5070',['ttrice',['../ERF__Constants_8H.html#a9b3da60e1e65429fe546d18c9c926105',1,'ERF_Constants.H']]], + ['turb_5fdisk_5fangle_5071',['turb_disk_angle',['../classSimpleAD.html#addf5c9255c895e8d29bc85a02a662844',1,'SimpleAD::turb_disk_angle()'],['../classGeneralAD.html#ad5945bec35f72c63369436bf3edce069',1,'GeneralAD::turb_disk_angle()'],['../structSolverChoice.html#addcff0f25c6925df38673747b4dea91e',1,'SolverChoice::turb_disk_angle()']]], + ['turb_5findex_5072',['turb_index',['../classWindFarm.html#af3061fab41eb0d20c97164376cc370dc',1,'WindFarm']]], + ['turbchoice_5073',['turbChoice',['../structSolverChoice.html#aa53b017d79e0067923180a0aa59367b4',1,'SolverChoice']]], + ['turbpert_5074',['turbPert',['../classERF.html#ac1b9cce4a3c1736c4af78f6b0e2143ce',1,'ERF']]], + ['type_5075',['type',['../structMamConstituents_1_1mode__component__t.html#a96f5cdd50364b1e2760b1cb4e88cd153',1,'MamConstituents::mode_component_t']]], + ['types_5076',['types',['../structMamConstituents_1_1modes__t.html#aea58b375f13ddc20860b2bd2a183899b',1,'MamConstituents::modes_t']]] ]; diff --git a/search/variables_14.js b/search/variables_14.js index 0884a291f..f53874464 100644 --- a/search/variables_14.js +++ b/search/variables_14.js @@ -1,29 +1,29 @@ var searchData= [ - ['u_5finp_5fsound_5075',['U_inp_sound',['../structInputSoundingData.html#acaca35a2682754cb6faa44e1958fba8b',1,'InputSoundingData']]], - ['u_5finp_5fsound_5fd_5076',['U_inp_sound_d',['../structInputSoundingData.html#ab040f8bf9b86d53f6acda8c10844c20f',1,'InputSoundingData']]], - ['u_5finp_5fsponge_5077',['U_inp_sponge',['../structInputSpongeData.html#aece8029ec7a192a21d88a796ada8e917',1,'InputSpongeData']]], - ['u_5fstar_5078',['u_star',['../classABLMost.html#acd5510d2f47502a57107f12c66f8a552',1,'ABLMost']]], - ['uniform_5fangle_5079',['uniform_angle',['../classRadiation.html#aedbf9cc7e81f84db53d0145a3c18727a',1,'Radiation']]], - ['uniquefilenames_5080',['uniquefilenames',['../classPhysProp.html#a4bc8ab2d58a26e16bea177aa9ea70b57',1,'PhysProp']]], - ['use_5fcoriolis_5081',['use_coriolis',['../structSolverChoice.html#a9e86533aa6df5bf6408d91f0dfd23606',1,'SolverChoice']]], - ['use_5fefficient_5fadvection_5082',['use_efficient_advection',['../structAdvChoice.html#a50c43113d4bd0ccaf9f1878134f00bb8',1,'AdvChoice']]], - ['use_5fexplicit_5fmost_5083',['use_explicit_most',['../structSolverChoice.html#a15db794855101421e20ba970dcd634e9',1,'SolverChoice']]], - ['use_5ffft_5084',['use_fft',['../classERF.html#a35e6065478296fac62affbf8f53b8c23',1,'ERF']]], - ['use_5fgravity_5085',['use_gravity',['../structSolverChoice.html#a3ab48411073a3c1f75435292d7b407e5',1,'SolverChoice']]], - ['use_5fke_5086',['use_KE',['../structTurbChoice.html#a1cca3daa3eed11109607efa9983ae8ed',1,'TurbChoice']]], - ['use_5flagged_5fdelta_5frt_5087',['use_lagged_delta_rt',['../structSolverChoice.html#a0e2a9a1ec68a94b24dc8f3f6d8bb7af0',1,'SolverChoice']]], - ['use_5fmoist_5fbackground_5088',['use_moist_background',['../structSolverChoice.html#aab88dd74d39b1ad369ae6324e05d7a35',1,'SolverChoice']]], - ['use_5fmoisture_5089',['use_moisture',['../classABLMost.html#ab55a547b6b74a177128af6c6a107930c',1,'ABLMost']]], - ['use_5fmono_5fadv_5090',['use_mono_adv',['../structSolverChoice.html#a3660145ad90d59b2a6693fd88bb01381',1,'SolverChoice']]], - ['use_5fnumdiff_5091',['use_NumDiff',['../structSolverChoice.html#aa2de671156cccf1f3a34b9f250fb0e28',1,'SolverChoice']]], - ['use_5frad_5fdt_5fcosz_5092',['use_rad_dt_cosz',['../classRadiation.html#a18cd8ea8ce343768fc2f630bcda8629d',1,'Radiation']]], - ['use_5freal_5fbcs_5093',['use_real_bcs',['../classERF.html#a86208285bf705f360a3c318a75097f61',1,'ERF']]], - ['use_5frotate_5fmost_5094',['use_rotate_most',['../structSolverChoice.html#af3dab90d6c6d356aa2f35c3dbe151411',1,'SolverChoice']]], - ['use_5fxhi_5fsponge_5fdamping_5095',['use_xhi_sponge_damping',['../structSpongeChoice.html#a980e2c4485a0769eb0405a77445e3db1',1,'SpongeChoice']]], - ['use_5fxlo_5fsponge_5fdamping_5096',['use_xlo_sponge_damping',['../structSpongeChoice.html#a0d60faef2ee2597c1df7807fc25204e2',1,'SpongeChoice']]], - ['use_5fyhi_5fsponge_5fdamping_5097',['use_yhi_sponge_damping',['../structSpongeChoice.html#ae2907fb8c5755c951b765b7d835013f6',1,'SpongeChoice']]], - ['use_5fylo_5fsponge_5fdamping_5098',['use_ylo_sponge_damping',['../structSpongeChoice.html#a5e3fe59ec39bd6ed95b33bd568dd711b',1,'SpongeChoice']]], - ['use_5fzhi_5fsponge_5fdamping_5099',['use_zhi_sponge_damping',['../structSpongeChoice.html#ac335f4f1640ad959aadb8e9054c3fda2',1,'SpongeChoice']]], - ['use_5fzlo_5fsponge_5fdamping_5100',['use_zlo_sponge_damping',['../structSpongeChoice.html#a2ac1def940f7e6666a1076be69b3cc33',1,'SpongeChoice']]] + ['u_5finp_5fsound_5077',['U_inp_sound',['../structInputSoundingData.html#acaca35a2682754cb6faa44e1958fba8b',1,'InputSoundingData']]], + ['u_5finp_5fsound_5fd_5078',['U_inp_sound_d',['../structInputSoundingData.html#ab040f8bf9b86d53f6acda8c10844c20f',1,'InputSoundingData']]], + ['u_5finp_5fsponge_5079',['U_inp_sponge',['../structInputSpongeData.html#aece8029ec7a192a21d88a796ada8e917',1,'InputSpongeData']]], + ['u_5fstar_5080',['u_star',['../classABLMost.html#acd5510d2f47502a57107f12c66f8a552',1,'ABLMost']]], + ['uniform_5fangle_5081',['uniform_angle',['../classRadiation.html#aedbf9cc7e81f84db53d0145a3c18727a',1,'Radiation']]], + ['uniquefilenames_5082',['uniquefilenames',['../classPhysProp.html#a4bc8ab2d58a26e16bea177aa9ea70b57',1,'PhysProp']]], + ['use_5fcoriolis_5083',['use_coriolis',['../structSolverChoice.html#a9e86533aa6df5bf6408d91f0dfd23606',1,'SolverChoice']]], + ['use_5fefficient_5fadvection_5084',['use_efficient_advection',['../structAdvChoice.html#a50c43113d4bd0ccaf9f1878134f00bb8',1,'AdvChoice']]], + ['use_5fexplicit_5fmost_5085',['use_explicit_most',['../structSolverChoice.html#a15db794855101421e20ba970dcd634e9',1,'SolverChoice']]], + ['use_5ffft_5086',['use_fft',['../classERF.html#a35e6065478296fac62affbf8f53b8c23',1,'ERF']]], + ['use_5fgravity_5087',['use_gravity',['../structSolverChoice.html#a3ab48411073a3c1f75435292d7b407e5',1,'SolverChoice']]], + ['use_5fke_5088',['use_KE',['../structTurbChoice.html#a1cca3daa3eed11109607efa9983ae8ed',1,'TurbChoice']]], + ['use_5flagged_5fdelta_5frt_5089',['use_lagged_delta_rt',['../structSolverChoice.html#a0e2a9a1ec68a94b24dc8f3f6d8bb7af0',1,'SolverChoice']]], + ['use_5fmoist_5fbackground_5090',['use_moist_background',['../structSolverChoice.html#aab88dd74d39b1ad369ae6324e05d7a35',1,'SolverChoice']]], + ['use_5fmoisture_5091',['use_moisture',['../classABLMost.html#ab55a547b6b74a177128af6c6a107930c',1,'ABLMost']]], + ['use_5fmono_5fadv_5092',['use_mono_adv',['../structSolverChoice.html#a3660145ad90d59b2a6693fd88bb01381',1,'SolverChoice']]], + ['use_5fnumdiff_5093',['use_NumDiff',['../structSolverChoice.html#aa2de671156cccf1f3a34b9f250fb0e28',1,'SolverChoice']]], + ['use_5frad_5fdt_5fcosz_5094',['use_rad_dt_cosz',['../classRadiation.html#a18cd8ea8ce343768fc2f630bcda8629d',1,'Radiation']]], + ['use_5freal_5fbcs_5095',['use_real_bcs',['../classERF.html#a86208285bf705f360a3c318a75097f61',1,'ERF']]], + ['use_5frotate_5fmost_5096',['use_rotate_most',['../structSolverChoice.html#af3dab90d6c6d356aa2f35c3dbe151411',1,'SolverChoice']]], + ['use_5fxhi_5fsponge_5fdamping_5097',['use_xhi_sponge_damping',['../structSpongeChoice.html#a980e2c4485a0769eb0405a77445e3db1',1,'SpongeChoice']]], + ['use_5fxlo_5fsponge_5fdamping_5098',['use_xlo_sponge_damping',['../structSpongeChoice.html#a0d60faef2ee2597c1df7807fc25204e2',1,'SpongeChoice']]], + ['use_5fyhi_5fsponge_5fdamping_5099',['use_yhi_sponge_damping',['../structSpongeChoice.html#ae2907fb8c5755c951b765b7d835013f6',1,'SpongeChoice']]], + ['use_5fylo_5fsponge_5fdamping_5100',['use_ylo_sponge_damping',['../structSpongeChoice.html#a5e3fe59ec39bd6ed95b33bd568dd711b',1,'SpongeChoice']]], + ['use_5fzhi_5fsponge_5fdamping_5101',['use_zhi_sponge_damping',['../structSpongeChoice.html#ac335f4f1640ad959aadb8e9054c3fda2',1,'SpongeChoice']]], + ['use_5fzlo_5fsponge_5fdamping_5102',['use_zlo_sponge_damping',['../structSpongeChoice.html#a2ac1def940f7e6666a1076be69b3cc33',1,'SpongeChoice']]] ]; diff --git a/search/variables_15.js b/search/variables_15.js index 183029f13..e69991f4b 100644 --- a/search/variables_15.js +++ b/search/variables_15.js @@ -1,15 +1,15 @@ var searchData= [ - ['v_5finp_5fsound_5101',['V_inp_sound',['../structInputSoundingData.html#adba2e69559670861133145572ed6aa2a',1,'InputSoundingData']]], - ['v_5finp_5fsound_5fd_5102',['V_inp_sound_d',['../structInputSoundingData.html#a36f5c3dc9c536d7a6da2f87d67ea6a08',1,'InputSoundingData']]], - ['v_5finp_5fsponge_5103',['V_inp_sponge',['../structInputSpongeData.html#a8cc25a2bbb25e676dadc57cf3e8f6db1',1,'InputSpongeData']]], - ['varid_5104',['varid',['../structncutils_1_1NCVar.html#a2dce982c1ddb8f3b89b071bc3bf15532',1,'ncutils::NCVar']]], - ['varname_5105',['varname',['../classNullSurf.html#ae096eaa2ce9385fabf5692c6a7ac6c26',1,'NullSurf']]], - ['vars_5fnew_5106',['vars_new',['../classERF.html#a1204ca4dc5d79f5da191ffbe09dfab9b',1,'ERF']]], - ['vars_5fold_5107',['vars_old',['../classERF.html#af31e928baa970a1507dfb0233b352542',1,'ERF']]], - ['vel_5ft_5favg_5108',['vel_t_avg',['../classERF.html#a3e146164ca6929ec6d4984b6a3f43c81',1,'ERF']]], - ['velocity_5109',['velocity',['../classWindFarm.html#a57a72ded446162e2e365dc0ff7c6e06a',1,'WindFarm::velocity()'],['../classGeneralAD.html#a5d98b31e348b25201d92055c16b6b6da',1,'GeneralAD::velocity()']]], - ['verbose_5110',['verbose',['../classERF.html#a43d0b17f6e155691a1e9474526df3af5',1,'ERF']]], - ['visc_5111',['visc',['../structmost__data.html#add81c9cef613709d079f42a22c7d15ac',1,'most_data']]], - ['void_5fbc_5112',['void_bc',['../ERF__InteriorGhostCells_8cpp.html#ab53ca744a656082f128b68f819aacbf5',1,'ERF_InteriorGhostCells.cpp']]] + ['v_5finp_5fsound_5103',['V_inp_sound',['../structInputSoundingData.html#adba2e69559670861133145572ed6aa2a',1,'InputSoundingData']]], + ['v_5finp_5fsound_5fd_5104',['V_inp_sound_d',['../structInputSoundingData.html#a36f5c3dc9c536d7a6da2f87d67ea6a08',1,'InputSoundingData']]], + ['v_5finp_5fsponge_5105',['V_inp_sponge',['../structInputSpongeData.html#a8cc25a2bbb25e676dadc57cf3e8f6db1',1,'InputSpongeData']]], + ['varid_5106',['varid',['../structncutils_1_1NCVar.html#a2dce982c1ddb8f3b89b071bc3bf15532',1,'ncutils::NCVar']]], + ['varname_5107',['varname',['../classNullSurf.html#ae096eaa2ce9385fabf5692c6a7ac6c26',1,'NullSurf']]], + ['vars_5fnew_5108',['vars_new',['../classERF.html#a1204ca4dc5d79f5da191ffbe09dfab9b',1,'ERF']]], + ['vars_5fold_5109',['vars_old',['../classERF.html#af31e928baa970a1507dfb0233b352542',1,'ERF']]], + ['vel_5ft_5favg_5110',['vel_t_avg',['../classERF.html#a3e146164ca6929ec6d4984b6a3f43c81',1,'ERF']]], + ['velocity_5111',['velocity',['../classWindFarm.html#a57a72ded446162e2e365dc0ff7c6e06a',1,'WindFarm::velocity()'],['../classGeneralAD.html#a5d98b31e348b25201d92055c16b6b6da',1,'GeneralAD::velocity()']]], + ['verbose_5112',['verbose',['../classERF.html#a43d0b17f6e155691a1e9474526df3af5',1,'ERF']]], + ['visc_5113',['visc',['../structmost__data.html#add81c9cef613709d079f42a22c7d15ac',1,'most_data']]], + ['void_5fbc_5114',['void_bc',['../ERF__InteriorGhostCells_8cpp.html#ab53ca744a656082f128b68f819aacbf5',1,'ERF_InteriorGhostCells.cpp']]] ]; diff --git a/search/variables_16.js b/search/variables_16.js index 21e8c0a55..bc53f92c4 100644 --- a/search/variables_16.js +++ b/search/variables_16.js @@ -1,23 +1,23 @@ var searchData= [ - ['w_5fstar_5113',['w_star',['../classABLMost.html#a11a418842597c03a5782fc53ec0a1fb1',1,'ABLMost']]], - ['water_5frefindex_5ffile_5114',['water_refindex_file',['../classMam4__aer.html#a57f3e715abe0988dd7179e11ce4bdcff',1,'Mam4_aer']]], - ['wavenum_5fhigh_5115',['wavenum_high',['../classRadConstants.html#a06d010a733e82bb2e8a6651c6e92cf51',1,'RadConstants']]], - ['wavenum_5flow_5116',['wavenum_low',['../classRadConstants.html#ab658087eff73ea76e37a41701497b79d',1,'RadConstants']]], - ['wavenumber1_5flongwave_5117',['wavenumber1_longwave',['../classRadConstants.html#add60bb42895c11810559d8bb753c1e63',1,'RadConstants']]], - ['wavenumber2_5flongwave_5118',['wavenumber2_longwave',['../classRadConstants.html#a86731ed9c7d8c8f4b269f79606c89ba1',1,'RadConstants']]], - ['wetdens_5fm_5119',['wetdens_m',['../classMam4__aer.html#aba67cb233002e4fd50c766e73ec3d022',1,'Mam4_aer']]], - ['wgtn_5120',['wgtn',['../structLinInterp_1_1InterpType.html#aa3befaac92860602bab896110eeb65da',1,'LinInterp::InterpType']]], - ['wgts_5121',['wgts',['../structLinInterp_1_1InterpType.html#a445ddb0a782f40cab78521e5fdc3bd8b',1,'LinInterp::InterpType']]], - ['wind_5fspeed_5122',['wind_speed',['../classFitch.html#aed06c922f243b8a80c17d17770430af5',1,'Fitch::wind_speed()'],['../classSimpleAD.html#a171f86e19e21f7c5632ca2c459d489f5',1,'SimpleAD::wind_speed()'],['../classGeneralAD.html#a0c19baa06277206decbdc1da57c02ea5',1,'GeneralAD::wind_speed()'],['../classEWP.html#a30275b7045b523cfe7afb5683f66d87a',1,'EWP::wind_speed()'],['../classWindFarm.html#a5d1dbc2f5df3a2ee2b239f04b82a2c6b',1,'WindFarm::wind_speed()']]], - ['windfarm_5fairfoil_5ftables_5123',['windfarm_airfoil_tables',['../structSolverChoice.html#af9c11d4a044eea88bad0b2e32318b412',1,'SolverChoice']]], - ['windfarm_5fblade_5ftable_5124',['windfarm_blade_table',['../structSolverChoice.html#aa401d2a5d51cb382e0b6e18502d961a9',1,'SolverChoice']]], - ['windfarm_5floc_5ftable_5125',['windfarm_loc_table',['../structSolverChoice.html#a44bc0227f088664e4e2c1090ebb1381d',1,'SolverChoice']]], - ['windfarm_5floc_5ftype_5126',['windfarm_loc_type',['../structSolverChoice.html#a54214b71edb43f251f04b79281c39375',1,'SolverChoice']]], - ['windfarm_5fspec_5ftable_5127',['windfarm_spec_table',['../structSolverChoice.html#a34c427126677860aa8acad633e6fb2be',1,'SolverChoice']]], - ['windfarm_5fspec_5ftable_5fextra_5128',['windfarm_spec_table_extra',['../structSolverChoice.html#a40de8b74e8c60f617558ef8a2fa72ddb',1,'SolverChoice']]], - ['windfarm_5ftype_5129',['windfarm_type',['../structSolverChoice.html#ac0a723e8797cdc0fe06b3fc781fca645',1,'SolverChoice']]], - ['windfarm_5fx_5fshift_5130',['windfarm_x_shift',['../structSolverChoice.html#a1b2950247c4d2789597b7610c69ff5b6',1,'SolverChoice']]], - ['windfarm_5fy_5fshift_5131',['windfarm_y_shift',['../structSolverChoice.html#adec260ba3c7bd01ffa4fd40bd90920cd',1,'SolverChoice']]], - ['wsmin_5132',['WSMIN',['../structmoeng__flux.html#a8fc4fe08604d2d3b15373d19075481f3',1,'moeng_flux::WSMIN()'],['../structsurface__temp__wave__coupled.html#af09bca4efd34fd9d8b6bb6a2f363ebee',1,'surface_temp_wave_coupled::WSMIN()'],['../structsurface__temp__donelan.html#ac568df907108f755ab450ffbcac18041',1,'surface_temp_donelan::WSMIN()'],['../structsurface__temp__mod__charnock.html#a85bd49a9221c24cd27422abc18190628',1,'surface_temp_mod_charnock::WSMIN()'],['../structsurface__temp__charnock.html#aa4c95644bfaf0b6071ae0d7072a9345f',1,'surface_temp_charnock::WSMIN()'],['../structsurface__temp.html#aeb169255fca0a94d9fb3a74c62606eed',1,'surface_temp::WSMIN()'],['../structsurface__flux__wave__coupled.html#a10d71fe6dd2f38c54562aa3ab207ef25',1,'surface_flux_wave_coupled::WSMIN()'],['../structsurface__flux__donelan.html#aa0c92783f88aeb52db12fd0b1b40bca7',1,'surface_flux_donelan::WSMIN()'],['../structsurface__flux__mod__charnock.html#a47b9c65ba7662c9f860179104b67b9d8',1,'surface_flux_mod_charnock::WSMIN()'],['../structsurface__flux__charnock.html#aadc72e53ca70ae1475fd787a0b71e717',1,'surface_flux_charnock::WSMIN()'],['../structsurface__flux.html#a6f66a7f868790814d4c30aee5c2502e5',1,'surface_flux::WSMIN()'],['../structadiabatic__wave__coupled.html#aa4eb74455480668121e37e678f596d07',1,'adiabatic_wave_coupled::WSMIN()'],['../structadiabatic__donelan.html#a22f8894821e62c7be32e764b2855a6ea',1,'adiabatic_donelan::WSMIN()'],['../structadiabatic__mod__charnock.html#a8e4da74a6cba0d34e62f4d40255b48dc',1,'adiabatic_mod_charnock::WSMIN()'],['../structadiabatic__charnock.html#a0e78cee7d7f845969fe2da8b72ef7955',1,'adiabatic_charnock::WSMIN()']]] + ['w_5fstar_5115',['w_star',['../classABLMost.html#a11a418842597c03a5782fc53ec0a1fb1',1,'ABLMost']]], + ['water_5frefindex_5ffile_5116',['water_refindex_file',['../classMam4__aer.html#a57f3e715abe0988dd7179e11ce4bdcff',1,'Mam4_aer']]], + ['wavenum_5fhigh_5117',['wavenum_high',['../classRadConstants.html#a06d010a733e82bb2e8a6651c6e92cf51',1,'RadConstants']]], + ['wavenum_5flow_5118',['wavenum_low',['../classRadConstants.html#ab658087eff73ea76e37a41701497b79d',1,'RadConstants']]], + ['wavenumber1_5flongwave_5119',['wavenumber1_longwave',['../classRadConstants.html#add60bb42895c11810559d8bb753c1e63',1,'RadConstants']]], + ['wavenumber2_5flongwave_5120',['wavenumber2_longwave',['../classRadConstants.html#a86731ed9c7d8c8f4b269f79606c89ba1',1,'RadConstants']]], + ['wetdens_5fm_5121',['wetdens_m',['../classMam4__aer.html#aba67cb233002e4fd50c766e73ec3d022',1,'Mam4_aer']]], + ['wgtn_5122',['wgtn',['../structLinInterp_1_1InterpType.html#aa3befaac92860602bab896110eeb65da',1,'LinInterp::InterpType']]], + ['wgts_5123',['wgts',['../structLinInterp_1_1InterpType.html#a445ddb0a782f40cab78521e5fdc3bd8b',1,'LinInterp::InterpType']]], + ['wind_5fspeed_5124',['wind_speed',['../classFitch.html#aed06c922f243b8a80c17d17770430af5',1,'Fitch::wind_speed()'],['../classSimpleAD.html#a171f86e19e21f7c5632ca2c459d489f5',1,'SimpleAD::wind_speed()'],['../classGeneralAD.html#a0c19baa06277206decbdc1da57c02ea5',1,'GeneralAD::wind_speed()'],['../classEWP.html#a30275b7045b523cfe7afb5683f66d87a',1,'EWP::wind_speed()'],['../classWindFarm.html#a5d1dbc2f5df3a2ee2b239f04b82a2c6b',1,'WindFarm::wind_speed()']]], + ['windfarm_5fairfoil_5ftables_5125',['windfarm_airfoil_tables',['../structSolverChoice.html#af9c11d4a044eea88bad0b2e32318b412',1,'SolverChoice']]], + ['windfarm_5fblade_5ftable_5126',['windfarm_blade_table',['../structSolverChoice.html#aa401d2a5d51cb382e0b6e18502d961a9',1,'SolverChoice']]], + ['windfarm_5floc_5ftable_5127',['windfarm_loc_table',['../structSolverChoice.html#a44bc0227f088664e4e2c1090ebb1381d',1,'SolverChoice']]], + ['windfarm_5floc_5ftype_5128',['windfarm_loc_type',['../structSolverChoice.html#a54214b71edb43f251f04b79281c39375',1,'SolverChoice']]], + ['windfarm_5fspec_5ftable_5129',['windfarm_spec_table',['../structSolverChoice.html#a34c427126677860aa8acad633e6fb2be',1,'SolverChoice']]], + ['windfarm_5fspec_5ftable_5fextra_5130',['windfarm_spec_table_extra',['../structSolverChoice.html#a40de8b74e8c60f617558ef8a2fa72ddb',1,'SolverChoice']]], + ['windfarm_5ftype_5131',['windfarm_type',['../structSolverChoice.html#ac0a723e8797cdc0fe06b3fc781fca645',1,'SolverChoice']]], + ['windfarm_5fx_5fshift_5132',['windfarm_x_shift',['../structSolverChoice.html#a1b2950247c4d2789597b7610c69ff5b6',1,'SolverChoice']]], + ['windfarm_5fy_5fshift_5133',['windfarm_y_shift',['../structSolverChoice.html#adec260ba3c7bd01ffa4fd40bd90920cd',1,'SolverChoice']]], + ['wsmin_5134',['WSMIN',['../structmoeng__flux.html#a8fc4fe08604d2d3b15373d19075481f3',1,'moeng_flux::WSMIN()'],['../structsurface__temp__wave__coupled.html#af09bca4efd34fd9d8b6bb6a2f363ebee',1,'surface_temp_wave_coupled::WSMIN()'],['../structsurface__temp__donelan.html#ac568df907108f755ab450ffbcac18041',1,'surface_temp_donelan::WSMIN()'],['../structsurface__temp__mod__charnock.html#a85bd49a9221c24cd27422abc18190628',1,'surface_temp_mod_charnock::WSMIN()'],['../structsurface__temp__charnock.html#aa4c95644bfaf0b6071ae0d7072a9345f',1,'surface_temp_charnock::WSMIN()'],['../structsurface__temp.html#aeb169255fca0a94d9fb3a74c62606eed',1,'surface_temp::WSMIN()'],['../structsurface__flux__wave__coupled.html#a10d71fe6dd2f38c54562aa3ab207ef25',1,'surface_flux_wave_coupled::WSMIN()'],['../structsurface__flux__donelan.html#aa0c92783f88aeb52db12fd0b1b40bca7',1,'surface_flux_donelan::WSMIN()'],['../structsurface__flux__mod__charnock.html#a47b9c65ba7662c9f860179104b67b9d8',1,'surface_flux_mod_charnock::WSMIN()'],['../structsurface__flux__charnock.html#aadc72e53ca70ae1475fd787a0b71e717',1,'surface_flux_charnock::WSMIN()'],['../structsurface__flux.html#a6f66a7f868790814d4c30aee5c2502e5',1,'surface_flux::WSMIN()'],['../structadiabatic__wave__coupled.html#aa4eb74455480668121e37e678f596d07',1,'adiabatic_wave_coupled::WSMIN()'],['../structadiabatic__donelan.html#a22f8894821e62c7be32e764b2855a6ea',1,'adiabatic_donelan::WSMIN()'],['../structadiabatic__mod__charnock.html#a8e4da74a6cba0d34e62f4d40255b48dc',1,'adiabatic_mod_charnock::WSMIN()'],['../structadiabatic__charnock.html#a0e78cee7d7f845969fe2da8b72ef7955',1,'adiabatic_charnock::WSMIN()']]] ]; diff --git a/search/variables_17.js b/search/variables_17.js index 6f3691604..a5c2e5743 100644 --- a/search/variables_17.js +++ b/search/variables_17.js @@ -1,10 +1,10 @@ var searchData= [ - ['xflux_5fimask_5133',['xflux_imask',['../classERF.html#af044f075df34caa2a530aa13e1801a5b',1,'ERF']]], - ['xhi_5fsponge_5fstart_5134',['xhi_sponge_start',['../structSpongeChoice.html#aec7c88a5686affc9c0ff6f9bb53fbd9f',1,'SpongeChoice']]], - ['xlo_5fsponge_5fend_5135',['xlo_sponge_end',['../structSpongeChoice.html#a18f392fd75ac69b62674b70ee67b9c61',1,'SpongeChoice']]], - ['xloc_5136',['xloc',['../classWindFarm.html#ac1bd117bca25527ede4ea107ad22b07c',1,'WindFarm::xloc()'],['../classEWP.html#a71d81573a989603580abd5dc33d85619',1,'EWP::xloc()'],['../classFitch.html#a6ee3e00c1e1678e194aa6e6e27e8b7b5',1,'Fitch::xloc()'],['../classGeneralAD.html#a370786ec406f37da4fb54cc21745c1f3',1,'GeneralAD::xloc()'],['../classSimpleAD.html#a6ea1373509429d435aa5fd40807586b7',1,'SimpleAD::xloc()']]], - ['xrmax_5137',['xrmax',['../classMam4__aer.html#afe9a0c7a84cd95438887533485fcc382',1,'Mam4_aer']]], - ['xrmin_5138',['xrmin',['../classMam4__aer.html#aa8d09180d0858fe4465698618a2a7391',1,'Mam4_aer']]], - ['xvel_5fbc_5fdata_5139',['xvel_bc_data',['../classERF.html#a902f60d94be5eaf86361d1d5ad942105',1,'ERF']]] + ['xflux_5fimask_5135',['xflux_imask',['../classERF.html#af044f075df34caa2a530aa13e1801a5b',1,'ERF']]], + ['xhi_5fsponge_5fstart_5136',['xhi_sponge_start',['../structSpongeChoice.html#aec7c88a5686affc9c0ff6f9bb53fbd9f',1,'SpongeChoice']]], + ['xlo_5fsponge_5fend_5137',['xlo_sponge_end',['../structSpongeChoice.html#a18f392fd75ac69b62674b70ee67b9c61',1,'SpongeChoice']]], + ['xloc_5138',['xloc',['../classWindFarm.html#ac1bd117bca25527ede4ea107ad22b07c',1,'WindFarm::xloc()'],['../classEWP.html#a71d81573a989603580abd5dc33d85619',1,'EWP::xloc()'],['../classFitch.html#a6ee3e00c1e1678e194aa6e6e27e8b7b5',1,'Fitch::xloc()'],['../classGeneralAD.html#a370786ec406f37da4fb54cc21745c1f3',1,'GeneralAD::xloc()'],['../classSimpleAD.html#a6ea1373509429d435aa5fd40807586b7',1,'SimpleAD::xloc()']]], + ['xrmax_5139',['xrmax',['../classMam4__aer.html#afe9a0c7a84cd95438887533485fcc382',1,'Mam4_aer']]], + ['xrmin_5140',['xrmin',['../classMam4__aer.html#aa8d09180d0858fe4465698618a2a7391',1,'Mam4_aer']]], + ['xvel_5fbc_5fdata_5141',['xvel_bc_data',['../classERF.html#a902f60d94be5eaf86361d1d5ad942105',1,'ERF']]] ]; diff --git a/search/variables_18.js b/search/variables_18.js index 7f5998b55..73f1b021f 100644 --- a/search/variables_18.js +++ b/search/variables_18.js @@ -1,8 +1,8 @@ var searchData= [ - ['yflux_5fimask_5140',['yflux_imask',['../classERF.html#aa4448d06a3e4fe9740927a636030939d',1,'ERF']]], - ['yhi_5fsponge_5fstart_5141',['yhi_sponge_start',['../structSpongeChoice.html#adacf43edb29544376743fa98ce7d8cb6',1,'SpongeChoice']]], - ['ylo_5fsponge_5fend_5142',['ylo_sponge_end',['../structSpongeChoice.html#afc444169c9f347bb2e3dd4eb99bc4158',1,'SpongeChoice']]], - ['yloc_5143',['yloc',['../classWindFarm.html#a18280646bd55077f0a59ea45506a630b',1,'WindFarm::yloc()'],['../classEWP.html#ad5aa60df138d71a40225791390e169e7',1,'EWP::yloc()'],['../classFitch.html#a2626dfdc3df0f209b2bcf6a265575228',1,'Fitch::yloc()'],['../classGeneralAD.html#ad75081940389e9013c4ca501713883e1',1,'GeneralAD::yloc()'],['../classSimpleAD.html#a83857d42fc25895b88b10b52af871b3d',1,'SimpleAD::yloc()']]], - ['yvel_5fbc_5fdata_5144',['yvel_bc_data',['../classERF.html#ae5e40fcd6dd76c80d0b5b09be5baef97',1,'ERF']]] + ['yflux_5fimask_5142',['yflux_imask',['../classERF.html#aa4448d06a3e4fe9740927a636030939d',1,'ERF']]], + ['yhi_5fsponge_5fstart_5143',['yhi_sponge_start',['../structSpongeChoice.html#adacf43edb29544376743fa98ce7d8cb6',1,'SpongeChoice']]], + ['ylo_5fsponge_5fend_5144',['ylo_sponge_end',['../structSpongeChoice.html#afc444169c9f347bb2e3dd4eb99bc4158',1,'SpongeChoice']]], + ['yloc_5145',['yloc',['../classWindFarm.html#a18280646bd55077f0a59ea45506a630b',1,'WindFarm::yloc()'],['../classEWP.html#ad5aa60df138d71a40225791390e169e7',1,'EWP::yloc()'],['../classFitch.html#a2626dfdc3df0f209b2bcf6a265575228',1,'Fitch::yloc()'],['../classGeneralAD.html#ad75081940389e9013c4ca501713883e1',1,'GeneralAD::yloc()'],['../classSimpleAD.html#a83857d42fc25895b88b10b52af871b3d',1,'SimpleAD::yloc()']]], + ['yvel_5fbc_5fdata_5146',['yvel_bc_data',['../classERF.html#ae5e40fcd6dd76c80d0b5b09be5baef97',1,'ERF']]] ]; diff --git a/search/variables_19.js b/search/variables_19.js index 832e6134e..9e81f979c 100644 --- a/search/variables_19.js +++ b/search/variables_19.js @@ -1,31 +1,31 @@ var searchData= [ - ['z0_5fconst_5145',['z0_const',['../structmost__data.html#ad18b8055b6887e821efe0c37c4076d08',1,'most_data::z0_const()'],['../classABLMost.html#acfc9a08ed0d029602e2e8e99232d0149',1,'ABLMost::z0_const()']]], - ['z0_5feps_5146',['z0_eps',['../structadiabatic__wave__coupled.html#a7cbf5ad24a59a72131bae5b57038ff72',1,'adiabatic_wave_coupled::z0_eps()'],['../structsurface__flux__wave__coupled.html#a6cf8c26b09960af5adea37c6e7ccbb0b',1,'surface_flux_wave_coupled::z0_eps()'],['../structsurface__temp__wave__coupled.html#abd39570dca269dda79fbb946df0a02ca',1,'surface_temp_wave_coupled::z0_eps()']]], - ['z0_5fmax_5147',['z0_max',['../structadiabatic__wave__coupled.html#afb0e6712baaff337c761988f6ec42b9b',1,'adiabatic_wave_coupled::z0_max()'],['../structsurface__flux__wave__coupled.html#a4f273873e2304563f10674c497cfad30',1,'surface_flux_wave_coupled::z0_max()'],['../structsurface__temp__wave__coupled.html#aedbd53ee9bf7b4c98f5a2b88207cbb01',1,'surface_temp_wave_coupled::z0_max()']]], - ['z_5f0_5148',['z_0',['../classABLMost.html#a1301dd4cb6875c7bdf5d69126b972f91',1,'ABLMost']]], - ['z_5finp_5fsound_5149',['z_inp_sound',['../structInputSoundingData.html#a9f73eb54af79291b72454e2840455b71',1,'InputSoundingData']]], - ['z_5finp_5fsound_5fd_5150',['z_inp_sound_d',['../structInputSoundingData.html#a6e892d7cdfa14b8a8a2aad412567a890',1,'InputSoundingData']]], - ['z_5finp_5fsponge_5151',['z_inp_sponge',['../structInputSpongeData.html#ae430ab35b7ded846911bd26b0d984155',1,'InputSpongeData']]], - ['z_5fphys_5fcc_5152',['z_phys_cc',['../classERF.html#a31be0f1ae705c52c8ccc520369013284',1,'ERF']]], - ['z_5fphys_5fnd_5153',['z_phys_nd',['../classERF.html#a93e63e5af35efa564fd4195e8703f84c',1,'ERF']]], - ['z_5fphys_5fnd_5fnew_5154',['z_phys_nd_new',['../classERF.html#a4ef635c22e72c715f5703a6b95a7abe5',1,'ERF']]], - ['z_5fphys_5fnd_5fsrc_5155',['z_phys_nd_src',['../classERF.html#a30dcf40e8f104fb6b6132805d2eff47c',1,'ERF']]], - ['z_5ft_5frk_5156',['z_t_rk',['../classERF.html#a72a59614c6d5ab840b924c84d5682270',1,'ERF']]], - ['zero_5fxflux_5157',['zero_xflux',['../structAdvChoice.html#a7a086b9e2aabb65d2e5e9053e7bd6018',1,'AdvChoice']]], - ['zero_5fyflux_5158',['zero_yflux',['../structAdvChoice.html#a118575fe302e72fcd231e77be6d117a9',1,'AdvChoice']]], - ['zero_5fzflux_5159',['zero_zflux',['../structAdvChoice.html#a7da4e5242e05aeba4822b71fab596954',1,'AdvChoice']]], - ['zflux_5fimask_5160',['zflux_imask',['../classERF.html#ada098767690d194f89717b0deb3adeac',1,'ERF']]], - ['zhi_5161',['zhi',['../classKessler.html#a8f1c8af54c49e78271d077456c3aa454',1,'Kessler::zhi()'],['../classRadiation.html#ac182d77504c899dee3ff639c2a8e93c6',1,'Radiation::zhi()'],['../classSAM.html#aaf2fc082e80f1c5cc9de339ff25ca27b',1,'SAM::zhi()']]], - ['zhi_5fsponge_5fstart_5162',['zhi_sponge_start',['../structSpongeChoice.html#a5e70ccbf1d7de42a4d938416635eee36',1,'SpongeChoice']]], - ['zi_5163',['zi',['../classAerRadProps.html#ac82b4bf91bb3a23e33074e00381388e3',1,'AerRadProps::zi()'],['../classRadiation.html#a7fd0d1f49797bc9d2c248cd334b44e36',1,'Radiation::zi()']]], - ['zlevels_5fstag_5164',['zlevels_stag',['../classERF.html#ace4f0c79f84075dd7a43bd2b0ede1a9b',1,'ERF']]], - ['zlo_5165',['zlo',['../classKessler.html#a02b5caebac4d5986947655feca7f0db5',1,'Kessler::zlo()'],['../classRadiation.html#add5e5480ecd2c337c1e52e47d62ebaa0',1,'Radiation::zlo()'],['../classSAM.html#a0473906305a6eaea0bad212893b9c911',1,'SAM::zlo()'],['../structrotate__flux.html#a17aa8cfa0cb8ee81926a938b8b826032',1,'rotate_flux::zlo()'],['../structcustom__flux.html#a3b40812bce1c4be2d850abe1bbc2d208',1,'custom_flux::zlo()'],['../structdonelan__flux.html#af7428f0272064ef770035521c9c9a98b',1,'donelan_flux::zlo()'],['../structmoeng__flux.html#a32dd97697698052a006613da3a0b7e67',1,'moeng_flux::zlo()']]], - ['zlo_5fsponge_5fend_5166',['zlo_sponge_end',['../structSpongeChoice.html#a1a79f8e32354ec98857597ddabfe884e',1,'SpongeChoice']]], - ['zloc_5167',['zloc',['../classWindFarm.html#a70d65d49e7ee4191c7f009416ab6ba27',1,'WindFarm']]], - ['zmid_5168',['zmid',['../classSAM.html#a5a5228929f2e9032152efe0a5cb9476b',1,'SAM']]], - ['zmom_5fcrse_5frhs_5169',['zmom_crse_rhs',['../classERF.html#aaf7e8e28172eebdfe2224e4ee823310d',1,'ERF']]], - ['zref_5170',['zref',['../structmost__data.html#a1acd5276639042ca0834c56656302ea6',1,'most_data']]], - ['zsurf_5171',['zsurf',['../structSolverChoice.html#aa4659e9babdc5d7327266f967d9a80ff',1,'SolverChoice']]], - ['zvel_5fbc_5fdata_5172',['zvel_bc_data',['../classERF.html#ae08c25dcf643c6ef39f27d7dd0cb7423',1,'ERF']]] + ['z0_5fconst_5147',['z0_const',['../structmost__data.html#ad18b8055b6887e821efe0c37c4076d08',1,'most_data::z0_const()'],['../classABLMost.html#acfc9a08ed0d029602e2e8e99232d0149',1,'ABLMost::z0_const()']]], + ['z0_5feps_5148',['z0_eps',['../structadiabatic__wave__coupled.html#a7cbf5ad24a59a72131bae5b57038ff72',1,'adiabatic_wave_coupled::z0_eps()'],['../structsurface__flux__wave__coupled.html#a6cf8c26b09960af5adea37c6e7ccbb0b',1,'surface_flux_wave_coupled::z0_eps()'],['../structsurface__temp__wave__coupled.html#abd39570dca269dda79fbb946df0a02ca',1,'surface_temp_wave_coupled::z0_eps()']]], + ['z0_5fmax_5149',['z0_max',['../structadiabatic__wave__coupled.html#afb0e6712baaff337c761988f6ec42b9b',1,'adiabatic_wave_coupled::z0_max()'],['../structsurface__flux__wave__coupled.html#a4f273873e2304563f10674c497cfad30',1,'surface_flux_wave_coupled::z0_max()'],['../structsurface__temp__wave__coupled.html#aedbd53ee9bf7b4c98f5a2b88207cbb01',1,'surface_temp_wave_coupled::z0_max()']]], + ['z_5f0_5150',['z_0',['../classABLMost.html#a1301dd4cb6875c7bdf5d69126b972f91',1,'ABLMost']]], + ['z_5finp_5fsound_5151',['z_inp_sound',['../structInputSoundingData.html#a9f73eb54af79291b72454e2840455b71',1,'InputSoundingData']]], + ['z_5finp_5fsound_5fd_5152',['z_inp_sound_d',['../structInputSoundingData.html#a6e892d7cdfa14b8a8a2aad412567a890',1,'InputSoundingData']]], + ['z_5finp_5fsponge_5153',['z_inp_sponge',['../structInputSpongeData.html#ae430ab35b7ded846911bd26b0d984155',1,'InputSpongeData']]], + ['z_5fphys_5fcc_5154',['z_phys_cc',['../classERF.html#a31be0f1ae705c52c8ccc520369013284',1,'ERF']]], + ['z_5fphys_5fnd_5155',['z_phys_nd',['../classERF.html#a93e63e5af35efa564fd4195e8703f84c',1,'ERF']]], + ['z_5fphys_5fnd_5fnew_5156',['z_phys_nd_new',['../classERF.html#a4ef635c22e72c715f5703a6b95a7abe5',1,'ERF']]], + ['z_5fphys_5fnd_5fsrc_5157',['z_phys_nd_src',['../classERF.html#a30dcf40e8f104fb6b6132805d2eff47c',1,'ERF']]], + ['z_5ft_5frk_5158',['z_t_rk',['../classERF.html#a72a59614c6d5ab840b924c84d5682270',1,'ERF']]], + ['zero_5fxflux_5159',['zero_xflux',['../structAdvChoice.html#a7a086b9e2aabb65d2e5e9053e7bd6018',1,'AdvChoice']]], + ['zero_5fyflux_5160',['zero_yflux',['../structAdvChoice.html#a118575fe302e72fcd231e77be6d117a9',1,'AdvChoice']]], + ['zero_5fzflux_5161',['zero_zflux',['../structAdvChoice.html#a7da4e5242e05aeba4822b71fab596954',1,'AdvChoice']]], + ['zflux_5fimask_5162',['zflux_imask',['../classERF.html#ada098767690d194f89717b0deb3adeac',1,'ERF']]], + ['zhi_5163',['zhi',['../classKessler.html#a8f1c8af54c49e78271d077456c3aa454',1,'Kessler::zhi()'],['../classRadiation.html#ac182d77504c899dee3ff639c2a8e93c6',1,'Radiation::zhi()'],['../classSAM.html#aaf2fc082e80f1c5cc9de339ff25ca27b',1,'SAM::zhi()']]], + ['zhi_5fsponge_5fstart_5164',['zhi_sponge_start',['../structSpongeChoice.html#a5e70ccbf1d7de42a4d938416635eee36',1,'SpongeChoice']]], + ['zi_5165',['zi',['../classAerRadProps.html#ac82b4bf91bb3a23e33074e00381388e3',1,'AerRadProps::zi()'],['../classRadiation.html#a7fd0d1f49797bc9d2c248cd334b44e36',1,'Radiation::zi()']]], + ['zlevels_5fstag_5166',['zlevels_stag',['../classERF.html#ace4f0c79f84075dd7a43bd2b0ede1a9b',1,'ERF']]], + ['zlo_5167',['zlo',['../classKessler.html#a02b5caebac4d5986947655feca7f0db5',1,'Kessler::zlo()'],['../classRadiation.html#add5e5480ecd2c337c1e52e47d62ebaa0',1,'Radiation::zlo()'],['../classSAM.html#a0473906305a6eaea0bad212893b9c911',1,'SAM::zlo()'],['../structrotate__flux.html#a17aa8cfa0cb8ee81926a938b8b826032',1,'rotate_flux::zlo()'],['../structcustom__flux.html#a3b40812bce1c4be2d850abe1bbc2d208',1,'custom_flux::zlo()'],['../structdonelan__flux.html#af7428f0272064ef770035521c9c9a98b',1,'donelan_flux::zlo()'],['../structmoeng__flux.html#a32dd97697698052a006613da3a0b7e67',1,'moeng_flux::zlo()']]], + ['zlo_5fsponge_5fend_5168',['zlo_sponge_end',['../structSpongeChoice.html#a1a79f8e32354ec98857597ddabfe884e',1,'SpongeChoice']]], + ['zloc_5169',['zloc',['../classWindFarm.html#a70d65d49e7ee4191c7f009416ab6ba27',1,'WindFarm']]], + ['zmid_5170',['zmid',['../classSAM.html#a5a5228929f2e9032152efe0a5cb9476b',1,'SAM']]], + ['zmom_5fcrse_5frhs_5171',['zmom_crse_rhs',['../classERF.html#aaf7e8e28172eebdfe2224e4ee823310d',1,'ERF']]], + ['zref_5172',['zref',['../structmost__data.html#a1acd5276639042ca0834c56656302ea6',1,'most_data']]], + ['zsurf_5173',['zsurf',['../structSolverChoice.html#aa4659e9babdc5d7327266f967d9a80ff',1,'SolverChoice']]], + ['zvel_5fbc_5fdata_5174',['zvel_bc_data',['../classERF.html#ae08c25dcf643c6ef39f27d7dd0cb7423',1,'ERF']]] ]; diff --git a/search/variables_2.js b/search/variables_2.js index 417951aed..89f06bfea 100644 --- a/search/variables_2.js +++ b/search/variables_2.js @@ -1,93 +1,94 @@ var searchData= [ - ['c1_4107',['c1',['../structWENO__Z5.html#aaef4d108f7f40585ead5bdb4d8ba5c67',1,'WENO_Z5::c1()'],['../structWENO5.html#a3acb5e8bde92b17f3eefb2a0cc3dad2e',1,'WENO5::c1()']]], + ['c1_4107',['c1',['../structWENO5.html#a3acb5e8bde92b17f3eefb2a0cc3dad2e',1,'WENO5']]], ['c1_4108',['C1',['../structMYNNLevel25.html#a56b79a6d80bf23bedd64223516746ae7',1,'MYNNLevel25']]], - ['c2_4109',['C2',['../structMYNNLevel25.html#a6d0246567e40d4625f019983bb1ed8e8',1,'MYNNLevel25']]], - ['c3_4110',['C3',['../structMYNNLevel25.html#a6b42dbf8b3f6a136e5d7a1517fa24119',1,'MYNNLevel25']]], - ['c4_4111',['C4',['../structMYNNLevel25.html#a55fad52b96bc4c5d909e1cc4332c54ad',1,'MYNNLevel25']]], - ['c5_4112',['C5',['../structMYNNLevel25.html#abccb8d9a56c593f5f75ce7f6a170a3be',1,'MYNNLevel25']]], - ['c_5fp_4113',['c_p',['../structSolverChoice.html#a43d16f0628ba5fbe64a813de7f25f56a',1,'SolverChoice']]], + ['c1_4109',['c1',['../structWENO__Z5.html#aaef4d108f7f40585ead5bdb4d8ba5c67',1,'WENO_Z5']]], + ['c2_4110',['C2',['../structMYNNLevel25.html#a6d0246567e40d4625f019983bb1ed8e8',1,'MYNNLevel25']]], + ['c3_4111',['C3',['../structMYNNLevel25.html#a6b42dbf8b3f6a136e5d7a1517fa24119',1,'MYNNLevel25']]], + ['c4_4112',['C4',['../structMYNNLevel25.html#a55fad52b96bc4c5d909e1cc4332c54ad',1,'MYNNLevel25']]], + ['c5_4113',['C5',['../structMYNNLevel25.html#abccb8d9a56c593f5f75ce7f6a170a3be',1,'MYNNLevel25']]], ['c_5fp_4114',['C_P',['../classWindFarm.html#a63c20a3eac21bceea0ae4bfbe4c9acac',1,'WindFarm::C_P()'],['../classGeneralAD.html#a789afc5fc0d7b06f7dc79e6eb05a5760',1,'GeneralAD::C_P()']]], - ['c_5ft_4115',['C_T',['../classWindFarm.html#a87e2fe5c89e49801a70f6acf9836e1e1',1,'WindFarm::C_T()'],['../classGeneralAD.html#ae82cceda872623720416dc9221693379',1,'GeneralAD::C_T()']]], - ['camname_4116',['camname',['../structMamConstituents_1_1aerosol__t.html#a23e50740903b1b826352cd7486c69913',1,'MamConstituents::aerosol_t::camname()'],['../structMamConstituents_1_1gas__t.html#ab996ee58a5c7dc033d07938d487e79f3',1,'MamConstituents::gas_t::camname()']]], - ['camname_5fmmr_5fa_4117',['camname_mmr_a',['../structMamConstituents_1_1mode__component__t.html#a3adfcd2619c7f477e8ecd6529d8f98b6',1,'MamConstituents::mode_component_t']]], - ['camname_5fmmr_5fc_4118',['camname_mmr_c',['../structMamConstituents_1_1mode__component__t.html#aab0b2aef67ab3544af7fb0ecf2930415',1,'MamConstituents::mode_component_t']]], - ['camname_5fnum_5fa_4119',['camname_num_a',['../structMamConstituents_1_1mode__component__t.html#a5a1aa28df874b8cb28f19e730b36f037',1,'MamConstituents::mode_component_t']]], - ['camname_5fnum_5fc_4120',['camname_num_c',['../structMamConstituents_1_1mode__component__t.html#a6f588bac515da5d63593bb61df75e432',1,'MamConstituents::mode_component_t']]], - ['ce_4121',['Ce',['../structTurbChoice.html#ab6d0ae39e92dcbe7362abf53364c1a8e',1,'TurbChoice']]], - ['ce_5fwall_4122',['Ce_wall',['../structTurbChoice.html#ab2d1ecb36171ca19ea851e8e682a1478',1,'TurbChoice']]], - ['cf_5fset_5fwidth_4123',['cf_set_width',['../classERF.html#a1e3e2855b6e811596226c167573ad62d',1,'ERF']]], - ['cf_5fwidth_4124',['cf_width',['../classERF.html#ad9084179f7384e10a519989ffd51fd34',1,'ERF']]], - ['cfl_4125',['cfl',['../classERF.html#a89f605d1a1eae06a7c79f9b6b65c637f',1,'ERF']]], - ['cfl_5fmax_4126',['CFL_MAX',['../classSAM.html#ab22f37f1f2b5d72ee2d20af56a29fc40',1,'SAM::CFL_MAX()'],['../classKessler.html#ab65a6b7181e08edaa8de14ea26bb8d62',1,'Kessler::CFL_MAX()']]], - ['cgrau_4127',['cgrau',['../ERF__Constants_8H.html#a22bb5d96152ac76ffe39d98d67b2b07a',1,'ERF_Constants.H']]], - ['change_5fmax_4128',['change_max',['../classERF.html#ae16d413b172bb3b3400af6d5cb236fd4',1,'ERF']]], - ['check_5ffile_4129',['check_file',['../classERF.html#ae701564fbe3da5bbd88587e5a08eca4e',1,'ERF']]], - ['check_5ftype_4130',['check_type',['../classERF.html#a32e0d0f5ae0db18ee81f9d4325a14f64',1,'ERF']]], - ['ci_4131',['CI',['../structTurbChoice.html#afbf3b28d53a35977d4ff77e6928122c0',1,'TurbChoice']]], - ['ck_4132',['Ck',['../structTurbChoice.html#a61ff7dc6ee4001ae8f2978efd5ff57e4',1,'TurbChoice']]], - ['cld_4133',['cld',['../classRadiation.html#a889a5f62e829af86690ece49bf2f9c6e',1,'Radiation']]], - ['cld_5fasm_5fbnd_5fsw_4134',['cld_asm_bnd_sw',['../classRadiation.html#a8ddade9e3b5ad13008fb253d2e7c17a4',1,'Radiation']]], - ['cld_5fasm_5fbnd_5fsw_5f1d_4135',['cld_asm_bnd_sw_1d',['../classRadiation.html#aff0446369d923ec1ba5b20e6b257d52d',1,'Radiation']]], - ['cld_5fasm_5fbnd_5fsw_5fo_5f1d_4136',['cld_asm_bnd_sw_o_1d',['../classRadiation.html#a4b3eed1432c08adcac97160424dafc79',1,'Radiation']]], - ['cld_5fasm_5fgpt_5fsw_4137',['cld_asm_gpt_sw',['../classRadiation.html#a8718e64a2e3ba0aa52e12bcac9dcb202',1,'Radiation']]], - ['cld_5fssa_5fbnd_5fsw_4138',['cld_ssa_bnd_sw',['../classRadiation.html#af35ffb83d032a581c45673e2627f8bb5',1,'Radiation']]], - ['cld_5fssa_5fbnd_5fsw_5f1d_4139',['cld_ssa_bnd_sw_1d',['../classRadiation.html#ad13553538dacaf76d38eacf804a13276',1,'Radiation']]], - ['cld_5fssa_5fbnd_5fsw_5fo_5f1d_4140',['cld_ssa_bnd_sw_o_1d',['../classRadiation.html#ad139630194e6035320fe89c828287912',1,'Radiation']]], - ['cld_5fssa_5fgpt_5fsw_4141',['cld_ssa_gpt_sw',['../classRadiation.html#a23309b232cd21359d1ffd8832acd4e09',1,'Radiation']]], - ['cld_5ftau_5fbnd_5flw_4142',['cld_tau_bnd_lw',['../classRadiation.html#a6f6042a4b1744a110d7955c6d0d8d08c',1,'Radiation']]], - ['cld_5ftau_5fbnd_5fsw_4143',['cld_tau_bnd_sw',['../classRadiation.html#aeae6687bdc7bfc93f2e7ff079fbb3244',1,'Radiation']]], - ['cld_5ftau_5fbnd_5fsw_5f1d_4144',['cld_tau_bnd_sw_1d',['../classRadiation.html#a6ffc09147dd502ea1b9ef005da70fa2d',1,'Radiation']]], - ['cld_5ftau_5fbnd_5fsw_5fo_5f1d_4145',['cld_tau_bnd_sw_o_1d',['../classRadiation.html#a4b65612bc60bb15b9e89971e5bed81b8',1,'Radiation']]], - ['cld_5ftau_5fgpt_5flw_4146',['cld_tau_gpt_lw',['../classRadiation.html#a038b9faf1daea703e3f7d82f0e889b05',1,'Radiation']]], - ['cld_5ftau_5fgpt_5fsw_4147',['cld_tau_gpt_sw',['../classRadiation.html#abbe4431f5c94243dd57fa8adb55d05e6',1,'Radiation']]], - ['cldfsnow_4148',['cldfsnow',['../classRadiation.html#ae535dbfdb6158094e4182ea1b660e7cc',1,'Radiation']]], - ['clear_5frh_4149',['clear_rh',['../classRadiation.html#a04fcc2194ca5c8df13d384ae567aa3c7',1,'Radiation']]], - ['clim_5fmodal_5faero_4150',['clim_modal_aero',['../classMam4__aer.html#a83c2a65a851a3329d62fca09dd0263d5',1,'Mam4_aer']]], - ['cloud_5foptics_4151',['cloud_optics',['../classOptics.html#a90c700e69b63c61c6275b12c63033334',1,'Optics']]], - ['cmd_4152',['cmd',['../classMultiBlockContainer.html#ac2e558406e28ee31351eb60c7465d0ad',1,'MultiBlockContainer']]], - ['cnk_5fa_4153',['Cnk_a',['../structmost__data.html#a83c3a7004441c335b630dd2d6973f518',1,'most_data']]], - ['cnk_5fa_4154',['cnk_a',['../classABLMost.html#a75310e9079ee238a932900feaad85ac5',1,'ABLMost']]], - ['cnk_5fb_4155',['Cnk_b',['../structmost__data.html#a51b78fb4a4b8fb6aa512d4bd4fcd3cd7',1,'most_data']]], - ['cnk_5fb1_4156',['Cnk_b1',['../structmost__data.html#acfac0135facabddbdd699609bac908e4',1,'most_data']]], - ['cnk_5fb2_4157',['Cnk_b2',['../structmost__data.html#a4488059550159398fd2cddaf4d37f31b',1,'most_data']]], - ['cnk_5fd_4158',['Cnk_d',['../structmost__data.html#a73b1c119aa9b4bcaac98753a4fde9e86',1,'most_data']]], - ['cnk_5fvisc_4159',['cnk_visc',['../classABLMost.html#a4f97d1d8c347710155ead2c1310338a0',1,'ABLMost']]], - ['coefficients_5ffile_5flw_4160',['coefficients_file_lw',['../classRrtmgp.html#a02493ce8d504b6a4d4a9a5cfec8d44f5',1,'Rrtmgp']]], - ['coefficients_5ffile_5fsw_4161',['coefficients_file_sw',['../classRrtmgp.html#a5fa9f64db9791a7f152055f484113714',1,'Rrtmgp']]], - ['coefice_4162',['coefice',['../classSAM.html#aad8c4616221c01599e4e32f2ebb08698',1,'SAM']]], - ['column_5ffile_5fname_4163',['column_file_name',['../classERF.html#a48bba6b1c1b39940b09aefbe56311e2f',1,'ERF']]], - ['column_5finterval_4164',['column_interval',['../classERF.html#afa0bef6d3146788302b81c0d4f4802d1',1,'ERF']]], - ['column_5floc_5fx_4165',['column_loc_x',['../classERF.html#a930b7d48218b3fc41d8719b50b3f6086',1,'ERF']]], - ['column_5floc_5fy_4166',['column_loc_y',['../classERF.html#a2b911f3a5a324813b1ff4462df6044a6',1,'ERF']]], - ['column_5fper_4167',['column_per',['../classERF.html#a7b0175190c6fcf829c7f2841f729b12a',1,'ERF']]], - ['comps_4168',['comps',['../structMamConstituents_1_1modes__t.html#a51263b4f4e52ec4e2068e775d7f5f1f4',1,'MamConstituents::modes_t']]], - ['config_4169',['config',['../structMYNNLevel25.html#a6065f4b0ba5299d0be0f92a614188034',1,'MYNNLevel25']]], - ['cons_5fnames_4170',['cons_names',['../classERF.html#afd8cd5a477754776135befa668fdd0c9',1,'ERF']]], - ['cons_5fto_5fprim_4171',['cons_to_prim',['../ERF__TI__utils_8H.html#a76b27b6105fe279f9a43296072c843b3',1,'ERF_TI_utils.H']]], - ['const_5fgrav_4172',['CONST_GRAV',['../ERF__Constants_8H.html#ac2d0c304ab1117368778efcda612de43',1,'ERF_Constants.H']]], - ['constant_5fdensity_4173',['constant_density',['../structSolverChoice.html#aa9cf425ef14a7e28ec3411044e737b23',1,'SolverChoice']]], - ['coriolis_5f3d_4174',['coriolis_3d',['../structSolverChoice.html#a7e93900ec3e84826fcf1e02435bdae42',1,'SolverChoice']]], - ['coriolis_5ffactor_4175',['coriolis_factor',['../structSolverChoice.html#a1163778ed56af6977001ef4ec55a3da3',1,'SolverChoice']]], - ['cosphi_4176',['cosphi',['../structSolverChoice.html#a411fbfea721cd40033e113cf54a8047f',1,'SolverChoice']]], - ['coszrs_4177',['coszrs',['../classRadiation.html#ada2d1a89ee69c66d7dd3ebf7a2f98d7b',1,'Radiation']]], - ['coupling_5ftype_4178',['coupling_type',['../structSolverChoice.html#af976afa61859c07e6249963edc367c2d',1,'SolverChoice']]], - ['cp_5fd_4179',['Cp_d',['../ERF__Constants_8H.html#a1ee33e063343c8fb15ed025c456ebd46',1,'ERF_Constants.H']]], - ['cp_5fl_4180',['Cp_l',['../ERF__Constants_8H.html#acecae1da25fb8c8d32d1f175e18df41f',1,'ERF_Constants.H']]], - ['cp_5fv_4181',['Cp_v',['../ERF__Constants_8H.html#aea1cea8d633adb36e2ea5018925b68ee',1,'ERF_Constants.H']]], - ['crain_4182',['crain',['../ERF__Constants_8H.html#aedc41c83fba50dcbd5e1385007d3edec',1,'ERF_Constants.H']]], - ['crefwlwi_4183',['crefwlwi',['../classMam4__aer.html#a32d3651a6f9299ecee85fee320dfda50',1,'Mam4_aer']]], - ['crefwlwr_4184',['crefwlwr',['../classMam4__aer.html#ae1eea21725e40b02e21086cd73dc9d66',1,'Mam4_aer']]], - ['crefwswi_4185',['crefwswi',['../classMam4__aer.html#ad48a521caea628250a1faa6154f6094b',1,'Mam4_aer']]], - ['crefwswr_4186',['crefwswr',['../classMam4__aer.html#a139c9796ada84ff24405114f8691d7cd',1,'Mam4_aer']]], - ['cs_4187',['Cs',['../structTurbChoice.html#aa75682bb872d7917ffb8fddb21532f40',1,'TurbChoice']]], - ['csnow_4188',['csnow',['../ERF__Constants_8H.html#a00a835048e6d7b67e76cd044f483a0e2',1,'ERF_Constants.H']]], - ['custom_5fforcing_5fprim_5fvars_4189',['custom_forcing_prim_vars',['../structSolverChoice.html#aae4f377d36d01b85a1f322c45009ac75',1,'SolverChoice']]], - ['custom_5fgeostrophic_5fprofile_4190',['custom_geostrophic_profile',['../structSolverChoice.html#a5e8754b29072596a584633734a9f64ef',1,'SolverChoice']]], - ['custom_5fmoisture_5fforcing_4191',['custom_moisture_forcing',['../structSolverChoice.html#aa2e312b4e6d08797fc3c1b6d67313d48',1,'SolverChoice']]], - ['custom_5fqstar_4192',['custom_qstar',['../classABLMost.html#a31707b89fbbbdeb445ba35ed240046c3',1,'ABLMost']]], - ['custom_5frhotheta_5fforcing_4193',['custom_rhotheta_forcing',['../structSolverChoice.html#a4e81a09c9f454c680568b7776a3ed90e',1,'SolverChoice']]], - ['custom_5ftstar_4194',['custom_tstar',['../classABLMost.html#afbd0b1a37d9e9d716d82910db203e82f',1,'ABLMost']]], - ['custom_5fustar_4195',['custom_ustar',['../classABLMost.html#a1bce26c6253a6191424e7b753cd24cfa',1,'ABLMost']]], - ['custom_5fw_5fsubsidence_4196',['custom_w_subsidence',['../structSolverChoice.html#a596f061b796ada0389c81a6125150b6e',1,'SolverChoice']]] + ['c_5fp_4115',['c_p',['../structSolverChoice.html#a43d16f0628ba5fbe64a813de7f25f56a',1,'SolverChoice']]], + ['c_5ft_4116',['C_T',['../classWindFarm.html#a87e2fe5c89e49801a70f6acf9836e1e1',1,'WindFarm::C_T()'],['../classGeneralAD.html#ae82cceda872623720416dc9221693379',1,'GeneralAD::C_T()']]], + ['camname_4117',['camname',['../structMamConstituents_1_1aerosol__t.html#a23e50740903b1b826352cd7486c69913',1,'MamConstituents::aerosol_t::camname()'],['../structMamConstituents_1_1gas__t.html#ab996ee58a5c7dc033d07938d487e79f3',1,'MamConstituents::gas_t::camname()']]], + ['camname_5fmmr_5fa_4118',['camname_mmr_a',['../structMamConstituents_1_1mode__component__t.html#a3adfcd2619c7f477e8ecd6529d8f98b6',1,'MamConstituents::mode_component_t']]], + ['camname_5fmmr_5fc_4119',['camname_mmr_c',['../structMamConstituents_1_1mode__component__t.html#aab0b2aef67ab3544af7fb0ecf2930415',1,'MamConstituents::mode_component_t']]], + ['camname_5fnum_5fa_4120',['camname_num_a',['../structMamConstituents_1_1mode__component__t.html#a5a1aa28df874b8cb28f19e730b36f037',1,'MamConstituents::mode_component_t']]], + ['camname_5fnum_5fc_4121',['camname_num_c',['../structMamConstituents_1_1mode__component__t.html#a6f588bac515da5d63593bb61df75e432',1,'MamConstituents::mode_component_t']]], + ['ce_4122',['Ce',['../structTurbChoice.html#ab6d0ae39e92dcbe7362abf53364c1a8e',1,'TurbChoice']]], + ['ce_5fwall_4123',['Ce_wall',['../structTurbChoice.html#ab2d1ecb36171ca19ea851e8e682a1478',1,'TurbChoice']]], + ['cf_5fset_5fwidth_4124',['cf_set_width',['../classERF.html#a1e3e2855b6e811596226c167573ad62d',1,'ERF']]], + ['cf_5fwidth_4125',['cf_width',['../classERF.html#ad9084179f7384e10a519989ffd51fd34',1,'ERF']]], + ['cfl_4126',['cfl',['../classERF.html#a89f605d1a1eae06a7c79f9b6b65c637f',1,'ERF']]], + ['cfl_5fmax_4127',['CFL_MAX',['../classSAM.html#ab22f37f1f2b5d72ee2d20af56a29fc40',1,'SAM::CFL_MAX()'],['../classKessler.html#ab65a6b7181e08edaa8de14ea26bb8d62',1,'Kessler::CFL_MAX()']]], + ['cgrau_4128',['cgrau',['../ERF__Constants_8H.html#a22bb5d96152ac76ffe39d98d67b2b07a',1,'ERF_Constants.H']]], + ['change_5fmax_4129',['change_max',['../classERF.html#ae16d413b172bb3b3400af6d5cb236fd4',1,'ERF']]], + ['check_5ffile_4130',['check_file',['../classERF.html#ae701564fbe3da5bbd88587e5a08eca4e',1,'ERF']]], + ['check_5ftype_4131',['check_type',['../classERF.html#a32e0d0f5ae0db18ee81f9d4325a14f64',1,'ERF']]], + ['ci_4132',['CI',['../structTurbChoice.html#afbf3b28d53a35977d4ff77e6928122c0',1,'TurbChoice']]], + ['ck_4133',['Ck',['../structTurbChoice.html#a61ff7dc6ee4001ae8f2978efd5ff57e4',1,'TurbChoice']]], + ['cld_4134',['cld',['../classRadiation.html#a889a5f62e829af86690ece49bf2f9c6e',1,'Radiation']]], + ['cld_5fasm_5fbnd_5fsw_4135',['cld_asm_bnd_sw',['../classRadiation.html#a8ddade9e3b5ad13008fb253d2e7c17a4',1,'Radiation']]], + ['cld_5fasm_5fbnd_5fsw_5f1d_4136',['cld_asm_bnd_sw_1d',['../classRadiation.html#aff0446369d923ec1ba5b20e6b257d52d',1,'Radiation']]], + ['cld_5fasm_5fbnd_5fsw_5fo_5f1d_4137',['cld_asm_bnd_sw_o_1d',['../classRadiation.html#a4b3eed1432c08adcac97160424dafc79',1,'Radiation']]], + ['cld_5fasm_5fgpt_5fsw_4138',['cld_asm_gpt_sw',['../classRadiation.html#a8718e64a2e3ba0aa52e12bcac9dcb202',1,'Radiation']]], + ['cld_5fssa_5fbnd_5fsw_4139',['cld_ssa_bnd_sw',['../classRadiation.html#af35ffb83d032a581c45673e2627f8bb5',1,'Radiation']]], + ['cld_5fssa_5fbnd_5fsw_5f1d_4140',['cld_ssa_bnd_sw_1d',['../classRadiation.html#ad13553538dacaf76d38eacf804a13276',1,'Radiation']]], + ['cld_5fssa_5fbnd_5fsw_5fo_5f1d_4141',['cld_ssa_bnd_sw_o_1d',['../classRadiation.html#ad139630194e6035320fe89c828287912',1,'Radiation']]], + ['cld_5fssa_5fgpt_5fsw_4142',['cld_ssa_gpt_sw',['../classRadiation.html#a23309b232cd21359d1ffd8832acd4e09',1,'Radiation']]], + ['cld_5ftau_5fbnd_5flw_4143',['cld_tau_bnd_lw',['../classRadiation.html#a6f6042a4b1744a110d7955c6d0d8d08c',1,'Radiation']]], + ['cld_5ftau_5fbnd_5fsw_4144',['cld_tau_bnd_sw',['../classRadiation.html#aeae6687bdc7bfc93f2e7ff079fbb3244',1,'Radiation']]], + ['cld_5ftau_5fbnd_5fsw_5f1d_4145',['cld_tau_bnd_sw_1d',['../classRadiation.html#a6ffc09147dd502ea1b9ef005da70fa2d',1,'Radiation']]], + ['cld_5ftau_5fbnd_5fsw_5fo_5f1d_4146',['cld_tau_bnd_sw_o_1d',['../classRadiation.html#a4b65612bc60bb15b9e89971e5bed81b8',1,'Radiation']]], + ['cld_5ftau_5fgpt_5flw_4147',['cld_tau_gpt_lw',['../classRadiation.html#a038b9faf1daea703e3f7d82f0e889b05',1,'Radiation']]], + ['cld_5ftau_5fgpt_5fsw_4148',['cld_tau_gpt_sw',['../classRadiation.html#abbe4431f5c94243dd57fa8adb55d05e6',1,'Radiation']]], + ['cldfsnow_4149',['cldfsnow',['../classRadiation.html#ae535dbfdb6158094e4182ea1b660e7cc',1,'Radiation']]], + ['clear_5frh_4150',['clear_rh',['../classRadiation.html#a04fcc2194ca5c8df13d384ae567aa3c7',1,'Radiation']]], + ['clim_5fmodal_5faero_4151',['clim_modal_aero',['../classMam4__aer.html#a83c2a65a851a3329d62fca09dd0263d5',1,'Mam4_aer']]], + ['cloud_5foptics_4152',['cloud_optics',['../classOptics.html#a90c700e69b63c61c6275b12c63033334',1,'Optics']]], + ['cmd_4153',['cmd',['../classMultiBlockContainer.html#ac2e558406e28ee31351eb60c7465d0ad',1,'MultiBlockContainer']]], + ['cnk_5fa_4154',['Cnk_a',['../structmost__data.html#a83c3a7004441c335b630dd2d6973f518',1,'most_data']]], + ['cnk_5fa_4155',['cnk_a',['../classABLMost.html#a75310e9079ee238a932900feaad85ac5',1,'ABLMost']]], + ['cnk_5fb_4156',['Cnk_b',['../structmost__data.html#a51b78fb4a4b8fb6aa512d4bd4fcd3cd7',1,'most_data']]], + ['cnk_5fb1_4157',['Cnk_b1',['../structmost__data.html#acfac0135facabddbdd699609bac908e4',1,'most_data']]], + ['cnk_5fb2_4158',['Cnk_b2',['../structmost__data.html#a4488059550159398fd2cddaf4d37f31b',1,'most_data']]], + ['cnk_5fd_4159',['Cnk_d',['../structmost__data.html#a73b1c119aa9b4bcaac98753a4fde9e86',1,'most_data']]], + ['cnk_5fvisc_4160',['cnk_visc',['../classABLMost.html#a4f97d1d8c347710155ead2c1310338a0',1,'ABLMost']]], + ['coefficients_5ffile_5flw_4161',['coefficients_file_lw',['../classRrtmgp.html#a02493ce8d504b6a4d4a9a5cfec8d44f5',1,'Rrtmgp']]], + ['coefficients_5ffile_5fsw_4162',['coefficients_file_sw',['../classRrtmgp.html#a5fa9f64db9791a7f152055f484113714',1,'Rrtmgp']]], + ['coefice_4163',['coefice',['../classSAM.html#aad8c4616221c01599e4e32f2ebb08698',1,'SAM']]], + ['column_5ffile_5fname_4164',['column_file_name',['../classERF.html#a48bba6b1c1b39940b09aefbe56311e2f',1,'ERF']]], + ['column_5finterval_4165',['column_interval',['../classERF.html#afa0bef6d3146788302b81c0d4f4802d1',1,'ERF']]], + ['column_5floc_5fx_4166',['column_loc_x',['../classERF.html#a930b7d48218b3fc41d8719b50b3f6086',1,'ERF']]], + ['column_5floc_5fy_4167',['column_loc_y',['../classERF.html#a2b911f3a5a324813b1ff4462df6044a6',1,'ERF']]], + ['column_5fper_4168',['column_per',['../classERF.html#a7b0175190c6fcf829c7f2841f729b12a',1,'ERF']]], + ['comps_4169',['comps',['../structMamConstituents_1_1modes__t.html#a51263b4f4e52ec4e2068e775d7f5f1f4',1,'MamConstituents::modes_t']]], + ['config_4170',['config',['../structMYNNLevel25.html#a6065f4b0ba5299d0be0f92a614188034',1,'MYNNLevel25']]], + ['cons_5fnames_4171',['cons_names',['../classERF.html#afd8cd5a477754776135befa668fdd0c9',1,'ERF']]], + ['cons_5fto_5fprim_4172',['cons_to_prim',['../ERF__TI__utils_8H.html#a76b27b6105fe279f9a43296072c843b3',1,'ERF_TI_utils.H']]], + ['const_5fgrav_4173',['CONST_GRAV',['../ERF__Constants_8H.html#ac2d0c304ab1117368778efcda612de43',1,'ERF_Constants.H']]], + ['constant_5fdensity_4174',['constant_density',['../structSolverChoice.html#aa9cf425ef14a7e28ec3411044e737b23',1,'SolverChoice']]], + ['coriolis_5f3d_4175',['coriolis_3d',['../structSolverChoice.html#a7e93900ec3e84826fcf1e02435bdae42',1,'SolverChoice']]], + ['coriolis_5ffactor_4176',['coriolis_factor',['../structSolverChoice.html#a1163778ed56af6977001ef4ec55a3da3',1,'SolverChoice']]], + ['cosphi_4177',['cosphi',['../structSolverChoice.html#a411fbfea721cd40033e113cf54a8047f',1,'SolverChoice']]], + ['coszrs_4178',['coszrs',['../classRadiation.html#ada2d1a89ee69c66d7dd3ebf7a2f98d7b',1,'Radiation']]], + ['coupling_5ftype_4179',['coupling_type',['../structSolverChoice.html#af976afa61859c07e6249963edc367c2d',1,'SolverChoice']]], + ['cp_5fd_4180',['Cp_d',['../ERF__Constants_8H.html#a1ee33e063343c8fb15ed025c456ebd46',1,'ERF_Constants.H']]], + ['cp_5fl_4181',['Cp_l',['../ERF__Constants_8H.html#acecae1da25fb8c8d32d1f175e18df41f',1,'ERF_Constants.H']]], + ['cp_5fv_4182',['Cp_v',['../ERF__Constants_8H.html#aea1cea8d633adb36e2ea5018925b68ee',1,'ERF_Constants.H']]], + ['crain_4183',['crain',['../ERF__Constants_8H.html#aedc41c83fba50dcbd5e1385007d3edec',1,'ERF_Constants.H']]], + ['crefwlwi_4184',['crefwlwi',['../classMam4__aer.html#a32d3651a6f9299ecee85fee320dfda50',1,'Mam4_aer']]], + ['crefwlwr_4185',['crefwlwr',['../classMam4__aer.html#ae1eea21725e40b02e21086cd73dc9d66',1,'Mam4_aer']]], + ['crefwswi_4186',['crefwswi',['../classMam4__aer.html#ad48a521caea628250a1faa6154f6094b',1,'Mam4_aer']]], + ['crefwswr_4187',['crefwswr',['../classMam4__aer.html#a139c9796ada84ff24405114f8691d7cd',1,'Mam4_aer']]], + ['cs_4188',['Cs',['../structTurbChoice.html#aa75682bb872d7917ffb8fddb21532f40',1,'TurbChoice']]], + ['csnow_4189',['csnow',['../ERF__Constants_8H.html#a00a835048e6d7b67e76cd044f483a0e2',1,'ERF_Constants.H']]], + ['custom_5fforcing_5fprim_5fvars_4190',['custom_forcing_prim_vars',['../structSolverChoice.html#aae4f377d36d01b85a1f322c45009ac75',1,'SolverChoice']]], + ['custom_5fgeostrophic_5fprofile_4191',['custom_geostrophic_profile',['../structSolverChoice.html#a5e8754b29072596a584633734a9f64ef',1,'SolverChoice']]], + ['custom_5fmoisture_5fforcing_4192',['custom_moisture_forcing',['../structSolverChoice.html#aa2e312b4e6d08797fc3c1b6d67313d48',1,'SolverChoice']]], + ['custom_5fqstar_4193',['custom_qstar',['../classABLMost.html#a31707b89fbbbdeb445ba35ed240046c3',1,'ABLMost']]], + ['custom_5frhotheta_5fforcing_4194',['custom_rhotheta_forcing',['../structSolverChoice.html#a4e81a09c9f454c680568b7776a3ed90e',1,'SolverChoice']]], + ['custom_5ftstar_4195',['custom_tstar',['../classABLMost.html#afbd0b1a37d9e9d716d82910db203e82f',1,'ABLMost']]], + ['custom_5fustar_4196',['custom_ustar',['../classABLMost.html#a1bce26c6253a6191424e7b753cd24cfa',1,'ABLMost']]], + ['custom_5fw_5fsubsidence_4197',['custom_w_subsidence',['../structSolverChoice.html#a596f061b796ada0389c81a6125150b6e',1,'SolverChoice']]] ]; diff --git a/search/variables_3.js b/search/variables_3.js index 7c8b301a9..056ed5a76 100644 --- a/search/variables_3.js +++ b/search/variables_3.js @@ -1,69 +1,69 @@ var searchData= [ - ['d_5fhavg_5fdensity_4197',['d_havg_density',['../classERF.html#a84cf7616e7b3928f08f4bd56112db01e',1,'ERF']]], - ['d_5fhavg_5fpressure_4198',['d_havg_pressure',['../classERF.html#a9a4f076c56f31fbb5e68c09706605a05',1,'ERF']]], - ['d_5fhavg_5fqc_4199',['d_havg_qc',['../classERF.html#a8199cc1ec38b9dfd47262ccc7df6a941',1,'ERF']]], - ['d_5fhavg_5fqv_4200',['d_havg_qv',['../classERF.html#a2b0085123e02051ac4c2a72e9972e6ee',1,'ERF']]], - ['d_5fhavg_5ftemperature_4201',['d_havg_temperature',['../classERF.html#a20350959b7b3e252ee3a802e7998ca8d',1,'ERF']]], - ['d_5frayleigh_5fptrs_4202',['d_rayleigh_ptrs',['../classERF.html#ad598bde8e728479faaa7c2820096b47a',1,'ERF']]], - ['d_5frhoqt_5fsrc_4203',['d_rhoqt_src',['../classERF.html#a838687881ef3626f932d0e95ceff0e53',1,'ERF']]], - ['d_5frhotheta_5fsrc_4204',['d_rhotheta_src',['../classERF.html#a0c1fdcfbc9cbd6cb13e41d1170b161f8',1,'ERF']]], - ['d_5fsponge_5fptrs_4205',['d_sponge_ptrs',['../classERF.html#a3b9bcb54c278dfec6027e9727cc01bc5',1,'ERF']]], - ['d_5fu_5fgeos_4206',['d_u_geos',['../classERF.html#ac020980af9dbf46be43dd9f7127c06da',1,'ERF']]], - ['d_5fv_5fgeos_4207',['d_v_geos',['../classERF.html#a7d245afb7b3236b5967902f50bf9000b',1,'ERF']]], - ['d_5fw_5fsubsid_4208',['d_w_subsid',['../classERF.html#ac94ddee2f501dbcea2a516284b7119b5',1,'ERF']]], - ['data_4209',['data',['../structNDArray.html#a9d3679c95b5bf1813a7edaedf221837e',1,'NDArray']]], - ['data_5fsampler_4210',['data_sampler',['../classERF.html#a83ad7f8f4cf9920a6798f3b931355a2f',1,'ERF']]], - ['datalog_4211',['datalog',['../classERF.html#a1cade630b005dbcc0f644987ef3db287',1,'ERF']]], - ['datalogname_4212',['datalogname',['../classERF.html#a9248a4eb025c2647e003f838cba52a21',1,'ERF']]], - ['dei_4213',['dei',['../classRadiation.html#a5d6b802fde5710034668dec77e7a39a8',1,'Radiation']]], - ['density_5faer_4214',['density_aer',['../structPhysProp_1_1physprop__t.html#a8df74558339352f0e8c0031fc3160a09',1,'PhysProp::physprop_t']]], - ['depth_4215',['depth',['../classABLMost.html#a38ed37dd984fcc7be3b5ae04b7272459',1,'ABLMost']]], - ['derived_5fnames_4216',['derived_names',['../classERF.html#a9fc0f6e6ca35036d2e3a36dd42e66435',1,'ERF']]], - ['des_4217',['des',['../classRadiation.html#a6fb15791b58bf08aea781bc906b3c431',1,'Radiation']]], - ['destag_5fprofiles_4218',['destag_profiles',['../classERF.html#a65f19c55c8d3669445866a1c3bbb628d',1,'ERF']]], - ['detj_5fcc_4219',['detJ_cc',['../classERF.html#a30f8b851ed29d38695d44cff257f14e6',1,'ERF']]], - ['detj_5fcc_5fnew_4220',['detJ_cc_new',['../classERF.html#ae39bf64c5306b1dd939d82d9df728daa',1,'ERF']]], - ['detj_5fcc_5fsrc_4221',['detJ_cc_src',['../classERF.html#a9a411e0ea9d9bdbfab957c8081229091',1,'ERF']]], - ['dgnum_4222',['dgnum',['../structPhysProp_1_1physprop__t.html#a66b63e7d4250ce345343af372d529193',1,'PhysProp::physprop_t']]], - ['dgnumdry_5fm_4223',['dgnumdry_m',['../classMam4__aer.html#a12eaca69207827a3988597c3e2f2bb0e',1,'Mam4_aer']]], - ['dgnumhi_4224',['dgnumhi',['../structPhysProp_1_1physprop__t.html#a0a6b0b2e1d1906ac628da5c03c54dd2c',1,'PhysProp::physprop_t']]], - ['dgnumlo_4225',['dgnumlo',['../structPhysProp_1_1physprop__t.html#a2e423bf4c825875ea8d9a72ead6c3b20',1,'PhysProp::physprop_t']]], - ['dgnumwet_5fm_4226',['dgnumwet_m',['../classMam4__aer.html#a69a1949364f03af84c9e4c12973a5223',1,'Mam4_aer']]], - ['diffchoice_4227',['diffChoice',['../structSolverChoice.html#a396122e87a3d15c4ec8666d7dd18c095',1,'SolverChoice']]], - ['diffelq_4228',['diffelq',['../ERF__Constants_8H.html#a4e1c44dade7fcd7648d3e87ba5bba4c1',1,'ERF_Constants.H']]], - ['diffuse_5fke_5f3d_4229',['diffuse_KE_3D',['../structTurbChoice.html#a5864f0fe05bcbd45554301ade763d5ca',1,'TurbChoice']]], - ['diffuse_5fmoistvars_4230',['diffuse_moistvars',['../structMYNNLevel25.html#af677ab24bae6b1f78751489a8df5b1be',1,'MYNNLevel25']]], - ['dimid_4231',['dimid',['../structncutils_1_1NCDim.html#a1c5560c95be35dbcedaf1390972175f8',1,'ncutils::NCDim']]], - ['disk_5fcell_5fcount_4232',['disk_cell_count',['../classSimpleAD.html#a4a8f7fe612cdc61b58b386b0b3f61da7',1,'SimpleAD::disk_cell_count()'],['../classGeneralAD.html#a4a6d71d880f30aeb756885ac4e8d2b5b',1,'GeneralAD::disk_cell_count()']]], - ['dispersion_5faer_4233',['dispersion_aer',['../structPhysProp_1_1physprop__t.html#adf99574ee8aea212bec426dd42a4a9e4',1,'PhysProp::physprop_t']]], - ['do_5faerosol_5frad_4234',['do_aerosol_rad',['../classRadiation.html#a6a43bd5c228b629042b73e06f8fbcf87',1,'Radiation']]], - ['do_5fcloud_4235',['do_cloud',['../structSolverChoice.html#af352bb75ceaeae4ac534d3378fbf393a',1,'SolverChoice']]], - ['do_5fforest_4236',['do_forest',['../structSolverChoice.html#a6937b2ada31923a31997430715a43bef',1,'SolverChoice']]], - ['do_5flong_5fwave_5frad_4237',['do_long_wave_rad',['../classRadiation.html#afb905ef9ee37afaa882346803dae94c9',1,'Radiation']]], - ['do_5fprecip_4238',['do_precip',['../structSolverChoice.html#a766e5884354ed6483704f8257036ee75',1,'SolverChoice']]], - ['do_5fshort_5fwave_5frad_4239',['do_short_wave_rad',['../classRadiation.html#ad1177f9f1504cb562fb70b7f454387fc',1,'Radiation']]], - ['do_5fsnow_5foptics_4240',['do_snow_optics',['../classRadiation.html#a8c411f9344910aab58b29c4a3bcab401',1,'Radiation']]], - ['docloud_4241',['docloud',['../classSAM.html#a77c335e68b7ad8e6069d1318ea673a16',1,'SAM::docloud()'],['../classKessler.html#a7335cec5eabf2a33c8cd274b09863c28',1,'Kessler::docloud()']]], - ['dohirs_4242',['dohirs',['../classRadiation.html#aface9778f843db231e142379cffb709c',1,'Radiation']]], - ['domain_5fbc_5ftype_4243',['domain_bc_type',['../classERF.html#ae5968f1bed602fa87cdd5cb7905b7e5e',1,'ERF']]], - ['domain_5fbcs_5ftype_4244',['domain_bcs_type',['../classERF.html#a574521986a6e403159f83c8b8123ba90',1,'ERF']]], - ['domain_5fbcs_5ftype_5fd_4245',['domain_bcs_type_d',['../classERF.html#a8a99e22b1111c803e31b4afd5fcdea60',1,'ERF']]], - ['doprecip_4246',['doprecip',['../classKessler.html#a2d8ae6f03c19821ef6279dcadd5cb36e',1,'Kessler::doprecip()'],['../classSAM.html#a54766f324324d579d2591a0bdc60e359',1,'SAM::doprecip()']]], - ['dryrad_5faer_4247',['dryrad_aer',['../structPhysProp_1_1physprop__t.html#a55622eb338277f3ce9c7d5b774a9c2c5',1,'PhysProp::physprop_t']]], - ['dryscal_5fhoriz_5fadv_5ftype_4248',['dryscal_horiz_adv_type',['../structAdvChoice.html#a74a383e01c24980b72b920054ee5c1ab',1,'AdvChoice']]], - ['dryscal_5fhoriz_5fupw_5ffrac_4249',['dryscal_horiz_upw_frac',['../structAdvChoice.html#afb0ff64219a9e79d077b1a06da7817ae',1,'AdvChoice']]], - ['dryscal_5fvert_5fadv_5ftype_4250',['dryscal_vert_adv_type',['../structAdvChoice.html#add9ddd5d61fc695bd2df0e3818767b78',1,'AdvChoice']]], - ['dryscal_5fvert_5fupw_5ffrac_4251',['dryscal_vert_upw_frac',['../structAdvChoice.html#a1fc6421356a6c2ecfea0a46b3928d9cf',1,'AdvChoice']]], - ['dt_4252',['dt',['../classKessler.html#a86cf1c45a302d0e4a860860dab3dbe65',1,'Kessler::dt()'],['../classSAM.html#af9ffbd0c3f98c0c5d0a7ac4b1fb3dec9',1,'SAM::dt()'],['../classRadiation.html#a98ebcca0b6a735bb910aedef14ce9a37',1,'Radiation::dt()'],['../classERF.html#ad34bae243fdb6c3029f5abe4fb4bca2d',1,'ERF::dt()']]], - ['dt_5favg_4253',['dt_avg',['../classRadiation.html#af65d65db4b84a4afd921db0f10ffa31e',1,'Radiation']]], - ['dt_5fmri_5fratio_4254',['dt_mri_ratio',['../classERF.html#a3cf7cb2e51eb7b69cb4079ffc6722459',1,'ERF']]], - ['dtos_4255',['dtos',['../classMultiBlockContainer.html#a537ef22d2809607f9d353b912eedffcf',1,'MultiBlockContainer']]], - ['dycore_5fhoriz_5fadv_5ftype_4256',['dycore_horiz_adv_type',['../structAdvChoice.html#a81152997920406ea2aa97cbb5af2d9b6',1,'AdvChoice']]], - ['dycore_5fhoriz_5fupw_5ffrac_4257',['dycore_horiz_upw_frac',['../structAdvChoice.html#abde30f55d66f1716d7459a09001d3f43',1,'AdvChoice']]], - ['dycore_5fvert_5fadv_5ftype_4258',['dycore_vert_adv_type',['../structAdvChoice.html#a2dd44749e2d4f224ae1da4f9e53e257a',1,'AdvChoice']]], - ['dycore_5fvert_5fupw_5ffrac_4259',['dycore_vert_upw_frac',['../structAdvChoice.html#a48a2a3eb5899f899e202df67fd8bb2e0',1,'AdvChoice']]], - ['dynamicviscosity_4260',['dynamicViscosity',['../structDiffChoice.html#abaff02e5f99628d6a91b546f3ad1fae6',1,'DiffChoice']]], - ['dz0_4261',['dz0',['../structSolverChoice.html#a0a4f1c55ea1e3a7d50f926ee0d20a21c',1,'SolverChoice']]], - ['dz_5fmin_4262',['dz_min',['../classERF.html#a15db5266359edba700f523f16da303a7',1,'ERF']]] + ['d_5fhavg_5fdensity_4198',['d_havg_density',['../classERF.html#a84cf7616e7b3928f08f4bd56112db01e',1,'ERF']]], + ['d_5fhavg_5fpressure_4199',['d_havg_pressure',['../classERF.html#a9a4f076c56f31fbb5e68c09706605a05',1,'ERF']]], + ['d_5fhavg_5fqc_4200',['d_havg_qc',['../classERF.html#a8199cc1ec38b9dfd47262ccc7df6a941',1,'ERF']]], + ['d_5fhavg_5fqv_4201',['d_havg_qv',['../classERF.html#a2b0085123e02051ac4c2a72e9972e6ee',1,'ERF']]], + ['d_5fhavg_5ftemperature_4202',['d_havg_temperature',['../classERF.html#a20350959b7b3e252ee3a802e7998ca8d',1,'ERF']]], + ['d_5frayleigh_5fptrs_4203',['d_rayleigh_ptrs',['../classERF.html#ad598bde8e728479faaa7c2820096b47a',1,'ERF']]], + ['d_5frhoqt_5fsrc_4204',['d_rhoqt_src',['../classERF.html#a838687881ef3626f932d0e95ceff0e53',1,'ERF']]], + ['d_5frhotheta_5fsrc_4205',['d_rhotheta_src',['../classERF.html#a0c1fdcfbc9cbd6cb13e41d1170b161f8',1,'ERF']]], + ['d_5fsponge_5fptrs_4206',['d_sponge_ptrs',['../classERF.html#a3b9bcb54c278dfec6027e9727cc01bc5',1,'ERF']]], + ['d_5fu_5fgeos_4207',['d_u_geos',['../classERF.html#ac020980af9dbf46be43dd9f7127c06da',1,'ERF']]], + ['d_5fv_5fgeos_4208',['d_v_geos',['../classERF.html#a7d245afb7b3236b5967902f50bf9000b',1,'ERF']]], + ['d_5fw_5fsubsid_4209',['d_w_subsid',['../classERF.html#ac94ddee2f501dbcea2a516284b7119b5',1,'ERF']]], + ['data_4210',['data',['../structNDArray.html#a9d3679c95b5bf1813a7edaedf221837e',1,'NDArray']]], + ['data_5fsampler_4211',['data_sampler',['../classERF.html#a83ad7f8f4cf9920a6798f3b931355a2f',1,'ERF']]], + ['datalog_4212',['datalog',['../classERF.html#a1cade630b005dbcc0f644987ef3db287',1,'ERF']]], + ['datalogname_4213',['datalogname',['../classERF.html#a9248a4eb025c2647e003f838cba52a21',1,'ERF']]], + ['dei_4214',['dei',['../classRadiation.html#a5d6b802fde5710034668dec77e7a39a8',1,'Radiation']]], + ['density_5faer_4215',['density_aer',['../structPhysProp_1_1physprop__t.html#a8df74558339352f0e8c0031fc3160a09',1,'PhysProp::physprop_t']]], + ['depth_4216',['depth',['../classABLMost.html#a38ed37dd984fcc7be3b5ae04b7272459',1,'ABLMost']]], + ['derived_5fnames_4217',['derived_names',['../classERF.html#a9fc0f6e6ca35036d2e3a36dd42e66435',1,'ERF']]], + ['des_4218',['des',['../classRadiation.html#a6fb15791b58bf08aea781bc906b3c431',1,'Radiation']]], + ['destag_5fprofiles_4219',['destag_profiles',['../classERF.html#a65f19c55c8d3669445866a1c3bbb628d',1,'ERF']]], + ['detj_5fcc_4220',['detJ_cc',['../classERF.html#a30f8b851ed29d38695d44cff257f14e6',1,'ERF']]], + ['detj_5fcc_5fnew_4221',['detJ_cc_new',['../classERF.html#ae39bf64c5306b1dd939d82d9df728daa',1,'ERF']]], + ['detj_5fcc_5fsrc_4222',['detJ_cc_src',['../classERF.html#a9a411e0ea9d9bdbfab957c8081229091',1,'ERF']]], + ['dgnum_4223',['dgnum',['../structPhysProp_1_1physprop__t.html#a66b63e7d4250ce345343af372d529193',1,'PhysProp::physprop_t']]], + ['dgnumdry_5fm_4224',['dgnumdry_m',['../classMam4__aer.html#a12eaca69207827a3988597c3e2f2bb0e',1,'Mam4_aer']]], + ['dgnumhi_4225',['dgnumhi',['../structPhysProp_1_1physprop__t.html#a0a6b0b2e1d1906ac628da5c03c54dd2c',1,'PhysProp::physprop_t']]], + ['dgnumlo_4226',['dgnumlo',['../structPhysProp_1_1physprop__t.html#a2e423bf4c825875ea8d9a72ead6c3b20',1,'PhysProp::physprop_t']]], + ['dgnumwet_5fm_4227',['dgnumwet_m',['../classMam4__aer.html#a69a1949364f03af84c9e4c12973a5223',1,'Mam4_aer']]], + ['diffchoice_4228',['diffChoice',['../structSolverChoice.html#a396122e87a3d15c4ec8666d7dd18c095',1,'SolverChoice']]], + ['diffelq_4229',['diffelq',['../ERF__Constants_8H.html#a4e1c44dade7fcd7648d3e87ba5bba4c1',1,'ERF_Constants.H']]], + ['diffuse_5fke_5f3d_4230',['diffuse_KE_3D',['../structTurbChoice.html#a5864f0fe05bcbd45554301ade763d5ca',1,'TurbChoice']]], + ['diffuse_5fmoistvars_4231',['diffuse_moistvars',['../structMYNNLevel25.html#af677ab24bae6b1f78751489a8df5b1be',1,'MYNNLevel25']]], + ['dimid_4232',['dimid',['../structncutils_1_1NCDim.html#a1c5560c95be35dbcedaf1390972175f8',1,'ncutils::NCDim']]], + ['disk_5fcell_5fcount_4233',['disk_cell_count',['../classSimpleAD.html#a4a8f7fe612cdc61b58b386b0b3f61da7',1,'SimpleAD::disk_cell_count()'],['../classGeneralAD.html#a4a6d71d880f30aeb756885ac4e8d2b5b',1,'GeneralAD::disk_cell_count()']]], + ['dispersion_5faer_4234',['dispersion_aer',['../structPhysProp_1_1physprop__t.html#adf99574ee8aea212bec426dd42a4a9e4',1,'PhysProp::physprop_t']]], + ['do_5faerosol_5frad_4235',['do_aerosol_rad',['../classRadiation.html#a6a43bd5c228b629042b73e06f8fbcf87',1,'Radiation']]], + ['do_5fcloud_4236',['do_cloud',['../structSolverChoice.html#af352bb75ceaeae4ac534d3378fbf393a',1,'SolverChoice']]], + ['do_5fforest_4237',['do_forest',['../structSolverChoice.html#a6937b2ada31923a31997430715a43bef',1,'SolverChoice']]], + ['do_5flong_5fwave_5frad_4238',['do_long_wave_rad',['../classRadiation.html#afb905ef9ee37afaa882346803dae94c9',1,'Radiation']]], + ['do_5fprecip_4239',['do_precip',['../structSolverChoice.html#a766e5884354ed6483704f8257036ee75',1,'SolverChoice']]], + ['do_5fshort_5fwave_5frad_4240',['do_short_wave_rad',['../classRadiation.html#ad1177f9f1504cb562fb70b7f454387fc',1,'Radiation']]], + ['do_5fsnow_5foptics_4241',['do_snow_optics',['../classRadiation.html#a8c411f9344910aab58b29c4a3bcab401',1,'Radiation']]], + ['docloud_4242',['docloud',['../classSAM.html#a77c335e68b7ad8e6069d1318ea673a16',1,'SAM::docloud()'],['../classKessler.html#a7335cec5eabf2a33c8cd274b09863c28',1,'Kessler::docloud()']]], + ['dohirs_4243',['dohirs',['../classRadiation.html#aface9778f843db231e142379cffb709c',1,'Radiation']]], + ['domain_5fbc_5ftype_4244',['domain_bc_type',['../classERF.html#ae5968f1bed602fa87cdd5cb7905b7e5e',1,'ERF']]], + ['domain_5fbcs_5ftype_4245',['domain_bcs_type',['../classERF.html#a574521986a6e403159f83c8b8123ba90',1,'ERF']]], + ['domain_5fbcs_5ftype_5fd_4246',['domain_bcs_type_d',['../classERF.html#a8a99e22b1111c803e31b4afd5fcdea60',1,'ERF']]], + ['doprecip_4247',['doprecip',['../classKessler.html#a2d8ae6f03c19821ef6279dcadd5cb36e',1,'Kessler::doprecip()'],['../classSAM.html#a54766f324324d579d2591a0bdc60e359',1,'SAM::doprecip()']]], + ['dryrad_5faer_4248',['dryrad_aer',['../structPhysProp_1_1physprop__t.html#a55622eb338277f3ce9c7d5b774a9c2c5',1,'PhysProp::physprop_t']]], + ['dryscal_5fhoriz_5fadv_5ftype_4249',['dryscal_horiz_adv_type',['../structAdvChoice.html#a74a383e01c24980b72b920054ee5c1ab',1,'AdvChoice']]], + ['dryscal_5fhoriz_5fupw_5ffrac_4250',['dryscal_horiz_upw_frac',['../structAdvChoice.html#afb0ff64219a9e79d077b1a06da7817ae',1,'AdvChoice']]], + ['dryscal_5fvert_5fadv_5ftype_4251',['dryscal_vert_adv_type',['../structAdvChoice.html#add9ddd5d61fc695bd2df0e3818767b78',1,'AdvChoice']]], + ['dryscal_5fvert_5fupw_5ffrac_4252',['dryscal_vert_upw_frac',['../structAdvChoice.html#a1fc6421356a6c2ecfea0a46b3928d9cf',1,'AdvChoice']]], + ['dt_4253',['dt',['../classKessler.html#a86cf1c45a302d0e4a860860dab3dbe65',1,'Kessler::dt()'],['../classSAM.html#af9ffbd0c3f98c0c5d0a7ac4b1fb3dec9',1,'SAM::dt()'],['../classRadiation.html#a98ebcca0b6a735bb910aedef14ce9a37',1,'Radiation::dt()'],['../classERF.html#ad34bae243fdb6c3029f5abe4fb4bca2d',1,'ERF::dt()']]], + ['dt_5favg_4254',['dt_avg',['../classRadiation.html#af65d65db4b84a4afd921db0f10ffa31e',1,'Radiation']]], + ['dt_5fmri_5fratio_4255',['dt_mri_ratio',['../classERF.html#a3cf7cb2e51eb7b69cb4079ffc6722459',1,'ERF']]], + ['dtos_4256',['dtos',['../classMultiBlockContainer.html#a537ef22d2809607f9d353b912eedffcf',1,'MultiBlockContainer']]], + ['dycore_5fhoriz_5fadv_5ftype_4257',['dycore_horiz_adv_type',['../structAdvChoice.html#a81152997920406ea2aa97cbb5af2d9b6',1,'AdvChoice']]], + ['dycore_5fhoriz_5fupw_5ffrac_4258',['dycore_horiz_upw_frac',['../structAdvChoice.html#abde30f55d66f1716d7459a09001d3f43',1,'AdvChoice']]], + ['dycore_5fvert_5fadv_5ftype_4259',['dycore_vert_adv_type',['../structAdvChoice.html#a2dd44749e2d4f224ae1da4f9e53e257a',1,'AdvChoice']]], + ['dycore_5fvert_5fupw_5ffrac_4260',['dycore_vert_upw_frac',['../structAdvChoice.html#a48a2a3eb5899f899e202df67fd8bb2e0',1,'AdvChoice']]], + ['dynamicviscosity_4261',['dynamicViscosity',['../structDiffChoice.html#abaff02e5f99628d6a91b546f3ad1fae6',1,'DiffChoice']]], + ['dz0_4262',['dz0',['../structSolverChoice.html#a0a4f1c55ea1e3a7d50f926ee0d20a21c',1,'SolverChoice']]], + ['dz_5fmin_4263',['dz_min',['../classERF.html#a15db5266359edba700f523f16da303a7',1,'ERF']]] ]; diff --git a/search/variables_4.js b/search/variables_4.js index d52ab3077..fed107b47 100644 --- a/search/variables_4.js +++ b/search/variables_4.js @@ -1,26 +1,26 @@ var searchData= [ - ['eccen_4263',['eccen',['../classRadiation.html#a62efb2cdbddfca4321d9e866b6a79b11',1,'Radiation']]], - ['eddydiffs_5flev_4264',['eddyDiffs_lev',['../classERF.html#a327d704704abd516be19339cb2d226f9',1,'ERF']]], - ['egccoef_4265',['egccoef',['../ERF__Constants_8H.html#a65f78c57eaba4f35dc9183cd2f3e66e3',1,'ERF_Constants.H']]], - ['egicoef_4266',['egicoef',['../ERF__Constants_8H.html#a6b49f5e9d61881c5a59656453a6c025f',1,'ERF_Constants.H']]], - ['empty_4267',['empty',['../classUnionListIF.html#ada33e955e690c4535d78e6db572707d7',1,'UnionListIF']]], - ['eps_4268',['eps',['../structsurface__flux__wave__coupled.html#aee14d25dbf38dc291b9c4900d737e121',1,'surface_flux_wave_coupled::eps()'],['../structWENO__Z7.html#a5f83e00b8908c86f74e2a4c5ea373090',1,'WENO_Z7::eps()'],['../structWENO__Z5.html#ab4cfe75de30306d2462c33b4797fa570',1,'WENO_Z5::eps()'],['../structWENO__MZQ3.html#ad02f88cd05b6e31261fb3380887a2099',1,'WENO_MZQ3::eps()'],['../structWENO__Z3.html#a04370c4cf4d845f967ec610ff66f5d2b',1,'WENO_Z3::eps()'],['../structWENO7.html#a51bb3b4aafa54396917073e91d53140b',1,'WENO7::eps()'],['../structWENO5.html#a0eb3eb8be72f02731cd24f03d5c2b9ca',1,'WENO5::eps()'],['../structWENO3.html#a5ea04e699e55b168c29b38e9e453660f',1,'WENO3::eps()'],['../structMYNNLevel2.html#a2d226d66711e6659f0428210f8283f9d',1,'MYNNLevel2::eps()'],['../structrotate__flux.html#ae2e4dd388a9a609acf27d90fea305e11',1,'rotate_flux::eps()'],['../structcustom__flux.html#ae0e2af01151c51f4c335f053a8bb8f17',1,'custom_flux::eps()'],['../structmoeng__flux.html#a3d06eff1aa7d6c357e1245eb8f5b96f7',1,'moeng_flux::eps()'],['../structsurface__temp__wave__coupled.html#a2a663fad6d183ced2edb1dc99fe104bf',1,'surface_temp_wave_coupled::eps()'],['../structadiabatic__wave__coupled.html#a3f907fc7025d3d3f7e44c222e12b4df1',1,'adiabatic_wave_coupled::eps()']]], - ['epsilo_4269',['epsilo',['../ERF__Constants_8H.html#a630c4c3e10ef44d50ca4c6939a59b6a3',1,'ERF_Constants.H']]], - ['erccoef_4270',['erccoef',['../ERF__Constants_8H.html#af90fa8b6a26f98067ce125597f35d983',1,'ERF_Constants.H']]], - ['erf1_4271',['erf1',['../classMultiBlockContainer.html#a1ee9fa78e0ade97253f818516df5d83d',1,'MultiBlockContainer']]], - ['erf2_4272',['erf2',['../classMultiBlockContainer.html#ac65a89fe2e12cff2c871d641f965e322',1,'MultiBlockContainer']]], - ['esccoef_4273',['esccoef',['../ERF__Constants_8H.html#ac16a7511bec41b7d5a558b5841e8f3b1',1,'ERF_Constants.H']]], - ['esicoef_4274',['esicoef',['../ERF__Constants_8H.html#a414035f12e97c86f4e40cb6763c29ddb',1,'ERF_Constants.H']]], - ['eta_5feps_4275',['eta_eps',['../structcustom__flux.html#aa04871c3e8d2e06f502cde2404c90be4',1,'custom_flux::eta_eps()'],['../structdonelan__flux.html#aac38c6d44658be0daa32dc8bd0b29adb',1,'donelan_flux::eta_eps()'],['../structmoeng__flux.html#a67cae16850c061bb189a783159ac6406',1,'moeng_flux::eta_eps()']]], - ['evapg1_4276',['evapg1',['../classSAM.html#a2e241fff555231e1cc87947a624bb5d6',1,'SAM']]], - ['evapg2_4277',['evapg2',['../classSAM.html#a3117e23160d027ccb4dacf744a477a40',1,'SAM']]], - ['evapr1_4278',['evapr1',['../classSAM.html#a8350a31a9f29bedee48b24bb43d5b0fc',1,'SAM']]], - ['evapr2_4279',['evapr2',['../classSAM.html#a0edeaaddf7573079fdc9af1484ce5582',1,'SAM']]], - ['evaps1_4280',['evaps1',['../classSAM.html#a56c463cbd313722b567dd88e7ac6fccd',1,'SAM']]], - ['evaps2_4281',['evaps2',['../classSAM.html#a8f9e9699afd94d393be846cd26933fd0',1,'SAM']]], - ['ext_5fcmip6_5fsw_4282',['ext_cmip6_sw',['../classAerRadProps.html#acf87aa0fdbfa3b73924a1f7c56088e55',1,'AerRadProps']]], - ['ext_5fsw_5fice_4283',['ext_sw_ice',['../classCloudRadProps.html#a4664e7123fdc065b7ff40e716453b050',1,'CloudRadProps']]], - ['ext_5fsw_5fliq_4284',['ext_sw_liq',['../classCloudRadProps.html#a98a74e616e9952f22102a6d3c3f4af51',1,'CloudRadProps']]], - ['extpsw_4285',['extpsw',['../structPhysProp_1_1physprop__t.html#aa86746c3ce43b7a278d78276bbe0d153',1,'PhysProp::physprop_t']]] + ['eccen_4264',['eccen',['../classRadiation.html#a62efb2cdbddfca4321d9e866b6a79b11',1,'Radiation']]], + ['eddydiffs_5flev_4265',['eddyDiffs_lev',['../classERF.html#a327d704704abd516be19339cb2d226f9',1,'ERF']]], + ['egccoef_4266',['egccoef',['../ERF__Constants_8H.html#a65f78c57eaba4f35dc9183cd2f3e66e3',1,'ERF_Constants.H']]], + ['egicoef_4267',['egicoef',['../ERF__Constants_8H.html#a6b49f5e9d61881c5a59656453a6c025f',1,'ERF_Constants.H']]], + ['empty_4268',['empty',['../classUnionListIF.html#ada33e955e690c4535d78e6db572707d7',1,'UnionListIF']]], + ['eps_4269',['eps',['../structsurface__flux__wave__coupled.html#aee14d25dbf38dc291b9c4900d737e121',1,'surface_flux_wave_coupled::eps()'],['../structWENO__Z7.html#a5f83e00b8908c86f74e2a4c5ea373090',1,'WENO_Z7::eps()'],['../structWENO__Z5.html#ab4cfe75de30306d2462c33b4797fa570',1,'WENO_Z5::eps()'],['../structWENO__MZQ3.html#ad02f88cd05b6e31261fb3380887a2099',1,'WENO_MZQ3::eps()'],['../structWENO__Z3.html#a04370c4cf4d845f967ec610ff66f5d2b',1,'WENO_Z3::eps()'],['../structWENO7.html#a51bb3b4aafa54396917073e91d53140b',1,'WENO7::eps()'],['../structWENO5.html#a0eb3eb8be72f02731cd24f03d5c2b9ca',1,'WENO5::eps()'],['../structWENO3.html#a5ea04e699e55b168c29b38e9e453660f',1,'WENO3::eps()'],['../structMYNNLevel2.html#a2d226d66711e6659f0428210f8283f9d',1,'MYNNLevel2::eps()'],['../structrotate__flux.html#ae2e4dd388a9a609acf27d90fea305e11',1,'rotate_flux::eps()'],['../structcustom__flux.html#ae0e2af01151c51f4c335f053a8bb8f17',1,'custom_flux::eps()'],['../structmoeng__flux.html#a3d06eff1aa7d6c357e1245eb8f5b96f7',1,'moeng_flux::eps()'],['../structsurface__temp__wave__coupled.html#a2a663fad6d183ced2edb1dc99fe104bf',1,'surface_temp_wave_coupled::eps()'],['../structadiabatic__wave__coupled.html#a3f907fc7025d3d3f7e44c222e12b4df1',1,'adiabatic_wave_coupled::eps()']]], + ['epsilo_4270',['epsilo',['../ERF__Constants_8H.html#a630c4c3e10ef44d50ca4c6939a59b6a3',1,'ERF_Constants.H']]], + ['erccoef_4271',['erccoef',['../ERF__Constants_8H.html#af90fa8b6a26f98067ce125597f35d983',1,'ERF_Constants.H']]], + ['erf1_4272',['erf1',['../classMultiBlockContainer.html#a1ee9fa78e0ade97253f818516df5d83d',1,'MultiBlockContainer']]], + ['erf2_4273',['erf2',['../classMultiBlockContainer.html#ac65a89fe2e12cff2c871d641f965e322',1,'MultiBlockContainer']]], + ['esccoef_4274',['esccoef',['../ERF__Constants_8H.html#ac16a7511bec41b7d5a558b5841e8f3b1',1,'ERF_Constants.H']]], + ['esicoef_4275',['esicoef',['../ERF__Constants_8H.html#a414035f12e97c86f4e40cb6763c29ddb',1,'ERF_Constants.H']]], + ['eta_5feps_4276',['eta_eps',['../structcustom__flux.html#aa04871c3e8d2e06f502cde2404c90be4',1,'custom_flux::eta_eps()'],['../structdonelan__flux.html#aac38c6d44658be0daa32dc8bd0b29adb',1,'donelan_flux::eta_eps()'],['../structmoeng__flux.html#a67cae16850c061bb189a783159ac6406',1,'moeng_flux::eta_eps()']]], + ['evapg1_4277',['evapg1',['../classSAM.html#a2e241fff555231e1cc87947a624bb5d6',1,'SAM']]], + ['evapg2_4278',['evapg2',['../classSAM.html#a3117e23160d027ccb4dacf744a477a40',1,'SAM']]], + ['evapr1_4279',['evapr1',['../classSAM.html#a8350a31a9f29bedee48b24bb43d5b0fc',1,'SAM']]], + ['evapr2_4280',['evapr2',['../classSAM.html#a0edeaaddf7573079fdc9af1484ce5582',1,'SAM']]], + ['evaps1_4281',['evaps1',['../classSAM.html#a56c463cbd313722b567dd88e7ac6fccd',1,'SAM']]], + ['evaps2_4282',['evaps2',['../classSAM.html#a8f9e9699afd94d393be846cd26933fd0',1,'SAM']]], + ['ext_5fcmip6_5fsw_4283',['ext_cmip6_sw',['../classAerRadProps.html#acf87aa0fdbfa3b73924a1f7c56088e55',1,'AerRadProps']]], + ['ext_5fsw_5fice_4284',['ext_sw_ice',['../classCloudRadProps.html#a4664e7123fdc065b7ff40e716453b050',1,'CloudRadProps']]], + ['ext_5fsw_5fliq_4285',['ext_sw_liq',['../classCloudRadProps.html#a98a74e616e9952f22102a6d3c3f4af51',1,'CloudRadProps']]], + ['extpsw_4286',['extpsw',['../structPhysProp_1_1physprop__t.html#aa86746c3ce43b7a278d78276bbe0d153',1,'PhysProp::physprop_t']]] ]; diff --git a/search/variables_5.js b/search/variables_5.js index 4b811c85a..ca43e2fef 100644 --- a/search/variables_5.js +++ b/search/variables_5.js @@ -1,29 +1,29 @@ var searchData= [ - ['f1_4286',['F1',['../structMYNNLevel2.html#a8be91cd073c493f390653b79f0a8706c',1,'MYNNLevel2']]], - ['f1_5factive_4287',['f1_active',['../classUnionCIF.html#a2efa596306e1f101538ea7addef01c50',1,'UnionCIF::f1_active()'],['../classIntersectionCIF.html#addd5d1b2d4f051377f8b3b2b2fcc395e',1,'IntersectionCIF::f1_active()']]], - ['f2_4288',['F2',['../structMYNNLevel2.html#a195f36a73787dea436d798f20d28ebb3',1,'MYNNLevel2']]], - ['f2_5factive_4289',['f2_active',['../classUnionCIF.html#a7a543347d220b1e1345c2af564cc0bd5',1,'UnionCIF::f2_active()'],['../classIntersectionCIF.html#a92f13c010706b380de68596e6ab778ec',1,'IntersectionCIF::f2_active()']]], - ['f_5fslow_4290',['F_slow',['../classMRISplitIntegrator.html#a088e107111ca012e026908b0c0b3cef7',1,'MRISplitIntegrator']]], - ['fast_5frhs_4291',['fast_rhs',['../classMRISplitIntegrator.html#a8f0b8ba2224608975dd1cfae5d811ffb',1,'MRISplitIntegrator']]], - ['fast_5frhs_5ffun_4292',['fast_rhs_fun',['../ERF__TI__substep__fun_8H.html#ac6afbd55bf5b7264098d44d9b8928f57',1,'ERF_TI_substep_fun.H']]], - ['fine_5fmask_4293',['fine_mask',['../classERF.html#a83c244120a15f0d9b9bca54e93976428',1,'ERF']]], - ['finished_5fwave_4294',['finished_wave',['../classERF.html#af282e3bdfdad38a0b898ed567ea446ee',1,'ERF']]], - ['fixed_5fdt_4295',['fixed_dt',['../classERF.html#a393b540493795b8c6ee0f64634b8b815',1,'ERF']]], - ['fixed_5ffast_5fdt_4296',['fixed_fast_dt',['../classERF.html#a4f3f43c6304a0a3ae78c42d54c05ee26',1,'ERF']]], - ['fixed_5fmri_5fdt_5fratio_4297',['fixed_mri_dt_ratio',['../classERF.html#ad2e1a979c0ad68e87eaee349beb7e9fd',1,'ERF']]], - ['fixed_5ftotal_5fsolar_5firradiance_4298',['fixed_total_solar_irradiance',['../classRadiation.html#a0cdd06e704e50fd3f6f18781f7d4ec38',1,'Radiation']]], - ['flns_4299',['flns',['../classRadiation.html#a6a65d086e75212c5d372c2fbdb694843',1,'Radiation']]], - ['flnt_4300',['flnt',['../classRadiation.html#aff08760a7c9aaa416621ac1c5dd9ac45',1,'Radiation']]], - ['flux_5ftype_4301',['flux_type',['../classABLMost.html#ad837d92390012682056ffac0b5f9a8f9',1,'ABLMost']]], - ['force_5fstage1_5fsingle_5fsubstep_4302',['force_stage1_single_substep',['../structSolverChoice.html#a3f8ae511632557066f6662eec79591e1',1,'SolverChoice::force_stage1_single_substep()'],['../classMRISplitIntegrator.html#a5b2e5780482fdbeab2ce9c053557cbf8',1,'MRISplitIntegrator::force_stage1_single_substep()']]], - ['fpr_5fc_4303',['FPr_c',['../classERF.html#a34160ca20fb400ee285664117cb80512',1,'ERF']]], - ['fpr_5fu_4304',['FPr_u',['../classERF.html#a0ef3455d5b4fc9a178e023b233d389a4',1,'ERF']]], - ['fpr_5fv_4305',['FPr_v',['../classERF.html#a1dc7086aec533a042e6033706845b0c3',1,'ERF']]], - ['fpr_5fw_4306',['FPr_w',['../classERF.html#ac9a11403c2238d0d1e7b65b2d100dbaf',1,'ERF']]], - ['freestream_5fphi_4307',['freestream_phi',['../classGeneralAD.html#acd1962338f30947c30f916121b8ca0e0',1,'GeneralAD::freestream_phi()'],['../classSimpleAD.html#ace7e3b24d201e3840260d1cdbb6ef3a5',1,'SimpleAD::freestream_phi()']]], - ['freestream_5fvelocity_4308',['freestream_velocity',['../classGeneralAD.html#a2232a2f38c6bfd8102e38e383b10ea0b',1,'GeneralAD::freestream_velocity()'],['../classSimpleAD.html#a67d11cb5167af18f4beb8fdf4fe917ad',1,'SimpleAD::freestream_velocity()']]], - ['fsds_4309',['fsds',['../classRadiation.html#aed316beadd323289608d8f856ca4ce0c',1,'Radiation']]], - ['fsns_4310',['fsns',['../classRadiation.html#a51f5029d29ffc61296dc89ac879c3f55',1,'Radiation']]], - ['fsnt_4311',['fsnt',['../classRadiation.html#a20f4c5b60d245576263ba50c105dc610',1,'Radiation']]] + ['f1_4287',['F1',['../structMYNNLevel2.html#a8be91cd073c493f390653b79f0a8706c',1,'MYNNLevel2']]], + ['f1_5factive_4288',['f1_active',['../classUnionCIF.html#a2efa596306e1f101538ea7addef01c50',1,'UnionCIF::f1_active()'],['../classIntersectionCIF.html#addd5d1b2d4f051377f8b3b2b2fcc395e',1,'IntersectionCIF::f1_active()']]], + ['f2_4289',['F2',['../structMYNNLevel2.html#a195f36a73787dea436d798f20d28ebb3',1,'MYNNLevel2']]], + ['f2_5factive_4290',['f2_active',['../classUnionCIF.html#a7a543347d220b1e1345c2af564cc0bd5',1,'UnionCIF::f2_active()'],['../classIntersectionCIF.html#a92f13c010706b380de68596e6ab778ec',1,'IntersectionCIF::f2_active()']]], + ['f_5fslow_4291',['F_slow',['../classMRISplitIntegrator.html#a088e107111ca012e026908b0c0b3cef7',1,'MRISplitIntegrator']]], + ['fast_5frhs_4292',['fast_rhs',['../classMRISplitIntegrator.html#a8f0b8ba2224608975dd1cfae5d811ffb',1,'MRISplitIntegrator']]], + ['fast_5frhs_5ffun_4293',['fast_rhs_fun',['../ERF__TI__substep__fun_8H.html#ac6afbd55bf5b7264098d44d9b8928f57',1,'ERF_TI_substep_fun.H']]], + ['fine_5fmask_4294',['fine_mask',['../classERF.html#a83c244120a15f0d9b9bca54e93976428',1,'ERF']]], + ['finished_5fwave_4295',['finished_wave',['../classERF.html#af282e3bdfdad38a0b898ed567ea446ee',1,'ERF']]], + ['fixed_5fdt_4296',['fixed_dt',['../classERF.html#a393b540493795b8c6ee0f64634b8b815',1,'ERF']]], + ['fixed_5ffast_5fdt_4297',['fixed_fast_dt',['../classERF.html#a4f3f43c6304a0a3ae78c42d54c05ee26',1,'ERF']]], + ['fixed_5fmri_5fdt_5fratio_4298',['fixed_mri_dt_ratio',['../classERF.html#ad2e1a979c0ad68e87eaee349beb7e9fd',1,'ERF']]], + ['fixed_5ftotal_5fsolar_5firradiance_4299',['fixed_total_solar_irradiance',['../classRadiation.html#a0cdd06e704e50fd3f6f18781f7d4ec38',1,'Radiation']]], + ['flns_4300',['flns',['../classRadiation.html#a6a65d086e75212c5d372c2fbdb694843',1,'Radiation']]], + ['flnt_4301',['flnt',['../classRadiation.html#aff08760a7c9aaa416621ac1c5dd9ac45',1,'Radiation']]], + ['flux_5ftype_4302',['flux_type',['../classABLMost.html#ad837d92390012682056ffac0b5f9a8f9',1,'ABLMost']]], + ['force_5fstage1_5fsingle_5fsubstep_4303',['force_stage1_single_substep',['../structSolverChoice.html#a3f8ae511632557066f6662eec79591e1',1,'SolverChoice::force_stage1_single_substep()'],['../classMRISplitIntegrator.html#a5b2e5780482fdbeab2ce9c053557cbf8',1,'MRISplitIntegrator::force_stage1_single_substep()']]], + ['fpr_5fc_4304',['FPr_c',['../classERF.html#a34160ca20fb400ee285664117cb80512',1,'ERF']]], + ['fpr_5fu_4305',['FPr_u',['../classERF.html#a0ef3455d5b4fc9a178e023b233d389a4',1,'ERF']]], + ['fpr_5fv_4306',['FPr_v',['../classERF.html#a1dc7086aec533a042e6033706845b0c3',1,'ERF']]], + ['fpr_5fw_4307',['FPr_w',['../classERF.html#ac9a11403c2238d0d1e7b65b2d100dbaf',1,'ERF']]], + ['freestream_5fphi_4308',['freestream_phi',['../classGeneralAD.html#acd1962338f30947c30f916121b8ca0e0',1,'GeneralAD::freestream_phi()'],['../classSimpleAD.html#ace7e3b24d201e3840260d1cdbb6ef3a5',1,'SimpleAD::freestream_phi()']]], + ['freestream_5fvelocity_4309',['freestream_velocity',['../classGeneralAD.html#a2232a2f38c6bfd8102e38e383b10ea0b',1,'GeneralAD::freestream_velocity()'],['../classSimpleAD.html#a67d11cb5167af18f4beb8fdf4fe917ad',1,'SimpleAD::freestream_velocity()']]], + ['fsds_4310',['fsds',['../classRadiation.html#aed316beadd323289608d8f856ca4ce0c',1,'Radiation']]], + ['fsns_4311',['fsns',['../classRadiation.html#a51f5029d29ffc61296dc89ac879c3f55',1,'Radiation']]], + ['fsnt_4312',['fsnt',['../classRadiation.html#a20f4c5b60d245576263ba50c105dc610',1,'Radiation']]] ]; diff --git a/search/variables_6.js b/search/variables_6.js index ad511c329..d00e45a33 100644 --- a/search/variables_6.js +++ b/search/variables_6.js @@ -1,31 +1,31 @@ var searchData= [ - ['g1_4312',['g1',['../structUPWIND3.html#a552999e68e80fcc77c602ba6818df36c',1,'UPWIND3::g1()'],['../structCENTERED2.html#ac8bd01fa97a379612f9457f992ea0782',1,'CENTERED2::g1()'],['../structWENO__Z7.html#a1592e565065b2ee52f9eaea298ecd7d5',1,'WENO_Z7::g1()'],['../structWENO__Z5.html#a920795e7ec43cf67356aaf8943fde456',1,'WENO_Z5::g1()'],['../structWENO__MZQ3.html#ad6c988889194e31f809b878a8b75390e',1,'WENO_MZQ3::g1()'],['../structWENO__Z3.html#acc8bf5960d4d7e92184f50911c0a4871',1,'WENO_Z3::g1()'],['../structWENO7.html#a847542024dd131b3455ac46c10969f57',1,'WENO7::g1()'],['../structWENO5.html#acedffa739822ba3574a74f6e3e6fe7a3',1,'WENO5::g1()'],['../structWENO3.html#a0c57f25abcb2dfd9ded1393d14d83568',1,'WENO3::g1()'],['../structCENTERED6.html#a6ffd5cab531876c4cb61598e3021e401',1,'CENTERED6::g1()'],['../structUPWIND5.html#a6020e2c4e4c44b76a2456ac7d2636007',1,'UPWIND5::g1()'],['../structCENTERED4.html#a2ae59ff4c8afe044deeb7a0b2569e34a',1,'CENTERED4::g1()']]], - ['g1_5f3_5f4_4313',['g1_3_4',['../structUPWINDALL.html#a5ec3aa15176050449c9d3024c0956e18',1,'UPWINDALL']]], - ['g1_5f5_5f6_4314',['g1_5_6',['../structUPWINDALL.html#a5d775740326820a724fb9b7b3cd24ebe',1,'UPWINDALL']]], - ['g2_4315',['g2',['../structCENTERED4.html#affba80f935c74285d66f7b86c7b859db',1,'CENTERED4::g2()'],['../structWENO__Z7.html#ab34dcf601a1679692239664751e35300',1,'WENO_Z7::g2()'],['../structWENO__Z5.html#af15d70f8e0513f44fb8fbab8c6b2020a',1,'WENO_Z5::g2()'],['../structWENO__MZQ3.html#a074870251e62994daec13919faff1576',1,'WENO_MZQ3::g2()'],['../structWENO__Z3.html#aa7976a5cf48e2e1cd1feecbaaa2218f9',1,'WENO_Z3::g2()'],['../structWENO7.html#a6fd89490f6c6a0c209bf34e7fee67d6b',1,'WENO7::g2()'],['../structWENO5.html#a4e300b80fa08a8a265ca1b3caa1fe009',1,'WENO5::g2()'],['../structWENO3.html#a7726242b3b06bf75643f8141d2ca78c8',1,'WENO3::g2()'],['../structCENTERED6.html#a32c3566f07adb5481cf94c54893a4206',1,'CENTERED6::g2()'],['../structUPWIND5.html#a37388f6bd9c8c8352387d531db414ef8',1,'UPWIND5::g2()'],['../structUPWIND3.html#a2a9ea3ce4eb7b5ba778a5a0a7a9a1922',1,'UPWIND3::g2()']]], - ['g2_5f3_5f4_4316',['g2_3_4',['../structUPWINDALL.html#a771832bce0ef052b6cfd438a385e2f1b',1,'UPWINDALL']]], - ['g2_5f5_5f6_4317',['g2_5_6',['../structUPWINDALL.html#ad549123976e1f955e7880cdee4871e36',1,'UPWINDALL']]], - ['g3_4318',['g3',['../structWENO5.html#acab4e47113826df9a8469d5647507385',1,'WENO5::g3()'],['../structWENO__Z7.html#adf413da0e2e51d403226859ed4463de9',1,'WENO_Z7::g3()'],['../structWENO__Z5.html#a2249935126e5768605c37eb9879765eb',1,'WENO_Z5::g3()'],['../structWENO__MZQ3.html#a97cfb78afa5c496fb3194141f284556c',1,'WENO_MZQ3::g3()'],['../structCENTERED6.html#addc1b756f97d4883080045a187e4d433',1,'CENTERED6::g3()'],['../structUPWIND5.html#aa8f3c0ecf7c76a2952679bd5c366b867',1,'UPWIND5::g3()'],['../structWENO7.html#a6da9486392dffd024784b275584612b1',1,'WENO7::g3()']]], - ['g3_5f5_5f6_4319',['g3_5_6',['../structUPWINDALL.html#a97d82cab1041d98ca70c6abc80286f6b',1,'UPWINDALL']]], - ['g4_4320',['g4',['../structWENO7.html#a5bc057e9b0e1f937a32733802539acff',1,'WENO7::g4()'],['../structWENO__Z7.html#aa24aee7fd8eb42f4f47aaf4844940bcb',1,'WENO_Z7::g4()']]], - ['g_5fd_5feff_4321',['g_d_eff',['../classCloudRadProps.html#ae567379b95d6a04ffa0680568d057905',1,'CloudRadProps']]], - ['g_5flambda_4322',['g_lambda',['../classCloudRadProps.html#a58599e69fa4af17830d28c4836e386db',1,'CloudRadProps']]], - ['g_5fmu_4323',['g_mu',['../classCloudRadProps.html#a24ce2602b37e1f5c1becf3ba0baee9d1',1,'CloudRadProps']]], - ['gam1_4324',['gam1',['../structMYNNLevel2.html#a603d910b71e93ffc0201ceb728d071fc',1,'MYNNLevel2']]], - ['gam2_4325',['gam2',['../structMYNNLevel2.html#afcbf928ab13e2f21e0491d99cb0d4daf',1,'MYNNLevel2']]], - ['gamaz_4326',['gamaz',['../classSAM.html#af47c1dda6481ee4549b60f2c03bdec18',1,'SAM']]], - ['gamma_4327',['Gamma',['../ERF__Constants_8H.html#afbb622bf3b404a3e7c77f3103b4d1231',1,'ERF_Constants.H']]], - ['gamma_5fh_4328',['gamma_h',['../structsimilarity__funs.html#a6c53efd885ed922115193bc9a36cb0e6',1,'similarity_funs']]], - ['gamma_5fm_4329',['gamma_m',['../structsimilarity__funs.html#ae78007489e8da2bf08c6f999381b9512',1,'similarity_funs']]], - ['gas_4330',['gas',['../structMamConstituents_1_1gaslist__t.html#aead26e24deeb3139776252191edc547b',1,'MamConstituents::gaslist_t']]], - ['gas_5fnames_4331',['gas_names',['../classOptics.html#aba268b2221309fdc437349b1427c5c6d',1,'Optics']]], - ['gas_5fvmr_4332',['gas_vmr',['../classRadiation.html#a8a48736892a600948ffa42c9d1b38700',1,'Radiation']]], - ['gaslist_4333',['gaslist',['../classMamConstituents.html#abd637475ed7adbc96892dc92b86d8f57',1,'MamConstituents::gaslist()'],['../classRadConstants.html#abaa201a157c245b8f20605e3d3c94938',1,'RadConstants::gaslist()']]], - ['gasnames_4334',['gasnames',['../classRadiation.html#a7d59cd8c1bc45b5c128726107a71b6bb',1,'Radiation']]], - ['geometric_5fradius_4335',['geometric_radius',['../classAerRadProps.html#a315308c2521564d2531785962659d292',1,'AerRadProps']]], - ['gpoint_5fbands_5flw_4336',['gpoint_bands_lw',['../classRadiation.html#af74c6b8838be2615c0dd0eefb5840d23',1,'Radiation']]], - ['gpoint_5fbands_5fsw_4337',['gpoint_bands_sw',['../classRadiation.html#a875467ba1e77ce2c0af0911c09422b42',1,'Radiation']]], - ['gravity_4338',['gravity',['../structmost__data.html#a7e3410c5a9916b84524bda4f324eec3b',1,'most_data::gravity()'],['../structSolverChoice.html#a47a54f2e44955202b5b437e4b1b4a61b',1,'SolverChoice::gravity()']]], - ['grid_5fstretching_5fratio_4339',['grid_stretching_ratio',['../structSolverChoice.html#a63b6fffe930de9eb25f92c2bafb00c00',1,'SolverChoice']]] + ['g1_4313',['g1',['../structUPWIND3.html#a552999e68e80fcc77c602ba6818df36c',1,'UPWIND3::g1()'],['../structCENTERED2.html#ac8bd01fa97a379612f9457f992ea0782',1,'CENTERED2::g1()'],['../structWENO__Z7.html#a1592e565065b2ee52f9eaea298ecd7d5',1,'WENO_Z7::g1()'],['../structWENO__Z5.html#a920795e7ec43cf67356aaf8943fde456',1,'WENO_Z5::g1()'],['../structWENO__MZQ3.html#ad6c988889194e31f809b878a8b75390e',1,'WENO_MZQ3::g1()'],['../structWENO__Z3.html#acc8bf5960d4d7e92184f50911c0a4871',1,'WENO_Z3::g1()'],['../structWENO7.html#a847542024dd131b3455ac46c10969f57',1,'WENO7::g1()'],['../structWENO5.html#acedffa739822ba3574a74f6e3e6fe7a3',1,'WENO5::g1()'],['../structWENO3.html#a0c57f25abcb2dfd9ded1393d14d83568',1,'WENO3::g1()'],['../structCENTERED6.html#a6ffd5cab531876c4cb61598e3021e401',1,'CENTERED6::g1()'],['../structUPWIND5.html#a6020e2c4e4c44b76a2456ac7d2636007',1,'UPWIND5::g1()'],['../structCENTERED4.html#a2ae59ff4c8afe044deeb7a0b2569e34a',1,'CENTERED4::g1()']]], + ['g1_5f3_5f4_4314',['g1_3_4',['../structUPWINDALL.html#a5ec3aa15176050449c9d3024c0956e18',1,'UPWINDALL']]], + ['g1_5f5_5f6_4315',['g1_5_6',['../structUPWINDALL.html#a5d775740326820a724fb9b7b3cd24ebe',1,'UPWINDALL']]], + ['g2_4316',['g2',['../structCENTERED4.html#affba80f935c74285d66f7b86c7b859db',1,'CENTERED4::g2()'],['../structWENO__Z7.html#ab34dcf601a1679692239664751e35300',1,'WENO_Z7::g2()'],['../structWENO__Z5.html#af15d70f8e0513f44fb8fbab8c6b2020a',1,'WENO_Z5::g2()'],['../structWENO__MZQ3.html#a074870251e62994daec13919faff1576',1,'WENO_MZQ3::g2()'],['../structWENO__Z3.html#aa7976a5cf48e2e1cd1feecbaaa2218f9',1,'WENO_Z3::g2()'],['../structWENO7.html#a6fd89490f6c6a0c209bf34e7fee67d6b',1,'WENO7::g2()'],['../structWENO5.html#a4e300b80fa08a8a265ca1b3caa1fe009',1,'WENO5::g2()'],['../structWENO3.html#a7726242b3b06bf75643f8141d2ca78c8',1,'WENO3::g2()'],['../structCENTERED6.html#a32c3566f07adb5481cf94c54893a4206',1,'CENTERED6::g2()'],['../structUPWIND5.html#a37388f6bd9c8c8352387d531db414ef8',1,'UPWIND5::g2()'],['../structUPWIND3.html#a2a9ea3ce4eb7b5ba778a5a0a7a9a1922',1,'UPWIND3::g2()']]], + ['g2_5f3_5f4_4317',['g2_3_4',['../structUPWINDALL.html#a771832bce0ef052b6cfd438a385e2f1b',1,'UPWINDALL']]], + ['g2_5f5_5f6_4318',['g2_5_6',['../structUPWINDALL.html#ad549123976e1f955e7880cdee4871e36',1,'UPWINDALL']]], + ['g3_4319',['g3',['../structWENO5.html#acab4e47113826df9a8469d5647507385',1,'WENO5::g3()'],['../structWENO__Z7.html#adf413da0e2e51d403226859ed4463de9',1,'WENO_Z7::g3()'],['../structWENO__Z5.html#a2249935126e5768605c37eb9879765eb',1,'WENO_Z5::g3()'],['../structWENO__MZQ3.html#a97cfb78afa5c496fb3194141f284556c',1,'WENO_MZQ3::g3()'],['../structCENTERED6.html#addc1b756f97d4883080045a187e4d433',1,'CENTERED6::g3()'],['../structUPWIND5.html#aa8f3c0ecf7c76a2952679bd5c366b867',1,'UPWIND5::g3()'],['../structWENO7.html#a6da9486392dffd024784b275584612b1',1,'WENO7::g3()']]], + ['g3_5f5_5f6_4320',['g3_5_6',['../structUPWINDALL.html#a97d82cab1041d98ca70c6abc80286f6b',1,'UPWINDALL']]], + ['g4_4321',['g4',['../structWENO7.html#a5bc057e9b0e1f937a32733802539acff',1,'WENO7::g4()'],['../structWENO__Z7.html#aa24aee7fd8eb42f4f47aaf4844940bcb',1,'WENO_Z7::g4()']]], + ['g_5fd_5feff_4322',['g_d_eff',['../classCloudRadProps.html#ae567379b95d6a04ffa0680568d057905',1,'CloudRadProps']]], + ['g_5flambda_4323',['g_lambda',['../classCloudRadProps.html#a58599e69fa4af17830d28c4836e386db',1,'CloudRadProps']]], + ['g_5fmu_4324',['g_mu',['../classCloudRadProps.html#a24ce2602b37e1f5c1becf3ba0baee9d1',1,'CloudRadProps']]], + ['gam1_4325',['gam1',['../structMYNNLevel2.html#a603d910b71e93ffc0201ceb728d071fc',1,'MYNNLevel2']]], + ['gam2_4326',['gam2',['../structMYNNLevel2.html#afcbf928ab13e2f21e0491d99cb0d4daf',1,'MYNNLevel2']]], + ['gamaz_4327',['gamaz',['../classSAM.html#af47c1dda6481ee4549b60f2c03bdec18',1,'SAM']]], + ['gamma_4328',['Gamma',['../ERF__Constants_8H.html#afbb622bf3b404a3e7c77f3103b4d1231',1,'ERF_Constants.H']]], + ['gamma_5fh_4329',['gamma_h',['../structsimilarity__funs.html#a6c53efd885ed922115193bc9a36cb0e6',1,'similarity_funs']]], + ['gamma_5fm_4330',['gamma_m',['../structsimilarity__funs.html#ae78007489e8da2bf08c6f999381b9512',1,'similarity_funs']]], + ['gas_4331',['gas',['../structMamConstituents_1_1gaslist__t.html#aead26e24deeb3139776252191edc547b',1,'MamConstituents::gaslist_t']]], + ['gas_5fnames_4332',['gas_names',['../classOptics.html#aba268b2221309fdc437349b1427c5c6d',1,'Optics']]], + ['gas_5fvmr_4333',['gas_vmr',['../classRadiation.html#a8a48736892a600948ffa42c9d1b38700',1,'Radiation']]], + ['gaslist_4334',['gaslist',['../classMamConstituents.html#abd637475ed7adbc96892dc92b86d8f57',1,'MamConstituents::gaslist()'],['../classRadConstants.html#abaa201a157c245b8f20605e3d3c94938',1,'RadConstants::gaslist()']]], + ['gasnames_4335',['gasnames',['../classRadiation.html#a7d59cd8c1bc45b5c128726107a71b6bb',1,'Radiation']]], + ['geometric_5fradius_4336',['geometric_radius',['../classAerRadProps.html#a315308c2521564d2531785962659d292',1,'AerRadProps']]], + ['gpoint_5fbands_5flw_4337',['gpoint_bands_lw',['../classRadiation.html#af74c6b8838be2615c0dd0eefb5840d23',1,'Radiation']]], + ['gpoint_5fbands_5fsw_4338',['gpoint_bands_sw',['../classRadiation.html#a875467ba1e77ce2c0af0911c09422b42',1,'Radiation']]], + ['gravity_4339',['gravity',['../structmost__data.html#a7e3410c5a9916b84524bda4f324eec3b',1,'most_data::gravity()'],['../structSolverChoice.html#a47a54f2e44955202b5b437e4b1b4a61b',1,'SolverChoice::gravity()']]], + ['grid_5fstretching_5fratio_4340',['grid_stretching_ratio',['../structSolverChoice.html#a63b6fffe930de9eb25f92c2bafb00c00',1,'SolverChoice']]] ]; diff --git a/search/variables_7.js b/search/variables_7.js index ceed65305..f96149f6c 100644 --- a/search/variables_7.js +++ b/search/variables_7.js @@ -1,23 +1,24 @@ var searchData= [ - ['h2otrip_4340',['h2otrip',['../ERF__Constants_8H.html#af5689377f29be012360a846bd447e278',1,'ERF_Constants.H']]], - ['h_5fhavg_5fdensity_4341',['h_havg_density',['../classERF.html#a4dd7c603e65d230105a4f1e0afb4cf8a',1,'ERF']]], - ['h_5fhavg_5fpressure_4342',['h_havg_pressure',['../classERF.html#a413293737b0021c97b50c62756561446',1,'ERF']]], - ['h_5fhavg_5fqc_4343',['h_havg_qc',['../classERF.html#a45233bcc95ac50c112b7146595164a8d',1,'ERF']]], - ['h_5fhavg_5fqv_4344',['h_havg_qv',['../classERF.html#ae8de26569516b41e5dc3cbb3419e891c',1,'ERF']]], - ['h_5fhavg_5ftemperature_4345',['h_havg_temperature',['../classERF.html#a9683c7b07c287e57856ee5a9c99917a1',1,'ERF']]], - ['h_5frayleigh_5fptrs_4346',['h_rayleigh_ptrs',['../classERF.html#ad9939824ea7b7d06ab252fed28d5a911',1,'ERF']]], - ['h_5frhoqt_5fsrc_4347',['h_rhoqt_src',['../classERF.html#a3c5eca26a28dda3a981b3581abadfca0',1,'ERF']]], - ['h_5frhotheta_5fsrc_4348',['h_rhotheta_src',['../classERF.html#a87aad7caaf3b575734994b47628a2faf',1,'ERF']]], - ['h_5fsponge_5fptrs_4349',['h_sponge_ptrs',['../classERF.html#a20a0f0d26791321eb4bbba6baee9f159',1,'ERF']]], - ['h_5fu_5fgeos_4350',['h_u_geos',['../classERF.html#a911c70f76cf62f205a1ce152ec4cdb54',1,'ERF']]], - ['h_5fv_5fgeos_4351',['h_v_geos',['../classERF.html#a825daede57fae86805edffd85d5d9dab',1,'ERF']]], - ['h_5fw_5fsubsid_4352',['h_w_subsid',['../classERF.html#a1a5d0d0b4e8c196f56dfab98f245aff5',1,'ERF']]], - ['has_5fqmoist_4353',['has_qmoist',['../classRadiation.html#ada93346f8e4bb7b21310c81007761e7e',1,'Radiation']]], - ['have_5fgeo_5fwind_5fprofile_4354',['have_geo_wind_profile',['../structSolverChoice.html#a65faffc1ea490b3934a9df768cfa26f1',1,'SolverChoice']]], - ['hub_5fheight_4355',['hub_height',['../classWindFarm.html#a6dfd6451498f50c17cb67c386d13ddfb',1,'WindFarm::hub_height()'],['../classEWP.html#a2ee471b0dcad3057297b809f4c5141ab',1,'EWP::hub_height()'],['../classFitch.html#ae3af34c6c07fd2d8b9b081b5c7ceb443',1,'Fitch::hub_height()'],['../classGeneralAD.html#ac82bba9c2818ca1e77adb01fdcdcaf66',1,'GeneralAD::hub_height()'],['../classSimpleAD.html#a4c17a08ad746b342bf62d7a1ad93781a',1,'SimpleAD::hub_height()']]], - ['huge_5freal_4356',['huge_real',['../classModalAeroWateruptake.html#a7b99efd9601245afe2274c268afb5305',1,'ModalAeroWateruptake']]], - ['hwave_4357',['Hwave',['../classERF.html#aef05cf88e9e9d2b56112336761493977',1,'ERF']]], - ['hwave_5fonegrid_4358',['Hwave_onegrid',['../classERF.html#a11f2d48d9af9b8f4574975cae06838f1',1,'ERF']]], - ['hygro_5faer_4359',['hygro_aer',['../structPhysProp_1_1physprop__t.html#af60d655c402eb7e47763c631b9432552',1,'PhysProp::physprop_t']]] + ['h2otrip_4341',['h2otrip',['../ERF__Constants_8H.html#af5689377f29be012360a846bd447e278',1,'ERF_Constants.H']]], + ['h_5fhavg_5fdensity_4342',['h_havg_density',['../classERF.html#a4dd7c603e65d230105a4f1e0afb4cf8a',1,'ERF']]], + ['h_5fhavg_5fpressure_4343',['h_havg_pressure',['../classERF.html#a413293737b0021c97b50c62756561446',1,'ERF']]], + ['h_5fhavg_5fqc_4344',['h_havg_qc',['../classERF.html#a45233bcc95ac50c112b7146595164a8d',1,'ERF']]], + ['h_5fhavg_5fqv_4345',['h_havg_qv',['../classERF.html#ae8de26569516b41e5dc3cbb3419e891c',1,'ERF']]], + ['h_5fhavg_5ftemperature_4346',['h_havg_temperature',['../classERF.html#a9683c7b07c287e57856ee5a9c99917a1',1,'ERF']]], + ['h_5frayleigh_5fptrs_4347',['h_rayleigh_ptrs',['../classERF.html#ad9939824ea7b7d06ab252fed28d5a911',1,'ERF']]], + ['h_5frhoqt_5fsrc_4348',['h_rhoqt_src',['../classERF.html#a3c5eca26a28dda3a981b3581abadfca0',1,'ERF']]], + ['h_5frhotheta_5fsrc_4349',['h_rhotheta_src',['../classERF.html#a87aad7caaf3b575734994b47628a2faf',1,'ERF']]], + ['h_5fsponge_5fptrs_4350',['h_sponge_ptrs',['../classERF.html#a20a0f0d26791321eb4bbba6baee9f159',1,'ERF']]], + ['h_5fu_5fgeos_4351',['h_u_geos',['../classERF.html#a911c70f76cf62f205a1ce152ec4cdb54',1,'ERF']]], + ['h_5fv_5fgeos_4352',['h_v_geos',['../classERF.html#a825daede57fae86805edffd85d5d9dab',1,'ERF']]], + ['h_5fw_5fsubsid_4353',['h_w_subsid',['../classERF.html#a1a5d0d0b4e8c196f56dfab98f245aff5',1,'ERF']]], + ['has_5fqmoist_4354',['has_qmoist',['../classRadiation.html#ada93346f8e4bb7b21310c81007761e7e',1,'Radiation']]], + ['have_5fgeo_5fwind_5fprofile_4355',['have_geo_wind_profile',['../structSolverChoice.html#a65faffc1ea490b3934a9df768cfa26f1',1,'SolverChoice']]], + ['hub_5fheight_4356',['hub_height',['../classWindFarm.html#a6dfd6451498f50c17cb67c386d13ddfb',1,'WindFarm::hub_height()'],['../classEWP.html#a2ee471b0dcad3057297b809f4c5141ab',1,'EWP::hub_height()'],['../classFitch.html#ae3af34c6c07fd2d8b9b081b5c7ceb443',1,'Fitch::hub_height()'],['../classGeneralAD.html#ac82bba9c2818ca1e77adb01fdcdcaf66',1,'GeneralAD::hub_height()'],['../classSimpleAD.html#a4c17a08ad746b342bf62d7a1ad93781a',1,'SimpleAD::hub_height()']]], + ['hub_5fheight_5fvelocity_4357',['hub_height_velocity',['../classFitch.html#af01d3f69b4f952f91970964d2f498e61',1,'Fitch']]], + ['huge_5freal_4358',['huge_real',['../classModalAeroWateruptake.html#a7b99efd9601245afe2274c268afb5305',1,'ModalAeroWateruptake']]], + ['hwave_4359',['Hwave',['../classERF.html#aef05cf88e9e9d2b56112336761493977',1,'ERF']]], + ['hwave_5fonegrid_4360',['Hwave_onegrid',['../classERF.html#a11f2d48d9af9b8f4574975cae06838f1',1,'ERF']]], + ['hygro_5faer_4361',['hygro_aer',['../structPhysProp_1_1physprop__t.html#af60d655c402eb7e47763c631b9432552',1,'PhysProp::physprop_t']]] ]; diff --git a/search/variables_8.js b/search/variables_8.js index 783395826..cc253577e 100644 --- a/search/variables_8.js +++ b/search/variables_8.js @@ -1,52 +1,52 @@ var searchData= [ - ['ice_5ffile_4360',['ice_file',['../classCloudRadProps.html#a4bdca9fbb3d26b9b013ea06b9385017e',1,'CloudRadProps']]], - ['ice_5ftau_5fbnd_5flw_4361',['ice_tau_bnd_lw',['../classRadiation.html#ab4092f9e967d5107e1722b0345e31053',1,'Radiation']]], - ['ice_5ftau_5fbnd_5fsw_4362',['ice_tau_bnd_sw',['../classRadiation.html#aba4d37f5325c0d89476eb2595f976bc1',1,'Radiation']]], - ['icecldoptics_4363',['icecldoptics',['../classMamConstituents.html#a45adfa2e9bca7c7a7b0dd807779e94ac',1,'MamConstituents::icecldoptics()'],['../classOptics.html#a357f26f1bf42c917131a48782732ce03',1,'Optics::icecldoptics()']]], - ['iceopticsfile_4364',['iceopticsfile',['../classMamConstituents.html#a0e74835fc2592d78facf9e4d9ea36f1c',1,'MamConstituents']]], - ['icesize_5ftable_5fmin_5ftemp_4365',['icesize_table_min_temp',['../classRadConstants.html#ab527187d8cc457be894cb3b4d5f3a22b',1,'RadConstants']]], - ['iciwp_4366',['iciwp',['../classRadiation.html#aa24b1e1de58c5122b78fd6afae5f737b',1,'Radiation']]], - ['iclwp_4367',['iclwp',['../classRadiation.html#a9cedc778ea026393eace9912b4ec8d5b',1,'Radiation']]], - ['icswp_4368',['icswp',['../classRadiation.html#ad2d2f52fdb57d7a44cfb553a3b70d346',1,'Radiation']]], - ['idx_4369',['idx',['../structMamConstituents_1_1gas__t.html#a92407cc5cf2752a7f7626b6f034e2fd3',1,'MamConstituents::gas_t::idx()'],['../structMamConstituents_1_1aerosol__t.html#a417db05e152088ff32fa5ca0ed2fadcc',1,'MamConstituents::aerosol_t::idx()'],['../structMamConstituents_1_1modelist__t.html#a8b01fce25cf4e89d61786dc304af557a',1,'MamConstituents::modelist_t::idx()']]], - ['idx_5flw_5fdiag_4370',['idx_lw_diag',['../classRadConstants.html#a4be67e03614ad60a9a3e5b0a5296a232',1,'RadConstants']]], - ['idx_5fmmr_5fa_4371',['idx_mmr_a',['../structMamConstituents_1_1mode__component__t.html#a5325a6229804cf4ead4edd0ae3365368',1,'MamConstituents::mode_component_t']]], - ['idx_5fmmr_5fc_4372',['idx_mmr_c',['../structMamConstituents_1_1mode__component__t.html#a2068ed3ee6d1c031830fdd74950c9dab',1,'MamConstituents::mode_component_t']]], - ['idx_5fnir_5fdiag_4373',['idx_nir_diag',['../classRadConstants.html#a5eccb1fa499f9f02449912985f70aa8e',1,'RadConstants']]], - ['idx_5fnum_5fa_4374',['idx_num_a',['../structMamConstituents_1_1mode__component__t.html#a27f686068187bef4800b0f50d673f636',1,'MamConstituents::mode_component_t']]], - ['idx_5fnum_5fc_4375',['idx_num_c',['../structMamConstituents_1_1mode__component__t.html#afeac72ae7d7e859f79d4c4c2baf54473',1,'MamConstituents::mode_component_t']]], - ['idx_5fprops_4376',['idx_props',['../structMamConstituents_1_1mode__component__t.html#a7ee6b4be8e5ef923b0f0ac0d56a5ee6c',1,'MamConstituents::mode_component_t::idx_props()'],['../structMamConstituents_1_1modelist__t.html#a1e532f0738a48c0740d4af9f635bef5c',1,'MamConstituents::modelist_t::idx_props()']]], - ['idx_5fsw_5fdiag_4377',['idx_sw_diag',['../classRadConstants.html#aa8d069e0dd3bcec898e914167c02f4ee',1,'RadConstants']]], - ['idx_5fuv_5fdiag_4378',['idx_uv_diag',['../classRadConstants.html#ab6e2774dc2b5fbd26204c95bb601610c',1,'RadConstants']]], - ['igamma_4379',['iGamma',['../ERF__Constants_8H.html#ab24194b3b11ee04368e1087acda6bde7',1,'ERF_Constants.H']]], - ['ihirsfq_4380',['ihirsfq',['../classRadiation.html#aa15d7c4d015604b92db440a1c5b1c988',1,'Radiation']]], - ['imax_4381',['imax',['../classModalAeroWateruptake.html#a5cc5abb758503a218ee7331ce15abf4e',1,'ModalAeroWateruptake']]], - ['include_5fsubgrid_5fvel_4382',['include_subgrid_vel',['../classMOSTAverage.html#ac3c62b4015d62ae8d1ad85cb6ad651ad',1,'MOSTAverage']]], - ['init_5fshrink_4383',['init_shrink',['../classERF.html#ad353aa9e275612ff2110c5a1405c1176',1,'ERF']]], - ['init_5fsounding_5fideal_4384',['init_sounding_ideal',['../classERF.html#a2eb81c590271b429f132103c9af25830',1,'ERF']]], - ['init_5ftype_4385',['init_type',['../classERF.html#a56ae431ddda8577a797dd939e53a593a',1,'ERF']]], - ['initialized_4386',['initialized',['../structMYNNLevel2.html#abc9b48297d9605827e5cb375ba714050',1,'MYNNLevel2']]], - ['input_5fbndry_5fplanes_4387',['input_bndry_planes',['../classERF.html#a80ad08512968ec45635df68abe66b1fc',1,'ERF']]], - ['input_5fsounding_5fdata_4388',['input_sounding_data',['../classERF.html#a83572d8dfad51158945b4a5ab06b2f72',1,'ERF']]], - ['input_5fsounding_5ffile_4389',['input_sounding_file',['../structInputSoundingData.html#a704d3ca6f9b6a480ad2f8c5e4b4e32f1',1,'InputSoundingData']]], - ['input_5fsounding_5ftime_4390',['input_sounding_time',['../structInputSoundingData.html#a4f3f4e6859d978e727af01ca625aea1b',1,'InputSoundingData']]], - ['input_5fsponge_5fdata_4391',['input_sponge_data',['../classERF.html#a8cb877a46fd94b5294425299dcb9cbaf',1,'ERF']]], - ['input_5fsponge_5ffile_4392',['input_sponge_file',['../structInputSpongeData.html#a944b8ce681cef2752c8797d83cae5eae',1,'InputSpongeData']]], - ['inputs_5fname_4393',['inputs_name',['../main_8cpp.html#aabaa127a3a319c1b86090d6c88568965',1,'inputs_name(): main.cpp'],['../ERF__writeJobInfo_8cpp.html#aabaa127a3a319c1b86090d6c88568965',1,'inputs_name(): main.cpp'],['../ERF__NCPlotFile_8H.html#aabaa127a3a319c1b86090d6c88568965',1,'inputs_name(): main.cpp']]], - ['int_4394',['Int',['../structncutils_1_1NCDType.html#ac5bfba212db12de3dfde52dc3ae3eb0c',1,'ncutils::NCDType']]], - ['interpolation_5ftype_4395',['interpolation_type',['../classERF.html#a812912653fe0d8ab1342bfef4793dd0e',1,'ERF']]], - ['ip_5f0_4396',['ip_0',['../ERF__Constants_8H.html#a8e89876f083cff186cc6124a1100e000',1,'ERF_Constants.H']]], - ['ir_5fd_4397',['iR_d',['../ERF__Constants_8H.html#a2c83556bc439f3f48ca5eb1cb5c81842',1,'ERF_Constants.H']]], - ['is_5fcmip6_5fvolc_4398',['is_cmip6_volc',['../classRadiation.html#a15ee15df795cea37aa3c93007f612cbd',1,'Radiation']]], - ['is_5fdensity_5fread_4399',['is_density_read',['../classReadBndryPlanes.html#a4bd406d7cec0850958383e33070a1c10',1,'ReadBndryPlanes']]], - ['is_5fke_5fread_4400',['is_KE_read',['../classReadBndryPlanes.html#a73ac00b0346e2510c6abf4fe6b08b100',1,'ReadBndryPlanes']]], - ['is_5fopen_4401',['is_open',['../classncutils_1_1NCFile.html#aa98d902ef67803393e80929bb73cb379',1,'ncutils::NCFile']]], - ['is_5fq1_5fread_4402',['is_q1_read',['../classReadBndryPlanes.html#ab1d7a9c8ad42eef46dbe0ce08c11c59b',1,'ReadBndryPlanes']]], - ['is_5fq2_5fread_4403',['is_q2_read',['../classReadBndryPlanes.html#a17e53d69ef900a4b14934f09a1a3c323',1,'ReadBndryPlanes']]], - ['is_5fscalar_5fread_4404',['is_scalar_read',['../classReadBndryPlanes.html#ab19118114d40ef7034e3072f3858bb59',1,'ReadBndryPlanes']]], - ['is_5ftemperature_5fread_4405',['is_temperature_read',['../classReadBndryPlanes.html#a4303d9f55f221509e6e91246a67c0a54',1,'ReadBndryPlanes']]], - ['is_5ftheta_5fread_4406',['is_theta_read',['../classReadBndryPlanes.html#a28a4ac197463cc8133d290b62efdf30a',1,'ReadBndryPlanes']]], - ['is_5fvelocity_5fread_4407',['is_velocity_read',['../classReadBndryPlanes.html#a14bf0864afdd66d2f497ad5372d526ff',1,'ReadBndryPlanes']]], - ['istep_4408',['istep',['../classERF.html#aefa640a036c25b7b770e88a5f838eb2a',1,'ERF']]] + ['ice_5ffile_4362',['ice_file',['../classCloudRadProps.html#a4bdca9fbb3d26b9b013ea06b9385017e',1,'CloudRadProps']]], + ['ice_5ftau_5fbnd_5flw_4363',['ice_tau_bnd_lw',['../classRadiation.html#ab4092f9e967d5107e1722b0345e31053',1,'Radiation']]], + ['ice_5ftau_5fbnd_5fsw_4364',['ice_tau_bnd_sw',['../classRadiation.html#aba4d37f5325c0d89476eb2595f976bc1',1,'Radiation']]], + ['icecldoptics_4365',['icecldoptics',['../classMamConstituents.html#a45adfa2e9bca7c7a7b0dd807779e94ac',1,'MamConstituents::icecldoptics()'],['../classOptics.html#a357f26f1bf42c917131a48782732ce03',1,'Optics::icecldoptics()']]], + ['iceopticsfile_4366',['iceopticsfile',['../classMamConstituents.html#a0e74835fc2592d78facf9e4d9ea36f1c',1,'MamConstituents']]], + ['icesize_5ftable_5fmin_5ftemp_4367',['icesize_table_min_temp',['../classRadConstants.html#ab527187d8cc457be894cb3b4d5f3a22b',1,'RadConstants']]], + ['iciwp_4368',['iciwp',['../classRadiation.html#aa24b1e1de58c5122b78fd6afae5f737b',1,'Radiation']]], + ['iclwp_4369',['iclwp',['../classRadiation.html#a9cedc778ea026393eace9912b4ec8d5b',1,'Radiation']]], + ['icswp_4370',['icswp',['../classRadiation.html#ad2d2f52fdb57d7a44cfb553a3b70d346',1,'Radiation']]], + ['idx_4371',['idx',['../structMamConstituents_1_1gas__t.html#a92407cc5cf2752a7f7626b6f034e2fd3',1,'MamConstituents::gas_t::idx()'],['../structMamConstituents_1_1aerosol__t.html#a417db05e152088ff32fa5ca0ed2fadcc',1,'MamConstituents::aerosol_t::idx()'],['../structMamConstituents_1_1modelist__t.html#a8b01fce25cf4e89d61786dc304af557a',1,'MamConstituents::modelist_t::idx()']]], + ['idx_5flw_5fdiag_4372',['idx_lw_diag',['../classRadConstants.html#a4be67e03614ad60a9a3e5b0a5296a232',1,'RadConstants']]], + ['idx_5fmmr_5fa_4373',['idx_mmr_a',['../structMamConstituents_1_1mode__component__t.html#a5325a6229804cf4ead4edd0ae3365368',1,'MamConstituents::mode_component_t']]], + ['idx_5fmmr_5fc_4374',['idx_mmr_c',['../structMamConstituents_1_1mode__component__t.html#a2068ed3ee6d1c031830fdd74950c9dab',1,'MamConstituents::mode_component_t']]], + ['idx_5fnir_5fdiag_4375',['idx_nir_diag',['../classRadConstants.html#a5eccb1fa499f9f02449912985f70aa8e',1,'RadConstants']]], + ['idx_5fnum_5fa_4376',['idx_num_a',['../structMamConstituents_1_1mode__component__t.html#a27f686068187bef4800b0f50d673f636',1,'MamConstituents::mode_component_t']]], + ['idx_5fnum_5fc_4377',['idx_num_c',['../structMamConstituents_1_1mode__component__t.html#afeac72ae7d7e859f79d4c4c2baf54473',1,'MamConstituents::mode_component_t']]], + ['idx_5fprops_4378',['idx_props',['../structMamConstituents_1_1mode__component__t.html#a7ee6b4be8e5ef923b0f0ac0d56a5ee6c',1,'MamConstituents::mode_component_t::idx_props()'],['../structMamConstituents_1_1modelist__t.html#a1e532f0738a48c0740d4af9f635bef5c',1,'MamConstituents::modelist_t::idx_props()']]], + ['idx_5fsw_5fdiag_4379',['idx_sw_diag',['../classRadConstants.html#aa8d069e0dd3bcec898e914167c02f4ee',1,'RadConstants']]], + ['idx_5fuv_5fdiag_4380',['idx_uv_diag',['../classRadConstants.html#ab6e2774dc2b5fbd26204c95bb601610c',1,'RadConstants']]], + ['igamma_4381',['iGamma',['../ERF__Constants_8H.html#ab24194b3b11ee04368e1087acda6bde7',1,'ERF_Constants.H']]], + ['ihirsfq_4382',['ihirsfq',['../classRadiation.html#aa15d7c4d015604b92db440a1c5b1c988',1,'Radiation']]], + ['imax_4383',['imax',['../classModalAeroWateruptake.html#a5cc5abb758503a218ee7331ce15abf4e',1,'ModalAeroWateruptake']]], + ['include_5fsubgrid_5fvel_4384',['include_subgrid_vel',['../classMOSTAverage.html#ac3c62b4015d62ae8d1ad85cb6ad651ad',1,'MOSTAverage']]], + ['init_5fshrink_4385',['init_shrink',['../classERF.html#ad353aa9e275612ff2110c5a1405c1176',1,'ERF']]], + ['init_5fsounding_5fideal_4386',['init_sounding_ideal',['../classERF.html#a2eb81c590271b429f132103c9af25830',1,'ERF']]], + ['init_5ftype_4387',['init_type',['../classERF.html#a56ae431ddda8577a797dd939e53a593a',1,'ERF']]], + ['initialized_4388',['initialized',['../structMYNNLevel2.html#abc9b48297d9605827e5cb375ba714050',1,'MYNNLevel2']]], + ['input_5fbndry_5fplanes_4389',['input_bndry_planes',['../classERF.html#a80ad08512968ec45635df68abe66b1fc',1,'ERF']]], + ['input_5fsounding_5fdata_4390',['input_sounding_data',['../classERF.html#a83572d8dfad51158945b4a5ab06b2f72',1,'ERF']]], + ['input_5fsounding_5ffile_4391',['input_sounding_file',['../structInputSoundingData.html#a704d3ca6f9b6a480ad2f8c5e4b4e32f1',1,'InputSoundingData']]], + ['input_5fsounding_5ftime_4392',['input_sounding_time',['../structInputSoundingData.html#a4f3f4e6859d978e727af01ca625aea1b',1,'InputSoundingData']]], + ['input_5fsponge_5fdata_4393',['input_sponge_data',['../classERF.html#a8cb877a46fd94b5294425299dcb9cbaf',1,'ERF']]], + ['input_5fsponge_5ffile_4394',['input_sponge_file',['../structInputSpongeData.html#a944b8ce681cef2752c8797d83cae5eae',1,'InputSpongeData']]], + ['inputs_5fname_4395',['inputs_name',['../main_8cpp.html#aabaa127a3a319c1b86090d6c88568965',1,'inputs_name(): main.cpp'],['../ERF__writeJobInfo_8cpp.html#aabaa127a3a319c1b86090d6c88568965',1,'inputs_name(): main.cpp'],['../ERF__NCPlotFile_8H.html#aabaa127a3a319c1b86090d6c88568965',1,'inputs_name(): main.cpp']]], + ['int_4396',['Int',['../structncutils_1_1NCDType.html#ac5bfba212db12de3dfde52dc3ae3eb0c',1,'ncutils::NCDType']]], + ['interpolation_5ftype_4397',['interpolation_type',['../classERF.html#a812912653fe0d8ab1342bfef4793dd0e',1,'ERF']]], + ['ip_5f0_4398',['ip_0',['../ERF__Constants_8H.html#a8e89876f083cff186cc6124a1100e000',1,'ERF_Constants.H']]], + ['ir_5fd_4399',['iR_d',['../ERF__Constants_8H.html#a2c83556bc439f3f48ca5eb1cb5c81842',1,'ERF_Constants.H']]], + ['is_5fcmip6_5fvolc_4400',['is_cmip6_volc',['../classRadiation.html#a15ee15df795cea37aa3c93007f612cbd',1,'Radiation']]], + ['is_5fdensity_5fread_4401',['is_density_read',['../classReadBndryPlanes.html#a4bd406d7cec0850958383e33070a1c10',1,'ReadBndryPlanes']]], + ['is_5fke_5fread_4402',['is_KE_read',['../classReadBndryPlanes.html#a73ac00b0346e2510c6abf4fe6b08b100',1,'ReadBndryPlanes']]], + ['is_5fopen_4403',['is_open',['../classncutils_1_1NCFile.html#aa98d902ef67803393e80929bb73cb379',1,'ncutils::NCFile']]], + ['is_5fq1_5fread_4404',['is_q1_read',['../classReadBndryPlanes.html#ab1d7a9c8ad42eef46dbe0ce08c11c59b',1,'ReadBndryPlanes']]], + ['is_5fq2_5fread_4405',['is_q2_read',['../classReadBndryPlanes.html#a17e53d69ef900a4b14934f09a1a3c323',1,'ReadBndryPlanes']]], + ['is_5fscalar_5fread_4406',['is_scalar_read',['../classReadBndryPlanes.html#ab19118114d40ef7034e3072f3858bb59',1,'ReadBndryPlanes']]], + ['is_5ftemperature_5fread_4407',['is_temperature_read',['../classReadBndryPlanes.html#a4303d9f55f221509e6e91246a67c0a54',1,'ReadBndryPlanes']]], + ['is_5ftheta_5fread_4408',['is_theta_read',['../classReadBndryPlanes.html#a28a4ac197463cc8133d290b62efdf30a',1,'ReadBndryPlanes']]], + ['is_5fvelocity_5fread_4409',['is_velocity_read',['../classReadBndryPlanes.html#a14bf0864afdd66d2f497ad5372d526ff',1,'ReadBndryPlanes']]], + ['istep_4410',['istep',['../classERF.html#aefa640a036c25b7b770e88a5f838eb2a',1,'ERF']]] ]; diff --git a/search/variables_9.js b/search/variables_9.js index bccadc60d..40208aadd 100644 --- a/search/variables_9.js +++ b/search/variables_9.js @@ -1,5 +1,5 @@ var searchData= [ - ['jjm_4409',['jjm',['../structLinInterp_1_1InterpType.html#aa81271a903001f119594cdced62b748c',1,'LinInterp::InterpType']]], - ['jjp_4410',['jjp',['../structLinInterp_1_1InterpType.html#a4afbbafb5bb8bf9742bdb82b166bef76',1,'LinInterp::InterpType']]] + ['jjm_4411',['jjm',['../structLinInterp_1_1InterpType.html#aa81271a903001f119594cdced62b748c',1,'LinInterp::InterpType']]], + ['jjp_4412',['jjp',['../structLinInterp_1_1InterpType.html#a4afbbafb5bb8bf9742bdb82b166bef76',1,'LinInterp::InterpType']]] ]; diff --git a/search/variables_a.js b/search/variables_a.js index 0993ea22d..304518fc1 100644 --- a/search/variables_a.js +++ b/search/variables_a.js @@ -1,8 +1,8 @@ var searchData= [ - ['k_5fdist_5flw_4411',['k_dist_lw',['../classRrtmgp.html#a9b6fe178ed49089a3ba56db0909e7414',1,'Rrtmgp']]], - ['k_5fdist_5fsw_4412',['k_dist_sw',['../classRrtmgp.html#aa59a2a79cee48c24f60ec786e84edb26',1,'Rrtmgp']]], - ['kappa_4413',['kappa',['../structmost__data.html#a73da7dc37cb1555348e956a4e2c932fe',1,'most_data']]], - ['kappa_4414',['KAPPA',['../ERF__Constants_8H.html#a0f51e1ef58cb9a3add46666cc98e6093',1,'ERF_Constants.H']]], - ['khi_5flsm_4415',['khi_lsm',['../classMM5.html#a5e32c57a0a88abb64a9d2f9ff3c1a19a',1,'MM5::khi_lsm()'],['../classSLM.html#a22738df1091f651c9c541abda9e2d5e7',1,'SLM::khi_lsm()']]] + ['k_5fdist_5flw_4413',['k_dist_lw',['../classRrtmgp.html#a9b6fe178ed49089a3ba56db0909e7414',1,'Rrtmgp']]], + ['k_5fdist_5fsw_4414',['k_dist_sw',['../classRrtmgp.html#aa59a2a79cee48c24f60ec786e84edb26',1,'Rrtmgp']]], + ['kappa_4415',['kappa',['../structmost__data.html#a73da7dc37cb1555348e956a4e2c932fe',1,'most_data']]], + ['kappa_4416',['KAPPA',['../ERF__Constants_8H.html#a0f51e1ef58cb9a3add46666cc98e6093',1,'ERF_Constants.H']]], + ['khi_5flsm_4417',['khi_lsm',['../classMM5.html#a5e32c57a0a88abb64a9d2f9ff3c1a19a',1,'MM5::khi_lsm()'],['../classSLM.html#a22738df1091f651c9c541abda9e2d5e7',1,'SLM::khi_lsm()']]] ]; diff --git a/search/variables_b.js b/search/variables_b.js index 26423ee33..2f02b3f62 100644 --- a/search/variables_b.js +++ b/search/variables_b.js @@ -1,38 +1,38 @@ var searchData= [ - ['l_5fv_4416',['L_v',['../ERF__Constants_8H.html#aee80ef06f62b6528b776d02de062cdd5',1,'ERF_Constants.H']]], - ['lambdac_4417',['lambdac',['../classRadiation.html#ab6dca247a6c812364c208e9e9801baeb',1,'Radiation']]], - ['lambm0_4418',['lambm0',['../classRadiation.html#a65e14eac1882d0877cb60c185b91f670',1,'Radiation']]], - ['last_5fcheck_5ffile_5fstep_4419',['last_check_file_step',['../classERF.html#a02722d16f3c26efe590702200f1296d7',1,'ERF']]], - ['last_5ffile_5fread_4420',['last_file_read',['../classReadBndryPlanes.html#a6a62ba4a2a722033004ff0d169b6382f',1,'ReadBndryPlanes']]], - ['last_5fplot_5ffile_5fstep_5f1_4421',['last_plot_file_step_1',['../classERF.html#a7d54d3f2317d06a8dfcde4f65cfc3e92',1,'ERF']]], - ['last_5fplot_5ffile_5fstep_5f2_4422',['last_plot_file_step_2',['../classERF.html#a09017292c9943ac2ed20ce7ed5c3c767',1,'ERF']]], - ['lat_5fice_4423',['lat_ice',['../ERF__Constants_8H.html#ab9605510ecc8468f94a0ba1842a0bf13',1,'ERF_Constants.H']]], - ['lat_5fvap_4424',['lat_vap',['../ERF__Constants_8H.html#a1a4a1b5aaf1d37a8a175a7b7177e9e2c',1,'ERF_Constants.H']]], - ['lcond_4425',['lcond',['../ERF__Constants_8H.html#a7b45c0074d559f423ac2d48e1b171518',1,'ERF_Constants.H']]], - ['les_5ftype_4426',['les_type',['../structTurbChoice.html#abbba68e0d699dd97701d31a0e37d5304',1,'TurbChoice']]], - ['lfus_4427',['lfus',['../ERF__Constants_8H.html#a0f65ea12b4405c50f1d777f7ca82dcfd',1,'ERF_Constants.H']]], - ['liq_5ftau_5fbnd_5flw_4428',['liq_tau_bnd_lw',['../classRadiation.html#a1ad7d7f87273083350b7cc35cff36b36',1,'Radiation']]], - ['liq_5ftau_5fbnd_5fsw_4429',['liq_tau_bnd_sw',['../classRadiation.html#ac96f9d8677d229ad2d59f2dbbbe58c93',1,'Radiation']]], - ['liqcldoptics_4430',['liqcldoptics',['../classMamConstituents.html#a090acb2786740c9e238ccd13de4471bb',1,'MamConstituents::liqcldoptics()'],['../classOptics.html#a87abc901496b039c596eed89b297a679',1,'Optics::liqcldoptics()']]], - ['liqopticsfile_4431',['liqopticsfile',['../classMamConstituents.html#ad22947a5d2761531d522eca254d86411',1,'MamConstituents']]], - ['liquid_5ffile_4432',['liquid_file',['../classCloudRadProps.html#a076ffd7ff44497eac9d3cace27964b0a',1,'CloudRadProps']]], - ['list_5fid_4433',['list_id',['../structMamConstituents_1_1modelist__t.html#a90b916987fc7b7cb87253d3bc3c4f94e',1,'MamConstituents::modelist_t::list_id()'],['../structMamConstituents_1_1aerlist__t.html#ab75334c58294e58e6f802fdc28fcb9c5',1,'MamConstituents::aerlist_t::list_id()'],['../structMamConstituents_1_1gaslist__t.html#a1936ba0848db011d9bc9635ace154696',1,'MamConstituents::gaslist_t::list_id()']]], - ['lmask_5flev_4434',['lmask_lev',['../classERF.html#a3f3e29874221e43e13e2a431e77e0e4e',1,'ERF']]], - ['lsm_4435',['lsm',['../classERF.html#ae0e9a78f120ba632d78cbf23c97b851c',1,'ERF']]], - ['lsm_5fdata_4436',['lsm_data',['../classERF.html#ad03da3399e893728741fac33100ce476',1,'ERF']]], - ['lsm_5ffab_5fflux_4437',['lsm_fab_flux',['../classMM5.html#a65622ec442bb57f8a4bdcfd789882661',1,'MM5::lsm_fab_flux()'],['../classSLM.html#a3bb65074894448f02b2e58b015dd580c',1,'SLM::lsm_fab_flux()']]], - ['lsm_5ffab_5fvars_4438',['lsm_fab_vars',['../classMM5.html#a1efdd2eea7c6fdc9631dadf56a7da1a2',1,'MM5::lsm_fab_vars()'],['../classSLM.html#a6fa497f40e1d0994cb3c2fb121faf40a',1,'SLM::lsm_fab_vars()']]], - ['lsm_5fflux_4439',['lsm_flux',['../classERF.html#aa5f6a6ceae0087393f386649d8bbbc31',1,'ERF']]], - ['lsm_5ftype_4440',['lsm_type',['../structSolverChoice.html#a43c1741535574c7e6f4fe6bf90552f31',1,'SolverChoice']]], - ['lsmvarmap_4441',['LsmVarMap',['../classSLM.html#acf0247edc5d92d5fb7b5183a524bf246',1,'SLM::LsmVarMap()'],['../classMM5.html#a44610d042a53d114892687d87c9e7f10',1,'MM5::LsmVarMap()']]], - ['lsmvarname_4442',['LsmVarName',['../classMM5.html#abb2bfd47b01eb3f85f6466a886a00dc9',1,'MM5::LsmVarName()'],['../classSLM.html#a41d6b4f925b97839d5cebec6d6a75133',1,'SLM::LsmVarName()']]], - ['lsub_4443',['lsub',['../ERF__Constants_8H.html#a3ab435b88eae71bef826cb01254ff33d',1,'ERF_Constants.H']]], - ['lw_5fabs_4444',['lw_abs',['../structPhysProp_1_1physprop__t.html#a7f49b6334fdf3ec5c8cbcef509a0cf7e',1,'PhysProp::physprop_t']]], - ['lw_5fband_5fmidpoints_4445',['lw_band_midpoints',['../classRadiation.html#a03b78a2a9376157b352274f4f6e6e591',1,'Radiation']]], - ['lw_5ffluxes_5fallsky_4446',['lw_fluxes_allsky',['../classRadiation.html#af25b399240484b4ce33080b87cf3186a',1,'Radiation']]], - ['lw_5ffluxes_5fclrsky_4447',['lw_fluxes_clrsky',['../classRadiation.html#adf15f2ae6aa46c3d8386d3da2f19ca28',1,'Radiation']]], - ['lw_5fhygro_5fabs_4448',['lw_hygro_abs',['../structPhysProp_1_1physprop__t.html#a2ceb8db8a17258bb21f1d0d53594ed05',1,'PhysProp::physprop_t']]], - ['lwave_4449',['Lwave',['../classERF.html#ad67b414a1a8b5bab6edeaf574f922825',1,'ERF']]], - ['lwave_5fonegrid_4450',['Lwave_onegrid',['../classERF.html#a83473e4b18de294a8b97dcdbbf048551',1,'ERF']]] + ['l_5fv_4418',['L_v',['../ERF__Constants_8H.html#aee80ef06f62b6528b776d02de062cdd5',1,'ERF_Constants.H']]], + ['lambdac_4419',['lambdac',['../classRadiation.html#ab6dca247a6c812364c208e9e9801baeb',1,'Radiation']]], + ['lambm0_4420',['lambm0',['../classRadiation.html#a65e14eac1882d0877cb60c185b91f670',1,'Radiation']]], + ['last_5fcheck_5ffile_5fstep_4421',['last_check_file_step',['../classERF.html#a02722d16f3c26efe590702200f1296d7',1,'ERF']]], + ['last_5ffile_5fread_4422',['last_file_read',['../classReadBndryPlanes.html#a6a62ba4a2a722033004ff0d169b6382f',1,'ReadBndryPlanes']]], + ['last_5fplot_5ffile_5fstep_5f1_4423',['last_plot_file_step_1',['../classERF.html#a7d54d3f2317d06a8dfcde4f65cfc3e92',1,'ERF']]], + ['last_5fplot_5ffile_5fstep_5f2_4424',['last_plot_file_step_2',['../classERF.html#a09017292c9943ac2ed20ce7ed5c3c767',1,'ERF']]], + ['lat_5fice_4425',['lat_ice',['../ERF__Constants_8H.html#ab9605510ecc8468f94a0ba1842a0bf13',1,'ERF_Constants.H']]], + ['lat_5fvap_4426',['lat_vap',['../ERF__Constants_8H.html#a1a4a1b5aaf1d37a8a175a7b7177e9e2c',1,'ERF_Constants.H']]], + ['lcond_4427',['lcond',['../ERF__Constants_8H.html#a7b45c0074d559f423ac2d48e1b171518',1,'ERF_Constants.H']]], + ['les_5ftype_4428',['les_type',['../structTurbChoice.html#abbba68e0d699dd97701d31a0e37d5304',1,'TurbChoice']]], + ['lfus_4429',['lfus',['../ERF__Constants_8H.html#a0f65ea12b4405c50f1d777f7ca82dcfd',1,'ERF_Constants.H']]], + ['liq_5ftau_5fbnd_5flw_4430',['liq_tau_bnd_lw',['../classRadiation.html#a1ad7d7f87273083350b7cc35cff36b36',1,'Radiation']]], + ['liq_5ftau_5fbnd_5fsw_4431',['liq_tau_bnd_sw',['../classRadiation.html#ac96f9d8677d229ad2d59f2dbbbe58c93',1,'Radiation']]], + ['liqcldoptics_4432',['liqcldoptics',['../classMamConstituents.html#a090acb2786740c9e238ccd13de4471bb',1,'MamConstituents::liqcldoptics()'],['../classOptics.html#a87abc901496b039c596eed89b297a679',1,'Optics::liqcldoptics()']]], + ['liqopticsfile_4433',['liqopticsfile',['../classMamConstituents.html#ad22947a5d2761531d522eca254d86411',1,'MamConstituents']]], + ['liquid_5ffile_4434',['liquid_file',['../classCloudRadProps.html#a076ffd7ff44497eac9d3cace27964b0a',1,'CloudRadProps']]], + ['list_5fid_4435',['list_id',['../structMamConstituents_1_1modelist__t.html#a90b916987fc7b7cb87253d3bc3c4f94e',1,'MamConstituents::modelist_t::list_id()'],['../structMamConstituents_1_1aerlist__t.html#ab75334c58294e58e6f802fdc28fcb9c5',1,'MamConstituents::aerlist_t::list_id()'],['../structMamConstituents_1_1gaslist__t.html#a1936ba0848db011d9bc9635ace154696',1,'MamConstituents::gaslist_t::list_id()']]], + ['lmask_5flev_4436',['lmask_lev',['../classERF.html#a3f3e29874221e43e13e2a431e77e0e4e',1,'ERF']]], + ['lsm_4437',['lsm',['../classERF.html#ae0e9a78f120ba632d78cbf23c97b851c',1,'ERF']]], + ['lsm_5fdata_4438',['lsm_data',['../classERF.html#ad03da3399e893728741fac33100ce476',1,'ERF']]], + ['lsm_5ffab_5fflux_4439',['lsm_fab_flux',['../classMM5.html#a65622ec442bb57f8a4bdcfd789882661',1,'MM5::lsm_fab_flux()'],['../classSLM.html#a3bb65074894448f02b2e58b015dd580c',1,'SLM::lsm_fab_flux()']]], + ['lsm_5ffab_5fvars_4440',['lsm_fab_vars',['../classMM5.html#a1efdd2eea7c6fdc9631dadf56a7da1a2',1,'MM5::lsm_fab_vars()'],['../classSLM.html#a6fa497f40e1d0994cb3c2fb121faf40a',1,'SLM::lsm_fab_vars()']]], + ['lsm_5fflux_4441',['lsm_flux',['../classERF.html#aa5f6a6ceae0087393f386649d8bbbc31',1,'ERF']]], + ['lsm_5ftype_4442',['lsm_type',['../structSolverChoice.html#a43c1741535574c7e6f4fe6bf90552f31',1,'SolverChoice']]], + ['lsmvarmap_4443',['LsmVarMap',['../classSLM.html#acf0247edc5d92d5fb7b5183a524bf246',1,'SLM::LsmVarMap()'],['../classMM5.html#a44610d042a53d114892687d87c9e7f10',1,'MM5::LsmVarMap()']]], + ['lsmvarname_4444',['LsmVarName',['../classMM5.html#abb2bfd47b01eb3f85f6466a886a00dc9',1,'MM5::LsmVarName()'],['../classSLM.html#a41d6b4f925b97839d5cebec6d6a75133',1,'SLM::LsmVarName()']]], + ['lsub_4445',['lsub',['../ERF__Constants_8H.html#a3ab435b88eae71bef826cb01254ff33d',1,'ERF_Constants.H']]], + ['lw_5fabs_4446',['lw_abs',['../structPhysProp_1_1physprop__t.html#a7f49b6334fdf3ec5c8cbcef509a0cf7e',1,'PhysProp::physprop_t']]], + ['lw_5fband_5fmidpoints_4447',['lw_band_midpoints',['../classRadiation.html#a03b78a2a9376157b352274f4f6e6e591',1,'Radiation']]], + ['lw_5ffluxes_5fallsky_4448',['lw_fluxes_allsky',['../classRadiation.html#af25b399240484b4ce33080b87cf3186a',1,'Radiation']]], + ['lw_5ffluxes_5fclrsky_4449',['lw_fluxes_clrsky',['../classRadiation.html#adf15f2ae6aa46c3d8386d3da2f19ca28',1,'Radiation']]], + ['lw_5fhygro_5fabs_4450',['lw_hygro_abs',['../structPhysProp_1_1physprop__t.html#a2ceb8db8a17258bb21f1d0d53594ed05',1,'PhysProp::physprop_t']]], + ['lwave_4451',['Lwave',['../classERF.html#ad67b414a1a8b5bab6edeaf574f922825',1,'ERF']]], + ['lwave_5fonegrid_4452',['Lwave_onegrid',['../classERF.html#a83473e4b18de294a8b97dcdbbf048551',1,'ERF']]] ]; diff --git a/search/variables_c.js b/search/variables_c.js index fea1bdeb1..4ba80c03c 100644 --- a/search/variables_c.js +++ b/search/variables_c.js @@ -1,231 +1,231 @@ var searchData= [ - ['m_5factive_4451',['m_active',['../classCIF.html#a1e3b931483e96527c09af4016a29d101',1,'CIF']]], - ['m_5faverages_4452',['m_averages',['../classMOSTAverage.html#a158b82286f1bed8b02da2c8b2ac7f4c0',1,'MOSTAverage']]], - ['m_5faxis_4453',['m_axis',['../classSAM.html#a37854ec84283a4229cf86b54cfcfc72b',1,'SAM::m_axis()'],['../classKessler.html#afea161a2b985d4c0eb4aa9390a808ab4',1,'Kessler::m_axis()'],['../classPlaneAverage.html#ab1c325b8a1241cb446bad96fa558e770',1,'PlaneAverage::m_axis()']]], - ['m_5fbc_5fextdir_5fvals_4454',['m_bc_extdir_vals',['../classERFPhysBCFunct__cons.html#a2765ac9561c270b92ef8bd77c3c96045',1,'ERFPhysBCFunct_cons::m_bc_extdir_vals()'],['../classERF.html#a27261ba76aa71f1ddbf87bca0ede579f',1,'ERF::m_bc_extdir_vals()'],['../classERFPhysBCFunct__w.html#afcaa9deb9258f849737281efb4327694',1,'ERFPhysBCFunct_w::m_bc_extdir_vals()'],['../classERFPhysBCFunct__u.html#a24b743a8e87bbc7ff9a62c2abbe2b28c',1,'ERFPhysBCFunct_u::m_bc_extdir_vals()'],['../classERFPhysBCFunct__v.html#afac2b29228e83f3693609ae1374d91e2',1,'ERFPhysBCFunct_v::m_bc_extdir_vals()']]], - ['m_5fbc_5fneumann_5fvals_4455',['m_bc_neumann_vals',['../classERFPhysBCFunct__u.html#a5b9cbbd733227f1cad1032feb2f93efe',1,'ERFPhysBCFunct_u::m_bc_neumann_vals()'],['../classERFPhysBCFunct__v.html#a7e82182923ff12b9ee242d7aaf8b25d9',1,'ERFPhysBCFunct_v::m_bc_neumann_vals()'],['../classERFPhysBCFunct__w.html#adac2302187d51d560028611a5d6b1743',1,'ERFPhysBCFunct_w::m_bc_neumann_vals()'],['../classERF.html#af783df8719de2e72e347de5860f71528',1,'ERF::m_bc_neumann_vals()'],['../classERFPhysBCFunct__cons.html#a390ff8852b8e8807798c1adff0dc4a75',1,'ERFPhysBCFunct_cons::m_bc_neumann_vals()']]], - ['m_5fbdy_5ftime_5finterval_4456',['m_bdy_time_interval',['../classABLMost.html#a049bc06685178431599f3bfaa57d63bd',1,'ABLMost']]], - ['m_5fblade_5fpitch_4457',['m_blade_pitch',['../classNullWindFarm.html#aabb34a6b16b5001624bf06c98aa226a9',1,'NullWindFarm']]], - ['m_5fbld_5fairfoil_5faoa_4458',['m_bld_airfoil_aoa',['../classNullWindFarm.html#a6f6bd907d33ec99543896b82fac6b4e4',1,'NullWindFarm']]], - ['m_5fbld_5fairfoil_5fcd_4459',['m_bld_airfoil_Cd',['../classNullWindFarm.html#a85b5fcee1d9a35f884255e9dec414bfd',1,'NullWindFarm']]], - ['m_5fbld_5fairfoil_5fcl_4460',['m_bld_airfoil_Cl',['../classNullWindFarm.html#ad337a725edf9efdaf1fd4a49ddd35505',1,'NullWindFarm']]], - ['m_5fbld_5fchord_4461',['m_bld_chord',['../classNullWindFarm.html#acbc82ecabc6211a7d2070f24a805fbc9',1,'NullWindFarm']]], - ['m_5fbld_5frad_5floc_4462',['m_bld_rad_loc',['../classNullWindFarm.html#a27f046283d051fb0abcf5f6d9080b471',1,'NullWindFarm']]], - ['m_5fbld_5ftwist_4463',['m_bld_twist',['../classNullWindFarm.html#a453673de82ca8ffbced1c32bfb27555d',1,'NullWindFarm']]], - ['m_5fbnd_5fbx_4464',['m_bnd_bx',['../structLineSampler.html#acf84e5ae60cbfd1faaf2e8ac6c9ff5eb',1,'LineSampler']]], - ['m_5fbnd_5frbx_4465',['m_bnd_rbx',['../structPlaneSampler.html#a85e5bf3ef37f89b54d88bba6e2334a24',1,'PlaneSampler']]], - ['m_5fbox_4466',['m_box',['../classRadiation.html#a37098b6502fef13732ed996200b7f64c',1,'Radiation']]], - ['m_5fc_5fp_4467',['m_C_P',['../classNullWindFarm.html#a2c312d78fc769a3d081c2df6492b5b35',1,'NullWindFarm']]], - ['m_5fc_5ft_4468',['m_C_T',['../classNullWindFarm.html#a5cb0849867fadd38770da912749adb50',1,'NullWindFarm']]], - ['m_5fcba_4469',['m_cba',['../classERFFillPatcher.html#a35fb56b2946f596728b9ac793eb47c5e',1,'ERFFillPatcher']]], - ['m_5fcd_5fforest_4470',['m_cd_forest',['../classForestDrag.html#ab8c2ba2f9e1a82a5e1b116df64dfb0f0',1,'ForestDrag']]], - ['m_5fcdm_4471',['m_cdm',['../classERFFillPatcher.html#a52af76dca01fd13bdb29834d4b9ca5e2',1,'ERFFillPatcher']]], - ['m_5fcenter_4472',['m_center',['../classFlowerIF.html#afde7bb14577df6460b603a3fb9c68c30',1,'FlowerIF']]], - ['m_5fcf_5fcrse_5fdata_5fnew_4473',['m_cf_crse_data_new',['../classERFFillPatcher.html#a89f24e6cfe30a2180b1667aead7edf28',1,'ERFFillPatcher']]], - ['m_5fcf_5fcrse_5fdata_5fold_4474',['m_cf_crse_data_old',['../classERFFillPatcher.html#ad6ac8a363c79d1a98703988478420586',1,'ERFFillPatcher']]], - ['m_5fcf_5fmask_4475',['m_cf_mask',['../classERFFillPatcher.html#a874bf44ab38e936013bbf8454a41a680',1,'ERFFillPatcher']]], - ['m_5fcgeom_4476',['m_cgeom',['../classERFFillPatcher.html#a5b1190e4ec0fe257d6d3fa886054dc2c',1,'ERFFillPatcher']]], - ['m_5fcheck_5fint_4477',['m_check_int',['../classERF.html#a69a3f925e95ec4244b0257f9de16d65a',1,'ERF']]], - ['m_5fcheck_5fper_4478',['m_check_per',['../classERF.html#a5fbf17cfc8d9e5b994783e05ec3594b2',1,'ERF']]], - ['m_5fcp_5fsoil_4479',['m_cp_soil',['../classMM5.html#a0bc2d572786956904d71c30db49e3ae2',1,'MM5::m_cp_soil()'],['../classSLM.html#a3c284ad4d275aa9ce80eca787cab87a4',1,'SLM::m_cp_soil()']]], - ['m_5fcrse_5ftimes_4480',['m_crse_times',['../classERFFillPatcher.html#a562ca1201d642f3a7dd5700a056776d9',1,'ERFFillPatcher']]], - ['m_5fd_5fsoil_4481',['m_d_soil',['../classMM5.html#a273c04f6eac3e48325dfce1e34e58df4',1,'MM5::m_d_soil()'],['../classSLM.html#a6ba8b659255822be9538ba66c22b2533',1,'SLM::m_d_soil()']]], - ['m_5fdata_4482',['m_data',['../structTimeInterpolatedData.html#a7021ade0b30697e6eef3df932447d4fc',1,'TimeInterpolatedData']]], - ['m_5fdata_5finterp_4483',['m_data_interp',['../classReadBndryPlanes.html#a5468d5d8813dc471dac1335611ec8dc9',1,'ReadBndryPlanes']]], - ['m_5fdata_5fn_4484',['m_data_n',['../classReadBndryPlanes.html#acc6e94621293c94d1322a8cafbf61ad4',1,'ReadBndryPlanes']]], - ['m_5fdata_5fnp1_4485',['m_data_np1',['../classReadBndryPlanes.html#ae34737833f599f3cb5ef945ac3f57f4b',1,'ReadBndryPlanes']]], - ['m_5fdata_5fnp2_4486',['m_data_np2',['../classReadBndryPlanes.html#a5338493101cfbb8eb27301f83aeca290',1,'ReadBndryPlanes']]], - ['m_5fdetj_5fcc_4487',['m_detJ_cc',['../classKessler.html#a534c115146bedf2e3f600ac351162252',1,'Kessler::m_detJ_cc()'],['../classSAM.html#a1b09febe32fbfebb402091fd31cd9996',1,'SAM::m_detJ_cc()']]], - ['m_5fdiameter_5fforest_4488',['m_diameter_forest',['../classForestDrag.html#a17d88d33ff5abbdd20b28e2e841b09b7',1,'ForestDrag']]], - ['m_5fdir_4489',['m_dir',['../structLineSampler.html#a8fc089e1d316a8d694fd521baae9f076',1,'LineSampler::m_dir()'],['../structPlaneSampler.html#a166b20f0a2cc42f436e82f327b974cb6',1,'PlaneSampler::m_dir()']]], - ['m_5fdmap_4490',['m_dmap',['../classTerrainPoisson.html#adf44ae8fab76f41f31a9f340ffa0aa1b',1,'TerrainPoisson']]], - ['m_5fdomain_5fbcs_5ftype_4491',['m_domain_bcs_type',['../classERFPhysBCFunct__cons.html#ab131fcff8649a5dde5f39fe890b6b383',1,'ERFPhysBCFunct_cons::m_domain_bcs_type()'],['../classERFPhysBCFunct__u.html#a90c9e642d2c31bc2245cf57f3fb4adc8',1,'ERFPhysBCFunct_u::m_domain_bcs_type()'],['../classERFPhysBCFunct__v.html#ae26c0b8c1a5145f1e1f2d44717745cfd',1,'ERFPhysBCFunct_v::m_domain_bcs_type()'],['../classERFPhysBCFunct__w.html#a052d31c743d030292761e95702615467',1,'ERFPhysBCFunct_w::m_domain_bcs_type()'],['../classERFPhysBCFunct__base.html#af918f7e795b633cdb0c2d377634c2bac',1,'ERFPhysBCFunct_base::m_domain_bcs_type()']]], - ['m_5fdomain_5fbcs_5ftype_5fd_4492',['m_domain_bcs_type_d',['../classERFPhysBCFunct__cons.html#aa39c1df9dc816a85f84c43c1b065be35',1,'ERFPhysBCFunct_cons::m_domain_bcs_type_d()'],['../classERFPhysBCFunct__base.html#a1363b51788d4178be65ec64c462b7f30',1,'ERFPhysBCFunct_base::m_domain_bcs_type_d()'],['../classERFPhysBCFunct__w.html#a87159676dd29c47ebd69e40b6dda5f1a',1,'ERFPhysBCFunct_w::m_domain_bcs_type_d()'],['../classERFPhysBCFunct__v.html#a0bc0f76b47d1d805161695e977dad5fb',1,'ERFPhysBCFunct_v::m_domain_bcs_type_d()'],['../classERFPhysBCFunct__u.html#a3b17acdd618c58f48856b4fa7a35abfc',1,'ERFPhysBCFunct_u::m_domain_bcs_type_d()']]], - ['m_5fdr_4493',['m_dr',['../classFlowerIF.html#a6e09a1d51eb36041dcb175f8784b8eeb',1,'FlowerIF']]], - ['m_5fdt_4494',['m_dt',['../classMM5.html#a41e60b81361852b0e4577bd7e3f88062',1,'MM5::m_dt()'],['../classSLM.html#a48b1e4c0290b62bafb4f6acb9291aa68',1,'SLM::m_dt()']]], - ['m_5fdt_5fcrse_4495',['m_dt_crse',['../classERFFillPatcher.html#ae89877908970649653ae09c42d3c7b05',1,'ERFFillPatcher']]], - ['m_5fdx_4496',['m_dx',['../classPlaneAverage.html#ade7352e3a72a2e09561e031acd32cc8a',1,'PlaneAverage']]], - ['m_5fdz_5flsm_4497',['m_dz_lsm',['../classSLM.html#a6dcae265ee0a43c0d7ecdd52074431ce',1,'SLM::m_dz_lsm()'],['../classMM5.html#a754e507be4ac680c9f49ab0158afc4b5',1,'MM5::m_dz_lsm()']]], - ['m_5feddydiffs_5flev_4498',['m_eddyDiffs_lev',['../classABLMost.html#a05cc96f74b89c4e277fe3db4ea01d3fa',1,'ABLMost']]], - ['m_5fexp_5fmost_4499',['m_exp_most',['../classABLMost.html#ac3de35be0d6cf3841e9a868830fc42c5',1,'ABLMost']]], - ['m_5fexpand_5fplotvars_5fto_5funif_5frr_4500',['m_expand_plotvars_to_unif_rr',['../classERF.html#adb272adf862040a2f1a6226c57c35627',1,'ERF']]], - ['m_5fextent_5frad_4501',['m_extent_rad',['../classReadBndryPlanes.html#ae341a8d70430128e78f7cac75e0d4e8a',1,'ReadBndryPlanes::m_extent_rad()'],['../classWriteBndryPlanes.html#a41799219d138892871e1a6e8c3755da1',1,'WriteBndryPlanes::m_extent_rad()']]], - ['m_5ff1_4502',['m_f1',['../classUnionCIF.html#a48c696814009301ff056340a2ebb601c',1,'UnionCIF::m_f1()'],['../classIntersectionCIF.html#a0b24d2c5c189c43b259c173c162aa1f1',1,'IntersectionCIF::m_f1()']]], - ['m_5ff2_4503',['m_f2',['../classIntersectionCIF.html#af11428d551013bf6318ef89873537a4e',1,'IntersectionCIF::m_f2()'],['../classUnionCIF.html#a150413e8d9e4bbd2b44e924c839f296a',1,'UnionCIF::m_f2()']]], - ['m_5ffac_5fcond_4504',['m_fac_cond',['../classKessler.html#a74746cef2381fd949a06be46f99a05c7',1,'Kessler::m_fac_cond()'],['../classSAM.html#a66b0ffc2f98c96c5a3b3c760a854be95',1,'SAM::m_fac_cond()']]], - ['m_5ffac_5ffus_4505',['m_fac_fus',['../classKessler.html#acaf08727482ff116185a6dbdf2bd54f9',1,'Kessler::m_fac_fus()'],['../classSAM.html#a53d38219476c32ba2dd751c02bcae53c',1,'SAM::m_fac_fus()']]], - ['m_5ffac_5fsub_4506',['m_fac_sub',['../classKessler.html#a2feda15429da3d8227d75cc3f6da71ba',1,'Kessler::m_fac_sub()'],['../classSAM.html#a8653cbf2c13ac3595f5f8710a3f1beec',1,'SAM::m_fac_sub()']]], - ['m_5ffact_5fnew_4507',['m_fact_new',['../classMOSTAverage.html#a960bae1d528aef6d0e7034dbea65a2c3',1,'MOSTAverage']]], - ['m_5ffact_5fold_4508',['m_fact_old',['../classMOSTAverage.html#ae1d62c88d62bbef8458d0084200f65f2',1,'MOSTAverage']]], - ['m_5ffactory_4509',['m_factory',['../classERF.html#abd4f9db387b864a97ac18c8dfe71f4e4',1,'ERF']]], - ['m_5ffba_4510',['m_fba',['../classERFFillPatcher.html#a297b1d2468ed152850c7bb6c156101b3',1,'ERFFillPatcher']]], - ['m_5ffdm_4511',['m_fdm',['../classERFFillPatcher.html#afef007cab3f3a1e4a7deea141f397e51',1,'ERFFillPatcher']]], - ['m_5ffgeom_4512',['m_fgeom',['../classERFFillPatcher.html#a12694a711f281b957f7015a98e5c9b77',1,'ERFFillPatcher']]], - ['m_5ffield_4513',['m_field',['../classPlaneAverage.html#a6c29e3eafbbb7028e801c513b29a1c09',1,'PlaneAverage']]], - ['m_5ffields_4514',['m_fields',['../classMOSTAverage.html#ad301df8e1ee46557a4d277c3f87fae69',1,'MOSTAverage']]], - ['m_5ffilename_4515',['m_filename',['../classReadBndryPlanes.html#a3a130c25c6b3c327e58d3e4687a051b9',1,'ReadBndryPlanes::m_filename()'],['../classWriteBndryPlanes.html#abbc94048dfd43b653b7754d785c11d2f',1,'WriteBndryPlanes::m_filename()']]], - ['m_5fforest_4516',['m_forest',['../classERF.html#a28cc050008267e4138c5a716ecf689a2',1,'ERF']]], - ['m_5fforest_5fdrag_4517',['m_forest_drag',['../classForestDrag.html#acb32d6e1088af2621a723601500db7b3',1,'ForestDrag']]], - ['m_5fgeom_4518',['m_geom',['../classKessler.html#a48f29ab8e5d1232ee83851fd904e9354',1,'Kessler::m_geom()'],['../classPlaneAverage.html#ae359b042dfa8a0b951a3d34706c3c385',1,'PlaneAverage::m_geom()'],['../classRadiation.html#ae5477e7b80b52cebf89ec3b8bdce0f3c',1,'Radiation::m_geom()'],['../classSAM.html#a8242fff43eb2cf417036eb36f5e4a3d8',1,'SAM::m_geom()'],['../classTerrainPoisson.html#a15e050b9bd993409e07ceef1650ebb31',1,'TerrainPoisson::m_geom()'],['../classamrex_1_1FFT_1_1PoissonTerrainPrecond.html#a76b540b21cf5a240c4bd93ce72dbb3ca',1,'amrex::FFT::PoissonTerrainPrecond::m_geom()'],['../classSLM.html#a870bfd56a5fe10dc6b7b8f0347a9b218',1,'SLM::m_geom()'],['../classMM5.html#a7edc95309bb52864bba5341f19262063',1,'MM5::m_geom()'],['../classWriteBndryPlanes.html#a007dc2174ebcc2e2d79e8f31f41255cb',1,'WriteBndryPlanes::m_geom()'],['../classTerrainIF.html#aeb902107efd92150abad59ec0a8cf088',1,'TerrainIF::m_geom()'],['../classERFPhysBCFunct__base.html#a8cde4476cef731ed821f25229ddb0c7b',1,'ERFPhysBCFunct_base::m_geom()'],['../classERFPhysBCFunct__w.html#a1e9f9a0981a60be4e8e3a2b906444878',1,'ERFPhysBCFunct_w::m_geom()'],['../classERFPhysBCFunct__v.html#a01f7c56f64ac414f4ec69ff8c45a2f2a',1,'ERFPhysBCFunct_v::m_geom()'],['../classERFPhysBCFunct__u.html#a12a1e078b61a3e00958bf0f3f69bfe5f',1,'ERFPhysBCFunct_u::m_geom()'],['../classERFPhysBCFunct__cons.html#a1a3121bc392962a3c3149a6e2db2791b',1,'ERFPhysBCFunct_cons::m_geom()'],['../classMOSTAverage.html#aed9b6c726189d8858abba0a2a66feca1',1,'MOSTAverage::m_geom()'],['../classABLMost.html#a1795a510d08fbd88e6599e014f97b6c5',1,'ABLMost::m_geom()'],['../classReadBndryPlanes.html#af4c91eeb64f4e49767e97c1e72de06fc',1,'ReadBndryPlanes::m_geom()']]], - ['m_5fgocp_4519',['m_gOcp',['../classKessler.html#aac004df387a7f0725724f017ca3d4a99',1,'Kessler::m_gOcp()'],['../classSAM.html#a3a76b3fc76d33c147dcaab81a738f41c',1,'SAM::m_gOcp()']]], - ['m_5fgrids_4520',['m_grids',['../classTerrainPoisson.html#ada942a4488d49acc588f1afe2a4cc877',1,'TerrainPoisson']]], - ['m_5fgtoe_4521',['m_gtoe',['../classSAM.html#a579b5a1e16d7b9d8d317e475a6a43705',1,'SAM::m_gtoe()'],['../classKessler.html#ae8749011028be638e3fb8051e22f83f1',1,'Kessler::m_gtoe()']]], - ['m_5fheight_5fforest_4522',['m_height_forest',['../classForestDrag.html#a70219f7646623030f5eca622c0467f7a',1,'ForestDrag']]], - ['m_5fhub_5fheight_4523',['m_hub_height',['../classNullWindFarm.html#ad403f4133b2292495e5dd949fcc59207',1,'NullWindFarm']]], - ['m_5fhwave_5flev_4524',['m_Hwave_lev',['../classABLMost.html#a644ccdc438574061ec7ae75cdc714ec6',1,'ABLMost']]], - ['m_5fi_5findx_4525',['m_i_indx',['../classMOSTAverage.html#a2f5fb25e7c5196338ee5a051708d8f62',1,'MOSTAverage']]], - ['m_5fifs_4526',['m_ifs',['../classUnionListIF.html#a89c2512bb20d220882024302d7a92a3f',1,'UnionListIF']]], - ['m_5fin_5frad_4527',['m_in_rad',['../classReadBndryPlanes.html#a8269a127a4db1fd93794dcb8062f5fa9',1,'ReadBndryPlanes::m_in_rad()'],['../classWriteBndryPlanes.html#a7b350ac1d0c6151ed748a575475f8fbd',1,'WriteBndryPlanes::m_in_rad()']]], - ['m_5fin_5ftimes_4528',['m_in_times',['../classReadBndryPlanes.html#adfe9045e42be78e2a735151d969183d7',1,'ReadBndryPlanes::m_in_times()'],['../classWriteBndryPlanes.html#a15fa114f52237b735599b6a5cac40d26',1,'WriteBndryPlanes::m_in_times()']]], - ['m_5fin_5ftimesteps_4529',['m_in_timesteps',['../classReadBndryPlanes.html#a7bfda76cde9aa1b8290577c40a612795',1,'ReadBndryPlanes::m_in_timesteps()'],['../classWriteBndryPlanes.html#a7cab948881900ffa97145c47221dcb44',1,'WriteBndryPlanes::m_in_timesteps()']]], - ['m_5finc_5fghost_4530',['m_inc_ghost',['../classPlaneAverage.html#abe59333d5fc9969465111df40dd9892e',1,'PlaneAverage']]], - ['m_5finclude_5fwstar_4531',['m_include_wstar',['../classABLMost.html#ac2e247ec9fd06cd15c788b83bf2c9ba6',1,'ABLMost']]], - ['m_5finside_4532',['m_inside',['../classFlowerIF.html#adabc11e60eca5148da34682a5c51058f',1,'FlowerIF']]], - ['m_5finterp_4533',['m_interp',['../classMOSTAverage.html#aeac5da9c3972fdde64f60720f88efe2e',1,'MOSTAverage::m_interp()'],['../classERFFillPatcher.html#a2fc352aecabd75ec92f5d17730683a1c',1,'ERFFillPatcher::m_interp()']]], - ['m_5fixtype_4534',['m_ixtype',['../classPlaneAverage.html#a45ad4c1f2922be9ba838bab13657385f',1,'PlaneAverage']]], - ['m_5fj_5findx_4535',['m_j_indx',['../classMOSTAverage.html#acdc75484e6ed5d2fadfb93573b6dded2',1,'MOSTAverage']]], - ['m_5fk_5fin_4536',['m_k_in',['../classMOSTAverage.html#ad570edb25d41640aa2d52122ae303884',1,'MOSTAverage']]], - ['m_5fk_5findx_4537',['m_k_indx',['../classMOSTAverage.html#afbe752293b7c2790b1994a2349261fda',1,'MOSTAverage']]], - ['m_5fk_5fsoil_4538',['m_k_soil',['../classMM5.html#ac5730f1413ae4a3dd5d4b2c683c41297',1,'MM5::m_k_soil()'],['../classSLM.html#aa674dfa04bde7d418f1195f707f84f5c',1,'SLM::m_k_soil()']]], - ['m_5flai_5fforest_4539',['m_lai_forest',['../classForestDrag.html#a6b967bb106243fd365ca0aa2cd9aa457',1,'ForestDrag']]], - ['m_5flaimax_5fforest_4540',['m_laimax_forest',['../classForestDrag.html#a24d15eda91f5abc361c3c5b37fb45efd',1,'ForestDrag']]], - ['m_5flat_4541',['m_lat',['../classRadiation.html#ae6fe4540ef5931fb2ac34ad19c6fe74e',1,'Radiation']]], - ['m_5flev_4542',['m_lev',['../classERFPhysBCFunct__cons.html#ad393b48c02e838f75be60a655eed9fa6',1,'ERFPhysBCFunct_cons::m_lev()'],['../classERFPhysBCFunct__u.html#a898867b7e245b2ecf05ab7f5ce4a4504',1,'ERFPhysBCFunct_u::m_lev()'],['../classERFPhysBCFunct__v.html#a22e73a039ee130b072f3a9ad079fc160',1,'ERFPhysBCFunct_v::m_lev()'],['../classERFPhysBCFunct__w.html#a277641c1cc5a27c2a01e49d21a9c88f4',1,'ERFPhysBCFunct_w::m_lev()'],['../classERFPhysBCFunct__base.html#a55272dec44184034a24cfe54bb7df1fd',1,'ERFPhysBCFunct_base::m_lev()'],['../structLineSampler.html#af614a59976e85627d9b5d41222265cde',1,'LineSampler::m_lev()'],['../structPlaneSampler.html#a31b77c80e1831ceb775ed63819016fd4',1,'PlaneSampler::m_lev()']]], - ['m_5flevel_4543',['m_level',['../classPlaneAverage.html#a6a25218bd5754ec121caab7e4acfc537',1,'PlaneAverage']]], - ['m_5fline_5faverage_4544',['m_line_average',['../classPlaneAverage.html#a998ec98b248ea4bd71284a2bd919fb0d',1,'PlaneAverage']]], - ['m_5fline_5fxcentroid_4545',['m_line_xcentroid',['../classPlaneAverage.html#a560dbd7059fb6cbb0421635c5d405d2b',1,'PlaneAverage']]], - ['m_5flmask_5flev_4546',['m_lmask_lev',['../classABLMost.html#aaa5bbc610662825ddd8a184b43f3541b',1,'ABLMost']]], - ['m_5flon_4547',['m_lon',['../classRadiation.html#a0069d200496f037a5bffa96e4bf9bce0',1,'Radiation']]], - ['m_5fls_4548',['m_ls',['../classSampleData.html#a12c059d78aea6b9c266a7cf17044a24c',1,'SampleData']]], - ['m_5fls_5fmf_4549',['m_ls_mf',['../structLineSampler.html#a1fa54ddedf5258bce17bb029e4aaf50e',1,'LineSampler']]], - ['m_5flsm_5fdata_5flev_4550',['m_lsm_data_lev',['../classABLMost.html#a958aaaf9e040462197c88c6c77f2aaf6',1,'ABLMost::m_lsm_data_lev()'],['../classLandSurface.html#a5a134e93d42328bfaa9611a9e625e1bb',1,'LandSurface::m_lsm_data_lev()']]], - ['m_5flsm_5fflux_5flev_4551',['m_lsm_flux_lev',['../classABLMost.html#a422336bc908d29f98dafb3b745b4f060',1,'ABLMost']]], - ['m_5flsm_5ffluxes_4552',['m_lsm_fluxes',['../classRadiation.html#a628ab4164c223bc55241535374a780cb',1,'Radiation']]], - ['m_5flsm_5fgeom_4553',['m_lsm_geom',['../classNullSurf.html#ac722d317f14ff1793ce7a38362987513',1,'NullSurf::m_lsm_geom()'],['../classSLM.html#ac41680d479e44b54678787b662c55fef',1,'SLM::m_lsm_geom()'],['../classMM5.html#a5bb965e19ba475c78c8c9c8528fbf871',1,'MM5::m_lsm_geom()']]], - ['m_5flsm_5fgeom_5flev_4554',['m_lsm_geom_lev',['../classLandSurface.html#a06a0bb4f12e604dbbd844bd4d2b0903f',1,'LandSurface']]], - ['m_5flsm_5fmodel_4555',['m_lsm_model',['../classLandSurface.html#a7415e46b046f76ef34902fa6ef1ef628',1,'LandSurface']]], - ['m_5flsm_5fsize_4556',['m_lsm_size',['../classMM5.html#a338909d8b32e73bee5188eb5f4e0e15d',1,'MM5::m_lsm_size()'],['../classNullSurf.html#a00480a80b00d313460c898669225b2ef',1,'NullSurf::m_lsm_size()'],['../classSLM.html#a4b4498e80099eadbb5405ec7095c07a8',1,'SLM::m_lsm_size()']]], - ['m_5flsm_5fzenith_4557',['m_lsm_zenith',['../classRadiation.html#a9ee4891cfb314df8458a47759de345d5',1,'Radiation']]], - ['m_5flwave_5flev_4558',['m_Lwave_lev',['../classABLMost.html#ab12af4a41dbc189d69850a81447434f7',1,'ABLMost']]], - ['m_5fma_4559',['m_ma',['../classABLMost.html#a466bfcda8ae4337d9c8781ab28e3f6fe',1,'ABLMost']]], - ['m_5fmax_5fstep_4560',['m_max_step',['../classMultiBlockContainer.html#a1f1ba45d36c26640b1d2817ae275a505',1,'MultiBlockContainer']]], - ['m_5fmaxlev_4561',['m_maxlev',['../classMOSTAverage.html#abc66735142b394193e3b6934ea817015',1,'MOSTAverage']]], - ['m_5fmoist_5fmodel_4562',['m_moist_model',['../classEulerianMicrophysics.html#a3d8916fc5900c54728d7549c68b21048',1,'EulerianMicrophysics']]], - ['m_5fmost_4563',['m_most',['../classERF.html#a051364b2373d8d86151c0b4a958035bd',1,'ERF']]], - ['m_5fmoving_5fterrain_4564',['m_moving_terrain',['../classERFPhysBCFunct__base.html#aa0e24cb3922f3d72d5438a6c3e5a4310',1,'ERFPhysBCFunct_base']]], - ['m_5fnavg_4565',['m_navg',['../classMOSTAverage.html#a0554ee593b5deca61ef0d26ebd26f6d6',1,'MOSTAverage']]], - ['m_5fncell_5fline_4566',['m_ncell_line',['../classPlaneAverage.html#a049c64513c0ed306d7e68ef95df87033',1,'PlaneAverage']]], - ['m_5fncell_5fplane_4567',['m_ncell_plane',['../classMOSTAverage.html#a89b9ec10eb8dee9a8be7c9597a3f5008',1,'MOSTAverage::m_ncell_plane()'],['../classPlaneAverage.html#a98ad1b7801e75ac43ddd3d06b0c5d7da',1,'PlaneAverage::m_ncell_plane()']]], - ['m_5fncell_5fregion_4568',['m_ncell_region',['../classMOSTAverage.html#ab227f9a8e9224820c00fa8b223712b3e',1,'MOSTAverage']]], - ['m_5fncomp_4569',['m_ncomp',['../classERFFillPatcher.html#a61c68ee600be65606db582402599c1d4',1,'ERFFillPatcher::m_ncomp()'],['../classPlaneAverage.html#af07d85c4bd48f4bedc0b180001c728dc',1,'PlaneAverage::m_ncomp()']]], - ['m_5fng_4570',['m_ng',['../classPlaneAverage.html#a4a8c3eb911548a254ef75c24659b1317',1,'PlaneAverage']]], - ['m_5fnghost_4571',['m_nghost',['../classERFFillPatcher.html#afdb02cfc6d41b23967ff0a6f0e22b849',1,'ERFFillPatcher']]], - ['m_5fnghost_5fsubset_4572',['m_nghost_subset',['../classERFFillPatcher.html#a83a91e2dc7bd7c39a27327024814061c',1,'ERFFillPatcher']]], - ['m_5fnominal_5fpower_4573',['m_nominal_power',['../classNullWindFarm.html#aac5f552b2717ab7f177541c1bf09828a',1,'NullWindFarm']]], - ['m_5fnorm_5fvec_4574',['m_norm_vec',['../classMOSTAverage.html#a90d1df8bd48dd2bf45776a01ba1a89f7',1,'MOSTAverage']]], - ['m_5fnpetals_4575',['m_npetals',['../classFlowerIF.html#a13021976563f28b30e35c378d19a5d75',1,'FlowerIF']]], - ['m_5fnvar_4576',['m_nvar',['../classMOSTAverage.html#a94ece9d178d0e85296cce07bab556bc7',1,'MOSTAverage']]], - ['m_5fnz_5flsm_4577',['m_nz_lsm',['../classMM5.html#a9e2b3186622686e5aae850eb1dc93d28',1,'MM5::m_nz_lsm()'],['../classSLM.html#ac5eb0f0fb3b7c78777a95bad4b5370ee',1,'SLM::m_nz_lsm()']]], - ['m_5fout_5frad_4578',['m_out_rad',['../classReadBndryPlanes.html#acb820b3ebc4c07d210831e6081c47aa9',1,'ReadBndryPlanes::m_out_rad()'],['../classWriteBndryPlanes.html#a2ce490f5166966b52112f126c9dc4dd8',1,'WriteBndryPlanes::m_out_rad()']]], - ['m_5fowns_5fdata_4579',['m_owns_data',['../structTimeInterpolatedData.html#a6eeb9167e2d8051c16fdbb1e7fee54ed',1,'TimeInterpolatedData']]], - ['m_5fphi_4580',['m_phi',['../structCENTERED2.html#ac162099524c29536f1d08dcbb7c6c67a',1,'CENTERED2::m_phi()'],['../structWENO__Z7.html#a3bab5ca3ba311c6f183bb9d5d5f99fee',1,'WENO_Z7::m_phi()'],['../structWENO__Z5.html#a962862416f273b267eb55802eff59edf',1,'WENO_Z5::m_phi()'],['../structWENO__MZQ3.html#a106585bb6e78f7027658c9c56f3ae892',1,'WENO_MZQ3::m_phi()'],['../structWENO__Z3.html#a8269a48070f989c0183112ccd8e57489',1,'WENO_Z3::m_phi()'],['../structWENO7.html#aacefd0bc2d7db63fa68026e0d041c637',1,'WENO7::m_phi()'],['../structWENO5.html#a28727bda47dc47677cf20c4d4bbda9a8',1,'WENO5::m_phi()'],['../structWENO3.html#a13120486db8a71a2059a9c7c1928b416',1,'WENO3::m_phi()'],['../structUPWINDALL.html#a36acc81d9046b2b80cf3755aa46bc10c',1,'UPWINDALL::m_phi()'],['../structCENTERED6.html#a732a4a686c30a3233c939f453b74f0b9',1,'CENTERED6::m_phi()'],['../structUPWIND5.html#a26ff7f987df2f61ab60c121c02dd4295',1,'UPWIND5::m_phi()'],['../structCENTERED4.html#a2a0e8c62c2eb7e34a73c94f212a21cb3',1,'CENTERED4::m_phi()'],['../structUPWIND3.html#a4f184417f94f60775a46357fbafe1cca',1,'UPWIND3::m_phi()']]], - ['m_5fplane_5faverage_4581',['m_plane_average',['../classMOSTAverage.html#a81ad3bc2787e30025f8bee91bc5c9dc2',1,'MOSTAverage']]], - ['m_5fplot_5fface_5fvels_4582',['m_plot_face_vels',['../classERF.html#a367a3daba5d844efbed84c52e647cea6',1,'ERF']]], - ['m_5fplot_5fint_5f1_4583',['m_plot_int_1',['../classERF.html#a57cfb4bfead8525174646964992c7e69',1,'ERF']]], - ['m_5fplot_5fint_5f2_4584',['m_plot_int_2',['../classERF.html#ad3311c9ceacd17f34bdb5e03cefa33b3',1,'ERF']]], - ['m_5fplot_5fper_5f1_4585',['m_plot_per_1',['../classERF.html#a3167adc9518cce649a90ab82e9f9c85d',1,'ERF']]], - ['m_5fplot_5fper_5f2_4586',['m_plot_per_2',['../classERF.html#aff879a9c686293a10a3a03027b765c51',1,'ERF']]], - ['m_5fpolicy_4587',['m_policy',['../classMOSTAverage.html#a0e87c91bf31d0e60a31b906081d24eea',1,'MOSTAverage']]], - ['m_5fpower_4588',['m_power',['../classNullWindFarm.html#a61554384fc601d7ae2fb758a8bc7f4f4',1,'NullWindFarm']]], - ['m_5fpp_5fprefix_4589',['m_pp_prefix',['../classMOSTAverage.html#a8e48f835a742b02f039aeb6bc520aef8',1,'MOSTAverage']]], - ['m_5fprecision_4590',['m_precision',['../classPlaneAverage.html#a1f08f5f76700c51c42243410ffce6e66',1,'PlaneAverage']]], - ['m_5fps_4591',['m_ps',['../classSampleData.html#ab96a6354333a8e9db8145813b68b1b5b',1,'SampleData']]], - ['m_5fps_5fmf_4592',['m_ps_mf',['../structPlaneSampler.html#a697a9d0158c0c14f796a7a016759d2f7',1,'PlaneSampler']]], - ['m_5fqmoist_5fsize_4593',['m_qmoist_size',['../classKessler.html#ae94091e97ccba54c040030c98e52aa7c',1,'Kessler::m_qmoist_size()'],['../classNullMoist.html#a645f66b91b08d84aa7451a9da0c11a72',1,'NullMoist::m_qmoist_size()'],['../classSAM.html#a4bf36ad050daafdcfea1aa83ad75f9cf',1,'SAM::m_qmoist_size()']]], - ['m_5fqstate_5fsize_4594',['m_qstate_size',['../classKessler.html#ad5167b56417db2cd78415b4654d6f7ca',1,'Kessler::m_qstate_size()'],['../classNullMoist.html#a3cb016aa9c0f1ee7534ad678723d1c59',1,'NullMoist::m_qstate_size()'],['../classSAM.html#a81c775ecb78f3f228a98a9c39d1d098d',1,'SAM::m_qstate_size()']]], - ['m_5fr_4595',['m_r',['../classFlowerIF.html#a09721c1438c00c21d1babb121dc3d447',1,'FlowerIF']]], - ['m_5fr2c_4596',['m_r2c',['../classamrex_1_1FFT_1_1PoissonTerrainPrecond.html#a79070d76a6a7f5dfe8602fc2c42f36ef',1,'amrex::FFT::PoissonTerrainPrecond']]], - ['m_5fr2d_4597',['m_r2d',['../classERF.html#addf62bfc534515447b94e928ac0b7135',1,'ERF']]], - ['m_5fradius_4598',['m_radius',['../classMOSTAverage.html#a2c167351f6655ef3276f8e5b39439e91',1,'MOSTAverage']]], - ['m_5fratio_4599',['m_ratio',['../classERFFillPatcher.html#ab5ab5fa9bd525d2673c433633e0b3fba',1,'ERFFillPatcher']]], - ['m_5frdocp_4600',['m_rdOcp',['../classReadBndryPlanes.html#a7e0bbe82df8b302172937d7dbb981a2c',1,'ReadBndryPlanes::m_rdOcp()'],['../classSAM.html#a3b461d5620f6b9a08a1e62b60a463af7',1,'SAM::m_rdOcp()']]], - ['m_5frelax_5fmask_4601',['m_relax_mask',['../classERFFillPatcher.html#abad97ea0363653435fd9f922e10a53b2',1,'ERFFillPatcher']]], - ['m_5frot_5ffields_4602',['m_rot_fields',['../classMOSTAverage.html#a733f1b5c94de8ee530f4f257510cb277',1,'MOSTAverage']]], - ['m_5frotate_4603',['m_rotate',['../classABLMost.html#ab107efa0b6bdf80ee44d232919f6a7ad',1,'ABLMost::m_rotate()'],['../classMOSTAverage.html#a7d43a66f7518f75e694e0582dd40ec44',1,'MOSTAverage::m_rotate()']]], - ['m_5frotor_5frad_4604',['m_rotor_rad',['../classNullWindFarm.html#a06d46ff7212efd7893e94b99fa981b9d',1,'NullWindFarm']]], - ['m_5frotor_5frpm_4605',['m_rotor_RPM',['../classNullWindFarm.html#ad19bb9c4842c561c0024ae6d686b1a78',1,'NullWindFarm']]], - ['m_5fset_5fmask_4606',['m_set_mask',['../classERFFillPatcher.html#a9d188e7b7e85221b257799a5a9c5098e',1,'ERFFillPatcher']]], - ['m_5fsign_4607',['m_sign',['../classFlowerIF.html#a1841ecb4de32a4763c2864784f0c22c4',1,'FlowerIF']]], - ['m_5fsst_5flev_4608',['m_sst_lev',['../classABLMost.html#ad8f1957bba407e17edb0a84ace515cde',1,'ABLMost']]], - ['m_5fstart_5fbdy_5ftime_4609',['m_start_bdy_time',['../classABLMost.html#a4fb97b28e44e9ff6930f18083923343a',1,'ABLMost']]], - ['m_5ft_5favg_4610',['m_t_avg',['../classMOSTAverage.html#a05905a4754c7eb39b766b96889b1bd47',1,'MOSTAverage']]], - ['m_5ft_5finit_4611',['m_t_init',['../classMOSTAverage.html#a3fe20fc4a4eb0b283f1d658b6237004c',1,'MOSTAverage']]], - ['m_5fterr_4612',['m_terr',['../classTerrainIF.html#a3e1f2814d20da7b5dd6d1d620b04784c',1,'TerrainIF']]], - ['m_5fterrain_5ftype_4613',['m_terrain_type',['../classERFPhysBCFunct__w.html#a96add99b86d3a03a872af7af85ad8e96',1,'ERFPhysBCFunct_w']]], - ['m_5ftheta_5fdir_4614',['m_theta_dir',['../classSLM.html#aec067697af550a8122138e57c4e0666d',1,'SLM::m_theta_dir()'],['../classMM5.html#ab8187a0b9206d9c1d6632d494a149d1a',1,'MM5::m_theta_dir()']]], - ['m_5fthrust_5fcoeff_4615',['m_thrust_coeff',['../classNullWindFarm.html#a7fe11fbaf6a246c60156e40aec3835f7',1,'NullWindFarm']]], - ['m_5fthrust_5fcoeff_5fstanding_4616',['m_thrust_coeff_standing',['../classNullWindFarm.html#a5a95464f19af9063228d23981f3a75cd',1,'NullWindFarm']]], - ['m_5ftime_4617',['m_time',['../structTimeInterpolatedData.html#a9b0102facc1d00011f48f95132955e27',1,'TimeInterpolatedData']]], - ['m_5ftime_5ffile_4618',['m_time_file',['../classReadBndryPlanes.html#a8027f415fce9acdc5ad53745016f67bf',1,'ReadBndryPlanes::m_time_file()'],['../classWriteBndryPlanes.html#a91c8abe5b1a15f5fe630db40230f08c1',1,'WriteBndryPlanes::m_time_file()']]], - ['m_5ftime_5fwindow_4619',['m_time_window',['../classMOSTAverage.html#ac95147c0d7961323ca8b079f63cd4be9',1,'MOSTAverage']]], - ['m_5ftinterp_4620',['m_tinterp',['../classReadBndryPlanes.html#a3f5e28f23e03b5c32f23ac953987728a',1,'ReadBndryPlanes']]], - ['m_5ftn_4621',['m_tn',['../classReadBndryPlanes.html#ade779c58aa5ea62cf1e03cbfaf98bb61',1,'ReadBndryPlanes']]], - ['m_5ftnp1_4622',['m_tnp1',['../classReadBndryPlanes.html#a4343c3c0761df0f96c58f8d268a43017',1,'ReadBndryPlanes']]], - ['m_5ftnp2_4623',['m_tnp2',['../classReadBndryPlanes.html#aca1dcdc531215bfd5a12fb286d064c8c',1,'ReadBndryPlanes']]], - ['m_5fturb_5fdisk_5fangle_4624',['m_turb_disk_angle',['../classNullWindFarm.html#a3b3156bf79da131a833a2a6a96b27421',1,'NullWindFarm']]], - ['m_5ftype_5fforest_4625',['m_type_forest',['../classForestDrag.html#ad8061afe4ea0b11059a6094ae07243cf',1,'ForestDrag']]], - ['m_5fu_5fbc_5fdata_4626',['m_u_bc_data',['../classERFPhysBCFunct__u.html#a603a1822cba514966ad201cfc676cdf6',1,'ERFPhysBCFunct_u']]], - ['m_5fuse_5fprecond_4627',['m_use_precond',['../classTerrainPoisson.html#a8dcf3ca721769bc5f8bf7c1b2ea9634e',1,'TerrainPoisson']]], - ['m_5fuse_5freal_5fbcs_4628',['m_use_real_bcs',['../classERFPhysBCFunct__cons.html#a0e54453355d6a7c96044113c8827a008',1,'ERFPhysBCFunct_cons::m_use_real_bcs()'],['../classERFPhysBCFunct__u.html#a4a1ce4ec8f730cb61568aee6eceefe1f',1,'ERFPhysBCFunct_u::m_use_real_bcs()'],['../classERFPhysBCFunct__v.html#aa17ac5983f98d1b13f952fa7f2c39b54',1,'ERFPhysBCFunct_v::m_use_real_bcs()'],['../classERFPhysBCFunct__w.html#a6e6cdc32da147f7bc00d8c408b5df9a1',1,'ERFPhysBCFunct_w::m_use_real_bcs()']]], - ['m_5fv_5fbc_5fdata_4629',['m_v_bc_data',['../classERFPhysBCFunct__v.html#a1abc171e8cfcd542f4d9e312e0f586c1',1,'ERFPhysBCFunct_v']]], - ['m_5fvar_5fnames_4630',['m_var_names',['../classReadBndryPlanes.html#aa5f533fb198d42785bfebe5cd8ae7131',1,'ReadBndryPlanes::m_var_names()'],['../classWriteBndryPlanes.html#a85703bf41a6ba0382f13a90f64ba417b',1,'WriteBndryPlanes::m_var_names()']]], - ['m_5fvar_5fz0_4631',['m_var_z0',['../classABLMost.html#ab1da46aefd129763fb25f5a6839e48dd',1,'ABLMost']]], - ['m_5fvelocity_4632',['m_velocity',['../classNullWindFarm.html#af83e2833c70c7374fa00ec94755e8038',1,'NullWindFarm']]], - ['m_5fvsg_4633',['m_Vsg',['../classMOSTAverage.html#a5dfb4235703aaa2364d49d7fbb8d1512',1,'MOSTAverage']]], - ['m_5fw2d_4634',['m_w2d',['../classERF.html#aa53035f34ba133b86172e180abda4209',1,'ERF']]], - ['m_5fw_5fbc_5fdata_4635',['m_w_bc_data',['../classERFPhysBCFunct__w.html#a4c66456080eb954ef8c80fc3dcfc4c3a',1,'ERFPhysBCFunct_w']]], - ['m_5fwind_5fspeed_4636',['m_wind_speed',['../classNullWindFarm.html#a9beae3f8f39bb7bde432530da926d6ef',1,'NullWindFarm']]], - ['m_5fwindfarm_5fmodel_4637',['m_windfarm_model',['../classWindFarm.html#af3953694e6a246585c20f50436a65123',1,'WindFarm']]], - ['m_5fx_5fforest_4638',['m_x_forest',['../classForestDrag.html#a6f6067a4f71428c8ab3039240a3207e4',1,'ForestDrag']]], - ['m_5fx_5fpos_4639',['m_x_pos',['../classMOSTAverage.html#a58c320eb48f9b8a1b0983d2770e9f3ea',1,'MOSTAverage']]], - ['m_5fxlo_4640',['m_xlo',['../classPlaneAverage.html#a42c7dfa900a0b69ba1d294455ca8ba51',1,'PlaneAverage']]], - ['m_5fxloc_4641',['m_xloc',['../classNullWindFarm.html#ac8ff132b0d2d52032ec19344ec6a74c6',1,'NullWindFarm']]], - ['m_5fy_5fforest_4642',['m_y_forest',['../classForestDrag.html#af1a72c6ce2a773a31ae0d6f84aa2aa71',1,'ForestDrag']]], - ['m_5fy_5fpos_4643',['m_y_pos',['../classMOSTAverage.html#a1beb0dad926be2f2d9cb1de69a1a3374',1,'MOSTAverage']]], - ['m_5fyloc_4644',['m_yloc',['../classNullWindFarm.html#a86792dc0d8fb3dfc9b9646c38a2926da',1,'NullWindFarm']]], - ['m_5fz_5fphys_5fnd_4645',['m_z_phys_nd',['../classMOSTAverage.html#a3a49018467b69573ef84df9cdfd86da4',1,'MOSTAverage::m_z_phys_nd()'],['../classERFPhysBCFunct__cons.html#ad33ab704eb9b5d62a4db9317f40255dd',1,'ERFPhysBCFunct_cons::m_z_phys_nd()'],['../classERFPhysBCFunct__u.html#aefe9bc994735627162154bc289a0de3c',1,'ERFPhysBCFunct_u::m_z_phys_nd()'],['../classERFPhysBCFunct__v.html#afffa0e227916c179928f9a3eb7a07c3c',1,'ERFPhysBCFunct_v::m_z_phys_nd()'],['../classERFPhysBCFunct__w.html#aa37508122179536336aa8dba19d34c1b',1,'ERFPhysBCFunct_w::m_z_phys_nd()'],['../classKessler.html#aaead0b1bbb0693e5ef480fd15bcbe559',1,'Kessler::m_z_phys_nd()'],['../classSAM.html#a51af1452ad89711f8ddaa554cdc49ee6',1,'SAM::m_z_phys_nd()']]], - ['m_5fz_5fpos_4646',['m_z_pos',['../classMOSTAverage.html#a81ff1b7e8d026f0cd74147cbcc016d15',1,'MOSTAverage']]], - ['m_5fzphys_4647',['m_zphys',['../classTerrainPoisson.html#a11b0c98e8dbdb9c050a17603e1b6fd30',1,'TerrainPoisson']]], - ['m_5fzref_4648',['m_zref',['../classMOSTAverage.html#af2f1477f6bc5e4b2f2ddee27d17dab9f',1,'MOSTAverage']]], - ['ma_5flist_4649',['ma_list',['../classMamConstituents.html#ab9703f219ce7a084e170017035dc269b',1,'MamConstituents']]], - ['mam_5faer_4650',['mam_aer',['../classAerRadProps.html#afb607ae14bfc3e46dd66c9e04627a57d',1,'AerRadProps']]], - ['mam_5fconsti_4651',['mam_consti',['../classAerRadProps.html#a66f750181cccc82c03268b0a4a245ecc',1,'AerRadProps::mam_consti()'],['../classMam4__aer.html#a2dcd6d3b6a38a2f0e8bc389c80fb4ae9',1,'Mam4_aer::mam_consti()']]], - ['mapfac_5fm_4652',['mapfac_m',['../classERF.html#a23aacdb72e9d2dfed8e2ebd2c2526497',1,'ERF']]], - ['mapfac_5fu_4653',['mapfac_u',['../classERF.html#a1e8afee1508b720dab56f5d044deb301',1,'ERF']]], - ['mapfac_5fv_4654',['mapfac_v',['../classERF.html#ae49b5055f9a7117fa15918a5daa775b7',1,'ERF']]], - ['mass_5fname_4655',['mass_name',['../structMamConstituents_1_1gas__t.html#ad63e38b410aa69ed3f76d6898b35b53a',1,'MamConstituents::gas_t::mass_name()'],['../structMamConstituents_1_1aerosol__t.html#a300418f68393143be3f4852641ac465b',1,'MamConstituents::aerosol_t::mass_name()']]], - ['max_5fiter_4656',['MAX_ITER',['../namespaceHSEutils.html#a10de540cb8ad96aea8cd080f4d1e72fa',1,'HSEutils']]], - ['max_5fstep_4657',['max_step',['../classERF.html#a0634154e8e58379c495c3e7fe7c5e4d6',1,'ERF']]], - ['mdata_4658',['mdata',['../structadiabatic__mod__charnock.html#ad33aa4fea2aa05dbb4057dcef251e0da',1,'adiabatic_mod_charnock::mdata()'],['../structadiabatic.html#afdc69c66b9c49f67d4f2409bc1f3ce29',1,'adiabatic::mdata()'],['../structsurface__temp__wave__coupled.html#a44d84ddefc6dc5572f1b1e614996b288',1,'surface_temp_wave_coupled::mdata()'],['../structsurface__temp__donelan.html#a78d9b2c9e7acc59519c2e5d911e2a83d',1,'surface_temp_donelan::mdata()'],['../structsurface__temp__mod__charnock.html#a98f673e5030f4509a8874466337f50c4',1,'surface_temp_mod_charnock::mdata()'],['../structsurface__temp__charnock.html#a073ad08e0d652e792b459878e10dc41b',1,'surface_temp_charnock::mdata()'],['../structsurface__temp.html#afec351f7cde260c6e96a27297cb4010f',1,'surface_temp::mdata()'],['../structsurface__flux__wave__coupled.html#a7c81c888df97ef0ff4dc54be9c4e163a',1,'surface_flux_wave_coupled::mdata()'],['../structsurface__flux__donelan.html#ab3b7307051954c791dcf73bb13213e9f',1,'surface_flux_donelan::mdata()'],['../structsurface__flux__mod__charnock.html#a6fa441221eb1f30d65437ce890adfd46',1,'surface_flux_mod_charnock::mdata()'],['../structsurface__flux__charnock.html#a60030c5104987d6287efd5d9b996014c',1,'surface_flux_charnock::mdata()'],['../structsurface__flux.html#a960909fe387424192cf802afccdc7bed',1,'surface_flux::mdata()'],['../structadiabatic__wave__coupled.html#a812ea5ea7d6223e5512c372b3260d1bc',1,'adiabatic_wave_coupled::mdata()'],['../structadiabatic__donelan.html#a6b220db789638a784c51dfedcda1ffb9',1,'adiabatic_donelan::mdata()'],['../structadiabatic__charnock.html#a5c11064c35d6eefd22558180155d6ede',1,'adiabatic_charnock::mdata()']]], - ['mg_5fverbose_4659',['mg_verbose',['../classERF.html#a2c4e27d6b7928c7081f17e63d0834200',1,'ERF']]], - ['mic_5ffab_5fvars_4660',['mic_fab_vars',['../classKessler.html#aa11214a3e579cc9d6309359b1c05e5ab',1,'Kessler::mic_fab_vars()'],['../classSAM.html#a36ee9e1e1a94d22304f46e064f16e11e',1,'SAM::mic_fab_vars()']]], - ['micro_4661',['micro',['../classERF.html#a4b7277d54649219f31fe286eee9d415a',1,'ERF']]], - ['micvarmap_4662',['MicVarMap',['../classKessler.html#a18164f048f846cd122de43803b49c1cb',1,'Kessler::MicVarMap()'],['../classSAM.html#a6008487ad12ada77acdcb3ee41371c98',1,'SAM::MicVarMap()']]], - ['modal_5foptics_5ffile_4663',['modal_optics_file',['../classMam4__aer.html#a396c0ab69e47a8cbc27c346aa2fb489d',1,'Mam4_aer']]], - ['mode_5ftype_5fnames_4664',['mode_type_names',['../classMamConstituents.html#a5c94b10764d82b018270ebf012cd657b',1,'MamConstituents']]], - ['modes_4665',['modes',['../classMamConstituents.html#a1692c29032818c08c3b1ac985a35d521',1,'MamConstituents']]], - ['moistscal_5fhoriz_5fadv_5ftype_4666',['moistscal_horiz_adv_type',['../structAdvChoice.html#a22f84c60e56d4b3bde6b7f9548c87af3',1,'AdvChoice']]], - ['moistscal_5fhoriz_5fupw_5ffrac_4667',['moistscal_horiz_upw_frac',['../structAdvChoice.html#a69b32bcee6cd30f3f88280d0ec49cd35',1,'AdvChoice']]], - ['moistscal_5fvert_5fadv_5ftype_4668',['moistscal_vert_adv_type',['../structAdvChoice.html#a2f888dfcb79cdb766ee04f21aada83ec',1,'AdvChoice']]], - ['moistscal_5fvert_5fupw_5ffrac_4669',['moistscal_vert_upw_frac',['../structAdvChoice.html#a334139583accdc5718a939b20b308bb9',1,'AdvChoice']]], - ['moisture_5ftype_4670',['moisture_type',['../structSolverChoice.html#aacbfbe6f4a3040db3efdc6dbf8fa291b',1,'SolverChoice::moisture_type()'],['../classRadiation.html#a1863ee4ba67242d2fb2dede10b4a9460',1,'Radiation::moisture_type()']]], - ['molec_5fdiff_5ftype_4671',['molec_diff_type',['../structDiffChoice.html#aed5c75ec58e358a735d97869147b2baf',1,'DiffChoice']]], - ['mri_5fintegrator_5fmem_4672',['mri_integrator_mem',['../classERF.html#a09d0fb2bd609c898a665d9530a744585',1,'ERF']]], - ['mu_4673',['mu',['../structPhysProp_1_1physprop__t.html#aa23d4f11099641ffb9c395c327156980',1,'PhysProp::physprop_t::mu()'],['../classRadiation.html#a2002e601e86a58ebb15989a5b61ebe60',1,'Radiation::mu()']]], - ['muelq_4674',['muelq',['../ERF__Constants_8H.html#a0e5683feac33352111ce4445dbedbf45',1,'ERF_Constants.H']]], - ['mvelpp_4675',['mvelpp',['../classRadiation.html#ae4dacdbc7383b92511c2385bd59ed49a',1,'Radiation']]], - ['mwdair_4676',['mwdair',['../ERF__Constants_8H.html#a650da208ce885c0f6c9c742d26dc4b0e',1,'ERF_Constants.H']]], - ['mwwv_4677',['mwwv',['../ERF__Constants_8H.html#a75abd92a75952e8eefd06628c8c3487d',1,'ERF_Constants.H']]], - ['my_5fturb_5fdisk_5fangle_4678',['my_turb_disk_angle',['../classWindFarm.html#a0d274380a6e7a61593459bb0b0f642d2',1,'WindFarm']]] + ['m_5factive_4453',['m_active',['../classCIF.html#a1e3b931483e96527c09af4016a29d101',1,'CIF']]], + ['m_5faverages_4454',['m_averages',['../classMOSTAverage.html#a158b82286f1bed8b02da2c8b2ac7f4c0',1,'MOSTAverage']]], + ['m_5faxis_4455',['m_axis',['../classSAM.html#a37854ec84283a4229cf86b54cfcfc72b',1,'SAM::m_axis()'],['../classKessler.html#afea161a2b985d4c0eb4aa9390a808ab4',1,'Kessler::m_axis()'],['../classPlaneAverage.html#ab1c325b8a1241cb446bad96fa558e770',1,'PlaneAverage::m_axis()']]], + ['m_5fbc_5fextdir_5fvals_4456',['m_bc_extdir_vals',['../classERFPhysBCFunct__cons.html#a2765ac9561c270b92ef8bd77c3c96045',1,'ERFPhysBCFunct_cons::m_bc_extdir_vals()'],['../classERF.html#a27261ba76aa71f1ddbf87bca0ede579f',1,'ERF::m_bc_extdir_vals()'],['../classERFPhysBCFunct__w.html#afcaa9deb9258f849737281efb4327694',1,'ERFPhysBCFunct_w::m_bc_extdir_vals()'],['../classERFPhysBCFunct__u.html#a24b743a8e87bbc7ff9a62c2abbe2b28c',1,'ERFPhysBCFunct_u::m_bc_extdir_vals()'],['../classERFPhysBCFunct__v.html#afac2b29228e83f3693609ae1374d91e2',1,'ERFPhysBCFunct_v::m_bc_extdir_vals()']]], + ['m_5fbc_5fneumann_5fvals_4457',['m_bc_neumann_vals',['../classERFPhysBCFunct__u.html#a5b9cbbd733227f1cad1032feb2f93efe',1,'ERFPhysBCFunct_u::m_bc_neumann_vals()'],['../classERFPhysBCFunct__v.html#a7e82182923ff12b9ee242d7aaf8b25d9',1,'ERFPhysBCFunct_v::m_bc_neumann_vals()'],['../classERFPhysBCFunct__w.html#adac2302187d51d560028611a5d6b1743',1,'ERFPhysBCFunct_w::m_bc_neumann_vals()'],['../classERF.html#af783df8719de2e72e347de5860f71528',1,'ERF::m_bc_neumann_vals()'],['../classERFPhysBCFunct__cons.html#a390ff8852b8e8807798c1adff0dc4a75',1,'ERFPhysBCFunct_cons::m_bc_neumann_vals()']]], + ['m_5fbdy_5ftime_5finterval_4458',['m_bdy_time_interval',['../classABLMost.html#a049bc06685178431599f3bfaa57d63bd',1,'ABLMost']]], + ['m_5fblade_5fpitch_4459',['m_blade_pitch',['../classNullWindFarm.html#aabb34a6b16b5001624bf06c98aa226a9',1,'NullWindFarm']]], + ['m_5fbld_5fairfoil_5faoa_4460',['m_bld_airfoil_aoa',['../classNullWindFarm.html#a6f6bd907d33ec99543896b82fac6b4e4',1,'NullWindFarm']]], + ['m_5fbld_5fairfoil_5fcd_4461',['m_bld_airfoil_Cd',['../classNullWindFarm.html#a85b5fcee1d9a35f884255e9dec414bfd',1,'NullWindFarm']]], + ['m_5fbld_5fairfoil_5fcl_4462',['m_bld_airfoil_Cl',['../classNullWindFarm.html#ad337a725edf9efdaf1fd4a49ddd35505',1,'NullWindFarm']]], + ['m_5fbld_5fchord_4463',['m_bld_chord',['../classNullWindFarm.html#acbc82ecabc6211a7d2070f24a805fbc9',1,'NullWindFarm']]], + ['m_5fbld_5frad_5floc_4464',['m_bld_rad_loc',['../classNullWindFarm.html#a27f046283d051fb0abcf5f6d9080b471',1,'NullWindFarm']]], + ['m_5fbld_5ftwist_4465',['m_bld_twist',['../classNullWindFarm.html#a453673de82ca8ffbced1c32bfb27555d',1,'NullWindFarm']]], + ['m_5fbnd_5fbx_4466',['m_bnd_bx',['../structLineSampler.html#acf84e5ae60cbfd1faaf2e8ac6c9ff5eb',1,'LineSampler']]], + ['m_5fbnd_5frbx_4467',['m_bnd_rbx',['../structPlaneSampler.html#a85e5bf3ef37f89b54d88bba6e2334a24',1,'PlaneSampler']]], + ['m_5fbox_4468',['m_box',['../classRadiation.html#a37098b6502fef13732ed996200b7f64c',1,'Radiation']]], + ['m_5fc_5fp_4469',['m_C_P',['../classNullWindFarm.html#a2c312d78fc769a3d081c2df6492b5b35',1,'NullWindFarm']]], + ['m_5fc_5ft_4470',['m_C_T',['../classNullWindFarm.html#a5cb0849867fadd38770da912749adb50',1,'NullWindFarm']]], + ['m_5fcba_4471',['m_cba',['../classERFFillPatcher.html#a35fb56b2946f596728b9ac793eb47c5e',1,'ERFFillPatcher']]], + ['m_5fcd_5fforest_4472',['m_cd_forest',['../classForestDrag.html#ab8c2ba2f9e1a82a5e1b116df64dfb0f0',1,'ForestDrag']]], + ['m_5fcdm_4473',['m_cdm',['../classERFFillPatcher.html#a52af76dca01fd13bdb29834d4b9ca5e2',1,'ERFFillPatcher']]], + ['m_5fcenter_4474',['m_center',['../classFlowerIF.html#afde7bb14577df6460b603a3fb9c68c30',1,'FlowerIF']]], + ['m_5fcf_5fcrse_5fdata_5fnew_4475',['m_cf_crse_data_new',['../classERFFillPatcher.html#a89f24e6cfe30a2180b1667aead7edf28',1,'ERFFillPatcher']]], + ['m_5fcf_5fcrse_5fdata_5fold_4476',['m_cf_crse_data_old',['../classERFFillPatcher.html#ad6ac8a363c79d1a98703988478420586',1,'ERFFillPatcher']]], + ['m_5fcf_5fmask_4477',['m_cf_mask',['../classERFFillPatcher.html#a874bf44ab38e936013bbf8454a41a680',1,'ERFFillPatcher']]], + ['m_5fcgeom_4478',['m_cgeom',['../classERFFillPatcher.html#a5b1190e4ec0fe257d6d3fa886054dc2c',1,'ERFFillPatcher']]], + ['m_5fcheck_5fint_4479',['m_check_int',['../classERF.html#a69a3f925e95ec4244b0257f9de16d65a',1,'ERF']]], + ['m_5fcheck_5fper_4480',['m_check_per',['../classERF.html#a5fbf17cfc8d9e5b994783e05ec3594b2',1,'ERF']]], + ['m_5fcp_5fsoil_4481',['m_cp_soil',['../classMM5.html#a0bc2d572786956904d71c30db49e3ae2',1,'MM5::m_cp_soil()'],['../classSLM.html#a3c284ad4d275aa9ce80eca787cab87a4',1,'SLM::m_cp_soil()']]], + ['m_5fcrse_5ftimes_4482',['m_crse_times',['../classERFFillPatcher.html#a562ca1201d642f3a7dd5700a056776d9',1,'ERFFillPatcher']]], + ['m_5fd_5fsoil_4483',['m_d_soil',['../classMM5.html#a273c04f6eac3e48325dfce1e34e58df4',1,'MM5::m_d_soil()'],['../classSLM.html#a6ba8b659255822be9538ba66c22b2533',1,'SLM::m_d_soil()']]], + ['m_5fdata_4484',['m_data',['../structTimeInterpolatedData.html#a7021ade0b30697e6eef3df932447d4fc',1,'TimeInterpolatedData']]], + ['m_5fdata_5finterp_4485',['m_data_interp',['../classReadBndryPlanes.html#a5468d5d8813dc471dac1335611ec8dc9',1,'ReadBndryPlanes']]], + ['m_5fdata_5fn_4486',['m_data_n',['../classReadBndryPlanes.html#acc6e94621293c94d1322a8cafbf61ad4',1,'ReadBndryPlanes']]], + ['m_5fdata_5fnp1_4487',['m_data_np1',['../classReadBndryPlanes.html#ae34737833f599f3cb5ef945ac3f57f4b',1,'ReadBndryPlanes']]], + ['m_5fdata_5fnp2_4488',['m_data_np2',['../classReadBndryPlanes.html#a5338493101cfbb8eb27301f83aeca290',1,'ReadBndryPlanes']]], + ['m_5fdetj_5fcc_4489',['m_detJ_cc',['../classKessler.html#a534c115146bedf2e3f600ac351162252',1,'Kessler::m_detJ_cc()'],['../classSAM.html#a1b09febe32fbfebb402091fd31cd9996',1,'SAM::m_detJ_cc()']]], + ['m_5fdiameter_5fforest_4490',['m_diameter_forest',['../classForestDrag.html#a17d88d33ff5abbdd20b28e2e841b09b7',1,'ForestDrag']]], + ['m_5fdir_4491',['m_dir',['../structLineSampler.html#a8fc089e1d316a8d694fd521baae9f076',1,'LineSampler::m_dir()'],['../structPlaneSampler.html#a166b20f0a2cc42f436e82f327b974cb6',1,'PlaneSampler::m_dir()']]], + ['m_5fdmap_4492',['m_dmap',['../classTerrainPoisson.html#adf44ae8fab76f41f31a9f340ffa0aa1b',1,'TerrainPoisson']]], + ['m_5fdomain_5fbcs_5ftype_4493',['m_domain_bcs_type',['../classERFPhysBCFunct__cons.html#ab131fcff8649a5dde5f39fe890b6b383',1,'ERFPhysBCFunct_cons::m_domain_bcs_type()'],['../classERFPhysBCFunct__u.html#a90c9e642d2c31bc2245cf57f3fb4adc8',1,'ERFPhysBCFunct_u::m_domain_bcs_type()'],['../classERFPhysBCFunct__v.html#ae26c0b8c1a5145f1e1f2d44717745cfd',1,'ERFPhysBCFunct_v::m_domain_bcs_type()'],['../classERFPhysBCFunct__w.html#a052d31c743d030292761e95702615467',1,'ERFPhysBCFunct_w::m_domain_bcs_type()'],['../classERFPhysBCFunct__base.html#af918f7e795b633cdb0c2d377634c2bac',1,'ERFPhysBCFunct_base::m_domain_bcs_type()']]], + ['m_5fdomain_5fbcs_5ftype_5fd_4494',['m_domain_bcs_type_d',['../classERFPhysBCFunct__cons.html#aa39c1df9dc816a85f84c43c1b065be35',1,'ERFPhysBCFunct_cons::m_domain_bcs_type_d()'],['../classERFPhysBCFunct__base.html#a1363b51788d4178be65ec64c462b7f30',1,'ERFPhysBCFunct_base::m_domain_bcs_type_d()'],['../classERFPhysBCFunct__w.html#a87159676dd29c47ebd69e40b6dda5f1a',1,'ERFPhysBCFunct_w::m_domain_bcs_type_d()'],['../classERFPhysBCFunct__v.html#a0bc0f76b47d1d805161695e977dad5fb',1,'ERFPhysBCFunct_v::m_domain_bcs_type_d()'],['../classERFPhysBCFunct__u.html#a3b17acdd618c58f48856b4fa7a35abfc',1,'ERFPhysBCFunct_u::m_domain_bcs_type_d()']]], + ['m_5fdr_4495',['m_dr',['../classFlowerIF.html#a6e09a1d51eb36041dcb175f8784b8eeb',1,'FlowerIF']]], + ['m_5fdt_4496',['m_dt',['../classMM5.html#a41e60b81361852b0e4577bd7e3f88062',1,'MM5::m_dt()'],['../classSLM.html#a48b1e4c0290b62bafb4f6acb9291aa68',1,'SLM::m_dt()']]], + ['m_5fdt_5fcrse_4497',['m_dt_crse',['../classERFFillPatcher.html#ae89877908970649653ae09c42d3c7b05',1,'ERFFillPatcher']]], + ['m_5fdx_4498',['m_dx',['../classPlaneAverage.html#ade7352e3a72a2e09561e031acd32cc8a',1,'PlaneAverage']]], + ['m_5fdz_5flsm_4499',['m_dz_lsm',['../classSLM.html#a6dcae265ee0a43c0d7ecdd52074431ce',1,'SLM::m_dz_lsm()'],['../classMM5.html#a754e507be4ac680c9f49ab0158afc4b5',1,'MM5::m_dz_lsm()']]], + ['m_5feddydiffs_5flev_4500',['m_eddyDiffs_lev',['../classABLMost.html#a05cc96f74b89c4e277fe3db4ea01d3fa',1,'ABLMost']]], + ['m_5fexp_5fmost_4501',['m_exp_most',['../classABLMost.html#ac3de35be0d6cf3841e9a868830fc42c5',1,'ABLMost']]], + ['m_5fexpand_5fplotvars_5fto_5funif_5frr_4502',['m_expand_plotvars_to_unif_rr',['../classERF.html#adb272adf862040a2f1a6226c57c35627',1,'ERF']]], + ['m_5fextent_5frad_4503',['m_extent_rad',['../classReadBndryPlanes.html#ae341a8d70430128e78f7cac75e0d4e8a',1,'ReadBndryPlanes::m_extent_rad()'],['../classWriteBndryPlanes.html#a41799219d138892871e1a6e8c3755da1',1,'WriteBndryPlanes::m_extent_rad()']]], + ['m_5ff1_4504',['m_f1',['../classUnionCIF.html#a48c696814009301ff056340a2ebb601c',1,'UnionCIF::m_f1()'],['../classIntersectionCIF.html#a0b24d2c5c189c43b259c173c162aa1f1',1,'IntersectionCIF::m_f1()']]], + ['m_5ff2_4505',['m_f2',['../classIntersectionCIF.html#af11428d551013bf6318ef89873537a4e',1,'IntersectionCIF::m_f2()'],['../classUnionCIF.html#a150413e8d9e4bbd2b44e924c839f296a',1,'UnionCIF::m_f2()']]], + ['m_5ffac_5fcond_4506',['m_fac_cond',['../classKessler.html#a74746cef2381fd949a06be46f99a05c7',1,'Kessler::m_fac_cond()'],['../classSAM.html#a66b0ffc2f98c96c5a3b3c760a854be95',1,'SAM::m_fac_cond()']]], + ['m_5ffac_5ffus_4507',['m_fac_fus',['../classKessler.html#acaf08727482ff116185a6dbdf2bd54f9',1,'Kessler::m_fac_fus()'],['../classSAM.html#a53d38219476c32ba2dd751c02bcae53c',1,'SAM::m_fac_fus()']]], + ['m_5ffac_5fsub_4508',['m_fac_sub',['../classKessler.html#a2feda15429da3d8227d75cc3f6da71ba',1,'Kessler::m_fac_sub()'],['../classSAM.html#a8653cbf2c13ac3595f5f8710a3f1beec',1,'SAM::m_fac_sub()']]], + ['m_5ffact_5fnew_4509',['m_fact_new',['../classMOSTAverage.html#a960bae1d528aef6d0e7034dbea65a2c3',1,'MOSTAverage']]], + ['m_5ffact_5fold_4510',['m_fact_old',['../classMOSTAverage.html#ae1d62c88d62bbef8458d0084200f65f2',1,'MOSTAverage']]], + ['m_5ffactory_4511',['m_factory',['../classERF.html#abd4f9db387b864a97ac18c8dfe71f4e4',1,'ERF']]], + ['m_5ffba_4512',['m_fba',['../classERFFillPatcher.html#a297b1d2468ed152850c7bb6c156101b3',1,'ERFFillPatcher']]], + ['m_5ffdm_4513',['m_fdm',['../classERFFillPatcher.html#afef007cab3f3a1e4a7deea141f397e51',1,'ERFFillPatcher']]], + ['m_5ffgeom_4514',['m_fgeom',['../classERFFillPatcher.html#a12694a711f281b957f7015a98e5c9b77',1,'ERFFillPatcher']]], + ['m_5ffield_4515',['m_field',['../classPlaneAverage.html#a6c29e3eafbbb7028e801c513b29a1c09',1,'PlaneAverage']]], + ['m_5ffields_4516',['m_fields',['../classMOSTAverage.html#ad301df8e1ee46557a4d277c3f87fae69',1,'MOSTAverage']]], + ['m_5ffilename_4517',['m_filename',['../classReadBndryPlanes.html#a3a130c25c6b3c327e58d3e4687a051b9',1,'ReadBndryPlanes::m_filename()'],['../classWriteBndryPlanes.html#abbc94048dfd43b653b7754d785c11d2f',1,'WriteBndryPlanes::m_filename()']]], + ['m_5fforest_4518',['m_forest',['../classERF.html#a28cc050008267e4138c5a716ecf689a2',1,'ERF']]], + ['m_5fforest_5fdrag_4519',['m_forest_drag',['../classForestDrag.html#acb32d6e1088af2621a723601500db7b3',1,'ForestDrag']]], + ['m_5fgeom_4520',['m_geom',['../classKessler.html#a48f29ab8e5d1232ee83851fd904e9354',1,'Kessler::m_geom()'],['../classPlaneAverage.html#ae359b042dfa8a0b951a3d34706c3c385',1,'PlaneAverage::m_geom()'],['../classRadiation.html#ae5477e7b80b52cebf89ec3b8bdce0f3c',1,'Radiation::m_geom()'],['../classSAM.html#a8242fff43eb2cf417036eb36f5e4a3d8',1,'SAM::m_geom()'],['../classTerrainPoisson.html#a15e050b9bd993409e07ceef1650ebb31',1,'TerrainPoisson::m_geom()'],['../classamrex_1_1FFT_1_1PoissonTerrainPrecond.html#a76b540b21cf5a240c4bd93ce72dbb3ca',1,'amrex::FFT::PoissonTerrainPrecond::m_geom()'],['../classSLM.html#a870bfd56a5fe10dc6b7b8f0347a9b218',1,'SLM::m_geom()'],['../classMM5.html#a7edc95309bb52864bba5341f19262063',1,'MM5::m_geom()'],['../classWriteBndryPlanes.html#a007dc2174ebcc2e2d79e8f31f41255cb',1,'WriteBndryPlanes::m_geom()'],['../classTerrainIF.html#aeb902107efd92150abad59ec0a8cf088',1,'TerrainIF::m_geom()'],['../classERFPhysBCFunct__base.html#a8cde4476cef731ed821f25229ddb0c7b',1,'ERFPhysBCFunct_base::m_geom()'],['../classERFPhysBCFunct__w.html#a1e9f9a0981a60be4e8e3a2b906444878',1,'ERFPhysBCFunct_w::m_geom()'],['../classERFPhysBCFunct__v.html#a01f7c56f64ac414f4ec69ff8c45a2f2a',1,'ERFPhysBCFunct_v::m_geom()'],['../classERFPhysBCFunct__u.html#a12a1e078b61a3e00958bf0f3f69bfe5f',1,'ERFPhysBCFunct_u::m_geom()'],['../classERFPhysBCFunct__cons.html#a1a3121bc392962a3c3149a6e2db2791b',1,'ERFPhysBCFunct_cons::m_geom()'],['../classMOSTAverage.html#aed9b6c726189d8858abba0a2a66feca1',1,'MOSTAverage::m_geom()'],['../classABLMost.html#a1795a510d08fbd88e6599e014f97b6c5',1,'ABLMost::m_geom()'],['../classReadBndryPlanes.html#af4c91eeb64f4e49767e97c1e72de06fc',1,'ReadBndryPlanes::m_geom()']]], + ['m_5fgocp_4521',['m_gOcp',['../classKessler.html#aac004df387a7f0725724f017ca3d4a99',1,'Kessler::m_gOcp()'],['../classSAM.html#a3a76b3fc76d33c147dcaab81a738f41c',1,'SAM::m_gOcp()']]], + ['m_5fgrids_4522',['m_grids',['../classTerrainPoisson.html#ada942a4488d49acc588f1afe2a4cc877',1,'TerrainPoisson']]], + ['m_5fgtoe_4523',['m_gtoe',['../classSAM.html#a579b5a1e16d7b9d8d317e475a6a43705',1,'SAM::m_gtoe()'],['../classKessler.html#ae8749011028be638e3fb8051e22f83f1',1,'Kessler::m_gtoe()']]], + ['m_5fheight_5fforest_4524',['m_height_forest',['../classForestDrag.html#a70219f7646623030f5eca622c0467f7a',1,'ForestDrag']]], + ['m_5fhub_5fheight_4525',['m_hub_height',['../classNullWindFarm.html#ad403f4133b2292495e5dd949fcc59207',1,'NullWindFarm']]], + ['m_5fhwave_5flev_4526',['m_Hwave_lev',['../classABLMost.html#a644ccdc438574061ec7ae75cdc714ec6',1,'ABLMost']]], + ['m_5fi_5findx_4527',['m_i_indx',['../classMOSTAverage.html#a2f5fb25e7c5196338ee5a051708d8f62',1,'MOSTAverage']]], + ['m_5fifs_4528',['m_ifs',['../classUnionListIF.html#a89c2512bb20d220882024302d7a92a3f',1,'UnionListIF']]], + ['m_5fin_5frad_4529',['m_in_rad',['../classReadBndryPlanes.html#a8269a127a4db1fd93794dcb8062f5fa9',1,'ReadBndryPlanes::m_in_rad()'],['../classWriteBndryPlanes.html#a7b350ac1d0c6151ed748a575475f8fbd',1,'WriteBndryPlanes::m_in_rad()']]], + ['m_5fin_5ftimes_4530',['m_in_times',['../classReadBndryPlanes.html#adfe9045e42be78e2a735151d969183d7',1,'ReadBndryPlanes::m_in_times()'],['../classWriteBndryPlanes.html#a15fa114f52237b735599b6a5cac40d26',1,'WriteBndryPlanes::m_in_times()']]], + ['m_5fin_5ftimesteps_4531',['m_in_timesteps',['../classReadBndryPlanes.html#a7bfda76cde9aa1b8290577c40a612795',1,'ReadBndryPlanes::m_in_timesteps()'],['../classWriteBndryPlanes.html#a7cab948881900ffa97145c47221dcb44',1,'WriteBndryPlanes::m_in_timesteps()']]], + ['m_5finc_5fghost_4532',['m_inc_ghost',['../classPlaneAverage.html#abe59333d5fc9969465111df40dd9892e',1,'PlaneAverage']]], + ['m_5finclude_5fwstar_4533',['m_include_wstar',['../classABLMost.html#ac2e247ec9fd06cd15c788b83bf2c9ba6',1,'ABLMost']]], + ['m_5finside_4534',['m_inside',['../classFlowerIF.html#adabc11e60eca5148da34682a5c51058f',1,'FlowerIF']]], + ['m_5finterp_4535',['m_interp',['../classMOSTAverage.html#aeac5da9c3972fdde64f60720f88efe2e',1,'MOSTAverage::m_interp()'],['../classERFFillPatcher.html#a2fc352aecabd75ec92f5d17730683a1c',1,'ERFFillPatcher::m_interp()']]], + ['m_5fixtype_4536',['m_ixtype',['../classPlaneAverage.html#a45ad4c1f2922be9ba838bab13657385f',1,'PlaneAverage']]], + ['m_5fj_5findx_4537',['m_j_indx',['../classMOSTAverage.html#acdc75484e6ed5d2fadfb93573b6dded2',1,'MOSTAverage']]], + ['m_5fk_5fin_4538',['m_k_in',['../classMOSTAverage.html#ad570edb25d41640aa2d52122ae303884',1,'MOSTAverage']]], + ['m_5fk_5findx_4539',['m_k_indx',['../classMOSTAverage.html#afbe752293b7c2790b1994a2349261fda',1,'MOSTAverage']]], + ['m_5fk_5fsoil_4540',['m_k_soil',['../classMM5.html#ac5730f1413ae4a3dd5d4b2c683c41297',1,'MM5::m_k_soil()'],['../classSLM.html#aa674dfa04bde7d418f1195f707f84f5c',1,'SLM::m_k_soil()']]], + ['m_5flai_5fforest_4541',['m_lai_forest',['../classForestDrag.html#a6b967bb106243fd365ca0aa2cd9aa457',1,'ForestDrag']]], + ['m_5flaimax_5fforest_4542',['m_laimax_forest',['../classForestDrag.html#a24d15eda91f5abc361c3c5b37fb45efd',1,'ForestDrag']]], + ['m_5flat_4543',['m_lat',['../classRadiation.html#ae6fe4540ef5931fb2ac34ad19c6fe74e',1,'Radiation']]], + ['m_5flev_4544',['m_lev',['../classERFPhysBCFunct__cons.html#ad393b48c02e838f75be60a655eed9fa6',1,'ERFPhysBCFunct_cons::m_lev()'],['../classERFPhysBCFunct__u.html#a898867b7e245b2ecf05ab7f5ce4a4504',1,'ERFPhysBCFunct_u::m_lev()'],['../classERFPhysBCFunct__v.html#a22e73a039ee130b072f3a9ad079fc160',1,'ERFPhysBCFunct_v::m_lev()'],['../classERFPhysBCFunct__w.html#a277641c1cc5a27c2a01e49d21a9c88f4',1,'ERFPhysBCFunct_w::m_lev()'],['../classERFPhysBCFunct__base.html#a55272dec44184034a24cfe54bb7df1fd',1,'ERFPhysBCFunct_base::m_lev()'],['../structLineSampler.html#af614a59976e85627d9b5d41222265cde',1,'LineSampler::m_lev()'],['../structPlaneSampler.html#a31b77c80e1831ceb775ed63819016fd4',1,'PlaneSampler::m_lev()']]], + ['m_5flevel_4545',['m_level',['../classPlaneAverage.html#a6a25218bd5754ec121caab7e4acfc537',1,'PlaneAverage']]], + ['m_5fline_5faverage_4546',['m_line_average',['../classPlaneAverage.html#a998ec98b248ea4bd71284a2bd919fb0d',1,'PlaneAverage']]], + ['m_5fline_5fxcentroid_4547',['m_line_xcentroid',['../classPlaneAverage.html#a560dbd7059fb6cbb0421635c5d405d2b',1,'PlaneAverage']]], + ['m_5flmask_5flev_4548',['m_lmask_lev',['../classABLMost.html#aaa5bbc610662825ddd8a184b43f3541b',1,'ABLMost']]], + ['m_5flon_4549',['m_lon',['../classRadiation.html#a0069d200496f037a5bffa96e4bf9bce0',1,'Radiation']]], + ['m_5fls_4550',['m_ls',['../classSampleData.html#a12c059d78aea6b9c266a7cf17044a24c',1,'SampleData']]], + ['m_5fls_5fmf_4551',['m_ls_mf',['../structLineSampler.html#a1fa54ddedf5258bce17bb029e4aaf50e',1,'LineSampler']]], + ['m_5flsm_5fdata_5flev_4552',['m_lsm_data_lev',['../classABLMost.html#a958aaaf9e040462197c88c6c77f2aaf6',1,'ABLMost::m_lsm_data_lev()'],['../classLandSurface.html#a5a134e93d42328bfaa9611a9e625e1bb',1,'LandSurface::m_lsm_data_lev()']]], + ['m_5flsm_5fflux_5flev_4553',['m_lsm_flux_lev',['../classABLMost.html#a422336bc908d29f98dafb3b745b4f060',1,'ABLMost']]], + ['m_5flsm_5ffluxes_4554',['m_lsm_fluxes',['../classRadiation.html#a628ab4164c223bc55241535374a780cb',1,'Radiation']]], + ['m_5flsm_5fgeom_4555',['m_lsm_geom',['../classNullSurf.html#ac722d317f14ff1793ce7a38362987513',1,'NullSurf::m_lsm_geom()'],['../classSLM.html#ac41680d479e44b54678787b662c55fef',1,'SLM::m_lsm_geom()'],['../classMM5.html#a5bb965e19ba475c78c8c9c8528fbf871',1,'MM5::m_lsm_geom()']]], + ['m_5flsm_5fgeom_5flev_4556',['m_lsm_geom_lev',['../classLandSurface.html#a06a0bb4f12e604dbbd844bd4d2b0903f',1,'LandSurface']]], + ['m_5flsm_5fmodel_4557',['m_lsm_model',['../classLandSurface.html#a7415e46b046f76ef34902fa6ef1ef628',1,'LandSurface']]], + ['m_5flsm_5fsize_4558',['m_lsm_size',['../classMM5.html#a338909d8b32e73bee5188eb5f4e0e15d',1,'MM5::m_lsm_size()'],['../classNullSurf.html#a00480a80b00d313460c898669225b2ef',1,'NullSurf::m_lsm_size()'],['../classSLM.html#a4b4498e80099eadbb5405ec7095c07a8',1,'SLM::m_lsm_size()']]], + ['m_5flsm_5fzenith_4559',['m_lsm_zenith',['../classRadiation.html#a9ee4891cfb314df8458a47759de345d5',1,'Radiation']]], + ['m_5flwave_5flev_4560',['m_Lwave_lev',['../classABLMost.html#ab12af4a41dbc189d69850a81447434f7',1,'ABLMost']]], + ['m_5fma_4561',['m_ma',['../classABLMost.html#a466bfcda8ae4337d9c8781ab28e3f6fe',1,'ABLMost']]], + ['m_5fmax_5fstep_4562',['m_max_step',['../classMultiBlockContainer.html#a1f1ba45d36c26640b1d2817ae275a505',1,'MultiBlockContainer']]], + ['m_5fmaxlev_4563',['m_maxlev',['../classMOSTAverage.html#abc66735142b394193e3b6934ea817015',1,'MOSTAverage']]], + ['m_5fmoist_5fmodel_4564',['m_moist_model',['../classEulerianMicrophysics.html#a3d8916fc5900c54728d7549c68b21048',1,'EulerianMicrophysics']]], + ['m_5fmost_4565',['m_most',['../classERF.html#a051364b2373d8d86151c0b4a958035bd',1,'ERF']]], + ['m_5fmoving_5fterrain_4566',['m_moving_terrain',['../classERFPhysBCFunct__base.html#aa0e24cb3922f3d72d5438a6c3e5a4310',1,'ERFPhysBCFunct_base']]], + ['m_5fnavg_4567',['m_navg',['../classMOSTAverage.html#a0554ee593b5deca61ef0d26ebd26f6d6',1,'MOSTAverage']]], + ['m_5fncell_5fline_4568',['m_ncell_line',['../classPlaneAverage.html#a049c64513c0ed306d7e68ef95df87033',1,'PlaneAverage']]], + ['m_5fncell_5fplane_4569',['m_ncell_plane',['../classMOSTAverage.html#a89b9ec10eb8dee9a8be7c9597a3f5008',1,'MOSTAverage::m_ncell_plane()'],['../classPlaneAverage.html#a98ad1b7801e75ac43ddd3d06b0c5d7da',1,'PlaneAverage::m_ncell_plane()']]], + ['m_5fncell_5fregion_4570',['m_ncell_region',['../classMOSTAverage.html#ab227f9a8e9224820c00fa8b223712b3e',1,'MOSTAverage']]], + ['m_5fncomp_4571',['m_ncomp',['../classERFFillPatcher.html#a61c68ee600be65606db582402599c1d4',1,'ERFFillPatcher::m_ncomp()'],['../classPlaneAverage.html#af07d85c4bd48f4bedc0b180001c728dc',1,'PlaneAverage::m_ncomp()']]], + ['m_5fng_4572',['m_ng',['../classPlaneAverage.html#a4a8c3eb911548a254ef75c24659b1317',1,'PlaneAverage']]], + ['m_5fnghost_4573',['m_nghost',['../classERFFillPatcher.html#afdb02cfc6d41b23967ff0a6f0e22b849',1,'ERFFillPatcher']]], + ['m_5fnghost_5fsubset_4574',['m_nghost_subset',['../classERFFillPatcher.html#a83a91e2dc7bd7c39a27327024814061c',1,'ERFFillPatcher']]], + ['m_5fnominal_5fpower_4575',['m_nominal_power',['../classNullWindFarm.html#aac5f552b2717ab7f177541c1bf09828a',1,'NullWindFarm']]], + ['m_5fnorm_5fvec_4576',['m_norm_vec',['../classMOSTAverage.html#a90d1df8bd48dd2bf45776a01ba1a89f7',1,'MOSTAverage']]], + ['m_5fnpetals_4577',['m_npetals',['../classFlowerIF.html#a13021976563f28b30e35c378d19a5d75',1,'FlowerIF']]], + ['m_5fnvar_4578',['m_nvar',['../classMOSTAverage.html#a94ece9d178d0e85296cce07bab556bc7',1,'MOSTAverage']]], + ['m_5fnz_5flsm_4579',['m_nz_lsm',['../classMM5.html#a9e2b3186622686e5aae850eb1dc93d28',1,'MM5::m_nz_lsm()'],['../classSLM.html#ac5eb0f0fb3b7c78777a95bad4b5370ee',1,'SLM::m_nz_lsm()']]], + ['m_5fout_5frad_4580',['m_out_rad',['../classReadBndryPlanes.html#acb820b3ebc4c07d210831e6081c47aa9',1,'ReadBndryPlanes::m_out_rad()'],['../classWriteBndryPlanes.html#a2ce490f5166966b52112f126c9dc4dd8',1,'WriteBndryPlanes::m_out_rad()']]], + ['m_5fowns_5fdata_4581',['m_owns_data',['../structTimeInterpolatedData.html#a6eeb9167e2d8051c16fdbb1e7fee54ed',1,'TimeInterpolatedData']]], + ['m_5fphi_4582',['m_phi',['../structCENTERED2.html#ac162099524c29536f1d08dcbb7c6c67a',1,'CENTERED2::m_phi()'],['../structWENO__Z7.html#a3bab5ca3ba311c6f183bb9d5d5f99fee',1,'WENO_Z7::m_phi()'],['../structWENO__Z5.html#a962862416f273b267eb55802eff59edf',1,'WENO_Z5::m_phi()'],['../structWENO__MZQ3.html#a106585bb6e78f7027658c9c56f3ae892',1,'WENO_MZQ3::m_phi()'],['../structWENO__Z3.html#a8269a48070f989c0183112ccd8e57489',1,'WENO_Z3::m_phi()'],['../structWENO7.html#aacefd0bc2d7db63fa68026e0d041c637',1,'WENO7::m_phi()'],['../structWENO5.html#a28727bda47dc47677cf20c4d4bbda9a8',1,'WENO5::m_phi()'],['../structWENO3.html#a13120486db8a71a2059a9c7c1928b416',1,'WENO3::m_phi()'],['../structUPWINDALL.html#a36acc81d9046b2b80cf3755aa46bc10c',1,'UPWINDALL::m_phi()'],['../structCENTERED6.html#a732a4a686c30a3233c939f453b74f0b9',1,'CENTERED6::m_phi()'],['../structUPWIND5.html#a26ff7f987df2f61ab60c121c02dd4295',1,'UPWIND5::m_phi()'],['../structCENTERED4.html#a2a0e8c62c2eb7e34a73c94f212a21cb3',1,'CENTERED4::m_phi()'],['../structUPWIND3.html#a4f184417f94f60775a46357fbafe1cca',1,'UPWIND3::m_phi()']]], + ['m_5fplane_5faverage_4583',['m_plane_average',['../classMOSTAverage.html#a81ad3bc2787e30025f8bee91bc5c9dc2',1,'MOSTAverage']]], + ['m_5fplot_5fface_5fvels_4584',['m_plot_face_vels',['../classERF.html#a367a3daba5d844efbed84c52e647cea6',1,'ERF']]], + ['m_5fplot_5fint_5f1_4585',['m_plot_int_1',['../classERF.html#a57cfb4bfead8525174646964992c7e69',1,'ERF']]], + ['m_5fplot_5fint_5f2_4586',['m_plot_int_2',['../classERF.html#ad3311c9ceacd17f34bdb5e03cefa33b3',1,'ERF']]], + ['m_5fplot_5fper_5f1_4587',['m_plot_per_1',['../classERF.html#a3167adc9518cce649a90ab82e9f9c85d',1,'ERF']]], + ['m_5fplot_5fper_5f2_4588',['m_plot_per_2',['../classERF.html#aff879a9c686293a10a3a03027b765c51',1,'ERF']]], + ['m_5fpolicy_4589',['m_policy',['../classMOSTAverage.html#a0e87c91bf31d0e60a31b906081d24eea',1,'MOSTAverage']]], + ['m_5fpower_4590',['m_power',['../classNullWindFarm.html#a61554384fc601d7ae2fb758a8bc7f4f4',1,'NullWindFarm']]], + ['m_5fpp_5fprefix_4591',['m_pp_prefix',['../classMOSTAverage.html#a8e48f835a742b02f039aeb6bc520aef8',1,'MOSTAverage']]], + ['m_5fprecision_4592',['m_precision',['../classPlaneAverage.html#a1f08f5f76700c51c42243410ffce6e66',1,'PlaneAverage']]], + ['m_5fps_4593',['m_ps',['../classSampleData.html#ab96a6354333a8e9db8145813b68b1b5b',1,'SampleData']]], + ['m_5fps_5fmf_4594',['m_ps_mf',['../structPlaneSampler.html#a697a9d0158c0c14f796a7a016759d2f7',1,'PlaneSampler']]], + ['m_5fqmoist_5fsize_4595',['m_qmoist_size',['../classKessler.html#ae94091e97ccba54c040030c98e52aa7c',1,'Kessler::m_qmoist_size()'],['../classNullMoist.html#a645f66b91b08d84aa7451a9da0c11a72',1,'NullMoist::m_qmoist_size()'],['../classSAM.html#a4bf36ad050daafdcfea1aa83ad75f9cf',1,'SAM::m_qmoist_size()']]], + ['m_5fqstate_5fsize_4596',['m_qstate_size',['../classKessler.html#ad5167b56417db2cd78415b4654d6f7ca',1,'Kessler::m_qstate_size()'],['../classNullMoist.html#a3cb016aa9c0f1ee7534ad678723d1c59',1,'NullMoist::m_qstate_size()'],['../classSAM.html#a81c775ecb78f3f228a98a9c39d1d098d',1,'SAM::m_qstate_size()']]], + ['m_5fr_4597',['m_r',['../classFlowerIF.html#a09721c1438c00c21d1babb121dc3d447',1,'FlowerIF']]], + ['m_5fr2c_4598',['m_r2c',['../classamrex_1_1FFT_1_1PoissonTerrainPrecond.html#a79070d76a6a7f5dfe8602fc2c42f36ef',1,'amrex::FFT::PoissonTerrainPrecond']]], + ['m_5fr2d_4599',['m_r2d',['../classERF.html#addf62bfc534515447b94e928ac0b7135',1,'ERF']]], + ['m_5fradius_4600',['m_radius',['../classMOSTAverage.html#a2c167351f6655ef3276f8e5b39439e91',1,'MOSTAverage']]], + ['m_5fratio_4601',['m_ratio',['../classERFFillPatcher.html#ab5ab5fa9bd525d2673c433633e0b3fba',1,'ERFFillPatcher']]], + ['m_5frdocp_4602',['m_rdOcp',['../classReadBndryPlanes.html#a7e0bbe82df8b302172937d7dbb981a2c',1,'ReadBndryPlanes::m_rdOcp()'],['../classSAM.html#a3b461d5620f6b9a08a1e62b60a463af7',1,'SAM::m_rdOcp()']]], + ['m_5frelax_5fmask_4603',['m_relax_mask',['../classERFFillPatcher.html#abad97ea0363653435fd9f922e10a53b2',1,'ERFFillPatcher']]], + ['m_5frot_5ffields_4604',['m_rot_fields',['../classMOSTAverage.html#a733f1b5c94de8ee530f4f257510cb277',1,'MOSTAverage']]], + ['m_5frotate_4605',['m_rotate',['../classABLMost.html#ab107efa0b6bdf80ee44d232919f6a7ad',1,'ABLMost::m_rotate()'],['../classMOSTAverage.html#a7d43a66f7518f75e694e0582dd40ec44',1,'MOSTAverage::m_rotate()']]], + ['m_5frotor_5frad_4606',['m_rotor_rad',['../classNullWindFarm.html#a06d46ff7212efd7893e94b99fa981b9d',1,'NullWindFarm']]], + ['m_5frotor_5frpm_4607',['m_rotor_RPM',['../classNullWindFarm.html#ad19bb9c4842c561c0024ae6d686b1a78',1,'NullWindFarm']]], + ['m_5fset_5fmask_4608',['m_set_mask',['../classERFFillPatcher.html#a9d188e7b7e85221b257799a5a9c5098e',1,'ERFFillPatcher']]], + ['m_5fsign_4609',['m_sign',['../classFlowerIF.html#a1841ecb4de32a4763c2864784f0c22c4',1,'FlowerIF']]], + ['m_5fsst_5flev_4610',['m_sst_lev',['../classABLMost.html#ad8f1957bba407e17edb0a84ace515cde',1,'ABLMost']]], + ['m_5fstart_5fbdy_5ftime_4611',['m_start_bdy_time',['../classABLMost.html#a4fb97b28e44e9ff6930f18083923343a',1,'ABLMost']]], + ['m_5ft_5favg_4612',['m_t_avg',['../classMOSTAverage.html#a05905a4754c7eb39b766b96889b1bd47',1,'MOSTAverage']]], + ['m_5ft_5finit_4613',['m_t_init',['../classMOSTAverage.html#a3fe20fc4a4eb0b283f1d658b6237004c',1,'MOSTAverage']]], + ['m_5fterr_4614',['m_terr',['../classTerrainIF.html#a3e1f2814d20da7b5dd6d1d620b04784c',1,'TerrainIF']]], + ['m_5fterrain_5ftype_4615',['m_terrain_type',['../classERFPhysBCFunct__w.html#a96add99b86d3a03a872af7af85ad8e96',1,'ERFPhysBCFunct_w']]], + ['m_5ftheta_5fdir_4616',['m_theta_dir',['../classSLM.html#aec067697af550a8122138e57c4e0666d',1,'SLM::m_theta_dir()'],['../classMM5.html#ab8187a0b9206d9c1d6632d494a149d1a',1,'MM5::m_theta_dir()']]], + ['m_5fthrust_5fcoeff_4617',['m_thrust_coeff',['../classNullWindFarm.html#a7fe11fbaf6a246c60156e40aec3835f7',1,'NullWindFarm']]], + ['m_5fthrust_5fcoeff_5fstanding_4618',['m_thrust_coeff_standing',['../classNullWindFarm.html#a5a95464f19af9063228d23981f3a75cd',1,'NullWindFarm']]], + ['m_5ftime_4619',['m_time',['../structTimeInterpolatedData.html#a9b0102facc1d00011f48f95132955e27',1,'TimeInterpolatedData']]], + ['m_5ftime_5ffile_4620',['m_time_file',['../classReadBndryPlanes.html#a8027f415fce9acdc5ad53745016f67bf',1,'ReadBndryPlanes::m_time_file()'],['../classWriteBndryPlanes.html#a91c8abe5b1a15f5fe630db40230f08c1',1,'WriteBndryPlanes::m_time_file()']]], + ['m_5ftime_5fwindow_4621',['m_time_window',['../classMOSTAverage.html#ac95147c0d7961323ca8b079f63cd4be9',1,'MOSTAverage']]], + ['m_5ftinterp_4622',['m_tinterp',['../classReadBndryPlanes.html#a3f5e28f23e03b5c32f23ac953987728a',1,'ReadBndryPlanes']]], + ['m_5ftn_4623',['m_tn',['../classReadBndryPlanes.html#ade779c58aa5ea62cf1e03cbfaf98bb61',1,'ReadBndryPlanes']]], + ['m_5ftnp1_4624',['m_tnp1',['../classReadBndryPlanes.html#a4343c3c0761df0f96c58f8d268a43017',1,'ReadBndryPlanes']]], + ['m_5ftnp2_4625',['m_tnp2',['../classReadBndryPlanes.html#aca1dcdc531215bfd5a12fb286d064c8c',1,'ReadBndryPlanes']]], + ['m_5fturb_5fdisk_5fangle_4626',['m_turb_disk_angle',['../classNullWindFarm.html#a3b3156bf79da131a833a2a6a96b27421',1,'NullWindFarm']]], + ['m_5ftype_5fforest_4627',['m_type_forest',['../classForestDrag.html#ad8061afe4ea0b11059a6094ae07243cf',1,'ForestDrag']]], + ['m_5fu_5fbc_5fdata_4628',['m_u_bc_data',['../classERFPhysBCFunct__u.html#a603a1822cba514966ad201cfc676cdf6',1,'ERFPhysBCFunct_u']]], + ['m_5fuse_5fprecond_4629',['m_use_precond',['../classTerrainPoisson.html#a8dcf3ca721769bc5f8bf7c1b2ea9634e',1,'TerrainPoisson']]], + ['m_5fuse_5freal_5fbcs_4630',['m_use_real_bcs',['../classERFPhysBCFunct__cons.html#a0e54453355d6a7c96044113c8827a008',1,'ERFPhysBCFunct_cons::m_use_real_bcs()'],['../classERFPhysBCFunct__u.html#a4a1ce4ec8f730cb61568aee6eceefe1f',1,'ERFPhysBCFunct_u::m_use_real_bcs()'],['../classERFPhysBCFunct__v.html#aa17ac5983f98d1b13f952fa7f2c39b54',1,'ERFPhysBCFunct_v::m_use_real_bcs()'],['../classERFPhysBCFunct__w.html#a6e6cdc32da147f7bc00d8c408b5df9a1',1,'ERFPhysBCFunct_w::m_use_real_bcs()']]], + ['m_5fv_5fbc_5fdata_4631',['m_v_bc_data',['../classERFPhysBCFunct__v.html#a1abc171e8cfcd542f4d9e312e0f586c1',1,'ERFPhysBCFunct_v']]], + ['m_5fvar_5fnames_4632',['m_var_names',['../classReadBndryPlanes.html#aa5f533fb198d42785bfebe5cd8ae7131',1,'ReadBndryPlanes::m_var_names()'],['../classWriteBndryPlanes.html#a85703bf41a6ba0382f13a90f64ba417b',1,'WriteBndryPlanes::m_var_names()']]], + ['m_5fvar_5fz0_4633',['m_var_z0',['../classABLMost.html#ab1da46aefd129763fb25f5a6839e48dd',1,'ABLMost']]], + ['m_5fvelocity_4634',['m_velocity',['../classNullWindFarm.html#af83e2833c70c7374fa00ec94755e8038',1,'NullWindFarm']]], + ['m_5fvsg_4635',['m_Vsg',['../classMOSTAverage.html#a5dfb4235703aaa2364d49d7fbb8d1512',1,'MOSTAverage']]], + ['m_5fw2d_4636',['m_w2d',['../classERF.html#aa53035f34ba133b86172e180abda4209',1,'ERF']]], + ['m_5fw_5fbc_5fdata_4637',['m_w_bc_data',['../classERFPhysBCFunct__w.html#a4c66456080eb954ef8c80fc3dcfc4c3a',1,'ERFPhysBCFunct_w']]], + ['m_5fwind_5fspeed_4638',['m_wind_speed',['../classNullWindFarm.html#a9beae3f8f39bb7bde432530da926d6ef',1,'NullWindFarm']]], + ['m_5fwindfarm_5fmodel_4639',['m_windfarm_model',['../classWindFarm.html#af3953694e6a246585c20f50436a65123',1,'WindFarm']]], + ['m_5fx_5fforest_4640',['m_x_forest',['../classForestDrag.html#a6f6067a4f71428c8ab3039240a3207e4',1,'ForestDrag']]], + ['m_5fx_5fpos_4641',['m_x_pos',['../classMOSTAverage.html#a58c320eb48f9b8a1b0983d2770e9f3ea',1,'MOSTAverage']]], + ['m_5fxlo_4642',['m_xlo',['../classPlaneAverage.html#a42c7dfa900a0b69ba1d294455ca8ba51',1,'PlaneAverage']]], + ['m_5fxloc_4643',['m_xloc',['../classNullWindFarm.html#ac8ff132b0d2d52032ec19344ec6a74c6',1,'NullWindFarm']]], + ['m_5fy_5fforest_4644',['m_y_forest',['../classForestDrag.html#af1a72c6ce2a773a31ae0d6f84aa2aa71',1,'ForestDrag']]], + ['m_5fy_5fpos_4645',['m_y_pos',['../classMOSTAverage.html#a1beb0dad926be2f2d9cb1de69a1a3374',1,'MOSTAverage']]], + ['m_5fyloc_4646',['m_yloc',['../classNullWindFarm.html#a86792dc0d8fb3dfc9b9646c38a2926da',1,'NullWindFarm']]], + ['m_5fz_5fphys_5fnd_4647',['m_z_phys_nd',['../classMOSTAverage.html#a3a49018467b69573ef84df9cdfd86da4',1,'MOSTAverage::m_z_phys_nd()'],['../classERFPhysBCFunct__cons.html#ad33ab704eb9b5d62a4db9317f40255dd',1,'ERFPhysBCFunct_cons::m_z_phys_nd()'],['../classERFPhysBCFunct__u.html#aefe9bc994735627162154bc289a0de3c',1,'ERFPhysBCFunct_u::m_z_phys_nd()'],['../classERFPhysBCFunct__v.html#afffa0e227916c179928f9a3eb7a07c3c',1,'ERFPhysBCFunct_v::m_z_phys_nd()'],['../classERFPhysBCFunct__w.html#aa37508122179536336aa8dba19d34c1b',1,'ERFPhysBCFunct_w::m_z_phys_nd()'],['../classKessler.html#aaead0b1bbb0693e5ef480fd15bcbe559',1,'Kessler::m_z_phys_nd()'],['../classSAM.html#a51af1452ad89711f8ddaa554cdc49ee6',1,'SAM::m_z_phys_nd()']]], + ['m_5fz_5fpos_4648',['m_z_pos',['../classMOSTAverage.html#a81ff1b7e8d026f0cd74147cbcc016d15',1,'MOSTAverage']]], + ['m_5fzphys_4649',['m_zphys',['../classTerrainPoisson.html#a11b0c98e8dbdb9c050a17603e1b6fd30',1,'TerrainPoisson']]], + ['m_5fzref_4650',['m_zref',['../classMOSTAverage.html#af2f1477f6bc5e4b2f2ddee27d17dab9f',1,'MOSTAverage']]], + ['ma_5flist_4651',['ma_list',['../classMamConstituents.html#ab9703f219ce7a084e170017035dc269b',1,'MamConstituents']]], + ['mam_5faer_4652',['mam_aer',['../classAerRadProps.html#afb607ae14bfc3e46dd66c9e04627a57d',1,'AerRadProps']]], + ['mam_5fconsti_4653',['mam_consti',['../classAerRadProps.html#a66f750181cccc82c03268b0a4a245ecc',1,'AerRadProps::mam_consti()'],['../classMam4__aer.html#a2dcd6d3b6a38a2f0e8bc389c80fb4ae9',1,'Mam4_aer::mam_consti()']]], + ['mapfac_5fm_4654',['mapfac_m',['../classERF.html#a23aacdb72e9d2dfed8e2ebd2c2526497',1,'ERF']]], + ['mapfac_5fu_4655',['mapfac_u',['../classERF.html#a1e8afee1508b720dab56f5d044deb301',1,'ERF']]], + ['mapfac_5fv_4656',['mapfac_v',['../classERF.html#ae49b5055f9a7117fa15918a5daa775b7',1,'ERF']]], + ['mass_5fname_4657',['mass_name',['../structMamConstituents_1_1gas__t.html#ad63e38b410aa69ed3f76d6898b35b53a',1,'MamConstituents::gas_t::mass_name()'],['../structMamConstituents_1_1aerosol__t.html#a300418f68393143be3f4852641ac465b',1,'MamConstituents::aerosol_t::mass_name()']]], + ['max_5fiter_4658',['MAX_ITER',['../namespaceHSEutils.html#a10de540cb8ad96aea8cd080f4d1e72fa',1,'HSEutils']]], + ['max_5fstep_4659',['max_step',['../classERF.html#a0634154e8e58379c495c3e7fe7c5e4d6',1,'ERF']]], + ['mdata_4660',['mdata',['../structadiabatic__mod__charnock.html#ad33aa4fea2aa05dbb4057dcef251e0da',1,'adiabatic_mod_charnock::mdata()'],['../structadiabatic.html#afdc69c66b9c49f67d4f2409bc1f3ce29',1,'adiabatic::mdata()'],['../structsurface__temp__wave__coupled.html#a44d84ddefc6dc5572f1b1e614996b288',1,'surface_temp_wave_coupled::mdata()'],['../structsurface__temp__donelan.html#a78d9b2c9e7acc59519c2e5d911e2a83d',1,'surface_temp_donelan::mdata()'],['../structsurface__temp__mod__charnock.html#a98f673e5030f4509a8874466337f50c4',1,'surface_temp_mod_charnock::mdata()'],['../structsurface__temp__charnock.html#a073ad08e0d652e792b459878e10dc41b',1,'surface_temp_charnock::mdata()'],['../structsurface__temp.html#afec351f7cde260c6e96a27297cb4010f',1,'surface_temp::mdata()'],['../structsurface__flux__wave__coupled.html#a7c81c888df97ef0ff4dc54be9c4e163a',1,'surface_flux_wave_coupled::mdata()'],['../structsurface__flux__donelan.html#ab3b7307051954c791dcf73bb13213e9f',1,'surface_flux_donelan::mdata()'],['../structsurface__flux__mod__charnock.html#a6fa441221eb1f30d65437ce890adfd46',1,'surface_flux_mod_charnock::mdata()'],['../structsurface__flux__charnock.html#a60030c5104987d6287efd5d9b996014c',1,'surface_flux_charnock::mdata()'],['../structsurface__flux.html#a960909fe387424192cf802afccdc7bed',1,'surface_flux::mdata()'],['../structadiabatic__wave__coupled.html#a812ea5ea7d6223e5512c372b3260d1bc',1,'adiabatic_wave_coupled::mdata()'],['../structadiabatic__donelan.html#a6b220db789638a784c51dfedcda1ffb9',1,'adiabatic_donelan::mdata()'],['../structadiabatic__charnock.html#a5c11064c35d6eefd22558180155d6ede',1,'adiabatic_charnock::mdata()']]], + ['mg_5fverbose_4661',['mg_verbose',['../classERF.html#a2c4e27d6b7928c7081f17e63d0834200',1,'ERF']]], + ['mic_5ffab_5fvars_4662',['mic_fab_vars',['../classKessler.html#aa11214a3e579cc9d6309359b1c05e5ab',1,'Kessler::mic_fab_vars()'],['../classSAM.html#a36ee9e1e1a94d22304f46e064f16e11e',1,'SAM::mic_fab_vars()']]], + ['micro_4663',['micro',['../classERF.html#a4b7277d54649219f31fe286eee9d415a',1,'ERF']]], + ['micvarmap_4664',['MicVarMap',['../classKessler.html#a18164f048f846cd122de43803b49c1cb',1,'Kessler::MicVarMap()'],['../classSAM.html#a6008487ad12ada77acdcb3ee41371c98',1,'SAM::MicVarMap()']]], + ['modal_5foptics_5ffile_4665',['modal_optics_file',['../classMam4__aer.html#a396c0ab69e47a8cbc27c346aa2fb489d',1,'Mam4_aer']]], + ['mode_5ftype_5fnames_4666',['mode_type_names',['../classMamConstituents.html#a5c94b10764d82b018270ebf012cd657b',1,'MamConstituents']]], + ['modes_4667',['modes',['../classMamConstituents.html#a1692c29032818c08c3b1ac985a35d521',1,'MamConstituents']]], + ['moistscal_5fhoriz_5fadv_5ftype_4668',['moistscal_horiz_adv_type',['../structAdvChoice.html#a22f84c60e56d4b3bde6b7f9548c87af3',1,'AdvChoice']]], + ['moistscal_5fhoriz_5fupw_5ffrac_4669',['moistscal_horiz_upw_frac',['../structAdvChoice.html#a69b32bcee6cd30f3f88280d0ec49cd35',1,'AdvChoice']]], + ['moistscal_5fvert_5fadv_5ftype_4670',['moistscal_vert_adv_type',['../structAdvChoice.html#a2f888dfcb79cdb766ee04f21aada83ec',1,'AdvChoice']]], + ['moistscal_5fvert_5fupw_5ffrac_4671',['moistscal_vert_upw_frac',['../structAdvChoice.html#a334139583accdc5718a939b20b308bb9',1,'AdvChoice']]], + ['moisture_5ftype_4672',['moisture_type',['../structSolverChoice.html#aacbfbe6f4a3040db3efdc6dbf8fa291b',1,'SolverChoice::moisture_type()'],['../classRadiation.html#a1863ee4ba67242d2fb2dede10b4a9460',1,'Radiation::moisture_type()']]], + ['molec_5fdiff_5ftype_4673',['molec_diff_type',['../structDiffChoice.html#aed5c75ec58e358a735d97869147b2baf',1,'DiffChoice']]], + ['mri_5fintegrator_5fmem_4674',['mri_integrator_mem',['../classERF.html#a09d0fb2bd609c898a665d9530a744585',1,'ERF']]], + ['mu_4675',['mu',['../structPhysProp_1_1physprop__t.html#aa23d4f11099641ffb9c395c327156980',1,'PhysProp::physprop_t::mu()'],['../classRadiation.html#a2002e601e86a58ebb15989a5b61ebe60',1,'Radiation::mu()']]], + ['muelq_4676',['muelq',['../ERF__Constants_8H.html#a0e5683feac33352111ce4445dbedbf45',1,'ERF_Constants.H']]], + ['mvelpp_4677',['mvelpp',['../classRadiation.html#ae4dacdbc7383b92511c2385bd59ed49a',1,'Radiation']]], + ['mwdair_4678',['mwdair',['../ERF__Constants_8H.html#a650da208ce885c0f6c9c742d26dc4b0e',1,'ERF_Constants.H']]], + ['mwwv_4679',['mwwv',['../ERF__Constants_8H.html#a75abd92a75952e8eefd06628c8c3487d',1,'ERF_Constants.H']]], + ['my_5fturb_5fdisk_5fangle_4680',['my_turb_disk_angle',['../classWindFarm.html#a0d274380a6e7a61593459bb0b0f642d2',1,'WindFarm']]] ]; diff --git a/search/variables_d.js b/search/variables_d.js index c3b0bb5dd..4d1944ad3 100644 --- a/search/variables_d.js +++ b/search/variables_d.js @@ -1,58 +1,58 @@ var searchData= [ - ['n_5fbld_5fsections_4679',['n_bld_sections',['../classWindFarm.html#a9e263152650471997aa43658904bc563',1,'WindFarm']]], - ['n_5fdiag_4680',['N_DIAG',['../classMamConstituents.html#a05b4d113513de18b2e7bbdc4e9cb4dbf',1,'MamConstituents']]], - ['n_5fdiag_4681',['n_diag',['../classMam4__aer.html#afe4495578dc4adefe7b2ab2780aee8ee',1,'Mam4_aer']]], - ['n_5fg_5fd_4682',['n_g_d',['../classCloudRadProps.html#a40e14de999dd323f0cc8db50f46031e8',1,'CloudRadProps']]], - ['n_5frad_5fcnst_4683',['n_rad_cnst',['../classMamConstituents.html#a75a27a90ef149368fc0a7676daeb4a84',1,'MamConstituents']]], - ['n_5fsounding_5ffiles_4684',['n_sounding_files',['../structInputSoundingData.html#a5655f2f77d75c1b8a2abd92a0b264813',1,'InputSoundingData']]], - ['n_5fsounding_5ftimes_4685',['n_sounding_times',['../structInputSoundingData.html#a47b2b2090f654ad7578b992b207d5b18',1,'InputSoundingData']]], - ['naer_4686',['naer',['../classRadiation.html#a59a37de7bc777e2ecac052a59d7a0aec',1,'Radiation']]], - ['name_4687',['name',['../structNDArray.html#a0d3be2b45f3fb008d12ec17dfd6abf09',1,'NDArray::name()'],['../classCloudRadProps.html#a7c91a5b46f8d85666e0ca0d1de8d23aa',1,'CloudRadProps::name()']]], - ['names_4688',['names',['../structMamConstituents_1_1modes__t.html#aa0ef7c08a80971086ecc620e6d7a6d31',1,'MamConstituents::modes_t']]], - ['nbndlw_4689',['nbndlw',['../classRadConstants.html#a960db6e337b49d1d4a714615a5fa4b7e',1,'RadConstants']]], - ['nbndsw_4690',['nbndsw',['../classRadConstants.html#a2d23948379a116a266cfd943b3275be4',1,'RadConstants']]], - ['nc_5fbdy_5ffile_4691',['nc_bdy_file',['../classERF.html#a7e9040f32464f1a6dee6e0384393451d',1,'ERF']]], - ['nc_5finit_5ffile_4692',['nc_init_file',['../classERF.html#a7ef14f6028b577eba70aef46b508be19',1,'ERF']]], - ['ncid_4693',['ncid',['../structncutils_1_1NCDim.html#a3272d1768518ba020b9bcd0d3699d544',1,'ncutils::NCDim::ncid()'],['../structncutils_1_1NCVar.html#a233d94aa3ccbef1cc12565340bcc7218',1,'ncutils::NCVar::ncid()'],['../classncutils_1_1NCGroup.html#a860fe8aaf1cd7859541c67594fb8eabd',1,'ncutils::NCGroup::ncid()']]], - ['ncoef_4694',['ncoef',['../classMam4__aer.html#afcd94bccbfcc44e6a5d8262abc42a9ca',1,'Mam4_aer::ncoef()'],['../structPhysProp_1_1physprop__t.html#acc1135d01fd7ca5a6f0ba980e23e5a55',1,'PhysProp::physprop_t::ncoef()']]], - ['ncol_4695',['ncol',['../classAerRadProps.html#a551936497e3a360746d6bfd53513d508',1,'AerRadProps::ncol()'],['../classRadiation.html#a8f47b85f948822c0e450beddb92373f4',1,'Radiation::ncol()'],['../classMam4__aer.html#aaf29baf8a0903c3401e8577e811f5d18',1,'Mam4_aer::ncol()']]], - ['ncomp_5fcons_4696',['ncomp_cons',['../classMRISplitIntegrator.html#a69e19ac4b8c02d71269e741e71b74c23',1,'MRISplitIntegrator']]], - ['ncorr_4697',['ncorr',['../structSolverChoice.html#a3b9fef36e4613507eef87379c2c9bf03',1,'SolverChoice']]], - ['net_5fflux_4698',['net_flux',['../classRadiation.html#a12afbdd30cf76b0bc083324cf22cbb73',1,'Radiation']]], - ['ng_5fdens_5fhse_4699',['ng_dens_hse',['../classERF.html#addf0fb2aae0efaa649c69685a4dcca83',1,'ERF']]], - ['ng_5fpres_5fhse_4700',['ng_pres_hse',['../classERF.html#a87dc6c0720462bfd088c909289cdca0b',1,'ERF']]], - ['ngas_4701',['ngas',['../classRadiation.html#aefc2fcddcd44a0c6d9ae06ec60e9ce37',1,'Radiation::ngas()'],['../classRrtmgp.html#a4b8b61c7a7fadac5b1cdd968144a5c01',1,'Rrtmgp::ngas()'],['../classOptics.html#abb94e5d9dc89e539796740c6f0b9a229',1,'Optics::ngas()'],['../structMamConstituents_1_1gaslist__t.html#a5fc9f5eeb290c5185e68bd2bf6f46618',1,'MamConstituents::gaslist_t::ngas()'],['../classAerRadProps.html#ae41f31dfce03d5b3952114e12436bec9',1,'AerRadProps::ngas()']]], - ['nlambda_4702',['nlambda',['../classCloudRadProps.html#a3ef54947677ddd898a7b6ded241db03c',1,'CloudRadProps']]], - ['nlev_4703',['nlev',['../classKessler.html#a8f9e3afdab979a19d8dfb0c4bdee471d',1,'Kessler::nlev()'],['../classSAM.html#a7da420869410dc959c2442962524259f',1,'SAM::nlev()'],['../classAerRadProps.html#a3854326c4b23eedef970611ab3a639dd',1,'AerRadProps::nlev()'],['../classMam4__aer.html#add9c70abae797f609d24a8ed47848030',1,'Mam4_aer::nlev()'],['../classRadiation.html#a65f94329afd4aad11489c87e5174c462',1,'Radiation::nlev()']]], - ['nlwbands_4704',['nlwbands',['../classRadiation.html#ab4451562115b24b40e0f04cae677c6e3',1,'Radiation::nlwbands()'],['../classRadConstants.html#a55471805ae99ef61cb9b0935bd1803f2',1,'RadConstants::nlwbands()'],['../classCloudRadProps.html#ab7f6932c5559602939b8a32fa42ca1ca',1,'CloudRadProps::nlwbands()'],['../classMam4__aer.html#abc58cbc8ee25e23731610007e0f62fe4',1,'Mam4_aer::nlwbands()'],['../classAerRadProps.html#af2dc3b884340390993212e03e99112af',1,'AerRadProps::nlwbands()']]], - ['nlwgpts_4705',['nlwgpts',['../classRadiation.html#a89625b089dbe4acbc85a7241fcbd3839',1,'Radiation']]], - ['nmodes_4706',['nmodes',['../classAerRadProps.html#a3bd718612795e1c875ad70da941cc89a',1,'AerRadProps::nmodes()'],['../classMam4__aer.html#adbd78e8ffa0bdd728b97ca66d08fb717',1,'Mam4_aer::nmodes()'],['../structMamConstituents_1_1modes__t.html#a9a549b30ee2d05c0bfe777b4625e7083',1,'MamConstituents::modes_t::nmodes()'],['../structMamConstituents_1_1modelist__t.html#aea57993996ab18dffe7ab00bc5e6c15e',1,'MamConstituents::modelist_t::nmodes()']]], - ['nmu_4707',['nmu',['../classCloudRadProps.html#ae7091519e3c4dfa0929e088c6234be73',1,'CloudRadProps']]], - ['no_5fsubstep_4708',['no_substep',['../classMRISplitIntegrator.html#abb86ebaf6ca5a42e59670d2b15549658',1,'MRISplitIntegrator']]], - ['no_5fsubstep_5ffun_4709',['no_substep_fun',['../ERF__TI__no__substep__fun_8H.html#a4cad8180e91d2eabd5638651fc24bcc7',1,'ERF_TI_no_substep_fun.H']]], - ['no_5fsubstepping_4710',['no_substepping',['../classMRISplitIntegrator.html#afa0623b638cd29d3f307d34ef5a98d0f',1,'MRISplitIntegrator']]], - ['noahmpio_4711',['noahmpio',['../classNOAH.html#ab6549b86a2408dccbb661e315c51e24c',1,'NOAH']]], - ['nominal_5fpower_4712',['nominal_power',['../classWindFarm.html#aa542d50137f25dcb568fafc483a83178',1,'WindFarm::nominal_power()'],['../classSimpleAD.html#af9dae2d9db9de431b450e61c55a83ffe',1,'SimpleAD::nominal_power()'],['../classGeneralAD.html#aeb00654d82c5f266554bd8cba035d19b',1,'GeneralAD::nominal_power()'],['../classFitch.html#afeb1ae13c307eeb71af9dfa8d97a3f7e',1,'Fitch::nominal_power()'],['../classEWP.html#a00497b6ecc9493be40be6ce4f5ae02c5',1,'EWP::nominal_power()']]], - ['npcf_4713',['npcf',['../classWaterVaporSat.html#abd48ae5df93e45c8d4bab8e1e985838b',1,'WaterVaporSat']]], - ['nradgas_4714',['nradgas',['../classRadConstants.html#acc3330716cd598dc36881b44c70687c5',1,'RadConstants']]], - ['nrh_4715',['nrh',['../classAerRadProps.html#aa21297bb80600126531f2d324f6d9c2f',1,'AerRadProps::nrh()'],['../classRadConstants.html#aaa19beec8cd86a9e09db7a2b34a7d883',1,'RadConstants::nrh()']]], - ['nspec_4716',['nspec',['../structMamConstituents_1_1mode__component__t.html#aa35e198644fe29379bc9d3830f2423c8',1,'MamConstituents::mode_component_t::nspec()'],['../classMam4__aer.html#a5167f5c7a13a42532cf945dcaa687c77',1,'Mam4_aer::nspec()']]], - ['nsubsteps_4717',['nsubsteps',['../classERF.html#aa3db2dd1b65310c66c4038650c22aaee',1,'ERF']]], - ['nswbands_4718',['nswbands',['../classAerRadProps.html#aded12109795a3f22556faecdd3fb3d03',1,'AerRadProps::nswbands()'],['../classCloudRadProps.html#aeee4ab1a6887ab34c966028c45079199',1,'CloudRadProps::nswbands()'],['../classMam4__aer.html#a72698fc4a4a0c54752ec0e76f161184f',1,'Mam4_aer::nswbands()'],['../classRadConstants.html#abf9d73367a1b46631bd2fae4516732c2',1,'RadConstants::nswbands()'],['../classRadiation.html#a2df876dcb21da075dc834af545a2c0ed',1,'Radiation::nswbands()']]], - ['nswgpts_4719',['nswgpts',['../classRadiation.html#a6569e23160036eb2186d6142e2387d9f',1,'Radiation']]], - ['ntimes_4720',['ntimes',['../structInputSoundingData.html#aecc862db70344fa9232f199fb61b307e',1,'InputSoundingData']]], - ['nudging_5ffrom_5finput_5fsounding_4721',['nudging_from_input_sounding',['../structSolverChoice.html#a5a9eef80b6339778c29acb7fb87dd9f1',1,'SolverChoice']]], - ['null_5fbc_5ffor_5ffill_4722',['null_bc_for_fill',['../ERF__Plotfile_8cpp.html#aeb56b4bca6dfa0e3b81d3f983926e8a2',1,'ERF_Plotfile.cpp']]], - ['num_5faeroes_4723',['num_aeroes',['../classAerRadProps.html#af174fea4281252e1cf87c621ab532aeb',1,'AerRadProps']]], - ['num_5fboxes_5fat_5flevel_4724',['num_boxes_at_level',['../classERF.html#adcd9f23975ffa605247b41d391c2a2f0',1,'ERF']]], - ['num_5ffiles_5fat_5flevel_4725',['num_files_at_level',['../classERF.html#a610a988f46e0496e6dbd0471ae817f75',1,'ERF']]], - ['num_5fmode_5ftypes_4726',['num_mode_types',['../classMamConstituents.html#a484fb8cc2efd161663df96136f6397a8',1,'MamConstituents']]], - ['num_5fspec_5ftypes_4727',['num_spec_types',['../classMamConstituents.html#a17b5c0080c2027fd08a2f3fcd7818333',1,'MamConstituents']]], - ['num_5fto_5fmass_5faer_4728',['num_to_mass_aer',['../structPhysProp_1_1physprop__t.html#aacc68f3bfaf1bcb4d76c0e49aa3d81fb',1,'PhysProp::physprop_t']]], - ['numaerosols_4729',['numaerosols',['../structMamConstituents_1_1aerlist__t.html#afae9af8c61b9fee3afdd374fffaab123',1,'MamConstituents::aerlist_t']]], - ['numdiffcoeff_4730',['NumDiffCoeff',['../structSolverChoice.html#a6dba64151e2e2f958e7c0e55db477bf2',1,'SolverChoice']]], - ['nzerog_4731',['nzerog',['../ERF__Constants_8H.html#a1d5b108314147320a74eaccbfa0d09b0',1,'ERF_Constants.H']]], - ['nzeror_4732',['nzeror',['../ERF__Constants_8H.html#aaa2fd2941341ea7699a9acfb434b2ee1',1,'ERF_Constants.H']]], - ['nzeros_4733',['nzeros',['../ERF__Constants_8H.html#ae56996ced8497f129d813e2f9c94786e',1,'ERF_Constants.H']]] + ['n_5fbld_5fsections_4681',['n_bld_sections',['../classWindFarm.html#a9e263152650471997aa43658904bc563',1,'WindFarm']]], + ['n_5fdiag_4682',['n_diag',['../classMam4__aer.html#afe4495578dc4adefe7b2ab2780aee8ee',1,'Mam4_aer']]], + ['n_5fdiag_4683',['N_DIAG',['../classMamConstituents.html#a05b4d113513de18b2e7bbdc4e9cb4dbf',1,'MamConstituents']]], + ['n_5fg_5fd_4684',['n_g_d',['../classCloudRadProps.html#a40e14de999dd323f0cc8db50f46031e8',1,'CloudRadProps']]], + ['n_5frad_5fcnst_4685',['n_rad_cnst',['../classMamConstituents.html#a75a27a90ef149368fc0a7676daeb4a84',1,'MamConstituents']]], + ['n_5fsounding_5ffiles_4686',['n_sounding_files',['../structInputSoundingData.html#a5655f2f77d75c1b8a2abd92a0b264813',1,'InputSoundingData']]], + ['n_5fsounding_5ftimes_4687',['n_sounding_times',['../structInputSoundingData.html#a47b2b2090f654ad7578b992b207d5b18',1,'InputSoundingData']]], + ['naer_4688',['naer',['../classRadiation.html#a59a37de7bc777e2ecac052a59d7a0aec',1,'Radiation']]], + ['name_4689',['name',['../structNDArray.html#a0d3be2b45f3fb008d12ec17dfd6abf09',1,'NDArray::name()'],['../classCloudRadProps.html#a7c91a5b46f8d85666e0ca0d1de8d23aa',1,'CloudRadProps::name()']]], + ['names_4690',['names',['../structMamConstituents_1_1modes__t.html#aa0ef7c08a80971086ecc620e6d7a6d31',1,'MamConstituents::modes_t']]], + ['nbndlw_4691',['nbndlw',['../classRadConstants.html#a960db6e337b49d1d4a714615a5fa4b7e',1,'RadConstants']]], + ['nbndsw_4692',['nbndsw',['../classRadConstants.html#a2d23948379a116a266cfd943b3275be4',1,'RadConstants']]], + ['nc_5fbdy_5ffile_4693',['nc_bdy_file',['../classERF.html#a7e9040f32464f1a6dee6e0384393451d',1,'ERF']]], + ['nc_5finit_5ffile_4694',['nc_init_file',['../classERF.html#a7ef14f6028b577eba70aef46b508be19',1,'ERF']]], + ['ncid_4695',['ncid',['../structncutils_1_1NCDim.html#a3272d1768518ba020b9bcd0d3699d544',1,'ncutils::NCDim::ncid()'],['../structncutils_1_1NCVar.html#a233d94aa3ccbef1cc12565340bcc7218',1,'ncutils::NCVar::ncid()'],['../classncutils_1_1NCGroup.html#a860fe8aaf1cd7859541c67594fb8eabd',1,'ncutils::NCGroup::ncid()']]], + ['ncoef_4696',['ncoef',['../classMam4__aer.html#afcd94bccbfcc44e6a5d8262abc42a9ca',1,'Mam4_aer::ncoef()'],['../structPhysProp_1_1physprop__t.html#acc1135d01fd7ca5a6f0ba980e23e5a55',1,'PhysProp::physprop_t::ncoef()']]], + ['ncol_4697',['ncol',['../classAerRadProps.html#a551936497e3a360746d6bfd53513d508',1,'AerRadProps::ncol()'],['../classRadiation.html#a8f47b85f948822c0e450beddb92373f4',1,'Radiation::ncol()'],['../classMam4__aer.html#aaf29baf8a0903c3401e8577e811f5d18',1,'Mam4_aer::ncol()']]], + ['ncomp_5fcons_4698',['ncomp_cons',['../classMRISplitIntegrator.html#a69e19ac4b8c02d71269e741e71b74c23',1,'MRISplitIntegrator']]], + ['ncorr_4699',['ncorr',['../structSolverChoice.html#a3b9fef36e4613507eef87379c2c9bf03',1,'SolverChoice']]], + ['net_5fflux_4700',['net_flux',['../classRadiation.html#a12afbdd30cf76b0bc083324cf22cbb73',1,'Radiation']]], + ['ng_5fdens_5fhse_4701',['ng_dens_hse',['../classERF.html#addf0fb2aae0efaa649c69685a4dcca83',1,'ERF']]], + ['ng_5fpres_5fhse_4702',['ng_pres_hse',['../classERF.html#a87dc6c0720462bfd088c909289cdca0b',1,'ERF']]], + ['ngas_4703',['ngas',['../classRadiation.html#aefc2fcddcd44a0c6d9ae06ec60e9ce37',1,'Radiation::ngas()'],['../classRrtmgp.html#a4b8b61c7a7fadac5b1cdd968144a5c01',1,'Rrtmgp::ngas()'],['../classOptics.html#abb94e5d9dc89e539796740c6f0b9a229',1,'Optics::ngas()'],['../structMamConstituents_1_1gaslist__t.html#a5fc9f5eeb290c5185e68bd2bf6f46618',1,'MamConstituents::gaslist_t::ngas()'],['../classAerRadProps.html#ae41f31dfce03d5b3952114e12436bec9',1,'AerRadProps::ngas()']]], + ['nlambda_4704',['nlambda',['../classCloudRadProps.html#a3ef54947677ddd898a7b6ded241db03c',1,'CloudRadProps']]], + ['nlev_4705',['nlev',['../classKessler.html#a8f9e3afdab979a19d8dfb0c4bdee471d',1,'Kessler::nlev()'],['../classSAM.html#a7da420869410dc959c2442962524259f',1,'SAM::nlev()'],['../classAerRadProps.html#a3854326c4b23eedef970611ab3a639dd',1,'AerRadProps::nlev()'],['../classMam4__aer.html#add9c70abae797f609d24a8ed47848030',1,'Mam4_aer::nlev()'],['../classRadiation.html#a65f94329afd4aad11489c87e5174c462',1,'Radiation::nlev()']]], + ['nlwbands_4706',['nlwbands',['../classRadiation.html#ab4451562115b24b40e0f04cae677c6e3',1,'Radiation::nlwbands()'],['../classRadConstants.html#a55471805ae99ef61cb9b0935bd1803f2',1,'RadConstants::nlwbands()'],['../classCloudRadProps.html#ab7f6932c5559602939b8a32fa42ca1ca',1,'CloudRadProps::nlwbands()'],['../classMam4__aer.html#abc58cbc8ee25e23731610007e0f62fe4',1,'Mam4_aer::nlwbands()'],['../classAerRadProps.html#af2dc3b884340390993212e03e99112af',1,'AerRadProps::nlwbands()']]], + ['nlwgpts_4707',['nlwgpts',['../classRadiation.html#a89625b089dbe4acbc85a7241fcbd3839',1,'Radiation']]], + ['nmodes_4708',['nmodes',['../classAerRadProps.html#a3bd718612795e1c875ad70da941cc89a',1,'AerRadProps::nmodes()'],['../classMam4__aer.html#adbd78e8ffa0bdd728b97ca66d08fb717',1,'Mam4_aer::nmodes()'],['../structMamConstituents_1_1modes__t.html#a9a549b30ee2d05c0bfe777b4625e7083',1,'MamConstituents::modes_t::nmodes()'],['../structMamConstituents_1_1modelist__t.html#aea57993996ab18dffe7ab00bc5e6c15e',1,'MamConstituents::modelist_t::nmodes()']]], + ['nmu_4709',['nmu',['../classCloudRadProps.html#ae7091519e3c4dfa0929e088c6234be73',1,'CloudRadProps']]], + ['no_5fsubstep_4710',['no_substep',['../classMRISplitIntegrator.html#abb86ebaf6ca5a42e59670d2b15549658',1,'MRISplitIntegrator']]], + ['no_5fsubstep_5ffun_4711',['no_substep_fun',['../ERF__TI__no__substep__fun_8H.html#a4cad8180e91d2eabd5638651fc24bcc7',1,'ERF_TI_no_substep_fun.H']]], + ['no_5fsubstepping_4712',['no_substepping',['../classMRISplitIntegrator.html#afa0623b638cd29d3f307d34ef5a98d0f',1,'MRISplitIntegrator']]], + ['noahmpio_4713',['noahmpio',['../classNOAH.html#ab6549b86a2408dccbb661e315c51e24c',1,'NOAH']]], + ['nominal_5fpower_4714',['nominal_power',['../classWindFarm.html#aa542d50137f25dcb568fafc483a83178',1,'WindFarm::nominal_power()'],['../classSimpleAD.html#af9dae2d9db9de431b450e61c55a83ffe',1,'SimpleAD::nominal_power()'],['../classGeneralAD.html#aeb00654d82c5f266554bd8cba035d19b',1,'GeneralAD::nominal_power()'],['../classFitch.html#afeb1ae13c307eeb71af9dfa8d97a3f7e',1,'Fitch::nominal_power()'],['../classEWP.html#a00497b6ecc9493be40be6ce4f5ae02c5',1,'EWP::nominal_power()']]], + ['npcf_4715',['npcf',['../classWaterVaporSat.html#abd48ae5df93e45c8d4bab8e1e985838b',1,'WaterVaporSat']]], + ['nradgas_4716',['nradgas',['../classRadConstants.html#acc3330716cd598dc36881b44c70687c5',1,'RadConstants']]], + ['nrh_4717',['nrh',['../classAerRadProps.html#aa21297bb80600126531f2d324f6d9c2f',1,'AerRadProps::nrh()'],['../classRadConstants.html#aaa19beec8cd86a9e09db7a2b34a7d883',1,'RadConstants::nrh()']]], + ['nspec_4718',['nspec',['../structMamConstituents_1_1mode__component__t.html#aa35e198644fe29379bc9d3830f2423c8',1,'MamConstituents::mode_component_t::nspec()'],['../classMam4__aer.html#a5167f5c7a13a42532cf945dcaa687c77',1,'Mam4_aer::nspec()']]], + ['nsubsteps_4719',['nsubsteps',['../classERF.html#aa3db2dd1b65310c66c4038650c22aaee',1,'ERF']]], + ['nswbands_4720',['nswbands',['../classAerRadProps.html#aded12109795a3f22556faecdd3fb3d03',1,'AerRadProps::nswbands()'],['../classCloudRadProps.html#aeee4ab1a6887ab34c966028c45079199',1,'CloudRadProps::nswbands()'],['../classMam4__aer.html#a72698fc4a4a0c54752ec0e76f161184f',1,'Mam4_aer::nswbands()'],['../classRadConstants.html#abf9d73367a1b46631bd2fae4516732c2',1,'RadConstants::nswbands()'],['../classRadiation.html#a2df876dcb21da075dc834af545a2c0ed',1,'Radiation::nswbands()']]], + ['nswgpts_4721',['nswgpts',['../classRadiation.html#a6569e23160036eb2186d6142e2387d9f',1,'Radiation']]], + ['ntimes_4722',['ntimes',['../structInputSoundingData.html#aecc862db70344fa9232f199fb61b307e',1,'InputSoundingData']]], + ['nudging_5ffrom_5finput_5fsounding_4723',['nudging_from_input_sounding',['../structSolverChoice.html#a5a9eef80b6339778c29acb7fb87dd9f1',1,'SolverChoice']]], + ['null_5fbc_5ffor_5ffill_4724',['null_bc_for_fill',['../ERF__Plotfile_8cpp.html#aeb56b4bca6dfa0e3b81d3f983926e8a2',1,'ERF_Plotfile.cpp']]], + ['num_5faeroes_4725',['num_aeroes',['../classAerRadProps.html#af174fea4281252e1cf87c621ab532aeb',1,'AerRadProps']]], + ['num_5fboxes_5fat_5flevel_4726',['num_boxes_at_level',['../classERF.html#adcd9f23975ffa605247b41d391c2a2f0',1,'ERF']]], + ['num_5ffiles_5fat_5flevel_4727',['num_files_at_level',['../classERF.html#a610a988f46e0496e6dbd0471ae817f75',1,'ERF']]], + ['num_5fmode_5ftypes_4728',['num_mode_types',['../classMamConstituents.html#a484fb8cc2efd161663df96136f6397a8',1,'MamConstituents']]], + ['num_5fspec_5ftypes_4729',['num_spec_types',['../classMamConstituents.html#a17b5c0080c2027fd08a2f3fcd7818333',1,'MamConstituents']]], + ['num_5fto_5fmass_5faer_4730',['num_to_mass_aer',['../structPhysProp_1_1physprop__t.html#aacc68f3bfaf1bcb4d76c0e49aa3d81fb',1,'PhysProp::physprop_t']]], + ['numaerosols_4731',['numaerosols',['../structMamConstituents_1_1aerlist__t.html#afae9af8c61b9fee3afdd374fffaab123',1,'MamConstituents::aerlist_t']]], + ['numdiffcoeff_4732',['NumDiffCoeff',['../structSolverChoice.html#a6dba64151e2e2f958e7c0e55db477bf2',1,'SolverChoice']]], + ['nzerog_4733',['nzerog',['../ERF__Constants_8H.html#a1d5b108314147320a74eaccbfa0d09b0',1,'ERF_Constants.H']]], + ['nzeror_4734',['nzeror',['../ERF__Constants_8H.html#aaa2fd2941341ea7699a9acfb434b2ee1',1,'ERF_Constants.H']]], + ['nzeros_4735',['nzeros',['../ERF__Constants_8H.html#ae56996ced8497f129d813e2f9c94786e',1,'ERF_Constants.H']]] ]; diff --git a/search/variables_e.js b/search/variables_e.js index 9bb572831..1a078a466 100644 --- a/search/variables_e.js +++ b/search/variables_e.js @@ -1,12 +1,12 @@ var searchData= [ - ['obliqr_4734',['obliqr',['../classRadiation.html#a4c1a53e6acb0412aab13695bb9b0aa1d',1,'Radiation']]], - ['oldcldoptics_4735',['oldcldoptics',['../classMamConstituents.html#adb5b880a08c3d173d929ba90d43a8344',1,'MamConstituents']]], - ['olen_4736',['olen',['../classABLMost.html#a0d6aa5a113a45ae1e56c0284241cfd01',1,'ABLMost']]], - ['omeps_4737',['omeps',['../ERF__Constants_8H.html#af04ee89db2f653c028681f044bd16222',1,'ERF_Constants.H']]], - ['optics_4738',['optics',['../classRadiation.html#ab0464f3862987a09a9f4713937a984c3',1,'Radiation']]], - ['opticsmethod_4739',['opticsmethod',['../structPhysProp_1_1physprop__t.html#aa4cb3b830849d849a08227041fff62cd',1,'PhysProp::physprop_t']]], - ['output_5f1d_5fcolumn_4740',['output_1d_column',['../classERF.html#ad17ff2753e754ff3eb1330612b820b5f',1,'ERF']]], - ['output_5fbndry_5fplanes_4741',['output_bndry_planes',['../classERF.html#a7c448670f7a5cadd6fe56f7e615c9eb6',1,'ERF']]], - ['owned_4742',['owned',['../structNDArray.html#a0a1c90304eddb4d078132a1c1f45bef9',1,'NDArray']]] + ['obliqr_4736',['obliqr',['../classRadiation.html#a4c1a53e6acb0412aab13695bb9b0aa1d',1,'Radiation']]], + ['oldcldoptics_4737',['oldcldoptics',['../classMamConstituents.html#adb5b880a08c3d173d929ba90d43a8344',1,'MamConstituents']]], + ['olen_4738',['olen',['../classABLMost.html#a0d6aa5a113a45ae1e56c0284241cfd01',1,'ABLMost']]], + ['omeps_4739',['omeps',['../ERF__Constants_8H.html#af04ee89db2f653c028681f044bd16222',1,'ERF_Constants.H']]], + ['optics_4740',['optics',['../classRadiation.html#ab0464f3862987a09a9f4713937a984c3',1,'Radiation']]], + ['opticsmethod_4741',['opticsmethod',['../structPhysProp_1_1physprop__t.html#aa4cb3b830849d849a08227041fff62cd',1,'PhysProp::physprop_t']]], + ['output_5f1d_5fcolumn_4742',['output_1d_column',['../classERF.html#ad17ff2753e754ff3eb1330612b820b5f',1,'ERF']]], + ['output_5fbndry_5fplanes_4743',['output_bndry_planes',['../classERF.html#a7c448670f7a5cadd6fe56f7e615c9eb6',1,'ERF']]], + ['owned_4744',['owned',['../structNDArray.html#a0a1c90304eddb4d078132a1c1f45bef9',1,'NDArray']]] ]; diff --git a/search/variables_f.js b/search/variables_f.js index 814a12828..68df3203d 100644 --- a/search/variables_f.js +++ b/search/variables_f.js @@ -1,70 +1,70 @@ var searchData= [ - ['p_5f0_4743',['p_0',['../ERF__Constants_8H.html#a994fea25f28c33c2e8f1e9c63d5b8b56',1,'ERF_Constants.H']]], - ['p_5finp_5fsound_5fd_4744',['p_inp_sound_d',['../structInputSoundingData.html#a0db7861e0fee3f8f0760c6685df3176f',1,'InputSoundingData']]], - ['pb_5famp_4745',['pb_amp',['../structTurbulentPerturbation.html#a4b075473cfeaf70617e053cf77db0168',1,'TurbulentPerturbation']]], - ['pb_5fba_4746',['pb_ba',['../structTurbulentPerturbation.html#a37cd2d582d2102a94d25a3fa6631e8dc',1,'TurbulentPerturbation']]], - ['pb_5fcell_4747',['pb_cell',['../structTurbulentPerturbation.html#a6c1c35c60d8c8a7e66c770d78fb314ef',1,'TurbulentPerturbation']]], - ['pb_5finterval_4748',['pb_interval',['../structTurbulentPerturbation.html#aa6a26d1d85a580dd957ae567d2ceaa7d',1,'TurbulentPerturbation']]], - ['pb_5flocal_5fetime_4749',['pb_local_etime',['../structTurbulentPerturbation.html#a287ae1e88114174731f07a5dceaefc19',1,'TurbulentPerturbation']]], - ['pb_5fmag_4750',['pb_mag',['../structTurbulentPerturbation.html#aabd79eb1dab7153b890242e036b32f2a',1,'TurbulentPerturbation']]], - ['pb_5fnetzero_4751',['pb_netZero',['../structTurbulentPerturbation.html#a6f4fb5bdc199eb01791ef8dbc2040961',1,'TurbulentPerturbation']]], - ['pbl_5fmynn_4752',['pbl_mynn',['../structTurbChoice.html#a11fd9429567c4dd4afa871170580aed0',1,'TurbChoice']]], - ['pbl_5fmynn_5flevel2_4753',['pbl_mynn_level2',['../structTurbChoice.html#a475d862a63ab672577fc2429f535feb9',1,'TurbChoice']]], - ['pbl_5ftype_4754',['pbl_type',['../structTurbChoice.html#a15b9bb58cde72bab3f5714934125f3f9',1,'TurbChoice']]], - ['pbl_5fysu_5fcoriolis_5ffreq_4755',['pbl_ysu_coriolis_freq',['../structTurbChoice.html#ac20bc5ed8f1482a520b623dc9cc1ef52',1,'TurbChoice']]], - ['pbl_5fysu_5fforce_5fover_5fwater_4756',['pbl_ysu_force_over_water',['../structTurbChoice.html#ac49c18b95424fe04c6a7c8eec934ec36',1,'TurbChoice']]], - ['pbl_5fysu_5fland_5fribcr_4757',['pbl_ysu_land_Ribcr',['../structTurbChoice.html#a96c1a42307db82ece270acdac75da9a3',1,'TurbChoice']]], - ['pbl_5fysu_5funst_5fribcr_4758',['pbl_ysu_unst_Ribcr',['../structTurbChoice.html#af274e04335b259bb7b35f7c836f8310f',1,'TurbChoice']]], - ['pbl_5fysu_5fuse_5fconsistent_5fcoriolis_4759',['pbl_ysu_use_consistent_coriolis',['../structTurbChoice.html#a727a9673de0517e62e58647a5d939b07',1,'TurbChoice']]], - ['pblh_4760',['pblh',['../classABLMost.html#a5ab8e9f3fdf7debf1c54bd0d8a1554db',1,'ABLMost']]], - ['pblh_5ftype_4761',['pblh_type',['../classABLMost.html#a84782c98096a1cc4395071cde97469ed',1,'ABLMost']]], - ['pcf_4762',['pcf',['../classWaterVaporSat.html#ac945aefc06aef842e140df159ec62c05',1,'WaterVaporSat']]], - ['pdel_4763',['pdel',['../classRadiation.html#ad1aed51aea035b6dfefcbe571a2d7b34',1,'Radiation']]], - ['pdeldry_4764',['pdeldry',['../classAerRadProps.html#a1bf28a8f87d617095d3cf88cf7ef738e',1,'AerRadProps']]], - ['pert_5finterval_4765',['pert_interval',['../classERF.html#a52761522e295887435c10853d8c7dc37',1,'ERF']]], - ['pert_5ftype_4766',['pert_type',['../structSolverChoice.html#abfd94767b3721755632c45a5ef290544',1,'SolverChoice']]], - ['phys_5fbc_5ftype_4767',['phys_bc_type',['../classERF.html#ae6df94c25ac21bf6a2e856a9901e3a15',1,'ERF']]], - ['physbcs_5fbase_4768',['physbcs_base',['../classERF.html#af4e7dc93dae16aa2cc94bbb20b699a6f',1,'ERF']]], - ['physbcs_5fcons_4769',['physbcs_cons',['../classERF.html#a2e9b04043853d25f2d76edbc0bed2e72',1,'ERF']]], - ['physbcs_5fu_4770',['physbcs_u',['../classERF.html#a64e55e5ae9df06433146db657eb9e72e',1,'ERF']]], - ['physbcs_5fv_4771',['physbcs_v',['../classERF.html#a79231b5cfd4576a742e46ae0082b5121',1,'ERF']]], - ['physbcs_5fw_4772',['physbcs_w',['../classERF.html#a45c8ecd777f47732993777a0afb8e140',1,'ERF']]], - ['physprop_4773',['physprop',['../classPhysProp.html#ae519d9ff501f4705b2b2f336c8f38e47',1,'PhysProp']]], - ['physprop_5ffile_4774',['physprop_file',['../structMamConstituents_1_1aerosol__t.html#a171adbde051fa00b94b7e0bfbd22d348',1,'MamConstituents::aerosol_t']]], - ['physprop_5ffiles_4775',['physprop_files',['../structMamConstituents_1_1modelist__t.html#ae4724929e731b1a00e0212d4c73495b4',1,'MamConstituents::modelist_t']]], - ['physprop_5fid_4776',['physprop_id',['../structMamConstituents_1_1aerosol__t.html#a6f7c83043cfbdc552c9ef9bcad6f24ed',1,'MamConstituents::aerosol_t']]], - ['pi_4777',['PI',['../ERF__Constants_8H.html#a988c4efd6fd0d855e241e77a73191428',1,'ERF_Constants.H']]], - ['pi43_4778',['pi43',['../classModalAeroWateruptake.html#a4a9705a6205eb9fad502289968668b77',1,'ModalAeroWateruptake']]], - ['pint_4779',['pint',['../classRadiation.html#a2f96bdaa65b73119271e1592fac6c569',1,'Radiation']]], - ['piotwo_4780',['PIoTwo',['../ERF__Constants_8H.html#ad51e17db99d11b190b2b57a23a518f7e',1,'ERF_Constants.H']]], - ['plot_5ffile_5f1_4781',['plot_file_1',['../classERF.html#aa54aaa938a18d34caa4d86e977647899',1,'ERF']]], - ['plot_5ffile_5f2_4782',['plot_file_2',['../classERF.html#a18fa84b06132715757d97ec38678aa2c',1,'ERF']]], - ['plot_5ffile_5flsm_4783',['plot_file_lsm',['../classLandSurface.html#af9c26970ce04b58725b9529fcc2fc62f',1,'LandSurface']]], - ['plot_5ffile_5fon_5frestart_4784',['plot_file_on_restart',['../classERF.html#adc00038dfe4c332e5d15f621184c69e8',1,'ERF']]], - ['plot_5flsm_4785',['plot_lsm',['../classERF.html#afc653b103aa26c56acafed85cdd95f52',1,'ERF']]], - ['plot_5fvar_5fnames_5f1_4786',['plot_var_names_1',['../classERF.html#a6865cf87abbb5aab0db00ff3b1ce94ac',1,'ERF']]], - ['plot_5fvar_5fnames_5f2_4787',['plot_var_names_2',['../classERF.html#a79705c02d6f25fbdcec14ca2432e5da1',1,'ERF']]], - ['plotfile_5ftype_5f1_4788',['plotfile_type_1',['../classERF.html#a184511b7b9b7d4beef453f5d5d679c54',1,'ERF']]], - ['plotfile_5ftype_5f2_4789',['plotfile_type_2',['../classERF.html#a980e94505df2ee0925612b004126df77',1,'ERF']]], - ['pm_5finteg_4790',['pm_integ',['../structInputSoundingData.html#a30ed369fe55e1a25d9f1e871c70506d0',1,'InputSoundingData']]], - ['pmid_4791',['pmid',['../classAerRadProps.html#ab56e110ccf8deaa71d452a64e69b8647',1,'AerRadProps::pmid()'],['../classRadiation.html#a32121d70e2b9720750b3a72fdc2a6ef9',1,'Radiation::pmid()']]], - ['poisson_5fabstol_4792',['poisson_abstol',['../structSolverChoice.html#ad7f586d62fb0872ba0340fb03d462c64',1,'SolverChoice']]], - ['poisson_5freltol_4793',['poisson_reltol',['../structSolverChoice.html#a238b0871f38f8b134ff3fe5af0d05479',1,'SolverChoice']]], - ['power_4794',['power',['../classWindFarm.html#aea801fd8c22bf9d4bdcec847f4e7f50a',1,'WindFarm::power()'],['../classSimpleAD.html#a4beb1f1734f5ba3b037cd6c89d79b351',1,'SimpleAD::power()'],['../classEWP.html#ab9a34e54d36268a3f7a0b376543bbff5',1,'EWP::power()'],['../classFitch.html#a88af1c4430e37f4950396b5a92e9ba03',1,'Fitch::power()'],['../classGeneralAD.html#a1a247dae534aad8b40e7780b3f296afe',1,'GeneralAD::power()']]], - ['pp_5finc_4795',['pp_inc',['../classERF.html#a0c5206542d4193bb687f5271be6fe5e5',1,'ERF']]], - ['pp_5fprefix_4796',['pp_prefix',['../structTurbulentPerturbation.html#a40f3307cf523b625489b8591869bbb47',1,'TurbulentPerturbation::pp_prefix()'],['../structAdvChoice.html#a667cbedb89514e330b6ca144298857da',1,'AdvChoice::pp_prefix()'],['../structSolverChoice.html#a4b0edf29a032ff18b10a42825fa9e4b6',1,'SolverChoice::pp_prefix()'],['../structDiffChoice.html#a9e8b6878f4d18ee6fe61a220612d70df',1,'DiffChoice::pp_prefix()'],['../structSpongeChoice.html#af06b59184315514abdadd3b54c073909',1,'SpongeChoice::pp_prefix()'],['../structTurbChoice.html#a6b8e56e5ace640df7834c013c6788020',1,'TurbChoice::pp_prefix()'],['../classERF.html#a59df30e7a5537c8543bb00772bd98b58',1,'ERF::pp_prefix()']]], - ['pr_5ft_4797',['Pr_t',['../structTurbChoice.html#ae1bec6cf14226b68f692f86daa1c5566',1,'TurbChoice']]], - ['pr_5ft_5finv_4798',['Pr_t_inv',['../structTurbChoice.html#aa90aa6c577f632a8c4582a3538d98ad5',1,'TurbChoice']]], - ['prefi_4799',['prefi',['../structPhysProp_1_1physprop__t.html#ad1a2b4cadbb2d65df2caff3232e1ab63',1,'PhysProp::physprop_t::prefi()'],['../classMam4__aer.html#adffbde9f294834c29b86c8d74f4155b8',1,'Mam4_aer::prefi()']]], - ['prefr_4800',['prefr',['../structPhysProp_1_1physprop__t.html#adfa6696c636955b4f5388f5c83795afb',1,'PhysProp::physprop_t::prefr()'],['../classMam4__aer.html#a7211d56f004f39cd34118af3c380a71e',1,'Mam4_aer::prefr()']]], - ['pres1d_4801',['pres1d',['../classSAM.html#a77e43f5c8a68a43f8109aa18b71fa64e',1,'SAM']]], - ['press_5fref_5finp_5fsound_4802',['press_ref_inp_sound',['../structInputSoundingData.html#a09ac90305ea3a4559d83ca589678a5aa',1,'InputSoundingData']]], - ['previouscputimeused_4803',['previousCPUTimeUsed',['../classERF.html#a1f412097e565c23acb4c17c67db10e22',1,'ERF']]], - ['prob_4804',['prob',['../classERF.html#a60e8cb933f237903e3fbcd6376c26db0',1,'ERF']]], - ['profile_5fint_4805',['profile_int',['../classERF.html#a633cd0b44d2e38f02c23e953aecd69eb',1,'ERF']]], - ['project_5finitial_5fvelocity_4806',['project_initial_velocity',['../structSolverChoice.html#aa7bb7f3c8b475b0e446c271d8aa5497f',1,'SolverChoice']]], - ['prop_4807',['prop',['../classMamConstituents.html#af4a85a7b8e8e4a677c8d34970487f14e',1,'MamConstituents']]], - ['props_4808',['props',['../structMamConstituents_1_1mode__component__t.html#a3f9b94d6f306e89f1be96830e442fb10',1,'MamConstituents::mode_component_t']]], - ['pt_5ftype_4809',['pt_type',['../structTurbulentPerturbation.html#ad0d78e0adbb21ae36f4483dd30e15d58',1,'TurbulentPerturbation']]] + ['p_5f0_4745',['p_0',['../ERF__Constants_8H.html#a994fea25f28c33c2e8f1e9c63d5b8b56',1,'ERF_Constants.H']]], + ['p_5finp_5fsound_5fd_4746',['p_inp_sound_d',['../structInputSoundingData.html#a0db7861e0fee3f8f0760c6685df3176f',1,'InputSoundingData']]], + ['pb_5famp_4747',['pb_amp',['../structTurbulentPerturbation.html#a4b075473cfeaf70617e053cf77db0168',1,'TurbulentPerturbation']]], + ['pb_5fba_4748',['pb_ba',['../structTurbulentPerturbation.html#a37cd2d582d2102a94d25a3fa6631e8dc',1,'TurbulentPerturbation']]], + ['pb_5fcell_4749',['pb_cell',['../structTurbulentPerturbation.html#a6c1c35c60d8c8a7e66c770d78fb314ef',1,'TurbulentPerturbation']]], + ['pb_5finterval_4750',['pb_interval',['../structTurbulentPerturbation.html#aa6a26d1d85a580dd957ae567d2ceaa7d',1,'TurbulentPerturbation']]], + ['pb_5flocal_5fetime_4751',['pb_local_etime',['../structTurbulentPerturbation.html#a287ae1e88114174731f07a5dceaefc19',1,'TurbulentPerturbation']]], + ['pb_5fmag_4752',['pb_mag',['../structTurbulentPerturbation.html#aabd79eb1dab7153b890242e036b32f2a',1,'TurbulentPerturbation']]], + ['pb_5fnetzero_4753',['pb_netZero',['../structTurbulentPerturbation.html#a6f4fb5bdc199eb01791ef8dbc2040961',1,'TurbulentPerturbation']]], + ['pbl_5fmynn_4754',['pbl_mynn',['../structTurbChoice.html#a11fd9429567c4dd4afa871170580aed0',1,'TurbChoice']]], + ['pbl_5fmynn_5flevel2_4755',['pbl_mynn_level2',['../structTurbChoice.html#a475d862a63ab672577fc2429f535feb9',1,'TurbChoice']]], + ['pbl_5ftype_4756',['pbl_type',['../structTurbChoice.html#a15b9bb58cde72bab3f5714934125f3f9',1,'TurbChoice']]], + ['pbl_5fysu_5fcoriolis_5ffreq_4757',['pbl_ysu_coriolis_freq',['../structTurbChoice.html#ac20bc5ed8f1482a520b623dc9cc1ef52',1,'TurbChoice']]], + ['pbl_5fysu_5fforce_5fover_5fwater_4758',['pbl_ysu_force_over_water',['../structTurbChoice.html#ac49c18b95424fe04c6a7c8eec934ec36',1,'TurbChoice']]], + ['pbl_5fysu_5fland_5fribcr_4759',['pbl_ysu_land_Ribcr',['../structTurbChoice.html#a96c1a42307db82ece270acdac75da9a3',1,'TurbChoice']]], + ['pbl_5fysu_5funst_5fribcr_4760',['pbl_ysu_unst_Ribcr',['../structTurbChoice.html#af274e04335b259bb7b35f7c836f8310f',1,'TurbChoice']]], + ['pbl_5fysu_5fuse_5fconsistent_5fcoriolis_4761',['pbl_ysu_use_consistent_coriolis',['../structTurbChoice.html#a727a9673de0517e62e58647a5d939b07',1,'TurbChoice']]], + ['pblh_4762',['pblh',['../classABLMost.html#a5ab8e9f3fdf7debf1c54bd0d8a1554db',1,'ABLMost']]], + ['pblh_5ftype_4763',['pblh_type',['../classABLMost.html#a84782c98096a1cc4395071cde97469ed',1,'ABLMost']]], + ['pcf_4764',['pcf',['../classWaterVaporSat.html#ac945aefc06aef842e140df159ec62c05',1,'WaterVaporSat']]], + ['pdel_4765',['pdel',['../classRadiation.html#ad1aed51aea035b6dfefcbe571a2d7b34',1,'Radiation']]], + ['pdeldry_4766',['pdeldry',['../classAerRadProps.html#a1bf28a8f87d617095d3cf88cf7ef738e',1,'AerRadProps']]], + ['pert_5finterval_4767',['pert_interval',['../classERF.html#a52761522e295887435c10853d8c7dc37',1,'ERF']]], + ['pert_5ftype_4768',['pert_type',['../structSolverChoice.html#abfd94767b3721755632c45a5ef290544',1,'SolverChoice']]], + ['phys_5fbc_5ftype_4769',['phys_bc_type',['../classERF.html#ae6df94c25ac21bf6a2e856a9901e3a15',1,'ERF']]], + ['physbcs_5fbase_4770',['physbcs_base',['../classERF.html#af4e7dc93dae16aa2cc94bbb20b699a6f',1,'ERF']]], + ['physbcs_5fcons_4771',['physbcs_cons',['../classERF.html#a2e9b04043853d25f2d76edbc0bed2e72',1,'ERF']]], + ['physbcs_5fu_4772',['physbcs_u',['../classERF.html#a64e55e5ae9df06433146db657eb9e72e',1,'ERF']]], + ['physbcs_5fv_4773',['physbcs_v',['../classERF.html#a79231b5cfd4576a742e46ae0082b5121',1,'ERF']]], + ['physbcs_5fw_4774',['physbcs_w',['../classERF.html#a45c8ecd777f47732993777a0afb8e140',1,'ERF']]], + ['physprop_4775',['physprop',['../classPhysProp.html#ae519d9ff501f4705b2b2f336c8f38e47',1,'PhysProp']]], + ['physprop_5ffile_4776',['physprop_file',['../structMamConstituents_1_1aerosol__t.html#a171adbde051fa00b94b7e0bfbd22d348',1,'MamConstituents::aerosol_t']]], + ['physprop_5ffiles_4777',['physprop_files',['../structMamConstituents_1_1modelist__t.html#ae4724929e731b1a00e0212d4c73495b4',1,'MamConstituents::modelist_t']]], + ['physprop_5fid_4778',['physprop_id',['../structMamConstituents_1_1aerosol__t.html#a6f7c83043cfbdc552c9ef9bcad6f24ed',1,'MamConstituents::aerosol_t']]], + ['pi_4779',['PI',['../ERF__Constants_8H.html#a988c4efd6fd0d855e241e77a73191428',1,'ERF_Constants.H']]], + ['pi43_4780',['pi43',['../classModalAeroWateruptake.html#a4a9705a6205eb9fad502289968668b77',1,'ModalAeroWateruptake']]], + ['pint_4781',['pint',['../classRadiation.html#a2f96bdaa65b73119271e1592fac6c569',1,'Radiation']]], + ['piotwo_4782',['PIoTwo',['../ERF__Constants_8H.html#ad51e17db99d11b190b2b57a23a518f7e',1,'ERF_Constants.H']]], + ['plot_5ffile_5f1_4783',['plot_file_1',['../classERF.html#aa54aaa938a18d34caa4d86e977647899',1,'ERF']]], + ['plot_5ffile_5f2_4784',['plot_file_2',['../classERF.html#a18fa84b06132715757d97ec38678aa2c',1,'ERF']]], + ['plot_5ffile_5flsm_4785',['plot_file_lsm',['../classLandSurface.html#af9c26970ce04b58725b9529fcc2fc62f',1,'LandSurface']]], + ['plot_5ffile_5fon_5frestart_4786',['plot_file_on_restart',['../classERF.html#adc00038dfe4c332e5d15f621184c69e8',1,'ERF']]], + ['plot_5flsm_4787',['plot_lsm',['../classERF.html#afc653b103aa26c56acafed85cdd95f52',1,'ERF']]], + ['plot_5fvar_5fnames_5f1_4788',['plot_var_names_1',['../classERF.html#a6865cf87abbb5aab0db00ff3b1ce94ac',1,'ERF']]], + ['plot_5fvar_5fnames_5f2_4789',['plot_var_names_2',['../classERF.html#a79705c02d6f25fbdcec14ca2432e5da1',1,'ERF']]], + ['plotfile_5ftype_5f1_4790',['plotfile_type_1',['../classERF.html#a184511b7b9b7d4beef453f5d5d679c54',1,'ERF']]], + ['plotfile_5ftype_5f2_4791',['plotfile_type_2',['../classERF.html#a980e94505df2ee0925612b004126df77',1,'ERF']]], + ['pm_5finteg_4792',['pm_integ',['../structInputSoundingData.html#a30ed369fe55e1a25d9f1e871c70506d0',1,'InputSoundingData']]], + ['pmid_4793',['pmid',['../classAerRadProps.html#ab56e110ccf8deaa71d452a64e69b8647',1,'AerRadProps::pmid()'],['../classRadiation.html#a32121d70e2b9720750b3a72fdc2a6ef9',1,'Radiation::pmid()']]], + ['poisson_5fabstol_4794',['poisson_abstol',['../structSolverChoice.html#ad7f586d62fb0872ba0340fb03d462c64',1,'SolverChoice']]], + ['poisson_5freltol_4795',['poisson_reltol',['../structSolverChoice.html#a238b0871f38f8b134ff3fe5af0d05479',1,'SolverChoice']]], + ['power_4796',['power',['../classWindFarm.html#aea801fd8c22bf9d4bdcec847f4e7f50a',1,'WindFarm::power()'],['../classSimpleAD.html#a4beb1f1734f5ba3b037cd6c89d79b351',1,'SimpleAD::power()'],['../classEWP.html#ab9a34e54d36268a3f7a0b376543bbff5',1,'EWP::power()'],['../classFitch.html#a88af1c4430e37f4950396b5a92e9ba03',1,'Fitch::power()'],['../classGeneralAD.html#a1a247dae534aad8b40e7780b3f296afe',1,'GeneralAD::power()']]], + ['pp_5finc_4797',['pp_inc',['../classERF.html#a0c5206542d4193bb687f5271be6fe5e5',1,'ERF']]], + ['pp_5fprefix_4798',['pp_prefix',['../structTurbulentPerturbation.html#a40f3307cf523b625489b8591869bbb47',1,'TurbulentPerturbation::pp_prefix()'],['../structAdvChoice.html#a667cbedb89514e330b6ca144298857da',1,'AdvChoice::pp_prefix()'],['../structSolverChoice.html#a4b0edf29a032ff18b10a42825fa9e4b6',1,'SolverChoice::pp_prefix()'],['../structDiffChoice.html#a9e8b6878f4d18ee6fe61a220612d70df',1,'DiffChoice::pp_prefix()'],['../structSpongeChoice.html#af06b59184315514abdadd3b54c073909',1,'SpongeChoice::pp_prefix()'],['../structTurbChoice.html#a6b8e56e5ace640df7834c013c6788020',1,'TurbChoice::pp_prefix()'],['../classERF.html#a59df30e7a5537c8543bb00772bd98b58',1,'ERF::pp_prefix()']]], + ['pr_5ft_4799',['Pr_t',['../structTurbChoice.html#ae1bec6cf14226b68f692f86daa1c5566',1,'TurbChoice']]], + ['pr_5ft_5finv_4800',['Pr_t_inv',['../structTurbChoice.html#aa90aa6c577f632a8c4582a3538d98ad5',1,'TurbChoice']]], + ['prefi_4801',['prefi',['../structPhysProp_1_1physprop__t.html#ad1a2b4cadbb2d65df2caff3232e1ab63',1,'PhysProp::physprop_t::prefi()'],['../classMam4__aer.html#adffbde9f294834c29b86c8d74f4155b8',1,'Mam4_aer::prefi()']]], + ['prefr_4802',['prefr',['../structPhysProp_1_1physprop__t.html#adfa6696c636955b4f5388f5c83795afb',1,'PhysProp::physprop_t::prefr()'],['../classMam4__aer.html#a7211d56f004f39cd34118af3c380a71e',1,'Mam4_aer::prefr()']]], + ['pres1d_4803',['pres1d',['../classSAM.html#a77e43f5c8a68a43f8109aa18b71fa64e',1,'SAM']]], + ['press_5fref_5finp_5fsound_4804',['press_ref_inp_sound',['../structInputSoundingData.html#a09ac90305ea3a4559d83ca589678a5aa',1,'InputSoundingData']]], + ['previouscputimeused_4805',['previousCPUTimeUsed',['../classERF.html#a1f412097e565c23acb4c17c67db10e22',1,'ERF']]], + ['prob_4806',['prob',['../classERF.html#a60e8cb933f237903e3fbcd6376c26db0',1,'ERF']]], + ['profile_5fint_4807',['profile_int',['../classERF.html#a633cd0b44d2e38f02c23e953aecd69eb',1,'ERF']]], + ['project_5finitial_5fvelocity_4808',['project_initial_velocity',['../structSolverChoice.html#aa7bb7f3c8b475b0e446c271d8aa5497f',1,'SolverChoice']]], + ['prop_4809',['prop',['../classMamConstituents.html#af4a85a7b8e8e4a677c8d34970487f14e',1,'MamConstituents']]], + ['props_4810',['props',['../structMamConstituents_1_1mode__component__t.html#a3f9b94d6f306e89f1be96830e442fb10',1,'MamConstituents::mode_component_t']]], + ['pt_5ftype_4811',['pt_type',['../structTurbulentPerturbation.html#ad0d78e0adbb21ae36f4483dd30e15d58',1,'TurbulentPerturbation']]] ];