diff --git a/_sources/source/theory/supportedEquationSet.rst.txt b/_sources/source/theory/supportedEquationSet.rst.txt index b634d559b..d35141824 100644 --- a/_sources/source/theory/supportedEquationSet.rst.txt +++ b/_sources/source/theory/supportedEquationSet.rst.txt @@ -855,6 +855,41 @@ where :math:`\Omega` is the earth's angular velocity and :math:`\lambda` is the .. _eqn_sst_des: +Laminar-Turbulent Transition Model Formulation +++++++++++++++++++++++++++++++++++++++++++++++ +To account for the effects of the laminar-turbulent boundary layer transition, +Menter's one-equation :math:`\gamma` transition model :cite:`Menter:2015` is coupled with the SST model. +The model consists of single transport equation for intermittency + +.. math:: + \frac{D(\rho \gamma)}{Dt}=P_{\gamma}-D_{\gamma}+\frac{\partial }{\partial x_j}\left[ (\mu + \frac{\mu_t}{\sigma_{\gamma}} )\frac{\partial \gamma}{\partial x_j} \right] + +The production term, :math:`P_{\gamma}`, and destruction term, :math:`D_{\gamma}`, are as: + +.. math:: + P_{\gamma}=F_{length} \rho S \gamma (1-\gamma) F_{onset}, \quad D_{\gamma}=C_{a2} \rho \Omega \gamma F_{turb} (C_{e2}\gamma-1) + +The model constants are: + +.. math:: + F_{length}=100, \quad c_{e2}=50, \quad c_{a2}=0.06, \quad \sigma_{\gamma}=1.0 + +The transition onset criteria of the model are defined as: + +.. math:: + F_{onset1}=\frac{Re_{v}}{2.2Re_{\theta c}}, \quad F_{onset2}=(F_{onset1},2.0 ) + +.. math:: + F_{onset3}=\max \left(1- \left (\frac{R_{T}}{3.5}\right)^3,0 \right ), \quad F_{onset}=\max(F_{onset2}-F_{onset3},0) + +.. math:: + F_{turb}=e^{-\left ( \frac{R_{T}}{2} \right )^{4}}, \quad R_T=\frac{\rho k}{\mu \omega}, \quad Re_v=\frac{\rho d_{w}^2S}{\mu} + +The transition onset occurs once the scaled vorticity Reynolds number, :math:`Re_{v}/2.2`, exceeds the critical momentum thickness Reynolds number, :math:`Re_{\theta c}`, from the empirical correlations. + +The output intermittency from the transition model is applied to both the production and destruction terms of the turbulent kinetic energy +transport equation. + Detached Eddy Simulation (DES) Formulation ++++++++++++++++++++++++++++++++++++++++++ diff --git a/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c.html b/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c.html new file mode 100644 index 000000000..f5dc0a638 --- /dev/null +++ b/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c.html @@ -0,0 +1,110 @@ + + + + + + + +Nalu-Wind: SDRSSTBLTM2015NodeKernel.C File Reference + + + + + + + + + + + +
+
+ + + + + + +
+
Nalu-Wind +  v0.1.0 +
+
CFD solver for wind plant simulations
+
+
+ + + + + + + + +
+
+ + +
+ +
+ + +
+
+
+Namespaces
+
+
SDRSSTBLTM2015NodeKernel.C File Reference
+
+
+
#include "node_kernels/SDRSSTBLTM2015NodeKernel.h"
+#include "Realm.h"
+#include "SolutionOptions.h"
+#include "SimdInterface.h"
+#include "utils/StkHelpers.h"
+#include "stk_mesh/base/MetaData.hpp"
+#include "stk_mesh/base/Types.hpp"
+
+Include dependency graph for SDRSSTBLTM2015NodeKernel.C:
+
+
+
+
+
+ + + + + +

+Namespaces

 sierra
 
 sierra::nalu
 
+
+ + + + diff --git a/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.map b/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.map new file mode 100644 index 000000000..66508b7a0 --- /dev/null +++ b/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.map @@ -0,0 +1,10 @@ + + + + + + + + + + diff --git a/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.md5 b/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.md5 new file mode 100644 index 000000000..e8978c2bd --- /dev/null +++ b/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.md5 @@ -0,0 +1 @@ +1458bbe6fcfefadd5aa2b5c09aa37c1a \ No newline at end of file diff --git a/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.svg b/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.svg new file mode 100644 index 000000000..23807f199 --- /dev/null +++ b/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.svg @@ -0,0 +1,216 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +SDRSSTBLTM2015NodeKernel.C + + + +Node1 + + +SDRSSTBLTM2015NodeKernel.C + + + + + +Node2 + + +node_kernels/SDRSSTBLTM2015 +NodeKernel.h + + + + + +Node1->Node2 + + + + + +Node3 + + +Realm.h + + + + + +Node1->Node3 + + + + + +Node4 + + +SolutionOptions.h + + + + + +Node1->Node4 + + + + + +Node5 + + +SimdInterface.h + + + + + +Node1->Node5 + + + + + +Node6 + + +utils/StkHelpers.h + + + + + +Node1->Node6 + + + + + +Node7 + + +stk_mesh/base/MetaData.hpp + + + + + +Node1->Node7 + + + + + +Node8 + + +stk_mesh/base/Types.hpp + + + + + +Node1->Node8 + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl_org.svg b/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl_org.svg new file mode 100644 index 000000000..8734d8b4b --- /dev/null +++ b/api_docs/_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c__incl_org.svg @@ -0,0 +1,128 @@ + + + + + + +SDRSSTBLTM2015NodeKernel.C + + + +Node1 + + +SDRSSTBLTM2015NodeKernel.C + + + + + +Node2 + + +node_kernels/SDRSSTBLTM2015 +NodeKernel.h + + + + + +Node1->Node2 + + + + + +Node3 + + +Realm.h + + + + + +Node1->Node3 + + + + + +Node4 + + +SolutionOptions.h + + + + + +Node1->Node4 + + + + + +Node5 + + +SimdInterface.h + + + + + +Node1->Node5 + + + + + +Node6 + + +utils/StkHelpers.h + + + + + +Node1->Node6 + + + + + +Node7 + + +stk_mesh/base/MetaData.hpp + + + + + +Node1->Node7 + + + + + +Node8 + + +stk_mesh/base/Types.hpp + + + + + +Node1->Node8 + + + + + diff --git a/api_docs/_specific_dissipation_rate_equation_system_8_c.html b/api_docs/_specific_dissipation_rate_equation_system_8_c.html index e00a5f476..8679dcf61 100644 --- a/api_docs/_specific_dissipation_rate_equation_system_8_c.html +++ b/api_docs/_specific_dissipation_rate_equation_system_8_c.html @@ -117,6 +117,7 @@ #include <node_kernels/SDRSSTDESNodeKernel.h>
#include <node_kernels/ScalarGclNodeKernel.h>
#include <node_kernels/SDRKONodeKernel.h>
+#include <node_kernels/SDRSSTBLTM2015NodeKernel.h>
#include "ngp_utils/NgpFieldBLAS.h"
#include "ngp_algorithms/NodalGradEdgeAlg.h"
#include "ngp_algorithms/NodalGradElemAlg.h"
diff --git a/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c.html b/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c.html new file mode 100644 index 000000000..31ee81830 --- /dev/null +++ b/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c.html @@ -0,0 +1,110 @@ + + + + + + + +Nalu-Wind: TKESSTBLTM2015NodeKernel.C File Reference + + + + + + + + + + + +
+
+ + + + + + +
+
Nalu-Wind +  v0.1.0 +
+
CFD solver for wind plant simulations
+
+
+ + + + + + + + +
+
+ + +
+ +
+ + +
+
+
+Namespaces
+
+
TKESSTBLTM2015NodeKernel.C File Reference
+
+
+
#include "node_kernels/TKESSTBLTM2015NodeKernel.h"
+#include "Realm.h"
+#include "SolutionOptions.h"
+#include "SimdInterface.h"
+#include "utils/StkHelpers.h"
+#include "stk_mesh/base/MetaData.hpp"
+#include "stk_mesh/base/Types.hpp"
+
+Include dependency graph for TKESSTBLTM2015NodeKernel.C:
+
+
+
+
+
+ + + + + +

+Namespaces

 sierra
 
 sierra::nalu
 
+
+ + + + diff --git a/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.map b/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.map new file mode 100644 index 000000000..b9eb8772e --- /dev/null +++ b/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.map @@ -0,0 +1,10 @@ + + + + + + + + + + diff --git a/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.md5 b/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.md5 new file mode 100644 index 000000000..93ea637b9 --- /dev/null +++ b/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.md5 @@ -0,0 +1 @@ +2333187576f145e078d519ab1c1f3001 \ No newline at end of file diff --git a/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.svg b/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.svg new file mode 100644 index 000000000..8d6601646 --- /dev/null +++ b/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl.svg @@ -0,0 +1,216 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +TKESSTBLTM2015NodeKernel.C + + + +Node1 + + +TKESSTBLTM2015NodeKernel.C + + + + + +Node2 + + +node_kernels/TKESSTBLTM2015 +NodeKernel.h + + + + + +Node1->Node2 + + + + + +Node3 + + +Realm.h + + + + + +Node1->Node3 + + + + + +Node4 + + +SolutionOptions.h + + + + + +Node1->Node4 + + + + + +Node5 + + +SimdInterface.h + + + + + +Node1->Node5 + + + + + +Node6 + + +utils/StkHelpers.h + + + + + +Node1->Node6 + + + + + +Node7 + + +stk_mesh/base/MetaData.hpp + + + + + +Node1->Node7 + + + + + +Node8 + + +stk_mesh/base/Types.hpp + + + + + +Node1->Node8 + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl_org.svg b/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl_org.svg new file mode 100644 index 000000000..79be30826 --- /dev/null +++ b/api_docs/_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c__incl_org.svg @@ -0,0 +1,128 @@ + + + + + + +TKESSTBLTM2015NodeKernel.C + + + +Node1 + + +TKESSTBLTM2015NodeKernel.C + + + + + +Node2 + + +node_kernels/TKESSTBLTM2015 +NodeKernel.h + + + + + +Node1->Node2 + + + + + +Node3 + + +Realm.h + + + + + +Node1->Node3 + + + + + +Node4 + + +SolutionOptions.h + + + + + +Node1->Node4 + + + + + +Node5 + + +SimdInterface.h + + + + + +Node1->Node5 + + + + + +Node6 + + +utils/StkHelpers.h + + + + + +Node1->Node6 + + + + + +Node7 + + +stk_mesh/base/MetaData.hpp + + + + + +Node1->Node7 + + + + + +Node8 + + +stk_mesh/base/Types.hpp + + + + + +Node1->Node8 + + + + + diff --git a/api_docs/_turb_kinetic_energy_equation_system_8_c.html b/api_docs/_turb_kinetic_energy_equation_system_8_c.html index cd992bcfe..9b4678795 100644 --- a/api_docs/_turb_kinetic_energy_equation_system_8_c.html +++ b/api_docs/_turb_kinetic_energy_equation_system_8_c.html @@ -124,6 +124,7 @@ #include <node_kernels/TKEKENodeKernel.h>
#include <node_kernels/TKERodiNodeKernel.h>
#include <node_kernels/TKEKONodeKernel.h>
+#include <node_kernels/TKESSTBLTM2015NodeKernel.h>
#include <ngp_utils/NgpLoopUtils.h>
#include <ngp_utils/NgpTypes.h>
#include <ngp_utils/NgpFieldBLAS.h>
diff --git a/api_docs/dir_e472670134093ca813a7551919ab9780.html b/api_docs/dir_e472670134093ca813a7551919ab9780.html index bb5026874..1f7a1fd56 100644 --- a/api_docs/dir_e472670134093ca813a7551919ab9780.html +++ b/api_docs/dir_e472670134093ca813a7551919ab9780.html @@ -117,6 +117,8 @@   file  SDRSSTAMSNodeKernel.C   +file  SDRSSTBLTM2015NodeKernel.C +  file  SDRSSTDESNodeKernel.C   file  SDRSSTLRNodeKernel.C @@ -135,6 +137,8 @@   file  TKESSTAMSNodeKernel.C   +file  TKESSTBLTM2015NodeKernel.C +  file  TKESSTDESNodeKernel.C   file  TKESSTIDDESNodeKernel.C diff --git a/api_docs/files.html b/api_docs/files.html index d130056c1..96544a8d1 100644 --- a/api_docs/files.html +++ b/api_docs/files.html @@ -363,124 +363,126 @@  SDRKONodeKernel.C  SDRLowReWallAlg.C  SDRSSTAMSNodeKernel.C - SDRSSTDESNodeKernel.C - SDRSSTLRNodeKernel.C - SDRSSTNodeKernel.C - SDRWallFuncAlg.C - SDRWallFuncAlgDriver.C - ShearStressTransportEquationSystem.C - SideWriter.C - Simulation.C - SinProfileChannelFlowVelocityAuxFunction.C - SloshingTankVOFAuxFunction.C - SmartField.C - SolutionNormPostProcessing.C - SolutionOptions.C - SolverAlgorithm.C - SolverAlgorithmDriver.C - SparsifiedEdgeLaplacian.C - SpecificDissipationRateEquationSystem.C - SpecificHeatPropertyEvaluator.C - SSTAMSAveragesAlg.C - SSTMaxLengthScaleAlg.C - SSTMaxLengthScaleDriver.C - SteadyTaylorVortexGradPressureAuxFunction.C - SteadyTaylorVortexMomentumSrcNodeSuppAlg.C - SteadyTaylorVortexPressureAuxFunction.C - SteadyTaylorVortexVelocityAuxFunction.C - StkHelpers.C - StkSimdConnectivityMap.C - StkSimdFaceConnectivityMap.C - StkSimdGatheredElementData.C - StkSimdNodeConnectivityMap.C - StkToTpetraComm.C - StkToTpetraLocalIndices.C - StkToTpetraMap.C - StreletsUpwindEdgeAlg.C - StringTimeCoordFunction.C - StringTimeCoordTemperatureAuxFunction.C - StrongDirichletBC.C - SupplementalAlgorithm.C - SurfaceForceAndMomentAlgorithm.C - SurfaceForceAndMomentAlgorithmDriver.C - SurfaceForceAndMomentWallFunctionAlgorithm.C - SutherlandsPropertyEvaluator.C - SyntheticLidar.C - TabulatedTemperatureAuxFunction.C - TaylorGreenPressureAuxFunction.C - TaylorGreenVelocityAuxFunction.C - TDRKENodeKernel.C - TemperaturePropAlgorithm.C - Tet4CVFEM.C - ThermalConductivityFromPrandtlPropAlgorithm.C - TimeIntegrator.C - TiogaBlock.C - TiogaOptions.C - TiogaRef.C - TiogaSTKIface.C - TKEKENodeKernel.C - TKEKONodeKernel.C - TKEKsgsNodeKernel.C - TKERodiNodeKernel.C - TKESSTAMSNodeKernel.C - TKESSTDESNodeKernel.C - TKESSTIDDESNodeKernel.C - TKESSTLRNodeKernel.C - TKESSTNodeKernel.C - TKEWallFuncAlg.C - TKEWallFuncAlgDriver.C - TornadoAuxFunction.C - TotalDissipationRateEquationSystem.C - TpetraLinearSystem.C - TpetraLinearSystemHelpers.C - TpetraSegregatedLinearSystem.C - Transfer.C - Transfers.C - TransportCoefficients.C - Tri32DCVFEM.C - Tri33DCVFEM.C - TurbineSurrogateKernel.C - TurbKineticEnergyEquationSystem.C - TurbulenceAveragingPostProcessing.C - TurbViscKEAlg.C - TurbViscKOAlg.C - TurbViscKsgsAlg.C - TurbViscSmagorinskyAlgorithm.C - TurbViscSSTAlg.C - TurbViscSSTLRAlg.C - TurbViscWaleAlgorithm.C - UpdateOversetFringeAlgorithmDriver.C - UtilitiesActuator.C - VariableDensityContinuitySrcNodeSuppAlg.C - VariableDensityMixFracAuxFunction.C - VariableDensityMixFracSrcNodeSuppAlg.C - VariableDensityMomentumSrcNodeSuppAlg.C - VariableDensityNonIsoContinuitySrcNodeSuppAlg.C - VariableDensityNonIsoEnthalpySrcNodeSuppAlg.C - VariableDensityNonIsoMomentumSrcNodeSuppAlg.C - VariableDensityNonIsoTemperatureAuxFunction.C - VariableDensityPressureAuxFunction.C - VariableDensityVelocityAuxFunction.C - VOFAdvectionEdgeAlg.C - VOFGclNodeKernel.C - VOFMassBDFNodeKernel.C - VolumeOfFluidEquationSystem.C - WallDistEdgeSolverAlg.C - WallDistElemKernel.C - WallDistEquationSystem.C - WallDistNodeKernel.C - WallFricVelAlgDriver.C - WallFuncGeometryAlg.C - WaterPropertyEvaluator.C - Wed6CVFEM.C - WilcoxKOmegaEquationSystem.C - WindEnergyPowerLawAuxFunction.C - WindEnergyTaylorVortexAuxFunction.C - WindEnergyTaylorVortexPressureAuxFunction.C - ZalesakDiskMassFlowRateKernel.C - ZalesakDiskVOFAuxFunction.C - ZalesakSphereMassFlowRateKernel.C - ZalesakSphereVOFAuxFunction.C + SDRSSTBLTM2015NodeKernel.C + SDRSSTDESNodeKernel.C + SDRSSTLRNodeKernel.C + SDRSSTNodeKernel.C + SDRWallFuncAlg.C + SDRWallFuncAlgDriver.C + ShearStressTransportEquationSystem.C + SideWriter.C + Simulation.C + SinProfileChannelFlowVelocityAuxFunction.C + SloshingTankVOFAuxFunction.C + SmartField.C + SolutionNormPostProcessing.C + SolutionOptions.C + SolverAlgorithm.C + SolverAlgorithmDriver.C + SparsifiedEdgeLaplacian.C + SpecificDissipationRateEquationSystem.C + SpecificHeatPropertyEvaluator.C + SSTAMSAveragesAlg.C + SSTMaxLengthScaleAlg.C + SSTMaxLengthScaleDriver.C + SteadyTaylorVortexGradPressureAuxFunction.C + SteadyTaylorVortexMomentumSrcNodeSuppAlg.C + SteadyTaylorVortexPressureAuxFunction.C + SteadyTaylorVortexVelocityAuxFunction.C + StkHelpers.C + StkSimdConnectivityMap.C + StkSimdFaceConnectivityMap.C + StkSimdGatheredElementData.C + StkSimdNodeConnectivityMap.C + StkToTpetraComm.C + StkToTpetraLocalIndices.C + StkToTpetraMap.C + StreletsUpwindEdgeAlg.C + StringTimeCoordFunction.C + StringTimeCoordTemperatureAuxFunction.C + StrongDirichletBC.C + SupplementalAlgorithm.C + SurfaceForceAndMomentAlgorithm.C + SurfaceForceAndMomentAlgorithmDriver.C + SurfaceForceAndMomentWallFunctionAlgorithm.C + SutherlandsPropertyEvaluator.C + SyntheticLidar.C + TabulatedTemperatureAuxFunction.C + TaylorGreenPressureAuxFunction.C + TaylorGreenVelocityAuxFunction.C + TDRKENodeKernel.C + TemperaturePropAlgorithm.C + Tet4CVFEM.C + ThermalConductivityFromPrandtlPropAlgorithm.C + TimeIntegrator.C + TiogaBlock.C + TiogaOptions.C + TiogaRef.C + TiogaSTKIface.C + TKEKENodeKernel.C + TKEKONodeKernel.C + TKEKsgsNodeKernel.C + TKERodiNodeKernel.C + TKESSTAMSNodeKernel.C + TKESSTBLTM2015NodeKernel.C + TKESSTDESNodeKernel.C + TKESSTIDDESNodeKernel.C + TKESSTLRNodeKernel.C + TKESSTNodeKernel.C + TKEWallFuncAlg.C + TKEWallFuncAlgDriver.C + TornadoAuxFunction.C + TotalDissipationRateEquationSystem.C + TpetraLinearSystem.C + TpetraLinearSystemHelpers.C + TpetraSegregatedLinearSystem.C + Transfer.C + Transfers.C + TransportCoefficients.C + Tri32DCVFEM.C + Tri33DCVFEM.C + TurbineSurrogateKernel.C + TurbKineticEnergyEquationSystem.C + TurbulenceAveragingPostProcessing.C + TurbViscKEAlg.C + TurbViscKOAlg.C + TurbViscKsgsAlg.C + TurbViscSmagorinskyAlgorithm.C + TurbViscSSTAlg.C + TurbViscSSTLRAlg.C + TurbViscWaleAlgorithm.C + UpdateOversetFringeAlgorithmDriver.C + UtilitiesActuator.C + VariableDensityContinuitySrcNodeSuppAlg.C + VariableDensityMixFracAuxFunction.C + VariableDensityMixFracSrcNodeSuppAlg.C + VariableDensityMomentumSrcNodeSuppAlg.C + VariableDensityNonIsoContinuitySrcNodeSuppAlg.C + VariableDensityNonIsoEnthalpySrcNodeSuppAlg.C + VariableDensityNonIsoMomentumSrcNodeSuppAlg.C + VariableDensityNonIsoTemperatureAuxFunction.C + VariableDensityPressureAuxFunction.C + VariableDensityVelocityAuxFunction.C + VOFAdvectionEdgeAlg.C + VOFGclNodeKernel.C + VOFMassBDFNodeKernel.C + VolumeOfFluidEquationSystem.C + WallDistEdgeSolverAlg.C + WallDistElemKernel.C + WallDistEquationSystem.C + WallDistNodeKernel.C + WallFricVelAlgDriver.C + WallFuncGeometryAlg.C + WaterPropertyEvaluator.C + Wed6CVFEM.C + WilcoxKOmegaEquationSystem.C + WindEnergyPowerLawAuxFunction.C + WindEnergyTaylorVortexAuxFunction.C + WindEnergyTaylorVortexPressureAuxFunction.C + ZalesakDiskMassFlowRateKernel.C + ZalesakDiskVOFAuxFunction.C + ZalesakSphereMassFlowRateKernel.C + ZalesakSphereVOFAuxFunction.C diff --git a/api_docs/search/all_11.js b/api_docs/search/all_11.js index 7268dc41f..3ce34404d 100644 --- a/api_docs/search/all_11.js +++ b/api_docs/search/all_11.js @@ -23,74 +23,75 @@ var searchData= ['sdrkonodekernel_2ec_486',['SDRKONodeKernel.C',['../_s_d_r_k_o_node_kernel_8_c.html',1,'']]], ['sdrlowrewallalg_2ec_487',['SDRLowReWallAlg.C',['../_s_d_r_low_re_wall_alg_8_c.html',1,'']]], ['sdrsstamsnodekernel_2ec_488',['SDRSSTAMSNodeKernel.C',['../_s_d_r_s_s_t_a_m_s_node_kernel_8_c.html',1,'']]], - ['sdrsstdesnodekernel_2ec_489',['SDRSSTDESNodeKernel.C',['../_s_d_r_s_s_t_d_e_s_node_kernel_8_c.html',1,'']]], - ['sdrsstlrnodekernel_2ec_490',['SDRSSTLRNodeKernel.C',['../_s_d_r_s_s_t_l_r_node_kernel_8_c.html',1,'']]], - ['sdrsstnodekernel_2ec_491',['SDRSSTNodeKernel.C',['../_s_d_r_s_s_t_node_kernel_8_c.html',1,'']]], - ['sdrwallfuncalg_2ec_492',['SDRWallFuncAlg.C',['../_s_d_r_wall_func_alg_8_c.html',1,'']]], - ['sdrwallfuncalgdriver_2ec_493',['SDRWallFuncAlgDriver.C',['../_s_d_r_wall_func_alg_driver_8_c.html',1,'']]], - ['segment_5fgenerator_5ftypes_494',['segment_generator_types',['../namespacesierra_1_1nalu.html#afe6914cbd0c47cab470ae033c0e79862',1,'sierra::nalu']]], - ['segregated_5fsum_5finto_495',['segregated_sum_into',['../namespacesierra_1_1nalu.html#a66c7314e9ef8ef936ff591d2e7452477',1,'sierra::nalu']]], - ['segregated_5fsum_5finto_5frow_496',['segregated_sum_into_row',['../namespacesierra_1_1nalu.html#ab41515299d1eb18ba72688670d53e912',1,'sierra::nalu']]], - ['set_5fcoordinates_5fhex_497',['set_coordinates_hex',['../namespacesierra_1_1nalu_1_1impl.html#a79cf64aafa6c5ca90f1e229e3ab1a64c',1,'sierra::nalu::impl']]], - ['shearstresstransportequationsystem_2ec_498',['ShearStressTransportEquationSystem.C',['../_shear_stress_transport_equation_system_8_c.html',1,'']]], - ['shifted_5fpyr_5fderiv_499',['shifted_pyr_deriv',['../namespacesierra_1_1nalu.html#a477cfc57bed160caf9c5613600c20cb5',1,'sierra::nalu']]], - ['sidewriter_2ec_500',['SideWriter.C',['../_side_writer_8_c.html',1,'']]], - ['sierra_501',['sierra',['../namespacesierra.html',1,'']]], - ['simd_5fnode_5fmap_502',['simd_node_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#abf8f0341cb023a69e37eb7961b6d97ab',1,'sierra::nalu::matrix_free']]], - ['simd_5fnode_5foffsets_503',['simd_node_offsets',['../namespacesierra_1_1nalu_1_1matrix__free.html#a0820e6b1161c4c9b2888acebd8cfe1bf',1,'sierra::nalu::matrix_free']]], - ['simulation_2ec_504',['Simulation.C',['../_simulation_8_c.html',1,'']]], - ['sinprofilechannelflowvelocityauxfunction_2ec_505',['SinProfileChannelFlowVelocityAuxFunction.C',['../_sin_profile_channel_flow_velocity_aux_function_8_c.html',1,'']]], - ['size_5fratio_5fx_506',['size_ratio_x',['../_perturbed_shear_layer_aux_functions_8_c.html#a9c87e5d31d7a790c0b998a4a557bda1f',1,'PerturbedShearLayerAuxFunctions.C']]], - ['size_5fratio_5fy_507',['size_ratio_y',['../_perturbed_shear_layer_aux_functions_8_c.html#a4c91cf3ea735e6cb7c78ce348d189403',1,'PerturbedShearLayerAuxFunctions.C']]], - ['size_5fratio_5fz_508',['size_ratio_z',['../_perturbed_shear_layer_aux_functions_8_c.html#a71b64ab91a1075d0da8f15c164a14225',1,'PerturbedShearLayerAuxFunctions.C']]], - ['sloshingtankvofauxfunction_2ec_509',['SloshingTankVOFAuxFunction.C',['../_sloshing_tank_v_o_f_aux_function_8_c.html',1,'']]], - ['smartfield_2ec_510',['SmartField.C',['../_smart_field_8_c.html',1,'']]], - ['solutionnormpostprocessing_2ec_511',['SolutionNormPostProcessing.C',['../_solution_norm_post_processing_8_c.html',1,'']]], - ['solutionoptions_2ec_512',['SolutionOptions.C',['../_solution_options_8_c.html',1,'']]], - ['solveralgorithm_2ec_513',['SolverAlgorithm.C',['../_solver_algorithm_8_c.html',1,'']]], - ['solveralgorithmdriver_2ec_514',['SolverAlgorithmDriver.C',['../_solver_algorithm_driver_8_c.html',1,'']]], - ['sort_5fconnections_515',['sort_connections',['../namespacesierra_1_1nalu.html#a88a2b25ab79b3ffe2c9e770e914deb1e',1,'sierra::nalu']]], - ['sortintlowhigh_516',['sortIntLowHigh',['../structsierra_1_1nalu_1_1sort_int_low_high.html',1,'sierra::nalu::sortIntLowHigh'],['../structsierra_1_1nalu_1_1sort_int_low_high.html#a9a70ff93faba136fc58637399a5f58eb',1,'sierra::nalu::sortIntLowHigh::sortIntLowHigh()']]], - ['sortpermutation_517',['sortPermutation',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a9763514840c202b7cc306a4bc6205329',1,'AssembleNGPNodeSolverAlgorithm.C']]], - ['sparsifiededgelaplacian_2ec_518',['SparsifiedEdgeLaplacian.C',['../_sparsified_edge_laplacian_8_c.html',1,'']]], - ['specificdissipationrateequationsystem_2ec_519',['SpecificDissipationRateEquationSystem.C',['../_specific_dissipation_rate_equation_system_8_c.html',1,'']]], - ['specificheatpropertyevaluator_2ec_520',['SpecificHeatPropertyEvaluator.C',['../_specific_heat_property_evaluator_8_c.html',1,'']]], - ['spherical_5fcap_5fquadrature_521',['spherical_cap_quadrature',['../namespacesierra_1_1nalu_1_1details.html#ac76c7eac0ae85b27e6b95f54361b932d',1,'sierra::nalu::details']]], - ['spherical_5fcap_5fradau_522',['spherical_cap_radau',['../namespacesierra_1_1nalu_1_1details.html#aa741aef68c579dca57a7fa09412afc32',1,'sierra::nalu::details']]], - ['spherical_5fcap_5ftruncated_5fnormal_523',['spherical_cap_truncated_normal',['../namespacesierra_1_1nalu_1_1details.html#a846f30d76c79bdeba662e227b83b1685',1,'sierra::nalu::details']]], - ['sstamsaveragesalg_2ec_524',['SSTAMSAveragesAlg.C',['../_s_s_t_a_m_s_averages_alg_8_c.html',1,'']]], - ['sstmaxlengthscalealg_2ec_525',['SSTMaxLengthScaleAlg.C',['../_s_s_t_max_length_scale_alg_8_c.html',1,'']]], - ['sstmaxlengthscaledriver_2ec_526',['SSTMaxLengthScaleDriver.C',['../_s_s_t_max_length_scale_driver_8_c.html',1,'']]], - ['steadytaylorvortexgradpressureauxfunction_2ec_527',['SteadyTaylorVortexGradPressureAuxFunction.C',['../_steady_taylor_vortex_grad_pressure_aux_function_8_c.html',1,'']]], - ['steadytaylorvortexmomentumsrcnodesuppalg_2ec_528',['SteadyTaylorVortexMomentumSrcNodeSuppAlg.C',['../_steady_taylor_vortex_momentum_src_node_supp_alg_8_c.html',1,'']]], - ['steadytaylorvortexpressureauxfunction_2ec_529',['SteadyTaylorVortexPressureAuxFunction.C',['../_steady_taylor_vortex_pressure_aux_function_8_c.html',1,'']]], - ['steadytaylorvortexvelocityauxfunction_2ec_530',['SteadyTaylorVortexVelocityAuxFunction.C',['../_steady_taylor_vortex_velocity_aux_function_8_c.html',1,'']]], - ['stk_5fedge_5findex_531',['stk_edge_index',['../namespacesierra_1_1nalu.html#acdb2abaa493a9e12e8b0f860b9472df4',1,'sierra::nalu']]], - ['stkhelpers_2ec_532',['StkHelpers.C',['../_stk_helpers_8_c.html',1,'']]], - ['stksimdconnectivitymap_2ec_533',['StkSimdConnectivityMap.C',['../_stk_simd_connectivity_map_8_c.html',1,'']]], - ['stksimdfaceconnectivitymap_2ec_534',['StkSimdFaceConnectivityMap.C',['../_stk_simd_face_connectivity_map_8_c.html',1,'']]], - ['stksimdgatheredelementdata_2ec_535',['StkSimdGatheredElementData.C',['../_stk_simd_gathered_element_data_8_c.html',1,'']]], - ['stksimdnodeconnectivitymap_2ec_536',['StkSimdNodeConnectivityMap.C',['../_stk_simd_node_connectivity_map_8_c.html',1,'']]], - ['stktotpetracomm_2ec_537',['StkToTpetraComm.C',['../_stk_to_tpetra_comm_8_c.html',1,'']]], - ['stktotpetralocalindices_2ec_538',['StkToTpetraLocalIndices.C',['../_stk_to_tpetra_local_indices_8_c.html',1,'']]], - ['stktotpetramap_2ec_539',['StkToTpetraMap.C',['../_stk_to_tpetra_map_8_c.html',1,'']]], - ['streletsupwindedgealg_2ec_540',['StreletsUpwindEdgeAlg.C',['../_strelets_upwind_edge_alg_8_c.html',1,'']]], - ['stringtimecoordfunction_2ec_541',['StringTimeCoordFunction.C',['../_string_time_coord_function_8_c.html',1,'']]], - ['stringtimecoordtemperatureauxfunction_2ec_542',['StringTimeCoordTemperatureAuxFunction.C',['../_string_time_coord_temperature_aux_function_8_c.html',1,'']]], - ['strongdirichletbc_2ec_543',['StrongDirichletBC.C',['../_strong_dirichlet_b_c_8_c.html',1,'']]], - ['sum_5finto_544',['sum_into',['../namespacesierra_1_1nalu.html#a8bfd9d89cd1b349a145d1e5921ef64b5',1,'sierra::nalu']]], - ['sum_5finto_5frow_545',['sum_into_row',['../namespacesierra_1_1nalu.html#a6107340a2a7f2cf2ff643f5438ea06cf',1,'sierra::nalu']]], - ['sum_5finto_5frow_5fvec_5f3_546',['sum_into_row_vec_3',['../namespacesierra_1_1nalu.html#a45348c785e27f57ce7428d86b2d87304',1,'sierra::nalu']]], - ['super_5felem_5fpart_547',['super_elem_part',['../namespacesierra_1_1nalu.html#afe88de34b5c31f6d37f05f18d1b88aa2',1,'sierra::nalu::super_elem_part(const stk::mesh::Part &part)'],['../namespacesierra_1_1nalu.html#a7f01979bc505724e60559e5e1b603be4',1,'sierra::nalu::super_elem_part(const stk::mesh::Part *part)']]], - ['super_5felem_5fpart_5fvector_548',['super_elem_part_vector',['../namespacesierra_1_1nalu.html#a11fbf627b180dcaaf227ddb72654fc58',1,'sierra::nalu']]], - ['super_5felement_5fpart_5fname_549',['super_element_part_name',['../namespacesierra_1_1nalu.html#ac100c11650a55c3106aa4586fbb1bac7',1,'sierra::nalu']]], - ['super_5felement_5fsuffix_550',['super_element_suffix',['../namespacesierra_1_1nalu.html#a4a8a61c2894c4a7f84534811814c6d07',1,'sierra::nalu']]], - ['super_5fsubset_5fpart_551',['super_subset_part',['../namespacesierra_1_1nalu.html#a36782be0268c132b9998bde2dffb15de',1,'sierra::nalu::super_subset_part(const stk::mesh::Part &part, int numElemNodes, int numSideNodes)'],['../namespacesierra_1_1nalu.html#a3ccf279ec1c5b969b4ee5f92a2926c5f',1,'sierra::nalu::super_subset_part(const stk::mesh::Part &part)']]], - ['super_5fsubset_5fpart_5fname_552',['super_subset_part_name',['../namespacesierra_1_1nalu.html#a3e6cc8344aa85a8f0e4590fcd91132b6',1,'sierra::nalu::super_subset_part_name(std::string base_name)'],['../namespacesierra_1_1nalu.html#a86f1b88cf795773b533056731e5a8b49',1,'sierra::nalu::super_subset_part_name(std::string base_name, int, int)']]], - ['supplementalalgorithm_2ec_553',['SupplementalAlgorithm.C',['../_supplemental_algorithm_8_c.html',1,'']]], - ['surfaceforceandmomentalgorithm_2ec_554',['SurfaceForceAndMomentAlgorithm.C',['../_surface_force_and_moment_algorithm_8_c.html',1,'']]], - ['surfaceforceandmomentalgorithmdriver_2ec_555',['SurfaceForceAndMomentAlgorithmDriver.C',['../_surface_force_and_moment_algorithm_driver_8_c.html',1,'']]], - ['surfaceforceandmomentwallfunctionalgorithm_2ec_556',['SurfaceForceAndMomentWallFunctionAlgorithm.C',['../_surface_force_and_moment_wall_function_algorithm_8_c.html',1,'']]], - ['sutherlandspropertyevaluator_2ec_557',['SutherlandsPropertyEvaluator.C',['../_sutherlands_property_evaluator_8_c.html',1,'']]], - ['syntheticlidar_2ec_558',['SyntheticLidar.C',['../_synthetic_lidar_8_c.html',1,'']]] + ['sdrsstbltm2015nodekernel_2ec_489',['SDRSSTBLTM2015NodeKernel.C',['../_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c.html',1,'']]], + ['sdrsstdesnodekernel_2ec_490',['SDRSSTDESNodeKernel.C',['../_s_d_r_s_s_t_d_e_s_node_kernel_8_c.html',1,'']]], + ['sdrsstlrnodekernel_2ec_491',['SDRSSTLRNodeKernel.C',['../_s_d_r_s_s_t_l_r_node_kernel_8_c.html',1,'']]], + ['sdrsstnodekernel_2ec_492',['SDRSSTNodeKernel.C',['../_s_d_r_s_s_t_node_kernel_8_c.html',1,'']]], + ['sdrwallfuncalg_2ec_493',['SDRWallFuncAlg.C',['../_s_d_r_wall_func_alg_8_c.html',1,'']]], + ['sdrwallfuncalgdriver_2ec_494',['SDRWallFuncAlgDriver.C',['../_s_d_r_wall_func_alg_driver_8_c.html',1,'']]], + ['segment_5fgenerator_5ftypes_495',['segment_generator_types',['../namespacesierra_1_1nalu.html#afe6914cbd0c47cab470ae033c0e79862',1,'sierra::nalu']]], + ['segregated_5fsum_5finto_496',['segregated_sum_into',['../namespacesierra_1_1nalu.html#a66c7314e9ef8ef936ff591d2e7452477',1,'sierra::nalu']]], + ['segregated_5fsum_5finto_5frow_497',['segregated_sum_into_row',['../namespacesierra_1_1nalu.html#ab41515299d1eb18ba72688670d53e912',1,'sierra::nalu']]], + ['set_5fcoordinates_5fhex_498',['set_coordinates_hex',['../namespacesierra_1_1nalu_1_1impl.html#a79cf64aafa6c5ca90f1e229e3ab1a64c',1,'sierra::nalu::impl']]], + ['shearstresstransportequationsystem_2ec_499',['ShearStressTransportEquationSystem.C',['../_shear_stress_transport_equation_system_8_c.html',1,'']]], + ['shifted_5fpyr_5fderiv_500',['shifted_pyr_deriv',['../namespacesierra_1_1nalu.html#a477cfc57bed160caf9c5613600c20cb5',1,'sierra::nalu']]], + ['sidewriter_2ec_501',['SideWriter.C',['../_side_writer_8_c.html',1,'']]], + ['sierra_502',['sierra',['../namespacesierra.html',1,'']]], + ['simd_5fnode_5fmap_503',['simd_node_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#abf8f0341cb023a69e37eb7961b6d97ab',1,'sierra::nalu::matrix_free']]], + ['simd_5fnode_5foffsets_504',['simd_node_offsets',['../namespacesierra_1_1nalu_1_1matrix__free.html#a0820e6b1161c4c9b2888acebd8cfe1bf',1,'sierra::nalu::matrix_free']]], + ['simulation_2ec_505',['Simulation.C',['../_simulation_8_c.html',1,'']]], + ['sinprofilechannelflowvelocityauxfunction_2ec_506',['SinProfileChannelFlowVelocityAuxFunction.C',['../_sin_profile_channel_flow_velocity_aux_function_8_c.html',1,'']]], + ['size_5fratio_5fx_507',['size_ratio_x',['../_perturbed_shear_layer_aux_functions_8_c.html#a9c87e5d31d7a790c0b998a4a557bda1f',1,'PerturbedShearLayerAuxFunctions.C']]], + ['size_5fratio_5fy_508',['size_ratio_y',['../_perturbed_shear_layer_aux_functions_8_c.html#a4c91cf3ea735e6cb7c78ce348d189403',1,'PerturbedShearLayerAuxFunctions.C']]], + ['size_5fratio_5fz_509',['size_ratio_z',['../_perturbed_shear_layer_aux_functions_8_c.html#a71b64ab91a1075d0da8f15c164a14225',1,'PerturbedShearLayerAuxFunctions.C']]], + ['sloshingtankvofauxfunction_2ec_510',['SloshingTankVOFAuxFunction.C',['../_sloshing_tank_v_o_f_aux_function_8_c.html',1,'']]], + ['smartfield_2ec_511',['SmartField.C',['../_smart_field_8_c.html',1,'']]], + ['solutionnormpostprocessing_2ec_512',['SolutionNormPostProcessing.C',['../_solution_norm_post_processing_8_c.html',1,'']]], + ['solutionoptions_2ec_513',['SolutionOptions.C',['../_solution_options_8_c.html',1,'']]], + ['solveralgorithm_2ec_514',['SolverAlgorithm.C',['../_solver_algorithm_8_c.html',1,'']]], + ['solveralgorithmdriver_2ec_515',['SolverAlgorithmDriver.C',['../_solver_algorithm_driver_8_c.html',1,'']]], + ['sort_5fconnections_516',['sort_connections',['../namespacesierra_1_1nalu.html#a88a2b25ab79b3ffe2c9e770e914deb1e',1,'sierra::nalu']]], + ['sortintlowhigh_517',['sortIntLowHigh',['../structsierra_1_1nalu_1_1sort_int_low_high.html',1,'sierra::nalu::sortIntLowHigh'],['../structsierra_1_1nalu_1_1sort_int_low_high.html#a9a70ff93faba136fc58637399a5f58eb',1,'sierra::nalu::sortIntLowHigh::sortIntLowHigh()']]], + ['sortpermutation_518',['sortPermutation',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a9763514840c202b7cc306a4bc6205329',1,'AssembleNGPNodeSolverAlgorithm.C']]], + ['sparsifiededgelaplacian_2ec_519',['SparsifiedEdgeLaplacian.C',['../_sparsified_edge_laplacian_8_c.html',1,'']]], + ['specificdissipationrateequationsystem_2ec_520',['SpecificDissipationRateEquationSystem.C',['../_specific_dissipation_rate_equation_system_8_c.html',1,'']]], + ['specificheatpropertyevaluator_2ec_521',['SpecificHeatPropertyEvaluator.C',['../_specific_heat_property_evaluator_8_c.html',1,'']]], + ['spherical_5fcap_5fquadrature_522',['spherical_cap_quadrature',['../namespacesierra_1_1nalu_1_1details.html#ac76c7eac0ae85b27e6b95f54361b932d',1,'sierra::nalu::details']]], + ['spherical_5fcap_5fradau_523',['spherical_cap_radau',['../namespacesierra_1_1nalu_1_1details.html#aa741aef68c579dca57a7fa09412afc32',1,'sierra::nalu::details']]], + ['spherical_5fcap_5ftruncated_5fnormal_524',['spherical_cap_truncated_normal',['../namespacesierra_1_1nalu_1_1details.html#a846f30d76c79bdeba662e227b83b1685',1,'sierra::nalu::details']]], + ['sstamsaveragesalg_2ec_525',['SSTAMSAveragesAlg.C',['../_s_s_t_a_m_s_averages_alg_8_c.html',1,'']]], + ['sstmaxlengthscalealg_2ec_526',['SSTMaxLengthScaleAlg.C',['../_s_s_t_max_length_scale_alg_8_c.html',1,'']]], + ['sstmaxlengthscaledriver_2ec_527',['SSTMaxLengthScaleDriver.C',['../_s_s_t_max_length_scale_driver_8_c.html',1,'']]], + ['steadytaylorvortexgradpressureauxfunction_2ec_528',['SteadyTaylorVortexGradPressureAuxFunction.C',['../_steady_taylor_vortex_grad_pressure_aux_function_8_c.html',1,'']]], + ['steadytaylorvortexmomentumsrcnodesuppalg_2ec_529',['SteadyTaylorVortexMomentumSrcNodeSuppAlg.C',['../_steady_taylor_vortex_momentum_src_node_supp_alg_8_c.html',1,'']]], + ['steadytaylorvortexpressureauxfunction_2ec_530',['SteadyTaylorVortexPressureAuxFunction.C',['../_steady_taylor_vortex_pressure_aux_function_8_c.html',1,'']]], + ['steadytaylorvortexvelocityauxfunction_2ec_531',['SteadyTaylorVortexVelocityAuxFunction.C',['../_steady_taylor_vortex_velocity_aux_function_8_c.html',1,'']]], + ['stk_5fedge_5findex_532',['stk_edge_index',['../namespacesierra_1_1nalu.html#acdb2abaa493a9e12e8b0f860b9472df4',1,'sierra::nalu']]], + ['stkhelpers_2ec_533',['StkHelpers.C',['../_stk_helpers_8_c.html',1,'']]], + ['stksimdconnectivitymap_2ec_534',['StkSimdConnectivityMap.C',['../_stk_simd_connectivity_map_8_c.html',1,'']]], + ['stksimdfaceconnectivitymap_2ec_535',['StkSimdFaceConnectivityMap.C',['../_stk_simd_face_connectivity_map_8_c.html',1,'']]], + ['stksimdgatheredelementdata_2ec_536',['StkSimdGatheredElementData.C',['../_stk_simd_gathered_element_data_8_c.html',1,'']]], + ['stksimdnodeconnectivitymap_2ec_537',['StkSimdNodeConnectivityMap.C',['../_stk_simd_node_connectivity_map_8_c.html',1,'']]], + ['stktotpetracomm_2ec_538',['StkToTpetraComm.C',['../_stk_to_tpetra_comm_8_c.html',1,'']]], + ['stktotpetralocalindices_2ec_539',['StkToTpetraLocalIndices.C',['../_stk_to_tpetra_local_indices_8_c.html',1,'']]], + ['stktotpetramap_2ec_540',['StkToTpetraMap.C',['../_stk_to_tpetra_map_8_c.html',1,'']]], + ['streletsupwindedgealg_2ec_541',['StreletsUpwindEdgeAlg.C',['../_strelets_upwind_edge_alg_8_c.html',1,'']]], + ['stringtimecoordfunction_2ec_542',['StringTimeCoordFunction.C',['../_string_time_coord_function_8_c.html',1,'']]], + ['stringtimecoordtemperatureauxfunction_2ec_543',['StringTimeCoordTemperatureAuxFunction.C',['../_string_time_coord_temperature_aux_function_8_c.html',1,'']]], + ['strongdirichletbc_2ec_544',['StrongDirichletBC.C',['../_strong_dirichlet_b_c_8_c.html',1,'']]], + ['sum_5finto_545',['sum_into',['../namespacesierra_1_1nalu.html#a8bfd9d89cd1b349a145d1e5921ef64b5',1,'sierra::nalu']]], + ['sum_5finto_5frow_546',['sum_into_row',['../namespacesierra_1_1nalu.html#a6107340a2a7f2cf2ff643f5438ea06cf',1,'sierra::nalu']]], + ['sum_5finto_5frow_5fvec_5f3_547',['sum_into_row_vec_3',['../namespacesierra_1_1nalu.html#a45348c785e27f57ce7428d86b2d87304',1,'sierra::nalu']]], + ['super_5felem_5fpart_548',['super_elem_part',['../namespacesierra_1_1nalu.html#afe88de34b5c31f6d37f05f18d1b88aa2',1,'sierra::nalu::super_elem_part(const stk::mesh::Part &part)'],['../namespacesierra_1_1nalu.html#a7f01979bc505724e60559e5e1b603be4',1,'sierra::nalu::super_elem_part(const stk::mesh::Part *part)']]], + ['super_5felem_5fpart_5fvector_549',['super_elem_part_vector',['../namespacesierra_1_1nalu.html#a11fbf627b180dcaaf227ddb72654fc58',1,'sierra::nalu']]], + ['super_5felement_5fpart_5fname_550',['super_element_part_name',['../namespacesierra_1_1nalu.html#ac100c11650a55c3106aa4586fbb1bac7',1,'sierra::nalu']]], + ['super_5felement_5fsuffix_551',['super_element_suffix',['../namespacesierra_1_1nalu.html#a4a8a61c2894c4a7f84534811814c6d07',1,'sierra::nalu']]], + ['super_5fsubset_5fpart_552',['super_subset_part',['../namespacesierra_1_1nalu.html#a36782be0268c132b9998bde2dffb15de',1,'sierra::nalu::super_subset_part(const stk::mesh::Part &part, int numElemNodes, int numSideNodes)'],['../namespacesierra_1_1nalu.html#a3ccf279ec1c5b969b4ee5f92a2926c5f',1,'sierra::nalu::super_subset_part(const stk::mesh::Part &part)']]], + ['super_5fsubset_5fpart_5fname_553',['super_subset_part_name',['../namespacesierra_1_1nalu.html#a3e6cc8344aa85a8f0e4590fcd91132b6',1,'sierra::nalu::super_subset_part_name(std::string base_name)'],['../namespacesierra_1_1nalu.html#a86f1b88cf795773b533056731e5a8b49',1,'sierra::nalu::super_subset_part_name(std::string base_name, int, int)']]], + ['supplementalalgorithm_2ec_554',['SupplementalAlgorithm.C',['../_supplemental_algorithm_8_c.html',1,'']]], + ['surfaceforceandmomentalgorithm_2ec_555',['SurfaceForceAndMomentAlgorithm.C',['../_surface_force_and_moment_algorithm_8_c.html',1,'']]], + ['surfaceforceandmomentalgorithmdriver_2ec_556',['SurfaceForceAndMomentAlgorithmDriver.C',['../_surface_force_and_moment_algorithm_driver_8_c.html',1,'']]], + ['surfaceforceandmomentwallfunctionalgorithm_2ec_557',['SurfaceForceAndMomentWallFunctionAlgorithm.C',['../_surface_force_and_moment_wall_function_algorithm_8_c.html',1,'']]], + ['sutherlandspropertyevaluator_2ec_558',['SutherlandsPropertyEvaluator.C',['../_sutherlands_property_evaluator_8_c.html',1,'']]], + ['syntheticlidar_2ec_559',['SyntheticLidar.C',['../_synthetic_lidar_8_c.html',1,'']]] ]; diff --git a/api_docs/search/all_12.js b/api_docs/search/all_12.js index ce6e318a1..854607b01 100644 --- a/api_docs/search/all_12.js +++ b/api_docs/search/all_12.js @@ -1,57 +1,58 @@ var searchData= [ - ['t0_5f_559',['t0_',['../_matrix_free_low_mach_equation_system_8_c.html#a35bce11319e51cdabfdbd8be5d95a721',1,'MatrixFreeLowMachEquationSystem.C']]], - ['tabulatedtemperatureauxfunction_2ec_560',['TabulatedTemperatureAuxFunction.C',['../_tabulated_temperature_aux_function_8_c.html',1,'']]], - ['taylorgreenpressureauxfunction_2ec_561',['TaylorGreenPressureAuxFunction.C',['../_taylor_green_pressure_aux_function_8_c.html',1,'']]], - ['taylorgreenvelocityauxfunction_2ec_562',['TaylorGreenVelocityAuxFunction.C',['../_taylor_green_velocity_aux_function_8_c.html',1,'']]], - ['tdrkenodekernel_2ec_563',['TDRKENodeKernel.C',['../_t_d_r_k_e_node_kernel_8_c.html',1,'']]], - ['temperaturepropalgorithm_2ec_564',['TemperaturePropAlgorithm.C',['../_temperature_prop_algorithm_8_c.html',1,'']]], - ['tensor_5fedge_5findex_565',['tensor_edge_index',['../namespacesierra_1_1nalu.html#a725d5c4f0bccdb772c28011a92f1208b',1,'sierra::nalu']]], - ['tet4cvfem_2ec_566',['Tet4CVFEM.C',['../_tet4_c_v_f_e_m_8_c.html',1,'']]], - ['tet_5fderiv_567',['tet_deriv',['../namespacesierra_1_1nalu.html#a7b08fb1709c3b1d6abfd014581f6ed0f',1,'sierra::nalu']]], - ['tet_5fgradient_5foperator_568',['tet_gradient_operator',['../namespacesierra_1_1nalu.html#a9c7d7f8645564e7ae68042f79e770640',1,'sierra::nalu']]], - ['teuchos_5fcommunicator_569',['teuchos_communicator',['../namespacesierra_1_1nalu_1_1matrix__free.html#a5809942d00cbae736134dd3f476c4966',1,'sierra::nalu::matrix_free']]], - ['thermalconductivityfromprandtlpropalgorithm_2ec_570',['ThermalConductivityFromPrandtlPropAlgorithm.C',['../_thermal_conductivity_from_prandtl_prop_algorithm_8_c.html',1,'']]], - ['timeintegrator_2ec_571',['TimeIntegrator.C',['../_time_integrator_8_c.html',1,'']]], - ['timer_5f_572',['timer_',['../_matrix_free_low_mach_equation_system_8_c.html#af69f4c96956f81c6cda9ead6dc16316a',1,'MatrixFreeLowMachEquationSystem.C']]], - ['tioga_5fnalu_573',['tioga_nalu',['../namespacetioga__nalu.html',1,'']]], - ['tiogablock_2ec_574',['TiogaBlock.C',['../_tioga_block_8_c.html',1,'']]], - ['tiogaoptions_2ec_575',['TiogaOptions.C',['../_tioga_options_8_c.html',1,'']]], - ['tiogaref_2ec_576',['TiogaRef.C',['../_tioga_ref_8_c.html',1,'']]], - ['tiogastkiface_2ec_577',['TiogaSTKIface.C',['../_tioga_s_t_k_iface_8_c.html',1,'']]], - ['tkekenodekernel_2ec_578',['TKEKENodeKernel.C',['../_t_k_e_k_e_node_kernel_8_c.html',1,'']]], - ['tkekonodekernel_2ec_579',['TKEKONodeKernel.C',['../_t_k_e_k_o_node_kernel_8_c.html',1,'']]], - ['tkeksgsnodekernel_2ec_580',['TKEKsgsNodeKernel.C',['../_t_k_e_ksgs_node_kernel_8_c.html',1,'']]], - ['tkerodinodekernel_2ec_581',['TKERodiNodeKernel.C',['../_t_k_e_rodi_node_kernel_8_c.html',1,'']]], - ['tkesstamsnodekernel_2ec_582',['TKESSTAMSNodeKernel.C',['../_t_k_e_s_s_t_a_m_s_node_kernel_8_c.html',1,'']]], - ['tkesstdesnodekernel_2ec_583',['TKESSTDESNodeKernel.C',['../_t_k_e_s_s_t_d_e_s_node_kernel_8_c.html',1,'']]], - ['tkesstiddesnodekernel_2ec_584',['TKESSTIDDESNodeKernel.C',['../_t_k_e_s_s_t_i_d_d_e_s_node_kernel_8_c.html',1,'']]], - ['tkesstlrnodekernel_2ec_585',['TKESSTLRNodeKernel.C',['../_t_k_e_s_s_t_l_r_node_kernel_8_c.html',1,'']]], - ['tkesstnodekernel_2ec_586',['TKESSTNodeKernel.C',['../_t_k_e_s_s_t_node_kernel_8_c.html',1,'']]], - ['tkewallfuncalg_2ec_587',['TKEWallFuncAlg.C',['../_t_k_e_wall_func_alg_8_c.html',1,'']]], - ['tkewallfuncalgdriver_2ec_588',['TKEWallFuncAlgDriver.C',['../_t_k_e_wall_func_alg_driver_8_c.html',1,'']]], - ['tornadoauxfunction_2ec_589',['TornadoAuxFunction.C',['../_tornado_aux_function_8_c.html',1,'']]], - ['totaldissipationrateequationsystem_2ec_590',['TotalDissipationRateEquationSystem.C',['../_total_dissipation_rate_equation_system_8_c.html',1,'']]], - ['tpetralinearsystem_2ec_591',['TpetraLinearSystem.C',['../_tpetra_linear_system_8_c.html',1,'']]], - ['tpetralinearsystemhelpers_2ec_592',['TpetraLinearSystemHelpers.C',['../_tpetra_linear_system_helpers_8_c.html',1,'']]], - ['tpetrasegregatedlinearsystem_2ec_593',['TpetraSegregatedLinearSystem.C',['../_tpetra_segregated_linear_system_8_c.html',1,'']]], - ['transfer_2ec_594',['Transfer.C',['../_transfer_8_c.html',1,'']]], - ['transfers_2ec_595',['Transfers.C',['../_transfers_8_c.html',1,'']]], - ['transform_5fto_5fsuper_5felem_5fpart_5fvector_596',['transform_to_super_elem_part_vector',['../namespacesierra_1_1nalu.html#a18137dc89b0a5ab4e49951d85cd32e63',1,'sierra::nalu']]], - ['transportcoefficients_2ec_597',['TransportCoefficients.C',['../_transport_coefficients_8_c.html',1,'']]], - ['tri32dcvfem_2ec_598',['Tri32DCVFEM.C',['../_tri32_d_c_v_f_e_m_8_c.html',1,'']]], - ['tri33dcvfem_2ec_599',['Tri33DCVFEM.C',['../_tri33_d_c_v_f_e_m_8_c.html',1,'']]], - ['tri_5fderivative_600',['tri_derivative',['../namespacesierra_1_1nalu.html#a164c8906b260dfb3898250a1a83b2561',1,'sierra::nalu']]], - ['tri_5fgradient_5foperator_601',['tri_gradient_operator',['../namespacesierra_1_1nalu.html#a856bf14876fdfa0ecfa747b6e351bf6a',1,'sierra::nalu']]], - ['truncated_5fnormal_5frule_602',['truncated_normal_rule',['../namespacesierra_1_1nalu_1_1details.html#ad92400b7977b34f8382f03d0196dfaeb',1,'sierra::nalu::details']]], - ['turbinesurrogatekernel_2ec_603',['TurbineSurrogateKernel.C',['../_turbine_surrogate_kernel_8_c.html',1,'']]], - ['turbkineticenergyequationsystem_2ec_604',['TurbKineticEnergyEquationSystem.C',['../_turb_kinetic_energy_equation_system_8_c.html',1,'']]], - ['turbulenceaveragingpostprocessing_2ec_605',['TurbulenceAveragingPostProcessing.C',['../_turbulence_averaging_post_processing_8_c.html',1,'']]], - ['turbvisckealg_2ec_606',['TurbViscKEAlg.C',['../_turb_visc_k_e_alg_8_c.html',1,'']]], - ['turbvisckoalg_2ec_607',['TurbViscKOAlg.C',['../_turb_visc_k_o_alg_8_c.html',1,'']]], - ['turbviscksgsalg_2ec_608',['TurbViscKsgsAlg.C',['../_turb_visc_ksgs_alg_8_c.html',1,'']]], - ['turbviscsmagorinskyalgorithm_2ec_609',['TurbViscSmagorinskyAlgorithm.C',['../_turb_visc_smagorinsky_algorithm_8_c.html',1,'']]], - ['turbviscsstalg_2ec_610',['TurbViscSSTAlg.C',['../_turb_visc_s_s_t_alg_8_c.html',1,'']]], - ['turbviscsstlralg_2ec_611',['TurbViscSSTLRAlg.C',['../_turb_visc_s_s_t_l_r_alg_8_c.html',1,'']]], - ['turbviscwalealgorithm_2ec_612',['TurbViscWaleAlgorithm.C',['../_turb_visc_wale_algorithm_8_c.html',1,'']]] + ['t0_5f_560',['t0_',['../_matrix_free_low_mach_equation_system_8_c.html#a35bce11319e51cdabfdbd8be5d95a721',1,'MatrixFreeLowMachEquationSystem.C']]], + ['tabulatedtemperatureauxfunction_2ec_561',['TabulatedTemperatureAuxFunction.C',['../_tabulated_temperature_aux_function_8_c.html',1,'']]], + ['taylorgreenpressureauxfunction_2ec_562',['TaylorGreenPressureAuxFunction.C',['../_taylor_green_pressure_aux_function_8_c.html',1,'']]], + ['taylorgreenvelocityauxfunction_2ec_563',['TaylorGreenVelocityAuxFunction.C',['../_taylor_green_velocity_aux_function_8_c.html',1,'']]], + ['tdrkenodekernel_2ec_564',['TDRKENodeKernel.C',['../_t_d_r_k_e_node_kernel_8_c.html',1,'']]], + ['temperaturepropalgorithm_2ec_565',['TemperaturePropAlgorithm.C',['../_temperature_prop_algorithm_8_c.html',1,'']]], + ['tensor_5fedge_5findex_566',['tensor_edge_index',['../namespacesierra_1_1nalu.html#a725d5c4f0bccdb772c28011a92f1208b',1,'sierra::nalu']]], + ['tet4cvfem_2ec_567',['Tet4CVFEM.C',['../_tet4_c_v_f_e_m_8_c.html',1,'']]], + ['tet_5fderiv_568',['tet_deriv',['../namespacesierra_1_1nalu.html#a7b08fb1709c3b1d6abfd014581f6ed0f',1,'sierra::nalu']]], + ['tet_5fgradient_5foperator_569',['tet_gradient_operator',['../namespacesierra_1_1nalu.html#a9c7d7f8645564e7ae68042f79e770640',1,'sierra::nalu']]], + ['teuchos_5fcommunicator_570',['teuchos_communicator',['../namespacesierra_1_1nalu_1_1matrix__free.html#a5809942d00cbae736134dd3f476c4966',1,'sierra::nalu::matrix_free']]], + ['thermalconductivityfromprandtlpropalgorithm_2ec_571',['ThermalConductivityFromPrandtlPropAlgorithm.C',['../_thermal_conductivity_from_prandtl_prop_algorithm_8_c.html',1,'']]], + ['timeintegrator_2ec_572',['TimeIntegrator.C',['../_time_integrator_8_c.html',1,'']]], + ['timer_5f_573',['timer_',['../_matrix_free_low_mach_equation_system_8_c.html#af69f4c96956f81c6cda9ead6dc16316a',1,'MatrixFreeLowMachEquationSystem.C']]], + ['tioga_5fnalu_574',['tioga_nalu',['../namespacetioga__nalu.html',1,'']]], + ['tiogablock_2ec_575',['TiogaBlock.C',['../_tioga_block_8_c.html',1,'']]], + ['tiogaoptions_2ec_576',['TiogaOptions.C',['../_tioga_options_8_c.html',1,'']]], + ['tiogaref_2ec_577',['TiogaRef.C',['../_tioga_ref_8_c.html',1,'']]], + ['tiogastkiface_2ec_578',['TiogaSTKIface.C',['../_tioga_s_t_k_iface_8_c.html',1,'']]], + ['tkekenodekernel_2ec_579',['TKEKENodeKernel.C',['../_t_k_e_k_e_node_kernel_8_c.html',1,'']]], + ['tkekonodekernel_2ec_580',['TKEKONodeKernel.C',['../_t_k_e_k_o_node_kernel_8_c.html',1,'']]], + ['tkeksgsnodekernel_2ec_581',['TKEKsgsNodeKernel.C',['../_t_k_e_ksgs_node_kernel_8_c.html',1,'']]], + ['tkerodinodekernel_2ec_582',['TKERodiNodeKernel.C',['../_t_k_e_rodi_node_kernel_8_c.html',1,'']]], + ['tkesstamsnodekernel_2ec_583',['TKESSTAMSNodeKernel.C',['../_t_k_e_s_s_t_a_m_s_node_kernel_8_c.html',1,'']]], + ['tkesstbltm2015nodekernel_2ec_584',['TKESSTBLTM2015NodeKernel.C',['../_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c.html',1,'']]], + ['tkesstdesnodekernel_2ec_585',['TKESSTDESNodeKernel.C',['../_t_k_e_s_s_t_d_e_s_node_kernel_8_c.html',1,'']]], + ['tkesstiddesnodekernel_2ec_586',['TKESSTIDDESNodeKernel.C',['../_t_k_e_s_s_t_i_d_d_e_s_node_kernel_8_c.html',1,'']]], + ['tkesstlrnodekernel_2ec_587',['TKESSTLRNodeKernel.C',['../_t_k_e_s_s_t_l_r_node_kernel_8_c.html',1,'']]], + ['tkesstnodekernel_2ec_588',['TKESSTNodeKernel.C',['../_t_k_e_s_s_t_node_kernel_8_c.html',1,'']]], + ['tkewallfuncalg_2ec_589',['TKEWallFuncAlg.C',['../_t_k_e_wall_func_alg_8_c.html',1,'']]], + ['tkewallfuncalgdriver_2ec_590',['TKEWallFuncAlgDriver.C',['../_t_k_e_wall_func_alg_driver_8_c.html',1,'']]], + ['tornadoauxfunction_2ec_591',['TornadoAuxFunction.C',['../_tornado_aux_function_8_c.html',1,'']]], + ['totaldissipationrateequationsystem_2ec_592',['TotalDissipationRateEquationSystem.C',['../_total_dissipation_rate_equation_system_8_c.html',1,'']]], + ['tpetralinearsystem_2ec_593',['TpetraLinearSystem.C',['../_tpetra_linear_system_8_c.html',1,'']]], + ['tpetralinearsystemhelpers_2ec_594',['TpetraLinearSystemHelpers.C',['../_tpetra_linear_system_helpers_8_c.html',1,'']]], + ['tpetrasegregatedlinearsystem_2ec_595',['TpetraSegregatedLinearSystem.C',['../_tpetra_segregated_linear_system_8_c.html',1,'']]], + ['transfer_2ec_596',['Transfer.C',['../_transfer_8_c.html',1,'']]], + ['transfers_2ec_597',['Transfers.C',['../_transfers_8_c.html',1,'']]], + ['transform_5fto_5fsuper_5felem_5fpart_5fvector_598',['transform_to_super_elem_part_vector',['../namespacesierra_1_1nalu.html#a18137dc89b0a5ab4e49951d85cd32e63',1,'sierra::nalu']]], + ['transportcoefficients_2ec_599',['TransportCoefficients.C',['../_transport_coefficients_8_c.html',1,'']]], + ['tri32dcvfem_2ec_600',['Tri32DCVFEM.C',['../_tri32_d_c_v_f_e_m_8_c.html',1,'']]], + ['tri33dcvfem_2ec_601',['Tri33DCVFEM.C',['../_tri33_d_c_v_f_e_m_8_c.html',1,'']]], + ['tri_5fderivative_602',['tri_derivative',['../namespacesierra_1_1nalu.html#a164c8906b260dfb3898250a1a83b2561',1,'sierra::nalu']]], + ['tri_5fgradient_5foperator_603',['tri_gradient_operator',['../namespacesierra_1_1nalu.html#a856bf14876fdfa0ecfa747b6e351bf6a',1,'sierra::nalu']]], + ['truncated_5fnormal_5frule_604',['truncated_normal_rule',['../namespacesierra_1_1nalu_1_1details.html#ad92400b7977b34f8382f03d0196dfaeb',1,'sierra::nalu::details']]], + ['turbinesurrogatekernel_2ec_605',['TurbineSurrogateKernel.C',['../_turbine_surrogate_kernel_8_c.html',1,'']]], + ['turbkineticenergyequationsystem_2ec_606',['TurbKineticEnergyEquationSystem.C',['../_turb_kinetic_energy_equation_system_8_c.html',1,'']]], + ['turbulenceaveragingpostprocessing_2ec_607',['TurbulenceAveragingPostProcessing.C',['../_turbulence_averaging_post_processing_8_c.html',1,'']]], + ['turbvisckealg_2ec_608',['TurbViscKEAlg.C',['../_turb_visc_k_e_alg_8_c.html',1,'']]], + ['turbvisckoalg_2ec_609',['TurbViscKOAlg.C',['../_turb_visc_k_o_alg_8_c.html',1,'']]], + ['turbviscksgsalg_2ec_610',['TurbViscKsgsAlg.C',['../_turb_visc_ksgs_alg_8_c.html',1,'']]], + ['turbviscsmagorinskyalgorithm_2ec_611',['TurbViscSmagorinskyAlgorithm.C',['../_turb_visc_smagorinsky_algorithm_8_c.html',1,'']]], + ['turbviscsstalg_2ec_612',['TurbViscSSTAlg.C',['../_turb_visc_s_s_t_alg_8_c.html',1,'']]], + ['turbviscsstlralg_2ec_613',['TurbViscSSTLRAlg.C',['../_turb_visc_s_s_t_l_r_alg_8_c.html',1,'']]], + ['turbviscwalealgorithm_2ec_614',['TurbViscWaleAlgorithm.C',['../_turb_visc_wale_algorithm_8_c.html',1,'']]] ]; diff --git a/api_docs/search/all_13.js b/api_docs/search/all_13.js index 460dc3a32..abc5a7e37 100644 --- a/api_docs/search/all_13.js +++ b/api_docs/search/all_13.js @@ -1,6 +1,6 @@ var searchData= [ - ['updateoversetfringealgorithmdriver_2ec_613',['UpdateOversetFringeAlgorithmDriver.C',['../_update_overset_fringe_algorithm_driver_8_c.html',1,'']]], - ['use_5fnalu_5fperformance_5ftesting_5fcallgrind_614',['USE_NALU_PERFORMANCE_TESTING_CALLGRIND',['../_realm_8_c.html#a2c70b49256943c49a371be198ce6f817',1,'Realm.C']]], - ['utilitiesactuator_2ec_615',['UtilitiesActuator.C',['../_utilities_actuator_8_c.html',1,'']]] + ['updateoversetfringealgorithmdriver_2ec_615',['UpdateOversetFringeAlgorithmDriver.C',['../_update_overset_fringe_algorithm_driver_8_c.html',1,'']]], + ['use_5fnalu_5fperformance_5ftesting_5fcallgrind_616',['USE_NALU_PERFORMANCE_TESTING_CALLGRIND',['../_realm_8_c.html#a2c70b49256943c49a371be198ce6f817',1,'Realm.C']]], + ['utilitiesactuator_2ec_617',['UtilitiesActuator.C',['../_utilities_actuator_8_c.html',1,'']]] ]; diff --git a/api_docs/search/all_14.js b/api_docs/search/all_14.js index 3bc14c838..63114a274 100644 --- a/api_docs/search/all_14.js +++ b/api_docs/search/all_14.js @@ -1,20 +1,20 @@ var searchData= [ - ['v0_616',['v0',['../_lidar_patterns_8_c.html#a9d30747f282fcf3cf96f805b675e28c2',1,'LidarPatterns.C']]], - ['v1_617',['v1',['../_lidar_patterns_8_c.html#a85c5ca749db7f4ea1897745aaae53ea4',1,'LidarPatterns.C']]], - ['v2_618',['v2',['../_lidar_patterns_8_c.html#a25f4f6f41e71398d2454691d64c7fc67',1,'LidarPatterns.C']]], - ['variabledensitycontinuitysrcnodesuppalg_2ec_619',['VariableDensityContinuitySrcNodeSuppAlg.C',['../_variable_density_continuity_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitymixfracauxfunction_2ec_620',['VariableDensityMixFracAuxFunction.C',['../_variable_density_mix_frac_aux_function_8_c.html',1,'']]], - ['variabledensitymixfracsrcnodesuppalg_2ec_621',['VariableDensityMixFracSrcNodeSuppAlg.C',['../_variable_density_mix_frac_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitymomentumsrcnodesuppalg_2ec_622',['VariableDensityMomentumSrcNodeSuppAlg.C',['../_variable_density_momentum_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitynonisocontinuitysrcnodesuppalg_2ec_623',['VariableDensityNonIsoContinuitySrcNodeSuppAlg.C',['../_variable_density_non_iso_continuity_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitynonisoenthalpysrcnodesuppalg_2ec_624',['VariableDensityNonIsoEnthalpySrcNodeSuppAlg.C',['../_variable_density_non_iso_enthalpy_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitynonisomomentumsrcnodesuppalg_2ec_625',['VariableDensityNonIsoMomentumSrcNodeSuppAlg.C',['../_variable_density_non_iso_momentum_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitynonisotemperatureauxfunction_2ec_626',['VariableDensityNonIsoTemperatureAuxFunction.C',['../_variable_density_non_iso_temperature_aux_function_8_c.html',1,'']]], - ['variabledensitypressureauxfunction_2ec_627',['VariableDensityPressureAuxFunction.C',['../_variable_density_pressure_aux_function_8_c.html',1,'']]], - ['variabledensityvelocityauxfunction_2ec_628',['VariableDensityVelocityAuxFunction.C',['../_variable_density_velocity_aux_function_8_c.html',1,'']]], - ['vofadvectionedgealg_2ec_629',['VOFAdvectionEdgeAlg.C',['../_v_o_f_advection_edge_alg_8_c.html',1,'']]], - ['vofgclnodekernel_2ec_630',['VOFGclNodeKernel.C',['../_v_o_f_gcl_node_kernel_8_c.html',1,'']]], - ['vofmassbdfnodekernel_2ec_631',['VOFMassBDFNodeKernel.C',['../_v_o_f_mass_b_d_f_node_kernel_8_c.html',1,'']]], - ['volumeoffluidequationsystem_2ec_632',['VolumeOfFluidEquationSystem.C',['../_volume_of_fluid_equation_system_8_c.html',1,'']]] + ['v0_618',['v0',['../_lidar_patterns_8_c.html#a9d30747f282fcf3cf96f805b675e28c2',1,'LidarPatterns.C']]], + ['v1_619',['v1',['../_lidar_patterns_8_c.html#a85c5ca749db7f4ea1897745aaae53ea4',1,'LidarPatterns.C']]], + ['v2_620',['v2',['../_lidar_patterns_8_c.html#a25f4f6f41e71398d2454691d64c7fc67',1,'LidarPatterns.C']]], + ['variabledensitycontinuitysrcnodesuppalg_2ec_621',['VariableDensityContinuitySrcNodeSuppAlg.C',['../_variable_density_continuity_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitymixfracauxfunction_2ec_622',['VariableDensityMixFracAuxFunction.C',['../_variable_density_mix_frac_aux_function_8_c.html',1,'']]], + ['variabledensitymixfracsrcnodesuppalg_2ec_623',['VariableDensityMixFracSrcNodeSuppAlg.C',['../_variable_density_mix_frac_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitymomentumsrcnodesuppalg_2ec_624',['VariableDensityMomentumSrcNodeSuppAlg.C',['../_variable_density_momentum_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitynonisocontinuitysrcnodesuppalg_2ec_625',['VariableDensityNonIsoContinuitySrcNodeSuppAlg.C',['../_variable_density_non_iso_continuity_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitynonisoenthalpysrcnodesuppalg_2ec_626',['VariableDensityNonIsoEnthalpySrcNodeSuppAlg.C',['../_variable_density_non_iso_enthalpy_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitynonisomomentumsrcnodesuppalg_2ec_627',['VariableDensityNonIsoMomentumSrcNodeSuppAlg.C',['../_variable_density_non_iso_momentum_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitynonisotemperatureauxfunction_2ec_628',['VariableDensityNonIsoTemperatureAuxFunction.C',['../_variable_density_non_iso_temperature_aux_function_8_c.html',1,'']]], + ['variabledensitypressureauxfunction_2ec_629',['VariableDensityPressureAuxFunction.C',['../_variable_density_pressure_aux_function_8_c.html',1,'']]], + ['variabledensityvelocityauxfunction_2ec_630',['VariableDensityVelocityAuxFunction.C',['../_variable_density_velocity_aux_function_8_c.html',1,'']]], + ['vofadvectionedgealg_2ec_631',['VOFAdvectionEdgeAlg.C',['../_v_o_f_advection_edge_alg_8_c.html',1,'']]], + ['vofgclnodekernel_2ec_632',['VOFGclNodeKernel.C',['../_v_o_f_gcl_node_kernel_8_c.html',1,'']]], + ['vofmassbdfnodekernel_2ec_633',['VOFMassBDFNodeKernel.C',['../_v_o_f_mass_b_d_f_node_kernel_8_c.html',1,'']]], + ['volumeoffluidequationsystem_2ec_634',['VolumeOfFluidEquationSystem.C',['../_volume_of_fluid_equation_system_8_c.html',1,'']]] ]; diff --git a/api_docs/search/all_15.js b/api_docs/search/all_15.js index 3bfd26bd3..7794449e4 100644 --- a/api_docs/search/all_15.js +++ b/api_docs/search/all_15.js @@ -1,18 +1,18 @@ var searchData= [ - ['walldistedgesolveralg_2ec_633',['WallDistEdgeSolverAlg.C',['../_wall_dist_edge_solver_alg_8_c.html',1,'']]], - ['walldistelemkernel_2ec_634',['WallDistElemKernel.C',['../_wall_dist_elem_kernel_8_c.html',1,'']]], - ['walldistequationsystem_2ec_635',['WallDistEquationSystem.C',['../_wall_dist_equation_system_8_c.html',1,'']]], - ['walldistnodekernel_2ec_636',['WallDistNodeKernel.C',['../_wall_dist_node_kernel_8_c.html',1,'']]], - ['wallfricvelalgdriver_2ec_637',['WallFricVelAlgDriver.C',['../_wall_fric_vel_alg_driver_8_c.html',1,'']]], - ['wallfuncgeometryalg_2ec_638',['WallFuncGeometryAlg.C',['../_wall_func_geometry_alg_8_c.html',1,'']]], - ['waterpropertyevaluator_2ec_639',['WaterPropertyEvaluator.C',['../_water_property_evaluator_8_c.html',1,'']]], - ['wed6cvfem_2ec_640',['Wed6CVFEM.C',['../_wed6_c_v_f_e_m_8_c.html',1,'']]], - ['wed_5fderiv_641',['wed_deriv',['../namespacesierra_1_1nalu.html#a72895cea697be2883b53061b7fb097f8',1,'sierra::nalu']]], - ['wed_5fgradient_5foperator_642',['wed_gradient_operator',['../namespacesierra_1_1nalu.html#a6251d183410b252ff345179c0dd1b549',1,'sierra::nalu']]], - ['wed_5fshape_5ffcn_643',['wed_shape_fcn',['../namespacesierra_1_1nalu.html#a6e721b7894636853c3e3f0ada05ba99c',1,'sierra::nalu']]], - ['wilcoxkomegaequationsystem_2ec_644',['WilcoxKOmegaEquationSystem.C',['../_wilcox_k_omega_equation_system_8_c.html',1,'']]], - ['windenergypowerlawauxfunction_2ec_645',['WindEnergyPowerLawAuxFunction.C',['../_wind_energy_power_law_aux_function_8_c.html',1,'']]], - ['windenergytaylorvortexauxfunction_2ec_646',['WindEnergyTaylorVortexAuxFunction.C',['../_wind_energy_taylor_vortex_aux_function_8_c.html',1,'']]], - ['windenergytaylorvortexpressureauxfunction_2ec_647',['WindEnergyTaylorVortexPressureAuxFunction.C',['../_wind_energy_taylor_vortex_pressure_aux_function_8_c.html',1,'']]] + ['walldistedgesolveralg_2ec_635',['WallDistEdgeSolverAlg.C',['../_wall_dist_edge_solver_alg_8_c.html',1,'']]], + ['walldistelemkernel_2ec_636',['WallDistElemKernel.C',['../_wall_dist_elem_kernel_8_c.html',1,'']]], + ['walldistequationsystem_2ec_637',['WallDistEquationSystem.C',['../_wall_dist_equation_system_8_c.html',1,'']]], + ['walldistnodekernel_2ec_638',['WallDistNodeKernel.C',['../_wall_dist_node_kernel_8_c.html',1,'']]], + ['wallfricvelalgdriver_2ec_639',['WallFricVelAlgDriver.C',['../_wall_fric_vel_alg_driver_8_c.html',1,'']]], + ['wallfuncgeometryalg_2ec_640',['WallFuncGeometryAlg.C',['../_wall_func_geometry_alg_8_c.html',1,'']]], + ['waterpropertyevaluator_2ec_641',['WaterPropertyEvaluator.C',['../_water_property_evaluator_8_c.html',1,'']]], + ['wed6cvfem_2ec_642',['Wed6CVFEM.C',['../_wed6_c_v_f_e_m_8_c.html',1,'']]], + ['wed_5fderiv_643',['wed_deriv',['../namespacesierra_1_1nalu.html#a72895cea697be2883b53061b7fb097f8',1,'sierra::nalu']]], + ['wed_5fgradient_5foperator_644',['wed_gradient_operator',['../namespacesierra_1_1nalu.html#a6251d183410b252ff345179c0dd1b549',1,'sierra::nalu']]], + ['wed_5fshape_5ffcn_645',['wed_shape_fcn',['../namespacesierra_1_1nalu.html#a6e721b7894636853c3e3f0ada05ba99c',1,'sierra::nalu']]], + ['wilcoxkomegaequationsystem_2ec_646',['WilcoxKOmegaEquationSystem.C',['../_wilcox_k_omega_equation_system_8_c.html',1,'']]], + ['windenergypowerlawauxfunction_2ec_647',['WindEnergyPowerLawAuxFunction.C',['../_wind_energy_power_law_aux_function_8_c.html',1,'']]], + ['windenergytaylorvortexauxfunction_2ec_648',['WindEnergyTaylorVortexAuxFunction.C',['../_wind_energy_taylor_vortex_aux_function_8_c.html',1,'']]], + ['windenergytaylorvortexpressureauxfunction_2ec_649',['WindEnergyTaylorVortexPressureAuxFunction.C',['../_wind_energy_taylor_vortex_pressure_aux_function_8_c.html',1,'']]] ]; diff --git a/api_docs/search/all_16.js b/api_docs/search/all_16.js index 191101ff0..224433716 100644 --- a/api_docs/search/all_16.js +++ b/api_docs/search/all_16.js @@ -1,4 +1,4 @@ var searchData= [ - ['yaml_648',['YAML',['../namespace_y_a_m_l.html',1,'']]] + ['yaml_650',['YAML',['../namespace_y_a_m_l.html',1,'']]] ]; diff --git a/api_docs/search/all_17.js b/api_docs/search/all_17.js index 041bc76ae..68e65cd47 100644 --- a/api_docs/search/all_17.js +++ b/api_docs/search/all_17.js @@ -1,7 +1,7 @@ var searchData= [ - ['zalesakdiskmassflowratekernel_2ec_649',['ZalesakDiskMassFlowRateKernel.C',['../_zalesak_disk_mass_flow_rate_kernel_8_c.html',1,'']]], - ['zalesakdiskvofauxfunction_2ec_650',['ZalesakDiskVOFAuxFunction.C',['../_zalesak_disk_v_o_f_aux_function_8_c.html',1,'']]], - ['zalesakspheremassflowratekernel_2ec_651',['ZalesakSphereMassFlowRateKernel.C',['../_zalesak_sphere_mass_flow_rate_kernel_8_c.html',1,'']]], - ['zalesakspherevofauxfunction_2ec_652',['ZalesakSphereVOFAuxFunction.C',['../_zalesak_sphere_v_o_f_aux_function_8_c.html',1,'']]] + ['zalesakdiskmassflowratekernel_2ec_651',['ZalesakDiskMassFlowRateKernel.C',['../_zalesak_disk_mass_flow_rate_kernel_8_c.html',1,'']]], + ['zalesakdiskvofauxfunction_2ec_652',['ZalesakDiskVOFAuxFunction.C',['../_zalesak_disk_v_o_f_aux_function_8_c.html',1,'']]], + ['zalesakspheremassflowratekernel_2ec_653',['ZalesakSphereMassFlowRateKernel.C',['../_zalesak_sphere_mass_flow_rate_kernel_8_c.html',1,'']]], + ['zalesakspherevofauxfunction_2ec_654',['ZalesakSphereVOFAuxFunction.C',['../_zalesak_sphere_v_o_f_aux_function_8_c.html',1,'']]] ]; diff --git a/api_docs/search/classes_0.js b/api_docs/search/classes_0.js index b2f31d4e0..d324591aa 100644 --- a/api_docs/search/classes_0.js +++ b/api_docs/search/classes_0.js @@ -1,6 +1,6 @@ var searchData= [ - ['compareentitybyid_653',['CompareEntityById',['../structsierra_1_1nalu_1_1_compare_entity_by_id.html',1,'sierra::nalu']]], - ['compareentityequalbyid_654',['CompareEntityEqualById',['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html',1,'sierra::nalu']]], - ['comparegausspoint_655',['compareGaussPoint',['../structsierra_1_1nalu_1_1compare_gauss_point.html',1,'sierra::nalu']]] + ['compareentitybyid_655',['CompareEntityById',['../structsierra_1_1nalu_1_1_compare_entity_by_id.html',1,'sierra::nalu']]], + ['compareentityequalbyid_656',['CompareEntityEqualById',['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html',1,'sierra::nalu']]], + ['comparegausspoint_657',['compareGaussPoint',['../structsierra_1_1nalu_1_1compare_gauss_point.html',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/classes_1.js b/api_docs/search/classes_1.js index 3cd4a108d..ad19ccfc8 100644 --- a/api_docs/search/classes_1.js +++ b/api_docs/search/classes_1.js @@ -1,4 +1,4 @@ var searchData= [ - ['sortintlowhigh_656',['sortIntLowHigh',['../structsierra_1_1nalu_1_1sort_int_low_high.html',1,'sierra::nalu']]] + ['sortintlowhigh_658',['sortIntLowHigh',['../structsierra_1_1nalu_1_1sort_int_low_high.html',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/defines_0.js b/api_docs/search/defines_0.js index 1ac9c4bf7..e32ac7986 100644 --- a/api_docs/search/defines_0.js +++ b/api_docs/search/defines_0.js @@ -1,4 +1,4 @@ var searchData= [ - ['dump_1307',['DUMP',['../_tpetra_linear_system_8_c.html#a283b6ae3de1b15abedafbe85207f621a',1,'DUMP(): TpetraLinearSystem.C'],['../_tpetra_linear_system_8_c.html#a283b6ae3de1b15abedafbe85207f621a',1,'DUMP(): TpetraLinearSystem.C'],['../_tpetra_segregated_linear_system_8_c.html#a283b6ae3de1b15abedafbe85207f621a',1,'DUMP(): TpetraSegregatedLinearSystem.C'],['../_tpetra_segregated_linear_system_8_c.html#a283b6ae3de1b15abedafbe85207f621a',1,'DUMP(): TpetraSegregatedLinearSystem.C']]] + ['dump_1311',['DUMP',['../_tpetra_linear_system_8_c.html#a283b6ae3de1b15abedafbe85207f621a',1,'DUMP(): TpetraLinearSystem.C'],['../_tpetra_linear_system_8_c.html#a283b6ae3de1b15abedafbe85207f621a',1,'DUMP(): TpetraLinearSystem.C'],['../_tpetra_segregated_linear_system_8_c.html#a283b6ae3de1b15abedafbe85207f621a',1,'DUMP(): TpetraSegregatedLinearSystem.C'],['../_tpetra_segregated_linear_system_8_c.html#a283b6ae3de1b15abedafbe85207f621a',1,'DUMP(): TpetraSegregatedLinearSystem.C']]] ]; diff --git a/api_docs/search/defines_1.js b/api_docs/search/defines_1.js index 728031d90..e15e18148 100644 --- a/api_docs/search/defines_1.js +++ b/api_docs/search/defines_1.js @@ -1,5 +1,5 @@ var searchData= [ - ['explicit_5ftype_5finstantiator_5flegacy_1308',['EXPLICIT_TYPE_INSTANTIATOR_LEGACY',['../_smart_field_8_c.html#adfb846e4b6b0d1840556708d155b2048',1,'SmartField.C']]], - ['explicit_5ftype_5finstantiator_5fngp_1309',['EXPLICIT_TYPE_INSTANTIATOR_NGP',['../_smart_field_8_c.html#ad9114756ea9d7d0a2bdab64ccbe327df',1,'SmartField.C']]] + ['explicit_5ftype_5finstantiator_5flegacy_1312',['EXPLICIT_TYPE_INSTANTIATOR_LEGACY',['../_smart_field_8_c.html#adfb846e4b6b0d1840556708d155b2048',1,'SmartField.C']]], + ['explicit_5ftype_5finstantiator_5fngp_1313',['EXPLICIT_TYPE_INSTANTIATOR_NGP',['../_smart_field_8_c.html#ad9114756ea9d7d0a2bdab64ccbe327df',1,'SmartField.C']]] ]; diff --git a/api_docs/search/defines_2.js b/api_docs/search/defines_2.js index 87c8402c5..d838c87ab 100644 --- a/api_docs/search/defines_2.js +++ b/api_docs/search/defines_2.js @@ -1,4 +1,4 @@ var searchData= [ - ['instantiate_5falg_1310',['INSTANTIATE_ALG',['../_nodal_grad_bndry_elem_alg_8_c.html#ade984798f8d580c115943c903d963346',1,'INSTANTIATE_ALG(): NodalGradBndryElemAlg.C'],['../_nodal_grad_elem_alg_8_c.html#ade984798f8d580c115943c903d963346',1,'INSTANTIATE_ALG(): NodalGradElemAlg.C']]] + ['instantiate_5falg_1314',['INSTANTIATE_ALG',['../_nodal_grad_bndry_elem_alg_8_c.html#ade984798f8d580c115943c903d963346',1,'INSTANTIATE_ALG(): NodalGradBndryElemAlg.C'],['../_nodal_grad_elem_alg_8_c.html#ade984798f8d580c115943c903d963346',1,'INSTANTIATE_ALG(): NodalGradElemAlg.C']]] ]; diff --git a/api_docs/search/defines_3.js b/api_docs/search/defines_3.js index b447edb71..7262e7c34 100644 --- a/api_docs/search/defines_3.js +++ b/api_docs/search/defines_3.js @@ -1,4 +1,4 @@ var searchData= [ - ['kk_5fmap_1311',['KK_MAP',['../_tpetra_linear_system_8_c.html#a897f94a09f72360ecd8fab06606b9b2b',1,'KK_MAP(): TpetraLinearSystem.C'],['../_tpetra_segregated_linear_system_8_c.html#a897f94a09f72360ecd8fab06606b9b2b',1,'KK_MAP(): TpetraSegregatedLinearSystem.C']]] + ['kk_5fmap_1315',['KK_MAP',['../_tpetra_linear_system_8_c.html#a897f94a09f72360ecd8fab06606b9b2b',1,'KK_MAP(): TpetraLinearSystem.C'],['../_tpetra_segregated_linear_system_8_c.html#a897f94a09f72360ecd8fab06606b9b2b',1,'KK_MAP(): TpetraSegregatedLinearSystem.C']]] ]; diff --git a/api_docs/search/defines_4.js b/api_docs/search/defines_4.js index dee729965..6a8dda74e 100644 --- a/api_docs/search/defines_4.js +++ b/api_docs/search/defines_4.js @@ -1,4 +1,4 @@ var searchData= [ - ['use_5fnalu_5fperformance_5ftesting_5fcallgrind_1312',['USE_NALU_PERFORMANCE_TESTING_CALLGRIND',['../_realm_8_c.html#a2c70b49256943c49a371be198ce6f817',1,'Realm.C']]] + ['use_5fnalu_5fperformance_5ftesting_5fcallgrind_1316',['USE_NALU_PERFORMANCE_TESTING_CALLGRIND',['../_realm_8_c.html#a2c70b49256943c49a371be198ce6f817',1,'Realm.C']]] ]; diff --git a/api_docs/search/files_0.js b/api_docs/search/files_0.js index 4d13fbb3d..f2bfa2bce 100644 --- a/api_docs/search/files_0.js +++ b/api_docs/search/files_0.js @@ -1,56 +1,56 @@ var searchData= [ - ['ablforcingalgorithm_2ec_669',['ABLForcingAlgorithm.C',['../_a_b_l_forcing_algorithm_8_c.html',1,'']]], - ['ablprofilefunction_2ec_670',['ABLProfileFunction.C',['../_a_b_l_profile_function_8_c.html',1,'']]], - ['ablwallfluxesalg_2ec_671',['ABLWallFluxesAlg.C',['../_a_b_l_wall_fluxes_alg_8_c.html',1,'']]], - ['ablwallfrictionvelalg_2ec_672',['ABLWallFrictionVelAlg.C',['../_a_b_l_wall_friction_vel_alg_8_c.html',1,'']]], - ['actuatorbladedistributor_2ec_673',['ActuatorBladeDistributor.C',['../_actuator_blade_distributor_8_c.html',1,'']]], - ['actuatorbulk_2ec_674',['ActuatorBulk.C',['../_actuator_bulk_8_c.html',1,'']]], - ['actuatorbulkdiskfast_2ec_675',['ActuatorBulkDiskFAST.C',['../_actuator_bulk_disk_f_a_s_t_8_c.html',1,'']]], - ['actuatorbulkfast_2ec_676',['ActuatorBulkFAST.C',['../_actuator_bulk_f_a_s_t_8_c.html',1,'']]], - ['actuatorbulksimple_2ec_677',['ActuatorBulkSimple.C',['../_actuator_bulk_simple_8_c.html',1,'']]], - ['actuatorexecutor_2ec_678',['ActuatorExecutor.C',['../_actuator_executor_8_c.html',1,'']]], - ['actuatorexecutorsfastngp_2ec_679',['ActuatorExecutorsFASTNgp.C',['../_actuator_executors_f_a_s_t_ngp_8_c.html',1,'']]], - ['actuatorexecutorssimplengp_2ec_680',['ActuatorExecutorsSimpleNgp.C',['../_actuator_executors_simple_ngp_8_c.html',1,'']]], - ['actuatorfllc_2ec_681',['ActuatorFLLC.C',['../_actuator_f_l_l_c_8_c.html',1,'']]], - ['actuatorfunctors_2ec_682',['ActuatorFunctors.C',['../_actuator_functors_8_c.html',1,'']]], - ['actuatorfunctorsfast_2ec_683',['ActuatorFunctorsFAST.C',['../_actuator_functors_f_a_s_t_8_c.html',1,'']]], - ['actuatorfunctorssimple_2ec_684',['ActuatorFunctorsSimple.C',['../_actuator_functors_simple_8_c.html',1,'']]], - ['actuatormodel_2ec_685',['ActuatorModel.C',['../_actuator_model_8_c.html',1,'']]], - ['actuatorparsing_2ec_686',['ActuatorParsing.C',['../_actuator_parsing_8_c.html',1,'']]], - ['actuatorparsingfast_2ec_687',['ActuatorParsingFAST.C',['../_actuator_parsing_f_a_s_t_8_c.html',1,'']]], - ['actuatorparsingsimple_2ec_688',['ActuatorParsingSimple.C',['../_actuator_parsing_simple_8_c.html',1,'']]], - ['actuatorsearch_2ec_689',['ActuatorSearch.C',['../_actuator_search_8_c.html',1,'']]], - ['aerocontainer_2ec_690',['AeroContainer.C',['../_aero_container_8_c.html',1,'']]], - ['algorithm_2ec_691',['Algorithm.C',['../_algorithm_8_c.html',1,'']]], - ['algorithmdriver_2ec_692',['AlgorithmDriver.C',['../_algorithm_driver_8_c.html',1,'']]], - ['amsalgdriver_2ec_693',['AMSAlgDriver.C',['../_a_m_s_alg_driver_8_c.html',1,'']]], - ['amsavgmdotedgealg_2ec_694',['AMSAvgMdotEdgeAlg.C',['../_a_m_s_avg_mdot_edge_alg_8_c.html',1,'']]], - ['amsmomentumedgepecletalg_2ec_695',['AMSMomentumEdgePecletAlg.C',['../_a_m_s_momentum_edge_peclet_alg_8_c.html',1,'']]], - ['assembleamsedgekernelalg_2ec_696',['AssembleAMSEdgeKernelAlg.C',['../_assemble_a_m_s_edge_kernel_alg_8_c.html',1,'']]], - ['assemblecontinuitynonconformalsolveralgorithm_2ec_697',['AssembleContinuityNonConformalSolverAlgorithm.C',['../_assemble_continuity_non_conformal_solver_algorithm_8_c.html',1,'']]], - ['assembleedgekernelalg_2ec_698',['AssembleEdgeKernelAlg.C',['../_assemble_edge_kernel_alg_8_c.html',1,'']]], - ['assembleedgesolveralgorithm_2ec_699',['AssembleEdgeSolverAlgorithm.C',['../_assemble_edge_solver_algorithm_8_c.html',1,'']]], - ['assembleelemsolveralgorithm_2ec_700',['AssembleElemSolverAlgorithm.C',['../_assemble_elem_solver_algorithm_8_c.html',1,'']]], - ['assemblefaceelemsolveralgorithm_2ec_701',['AssembleFaceElemSolverAlgorithm.C',['../_assemble_face_elem_solver_algorithm_8_c.html',1,'']]], - ['assemblemomentumedgeabltopbc_2ec_702',['AssembleMomentumEdgeABLTopBC.C',['../_assemble_momentum_edge_a_b_l_top_b_c_8_c.html',1,'']]], - ['assemblemomentumedgewallfunctionsolveralgorithm_2ec_703',['AssembleMomentumEdgeWallFunctionSolverAlgorithm.C',['../_assemble_momentum_edge_wall_function_solver_algorithm_8_c.html',1,'']]], - ['assemblemomentumnonconformalsolveralgorithm_2ec_704',['AssembleMomentumNonConformalSolverAlgorithm.C',['../_assemble_momentum_non_conformal_solver_algorithm_8_c.html',1,'']]], - ['assemblengpnodesolveralgorithm_2ec_705',['AssembleNGPNodeSolverAlgorithm.C',['../_assemble_n_g_p_node_solver_algorithm_8_c.html',1,'']]], - ['assemblenodalgradnonconformalalgorithm_2ec_706',['AssembleNodalGradNonConformalAlgorithm.C',['../_assemble_nodal_grad_non_conformal_algorithm_8_c.html',1,'']]], - ['assemblenodalgradunonconformalalgorithm_2ec_707',['AssembleNodalGradUNonConformalAlgorithm.C',['../_assemble_nodal_grad_u_non_conformal_algorithm_8_c.html',1,'']]], - ['assemblenodesolveralgorithm_2ec_708',['AssembleNodeSolverAlgorithm.C',['../_assemble_node_solver_algorithm_8_c.html',1,'']]], - ['assembleoversetdecoupledalgorithm_2ec_709',['AssembleOversetDecoupledAlgorithm.C',['../_assemble_overset_decoupled_algorithm_8_c.html',1,'']]], - ['assembleoversetpressurealgorithm_2ec_710',['AssembleOversetPressureAlgorithm.C',['../_assemble_overset_pressure_algorithm_8_c.html',1,'']]], - ['assembleoversetsolverconstraintalgorithm_2ec_711',['AssembleOversetSolverConstraintAlgorithm.C',['../_assemble_overset_solver_constraint_algorithm_8_c.html',1,'']]], - ['assembleoversetwalldistalgorithm_2ec_712',['AssembleOversetWallDistAlgorithm.C',['../_assemble_overset_wall_dist_algorithm_8_c.html',1,'']]], - ['assemblepngboundarysolveralgorithm_2ec_713',['AssemblePNGBoundarySolverAlgorithm.C',['../_assemble_p_n_g_boundary_solver_algorithm_8_c.html',1,'']]], - ['assemblepngelemsolveralgorithm_2ec_714',['AssemblePNGElemSolverAlgorithm.C',['../_assemble_p_n_g_elem_solver_algorithm_8_c.html',1,'']]], - ['assemblepngnonconformalsolveralgorithm_2ec_715',['AssemblePNGNonConformalSolverAlgorithm.C',['../_assemble_p_n_g_non_conformal_solver_algorithm_8_c.html',1,'']]], - ['assemblescalareigenedgesolveralgorithm_2ec_716',['AssembleScalarEigenEdgeSolverAlgorithm.C',['../_assemble_scalar_eigen_edge_solver_algorithm_8_c.html',1,'']]], - ['assemblescalarnonconformalsolveralgorithm_2ec_717',['AssembleScalarNonConformalSolverAlgorithm.C',['../_assemble_scalar_non_conformal_solver_algorithm_8_c.html',1,'']]], - ['assemblewalldistnonconformalalgorithm_2ec_718',['AssembleWallDistNonConformalAlgorithm.C',['../_assemble_wall_dist_non_conformal_algorithm_8_c.html',1,'']]], - ['assemblewallheattransferalgorithmdriver_2ec_719',['AssembleWallHeatTransferAlgorithmDriver.C',['../_assemble_wall_heat_transfer_algorithm_driver_8_c.html',1,'']]], - ['auxfunctionalgorithm_2ec_720',['AuxFunctionAlgorithm.C',['../_aux_function_algorithm_8_c.html',1,'']]], - ['averaginginfo_2ec_721',['AveragingInfo.C',['../_averaging_info_8_c.html',1,'']]] + ['ablforcingalgorithm_2ec_671',['ABLForcingAlgorithm.C',['../_a_b_l_forcing_algorithm_8_c.html',1,'']]], + ['ablprofilefunction_2ec_672',['ABLProfileFunction.C',['../_a_b_l_profile_function_8_c.html',1,'']]], + ['ablwallfluxesalg_2ec_673',['ABLWallFluxesAlg.C',['../_a_b_l_wall_fluxes_alg_8_c.html',1,'']]], + ['ablwallfrictionvelalg_2ec_674',['ABLWallFrictionVelAlg.C',['../_a_b_l_wall_friction_vel_alg_8_c.html',1,'']]], + ['actuatorbladedistributor_2ec_675',['ActuatorBladeDistributor.C',['../_actuator_blade_distributor_8_c.html',1,'']]], + ['actuatorbulk_2ec_676',['ActuatorBulk.C',['../_actuator_bulk_8_c.html',1,'']]], + ['actuatorbulkdiskfast_2ec_677',['ActuatorBulkDiskFAST.C',['../_actuator_bulk_disk_f_a_s_t_8_c.html',1,'']]], + ['actuatorbulkfast_2ec_678',['ActuatorBulkFAST.C',['../_actuator_bulk_f_a_s_t_8_c.html',1,'']]], + ['actuatorbulksimple_2ec_679',['ActuatorBulkSimple.C',['../_actuator_bulk_simple_8_c.html',1,'']]], + ['actuatorexecutor_2ec_680',['ActuatorExecutor.C',['../_actuator_executor_8_c.html',1,'']]], + ['actuatorexecutorsfastngp_2ec_681',['ActuatorExecutorsFASTNgp.C',['../_actuator_executors_f_a_s_t_ngp_8_c.html',1,'']]], + ['actuatorexecutorssimplengp_2ec_682',['ActuatorExecutorsSimpleNgp.C',['../_actuator_executors_simple_ngp_8_c.html',1,'']]], + ['actuatorfllc_2ec_683',['ActuatorFLLC.C',['../_actuator_f_l_l_c_8_c.html',1,'']]], + ['actuatorfunctors_2ec_684',['ActuatorFunctors.C',['../_actuator_functors_8_c.html',1,'']]], + ['actuatorfunctorsfast_2ec_685',['ActuatorFunctorsFAST.C',['../_actuator_functors_f_a_s_t_8_c.html',1,'']]], + ['actuatorfunctorssimple_2ec_686',['ActuatorFunctorsSimple.C',['../_actuator_functors_simple_8_c.html',1,'']]], + ['actuatormodel_2ec_687',['ActuatorModel.C',['../_actuator_model_8_c.html',1,'']]], + ['actuatorparsing_2ec_688',['ActuatorParsing.C',['../_actuator_parsing_8_c.html',1,'']]], + ['actuatorparsingfast_2ec_689',['ActuatorParsingFAST.C',['../_actuator_parsing_f_a_s_t_8_c.html',1,'']]], + ['actuatorparsingsimple_2ec_690',['ActuatorParsingSimple.C',['../_actuator_parsing_simple_8_c.html',1,'']]], + ['actuatorsearch_2ec_691',['ActuatorSearch.C',['../_actuator_search_8_c.html',1,'']]], + ['aerocontainer_2ec_692',['AeroContainer.C',['../_aero_container_8_c.html',1,'']]], + ['algorithm_2ec_693',['Algorithm.C',['../_algorithm_8_c.html',1,'']]], + ['algorithmdriver_2ec_694',['AlgorithmDriver.C',['../_algorithm_driver_8_c.html',1,'']]], + ['amsalgdriver_2ec_695',['AMSAlgDriver.C',['../_a_m_s_alg_driver_8_c.html',1,'']]], + ['amsavgmdotedgealg_2ec_696',['AMSAvgMdotEdgeAlg.C',['../_a_m_s_avg_mdot_edge_alg_8_c.html',1,'']]], + ['amsmomentumedgepecletalg_2ec_697',['AMSMomentumEdgePecletAlg.C',['../_a_m_s_momentum_edge_peclet_alg_8_c.html',1,'']]], + ['assembleamsedgekernelalg_2ec_698',['AssembleAMSEdgeKernelAlg.C',['../_assemble_a_m_s_edge_kernel_alg_8_c.html',1,'']]], + ['assemblecontinuitynonconformalsolveralgorithm_2ec_699',['AssembleContinuityNonConformalSolverAlgorithm.C',['../_assemble_continuity_non_conformal_solver_algorithm_8_c.html',1,'']]], + ['assembleedgekernelalg_2ec_700',['AssembleEdgeKernelAlg.C',['../_assemble_edge_kernel_alg_8_c.html',1,'']]], + ['assembleedgesolveralgorithm_2ec_701',['AssembleEdgeSolverAlgorithm.C',['../_assemble_edge_solver_algorithm_8_c.html',1,'']]], + ['assembleelemsolveralgorithm_2ec_702',['AssembleElemSolverAlgorithm.C',['../_assemble_elem_solver_algorithm_8_c.html',1,'']]], + ['assemblefaceelemsolveralgorithm_2ec_703',['AssembleFaceElemSolverAlgorithm.C',['../_assemble_face_elem_solver_algorithm_8_c.html',1,'']]], + ['assemblemomentumedgeabltopbc_2ec_704',['AssembleMomentumEdgeABLTopBC.C',['../_assemble_momentum_edge_a_b_l_top_b_c_8_c.html',1,'']]], + ['assemblemomentumedgewallfunctionsolveralgorithm_2ec_705',['AssembleMomentumEdgeWallFunctionSolverAlgorithm.C',['../_assemble_momentum_edge_wall_function_solver_algorithm_8_c.html',1,'']]], + ['assemblemomentumnonconformalsolveralgorithm_2ec_706',['AssembleMomentumNonConformalSolverAlgorithm.C',['../_assemble_momentum_non_conformal_solver_algorithm_8_c.html',1,'']]], + ['assemblengpnodesolveralgorithm_2ec_707',['AssembleNGPNodeSolverAlgorithm.C',['../_assemble_n_g_p_node_solver_algorithm_8_c.html',1,'']]], + ['assemblenodalgradnonconformalalgorithm_2ec_708',['AssembleNodalGradNonConformalAlgorithm.C',['../_assemble_nodal_grad_non_conformal_algorithm_8_c.html',1,'']]], + ['assemblenodalgradunonconformalalgorithm_2ec_709',['AssembleNodalGradUNonConformalAlgorithm.C',['../_assemble_nodal_grad_u_non_conformal_algorithm_8_c.html',1,'']]], + ['assemblenodesolveralgorithm_2ec_710',['AssembleNodeSolverAlgorithm.C',['../_assemble_node_solver_algorithm_8_c.html',1,'']]], + ['assembleoversetdecoupledalgorithm_2ec_711',['AssembleOversetDecoupledAlgorithm.C',['../_assemble_overset_decoupled_algorithm_8_c.html',1,'']]], + ['assembleoversetpressurealgorithm_2ec_712',['AssembleOversetPressureAlgorithm.C',['../_assemble_overset_pressure_algorithm_8_c.html',1,'']]], + ['assembleoversetsolverconstraintalgorithm_2ec_713',['AssembleOversetSolverConstraintAlgorithm.C',['../_assemble_overset_solver_constraint_algorithm_8_c.html',1,'']]], + ['assembleoversetwalldistalgorithm_2ec_714',['AssembleOversetWallDistAlgorithm.C',['../_assemble_overset_wall_dist_algorithm_8_c.html',1,'']]], + ['assemblepngboundarysolveralgorithm_2ec_715',['AssemblePNGBoundarySolverAlgorithm.C',['../_assemble_p_n_g_boundary_solver_algorithm_8_c.html',1,'']]], + ['assemblepngelemsolveralgorithm_2ec_716',['AssemblePNGElemSolverAlgorithm.C',['../_assemble_p_n_g_elem_solver_algorithm_8_c.html',1,'']]], + ['assemblepngnonconformalsolveralgorithm_2ec_717',['AssemblePNGNonConformalSolverAlgorithm.C',['../_assemble_p_n_g_non_conformal_solver_algorithm_8_c.html',1,'']]], + ['assemblescalareigenedgesolveralgorithm_2ec_718',['AssembleScalarEigenEdgeSolverAlgorithm.C',['../_assemble_scalar_eigen_edge_solver_algorithm_8_c.html',1,'']]], + ['assemblescalarnonconformalsolveralgorithm_2ec_719',['AssembleScalarNonConformalSolverAlgorithm.C',['../_assemble_scalar_non_conformal_solver_algorithm_8_c.html',1,'']]], + ['assemblewalldistnonconformalalgorithm_2ec_720',['AssembleWallDistNonConformalAlgorithm.C',['../_assemble_wall_dist_non_conformal_algorithm_8_c.html',1,'']]], + ['assemblewallheattransferalgorithmdriver_2ec_721',['AssembleWallHeatTransferAlgorithmDriver.C',['../_assemble_wall_heat_transfer_algorithm_driver_8_c.html',1,'']]], + ['auxfunctionalgorithm_2ec_722',['AuxFunctionAlgorithm.C',['../_aux_function_algorithm_8_c.html',1,'']]], + ['averaginginfo_2ec_723',['AveragingInfo.C',['../_averaging_info_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_1.js b/api_docs/search/files_1.js index 537832f03..ec9f30004 100644 --- a/api_docs/search/files_1.js +++ b/api_docs/search/files_1.js @@ -1,13 +1,13 @@ var searchData= [ - ['bdyheightalgorithm_2ec_722',['BdyHeightAlgorithm.C',['../_bdy_height_algorithm_8_c.html',1,'']]], - ['bdylayerstatistics_2ec_723',['BdyLayerStatistics.C',['../_bdy_layer_statistics_8_c.html',1,'']]], - ['bltgammam2015nodekernel_2ec_724',['BLTGammaM2015NodeKernel.C',['../_b_l_t_gamma_m2015_node_kernel_8_c.html',1,'']]], - ['boundaryconditions_2ec_725',['BoundaryConditions.C',['../_boundary_conditions_8_c.html',1,'']]], - ['boundarylayerperturbationauxfunction_2ec_726',['BoundaryLayerPerturbationAuxFunction.C',['../_boundary_layer_perturbation_aux_function_8_c.html',1,'']]], - ['boussinesqnonisoenthalpysrcnodesuppalg_2ec_727',['BoussinesqNonIsoEnthalpySrcNodeSuppAlg.C',['../_boussinesq_non_iso_enthalpy_src_node_supp_alg_8_c.html',1,'']]], - ['boussinesqnonisomomentumsrcnodesuppalg_2ec_728',['BoussinesqNonIsoMomentumSrcNodeSuppAlg.C',['../_boussinesq_non_iso_momentum_src_node_supp_alg_8_c.html',1,'']]], - ['boussinesqnonisotemperatureauxfunction_2ec_729',['BoussinesqNonIsoTemperatureAuxFunction.C',['../_boussinesq_non_iso_temperature_aux_function_8_c.html',1,'']]], - ['boussinesqnonisovelocityauxfunction_2ec_730',['BoussinesqNonIsoVelocityAuxFunction.C',['../_boussinesq_non_iso_velocity_aux_function_8_c.html',1,'']]], - ['buoyancysourcealg_2ec_731',['BuoyancySourceAlg.C',['../_buoyancy_source_alg_8_c.html',1,'']]] + ['bdyheightalgorithm_2ec_724',['BdyHeightAlgorithm.C',['../_bdy_height_algorithm_8_c.html',1,'']]], + ['bdylayerstatistics_2ec_725',['BdyLayerStatistics.C',['../_bdy_layer_statistics_8_c.html',1,'']]], + ['bltgammam2015nodekernel_2ec_726',['BLTGammaM2015NodeKernel.C',['../_b_l_t_gamma_m2015_node_kernel_8_c.html',1,'']]], + ['boundaryconditions_2ec_727',['BoundaryConditions.C',['../_boundary_conditions_8_c.html',1,'']]], + ['boundarylayerperturbationauxfunction_2ec_728',['BoundaryLayerPerturbationAuxFunction.C',['../_boundary_layer_perturbation_aux_function_8_c.html',1,'']]], + ['boussinesqnonisoenthalpysrcnodesuppalg_2ec_729',['BoussinesqNonIsoEnthalpySrcNodeSuppAlg.C',['../_boussinesq_non_iso_enthalpy_src_node_supp_alg_8_c.html',1,'']]], + ['boussinesqnonisomomentumsrcnodesuppalg_2ec_730',['BoussinesqNonIsoMomentumSrcNodeSuppAlg.C',['../_boussinesq_non_iso_momentum_src_node_supp_alg_8_c.html',1,'']]], + ['boussinesqnonisotemperatureauxfunction_2ec_731',['BoussinesqNonIsoTemperatureAuxFunction.C',['../_boussinesq_non_iso_temperature_aux_function_8_c.html',1,'']]], + ['boussinesqnonisovelocityauxfunction_2ec_732',['BoussinesqNonIsoVelocityAuxFunction.C',['../_boussinesq_non_iso_velocity_aux_function_8_c.html',1,'']]], + ['buoyancysourcealg_2ec_733',['BuoyancySourceAlg.C',['../_buoyancy_source_alg_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_10.js b/api_docs/search/files_10.js index f5078104f..45d64540d 100644 --- a/api_docs/search/files_10.js +++ b/api_docs/search/files_10.js @@ -1,7 +1,7 @@ var searchData= [ - ['rayleightaylormixfracauxfunction_2ec_938',['RayleighTaylorMixFracAuxFunction.C',['../_rayleigh_taylor_mix_frac_aux_function_8_c.html',1,'']]], - ['realm_2ec_939',['Realm.C',['../_realm_8_c.html',1,'']]], - ['realms_2ec_940',['Realms.C',['../_realms_8_c.html',1,'']]], - ['referencepropertydata_2ec_941',['ReferencePropertyData.C',['../_reference_property_data_8_c.html',1,'']]] + ['rayleightaylormixfracauxfunction_2ec_940',['RayleighTaylorMixFracAuxFunction.C',['../_rayleigh_taylor_mix_frac_aux_function_8_c.html',1,'']]], + ['realm_2ec_941',['Realm.C',['../_realm_8_c.html',1,'']]], + ['realms_2ec_942',['Realms.C',['../_realms_8_c.html',1,'']]], + ['referencepropertydata_2ec_943',['ReferencePropertyData.C',['../_reference_property_data_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_11.js b/api_docs/search/files_11.js index aef2d6aa1..a464c03f3 100644 --- a/api_docs/search/files_11.js +++ b/api_docs/search/files_11.js @@ -1,60 +1,61 @@ var searchData= [ - ['scalaredgeopensolveralg_2ec_942',['ScalarEdgeOpenSolverAlg.C',['../_scalar_edge_open_solver_alg_8_c.html',1,'']]], - ['scalaredgesolveralg_2ec_943',['ScalarEdgeSolverAlg.C',['../_scalar_edge_solver_alg_8_c.html',1,'']]], - ['scalarfacefluxbcelemkernel_2ec_944',['ScalarFaceFluxBCElemKernel.C',['../_scalar_face_flux_b_c_elem_kernel_8_c.html',1,'']]], - ['scalarfluxbc_2ec_945',['ScalarFluxBC.C',['../_scalar_flux_b_c_8_c.html',1,'']]], - ['scalarfluxbcelemkernel_2ec_946',['ScalarFluxBCElemKernel.C',['../_scalar_flux_b_c_elem_kernel_8_c.html',1,'']]], - ['scalarfluxpenaltyelemkernel_2ec_947',['ScalarFluxPenaltyElemKernel.C',['../_scalar_flux_penalty_elem_kernel_8_c.html',1,'']]], - ['scalargclnodekernel_2ec_948',['ScalarGclNodeKernel.C',['../_scalar_gcl_node_kernel_8_c.html',1,'']]], - ['scalarmassbdfnodekernel_2ec_949',['ScalarMassBDFNodeKernel.C',['../_scalar_mass_b_d_f_node_kernel_8_c.html',1,'']]], - ['scalaropenadvelemkernel_2ec_950',['ScalarOpenAdvElemKernel.C',['../_scalar_open_adv_elem_kernel_8_c.html',1,'']]], - ['scalaropenedgekernel_2ec_951',['ScalarOpenEdgeKernel.C',['../_scalar_open_edge_kernel_8_c.html',1,'']]], - ['scratchviews_2ec_952',['ScratchViews.C',['../_scratch_views_8_c.html',1,'']]], - ['sdrkonodekernel_2ec_953',['SDRKONodeKernel.C',['../_s_d_r_k_o_node_kernel_8_c.html',1,'']]], - ['sdrlowrewallalg_2ec_954',['SDRLowReWallAlg.C',['../_s_d_r_low_re_wall_alg_8_c.html',1,'']]], - ['sdrsstamsnodekernel_2ec_955',['SDRSSTAMSNodeKernel.C',['../_s_d_r_s_s_t_a_m_s_node_kernel_8_c.html',1,'']]], - ['sdrsstdesnodekernel_2ec_956',['SDRSSTDESNodeKernel.C',['../_s_d_r_s_s_t_d_e_s_node_kernel_8_c.html',1,'']]], - ['sdrsstlrnodekernel_2ec_957',['SDRSSTLRNodeKernel.C',['../_s_d_r_s_s_t_l_r_node_kernel_8_c.html',1,'']]], - ['sdrsstnodekernel_2ec_958',['SDRSSTNodeKernel.C',['../_s_d_r_s_s_t_node_kernel_8_c.html',1,'']]], - ['sdrwallfuncalg_2ec_959',['SDRWallFuncAlg.C',['../_s_d_r_wall_func_alg_8_c.html',1,'']]], - ['sdrwallfuncalgdriver_2ec_960',['SDRWallFuncAlgDriver.C',['../_s_d_r_wall_func_alg_driver_8_c.html',1,'']]], - ['shearstresstransportequationsystem_2ec_961',['ShearStressTransportEquationSystem.C',['../_shear_stress_transport_equation_system_8_c.html',1,'']]], - ['sidewriter_2ec_962',['SideWriter.C',['../_side_writer_8_c.html',1,'']]], - ['simulation_2ec_963',['Simulation.C',['../_simulation_8_c.html',1,'']]], - ['sinprofilechannelflowvelocityauxfunction_2ec_964',['SinProfileChannelFlowVelocityAuxFunction.C',['../_sin_profile_channel_flow_velocity_aux_function_8_c.html',1,'']]], - ['sloshingtankvofauxfunction_2ec_965',['SloshingTankVOFAuxFunction.C',['../_sloshing_tank_v_o_f_aux_function_8_c.html',1,'']]], - ['smartfield_2ec_966',['SmartField.C',['../_smart_field_8_c.html',1,'']]], - ['solutionnormpostprocessing_2ec_967',['SolutionNormPostProcessing.C',['../_solution_norm_post_processing_8_c.html',1,'']]], - ['solutionoptions_2ec_968',['SolutionOptions.C',['../_solution_options_8_c.html',1,'']]], - ['solveralgorithm_2ec_969',['SolverAlgorithm.C',['../_solver_algorithm_8_c.html',1,'']]], - ['solveralgorithmdriver_2ec_970',['SolverAlgorithmDriver.C',['../_solver_algorithm_driver_8_c.html',1,'']]], - ['sparsifiededgelaplacian_2ec_971',['SparsifiedEdgeLaplacian.C',['../_sparsified_edge_laplacian_8_c.html',1,'']]], - ['specificdissipationrateequationsystem_2ec_972',['SpecificDissipationRateEquationSystem.C',['../_specific_dissipation_rate_equation_system_8_c.html',1,'']]], - ['specificheatpropertyevaluator_2ec_973',['SpecificHeatPropertyEvaluator.C',['../_specific_heat_property_evaluator_8_c.html',1,'']]], - ['sstamsaveragesalg_2ec_974',['SSTAMSAveragesAlg.C',['../_s_s_t_a_m_s_averages_alg_8_c.html',1,'']]], - ['sstmaxlengthscalealg_2ec_975',['SSTMaxLengthScaleAlg.C',['../_s_s_t_max_length_scale_alg_8_c.html',1,'']]], - ['sstmaxlengthscaledriver_2ec_976',['SSTMaxLengthScaleDriver.C',['../_s_s_t_max_length_scale_driver_8_c.html',1,'']]], - ['steadytaylorvortexgradpressureauxfunction_2ec_977',['SteadyTaylorVortexGradPressureAuxFunction.C',['../_steady_taylor_vortex_grad_pressure_aux_function_8_c.html',1,'']]], - ['steadytaylorvortexmomentumsrcnodesuppalg_2ec_978',['SteadyTaylorVortexMomentumSrcNodeSuppAlg.C',['../_steady_taylor_vortex_momentum_src_node_supp_alg_8_c.html',1,'']]], - ['steadytaylorvortexpressureauxfunction_2ec_979',['SteadyTaylorVortexPressureAuxFunction.C',['../_steady_taylor_vortex_pressure_aux_function_8_c.html',1,'']]], - ['steadytaylorvortexvelocityauxfunction_2ec_980',['SteadyTaylorVortexVelocityAuxFunction.C',['../_steady_taylor_vortex_velocity_aux_function_8_c.html',1,'']]], - ['stkhelpers_2ec_981',['StkHelpers.C',['../_stk_helpers_8_c.html',1,'']]], - ['stksimdconnectivitymap_2ec_982',['StkSimdConnectivityMap.C',['../_stk_simd_connectivity_map_8_c.html',1,'']]], - ['stksimdfaceconnectivitymap_2ec_983',['StkSimdFaceConnectivityMap.C',['../_stk_simd_face_connectivity_map_8_c.html',1,'']]], - ['stksimdgatheredelementdata_2ec_984',['StkSimdGatheredElementData.C',['../_stk_simd_gathered_element_data_8_c.html',1,'']]], - ['stksimdnodeconnectivitymap_2ec_985',['StkSimdNodeConnectivityMap.C',['../_stk_simd_node_connectivity_map_8_c.html',1,'']]], - ['stktotpetracomm_2ec_986',['StkToTpetraComm.C',['../_stk_to_tpetra_comm_8_c.html',1,'']]], - ['stktotpetralocalindices_2ec_987',['StkToTpetraLocalIndices.C',['../_stk_to_tpetra_local_indices_8_c.html',1,'']]], - ['stktotpetramap_2ec_988',['StkToTpetraMap.C',['../_stk_to_tpetra_map_8_c.html',1,'']]], - ['streletsupwindedgealg_2ec_989',['StreletsUpwindEdgeAlg.C',['../_strelets_upwind_edge_alg_8_c.html',1,'']]], - ['stringtimecoordfunction_2ec_990',['StringTimeCoordFunction.C',['../_string_time_coord_function_8_c.html',1,'']]], - ['stringtimecoordtemperatureauxfunction_2ec_991',['StringTimeCoordTemperatureAuxFunction.C',['../_string_time_coord_temperature_aux_function_8_c.html',1,'']]], - ['strongdirichletbc_2ec_992',['StrongDirichletBC.C',['../_strong_dirichlet_b_c_8_c.html',1,'']]], - ['supplementalalgorithm_2ec_993',['SupplementalAlgorithm.C',['../_supplemental_algorithm_8_c.html',1,'']]], - ['surfaceforceandmomentalgorithm_2ec_994',['SurfaceForceAndMomentAlgorithm.C',['../_surface_force_and_moment_algorithm_8_c.html',1,'']]], - ['surfaceforceandmomentalgorithmdriver_2ec_995',['SurfaceForceAndMomentAlgorithmDriver.C',['../_surface_force_and_moment_algorithm_driver_8_c.html',1,'']]], - ['surfaceforceandmomentwallfunctionalgorithm_2ec_996',['SurfaceForceAndMomentWallFunctionAlgorithm.C',['../_surface_force_and_moment_wall_function_algorithm_8_c.html',1,'']]], - ['sutherlandspropertyevaluator_2ec_997',['SutherlandsPropertyEvaluator.C',['../_sutherlands_property_evaluator_8_c.html',1,'']]], - ['syntheticlidar_2ec_998',['SyntheticLidar.C',['../_synthetic_lidar_8_c.html',1,'']]] + ['scalaredgeopensolveralg_2ec_944',['ScalarEdgeOpenSolverAlg.C',['../_scalar_edge_open_solver_alg_8_c.html',1,'']]], + ['scalaredgesolveralg_2ec_945',['ScalarEdgeSolverAlg.C',['../_scalar_edge_solver_alg_8_c.html',1,'']]], + ['scalarfacefluxbcelemkernel_2ec_946',['ScalarFaceFluxBCElemKernel.C',['../_scalar_face_flux_b_c_elem_kernel_8_c.html',1,'']]], + ['scalarfluxbc_2ec_947',['ScalarFluxBC.C',['../_scalar_flux_b_c_8_c.html',1,'']]], + ['scalarfluxbcelemkernel_2ec_948',['ScalarFluxBCElemKernel.C',['../_scalar_flux_b_c_elem_kernel_8_c.html',1,'']]], + ['scalarfluxpenaltyelemkernel_2ec_949',['ScalarFluxPenaltyElemKernel.C',['../_scalar_flux_penalty_elem_kernel_8_c.html',1,'']]], + ['scalargclnodekernel_2ec_950',['ScalarGclNodeKernel.C',['../_scalar_gcl_node_kernel_8_c.html',1,'']]], + ['scalarmassbdfnodekernel_2ec_951',['ScalarMassBDFNodeKernel.C',['../_scalar_mass_b_d_f_node_kernel_8_c.html',1,'']]], + ['scalaropenadvelemkernel_2ec_952',['ScalarOpenAdvElemKernel.C',['../_scalar_open_adv_elem_kernel_8_c.html',1,'']]], + ['scalaropenedgekernel_2ec_953',['ScalarOpenEdgeKernel.C',['../_scalar_open_edge_kernel_8_c.html',1,'']]], + ['scratchviews_2ec_954',['ScratchViews.C',['../_scratch_views_8_c.html',1,'']]], + ['sdrkonodekernel_2ec_955',['SDRKONodeKernel.C',['../_s_d_r_k_o_node_kernel_8_c.html',1,'']]], + ['sdrlowrewallalg_2ec_956',['SDRLowReWallAlg.C',['../_s_d_r_low_re_wall_alg_8_c.html',1,'']]], + ['sdrsstamsnodekernel_2ec_957',['SDRSSTAMSNodeKernel.C',['../_s_d_r_s_s_t_a_m_s_node_kernel_8_c.html',1,'']]], + ['sdrsstbltm2015nodekernel_2ec_958',['SDRSSTBLTM2015NodeKernel.C',['../_s_d_r_s_s_t_b_l_t_m2015_node_kernel_8_c.html',1,'']]], + ['sdrsstdesnodekernel_2ec_959',['SDRSSTDESNodeKernel.C',['../_s_d_r_s_s_t_d_e_s_node_kernel_8_c.html',1,'']]], + ['sdrsstlrnodekernel_2ec_960',['SDRSSTLRNodeKernel.C',['../_s_d_r_s_s_t_l_r_node_kernel_8_c.html',1,'']]], + ['sdrsstnodekernel_2ec_961',['SDRSSTNodeKernel.C',['../_s_d_r_s_s_t_node_kernel_8_c.html',1,'']]], + ['sdrwallfuncalg_2ec_962',['SDRWallFuncAlg.C',['../_s_d_r_wall_func_alg_8_c.html',1,'']]], + ['sdrwallfuncalgdriver_2ec_963',['SDRWallFuncAlgDriver.C',['../_s_d_r_wall_func_alg_driver_8_c.html',1,'']]], + ['shearstresstransportequationsystem_2ec_964',['ShearStressTransportEquationSystem.C',['../_shear_stress_transport_equation_system_8_c.html',1,'']]], + ['sidewriter_2ec_965',['SideWriter.C',['../_side_writer_8_c.html',1,'']]], + ['simulation_2ec_966',['Simulation.C',['../_simulation_8_c.html',1,'']]], + ['sinprofilechannelflowvelocityauxfunction_2ec_967',['SinProfileChannelFlowVelocityAuxFunction.C',['../_sin_profile_channel_flow_velocity_aux_function_8_c.html',1,'']]], + ['sloshingtankvofauxfunction_2ec_968',['SloshingTankVOFAuxFunction.C',['../_sloshing_tank_v_o_f_aux_function_8_c.html',1,'']]], + ['smartfield_2ec_969',['SmartField.C',['../_smart_field_8_c.html',1,'']]], + ['solutionnormpostprocessing_2ec_970',['SolutionNormPostProcessing.C',['../_solution_norm_post_processing_8_c.html',1,'']]], + ['solutionoptions_2ec_971',['SolutionOptions.C',['../_solution_options_8_c.html',1,'']]], + ['solveralgorithm_2ec_972',['SolverAlgorithm.C',['../_solver_algorithm_8_c.html',1,'']]], + ['solveralgorithmdriver_2ec_973',['SolverAlgorithmDriver.C',['../_solver_algorithm_driver_8_c.html',1,'']]], + ['sparsifiededgelaplacian_2ec_974',['SparsifiedEdgeLaplacian.C',['../_sparsified_edge_laplacian_8_c.html',1,'']]], + ['specificdissipationrateequationsystem_2ec_975',['SpecificDissipationRateEquationSystem.C',['../_specific_dissipation_rate_equation_system_8_c.html',1,'']]], + ['specificheatpropertyevaluator_2ec_976',['SpecificHeatPropertyEvaluator.C',['../_specific_heat_property_evaluator_8_c.html',1,'']]], + ['sstamsaveragesalg_2ec_977',['SSTAMSAveragesAlg.C',['../_s_s_t_a_m_s_averages_alg_8_c.html',1,'']]], + ['sstmaxlengthscalealg_2ec_978',['SSTMaxLengthScaleAlg.C',['../_s_s_t_max_length_scale_alg_8_c.html',1,'']]], + ['sstmaxlengthscaledriver_2ec_979',['SSTMaxLengthScaleDriver.C',['../_s_s_t_max_length_scale_driver_8_c.html',1,'']]], + ['steadytaylorvortexgradpressureauxfunction_2ec_980',['SteadyTaylorVortexGradPressureAuxFunction.C',['../_steady_taylor_vortex_grad_pressure_aux_function_8_c.html',1,'']]], + ['steadytaylorvortexmomentumsrcnodesuppalg_2ec_981',['SteadyTaylorVortexMomentumSrcNodeSuppAlg.C',['../_steady_taylor_vortex_momentum_src_node_supp_alg_8_c.html',1,'']]], + ['steadytaylorvortexpressureauxfunction_2ec_982',['SteadyTaylorVortexPressureAuxFunction.C',['../_steady_taylor_vortex_pressure_aux_function_8_c.html',1,'']]], + ['steadytaylorvortexvelocityauxfunction_2ec_983',['SteadyTaylorVortexVelocityAuxFunction.C',['../_steady_taylor_vortex_velocity_aux_function_8_c.html',1,'']]], + ['stkhelpers_2ec_984',['StkHelpers.C',['../_stk_helpers_8_c.html',1,'']]], + ['stksimdconnectivitymap_2ec_985',['StkSimdConnectivityMap.C',['../_stk_simd_connectivity_map_8_c.html',1,'']]], + ['stksimdfaceconnectivitymap_2ec_986',['StkSimdFaceConnectivityMap.C',['../_stk_simd_face_connectivity_map_8_c.html',1,'']]], + ['stksimdgatheredelementdata_2ec_987',['StkSimdGatheredElementData.C',['../_stk_simd_gathered_element_data_8_c.html',1,'']]], + ['stksimdnodeconnectivitymap_2ec_988',['StkSimdNodeConnectivityMap.C',['../_stk_simd_node_connectivity_map_8_c.html',1,'']]], + ['stktotpetracomm_2ec_989',['StkToTpetraComm.C',['../_stk_to_tpetra_comm_8_c.html',1,'']]], + ['stktotpetralocalindices_2ec_990',['StkToTpetraLocalIndices.C',['../_stk_to_tpetra_local_indices_8_c.html',1,'']]], + ['stktotpetramap_2ec_991',['StkToTpetraMap.C',['../_stk_to_tpetra_map_8_c.html',1,'']]], + ['streletsupwindedgealg_2ec_992',['StreletsUpwindEdgeAlg.C',['../_strelets_upwind_edge_alg_8_c.html',1,'']]], + ['stringtimecoordfunction_2ec_993',['StringTimeCoordFunction.C',['../_string_time_coord_function_8_c.html',1,'']]], + ['stringtimecoordtemperatureauxfunction_2ec_994',['StringTimeCoordTemperatureAuxFunction.C',['../_string_time_coord_temperature_aux_function_8_c.html',1,'']]], + ['strongdirichletbc_2ec_995',['StrongDirichletBC.C',['../_strong_dirichlet_b_c_8_c.html',1,'']]], + ['supplementalalgorithm_2ec_996',['SupplementalAlgorithm.C',['../_supplemental_algorithm_8_c.html',1,'']]], + ['surfaceforceandmomentalgorithm_2ec_997',['SurfaceForceAndMomentAlgorithm.C',['../_surface_force_and_moment_algorithm_8_c.html',1,'']]], + ['surfaceforceandmomentalgorithmdriver_2ec_998',['SurfaceForceAndMomentAlgorithmDriver.C',['../_surface_force_and_moment_algorithm_driver_8_c.html',1,'']]], + ['surfaceforceandmomentwallfunctionalgorithm_2ec_999',['SurfaceForceAndMomentWallFunctionAlgorithm.C',['../_surface_force_and_moment_wall_function_algorithm_8_c.html',1,'']]], + ['sutherlandspropertyevaluator_2ec_1000',['SutherlandsPropertyEvaluator.C',['../_sutherlands_property_evaluator_8_c.html',1,'']]], + ['syntheticlidar_2ec_1001',['SyntheticLidar.C',['../_synthetic_lidar_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_12.js b/api_docs/search/files_12.js index 60baef121..06fc3e762 100644 --- a/api_docs/search/files_12.js +++ b/api_docs/search/files_12.js @@ -1,46 +1,47 @@ var searchData= [ - ['tabulatedtemperatureauxfunction_2ec_999',['TabulatedTemperatureAuxFunction.C',['../_tabulated_temperature_aux_function_8_c.html',1,'']]], - ['taylorgreenpressureauxfunction_2ec_1000',['TaylorGreenPressureAuxFunction.C',['../_taylor_green_pressure_aux_function_8_c.html',1,'']]], - ['taylorgreenvelocityauxfunction_2ec_1001',['TaylorGreenVelocityAuxFunction.C',['../_taylor_green_velocity_aux_function_8_c.html',1,'']]], - ['tdrkenodekernel_2ec_1002',['TDRKENodeKernel.C',['../_t_d_r_k_e_node_kernel_8_c.html',1,'']]], - ['temperaturepropalgorithm_2ec_1003',['TemperaturePropAlgorithm.C',['../_temperature_prop_algorithm_8_c.html',1,'']]], - ['tet4cvfem_2ec_1004',['Tet4CVFEM.C',['../_tet4_c_v_f_e_m_8_c.html',1,'']]], - ['thermalconductivityfromprandtlpropalgorithm_2ec_1005',['ThermalConductivityFromPrandtlPropAlgorithm.C',['../_thermal_conductivity_from_prandtl_prop_algorithm_8_c.html',1,'']]], - ['timeintegrator_2ec_1006',['TimeIntegrator.C',['../_time_integrator_8_c.html',1,'']]], - ['tiogablock_2ec_1007',['TiogaBlock.C',['../_tioga_block_8_c.html',1,'']]], - ['tiogaoptions_2ec_1008',['TiogaOptions.C',['../_tioga_options_8_c.html',1,'']]], - ['tiogaref_2ec_1009',['TiogaRef.C',['../_tioga_ref_8_c.html',1,'']]], - ['tiogastkiface_2ec_1010',['TiogaSTKIface.C',['../_tioga_s_t_k_iface_8_c.html',1,'']]], - ['tkekenodekernel_2ec_1011',['TKEKENodeKernel.C',['../_t_k_e_k_e_node_kernel_8_c.html',1,'']]], - ['tkekonodekernel_2ec_1012',['TKEKONodeKernel.C',['../_t_k_e_k_o_node_kernel_8_c.html',1,'']]], - ['tkeksgsnodekernel_2ec_1013',['TKEKsgsNodeKernel.C',['../_t_k_e_ksgs_node_kernel_8_c.html',1,'']]], - ['tkerodinodekernel_2ec_1014',['TKERodiNodeKernel.C',['../_t_k_e_rodi_node_kernel_8_c.html',1,'']]], - ['tkesstamsnodekernel_2ec_1015',['TKESSTAMSNodeKernel.C',['../_t_k_e_s_s_t_a_m_s_node_kernel_8_c.html',1,'']]], - ['tkesstdesnodekernel_2ec_1016',['TKESSTDESNodeKernel.C',['../_t_k_e_s_s_t_d_e_s_node_kernel_8_c.html',1,'']]], - ['tkesstiddesnodekernel_2ec_1017',['TKESSTIDDESNodeKernel.C',['../_t_k_e_s_s_t_i_d_d_e_s_node_kernel_8_c.html',1,'']]], - ['tkesstlrnodekernel_2ec_1018',['TKESSTLRNodeKernel.C',['../_t_k_e_s_s_t_l_r_node_kernel_8_c.html',1,'']]], - ['tkesstnodekernel_2ec_1019',['TKESSTNodeKernel.C',['../_t_k_e_s_s_t_node_kernel_8_c.html',1,'']]], - ['tkewallfuncalg_2ec_1020',['TKEWallFuncAlg.C',['../_t_k_e_wall_func_alg_8_c.html',1,'']]], - ['tkewallfuncalgdriver_2ec_1021',['TKEWallFuncAlgDriver.C',['../_t_k_e_wall_func_alg_driver_8_c.html',1,'']]], - ['tornadoauxfunction_2ec_1022',['TornadoAuxFunction.C',['../_tornado_aux_function_8_c.html',1,'']]], - ['totaldissipationrateequationsystem_2ec_1023',['TotalDissipationRateEquationSystem.C',['../_total_dissipation_rate_equation_system_8_c.html',1,'']]], - ['tpetralinearsystem_2ec_1024',['TpetraLinearSystem.C',['../_tpetra_linear_system_8_c.html',1,'']]], - ['tpetralinearsystemhelpers_2ec_1025',['TpetraLinearSystemHelpers.C',['../_tpetra_linear_system_helpers_8_c.html',1,'']]], - ['tpetrasegregatedlinearsystem_2ec_1026',['TpetraSegregatedLinearSystem.C',['../_tpetra_segregated_linear_system_8_c.html',1,'']]], - ['transfer_2ec_1027',['Transfer.C',['../_transfer_8_c.html',1,'']]], - ['transfers_2ec_1028',['Transfers.C',['../_transfers_8_c.html',1,'']]], - ['transportcoefficients_2ec_1029',['TransportCoefficients.C',['../_transport_coefficients_8_c.html',1,'']]], - ['tri32dcvfem_2ec_1030',['Tri32DCVFEM.C',['../_tri32_d_c_v_f_e_m_8_c.html',1,'']]], - ['tri33dcvfem_2ec_1031',['Tri33DCVFEM.C',['../_tri33_d_c_v_f_e_m_8_c.html',1,'']]], - ['turbinesurrogatekernel_2ec_1032',['TurbineSurrogateKernel.C',['../_turbine_surrogate_kernel_8_c.html',1,'']]], - ['turbkineticenergyequationsystem_2ec_1033',['TurbKineticEnergyEquationSystem.C',['../_turb_kinetic_energy_equation_system_8_c.html',1,'']]], - ['turbulenceaveragingpostprocessing_2ec_1034',['TurbulenceAveragingPostProcessing.C',['../_turbulence_averaging_post_processing_8_c.html',1,'']]], - ['turbvisckealg_2ec_1035',['TurbViscKEAlg.C',['../_turb_visc_k_e_alg_8_c.html',1,'']]], - ['turbvisckoalg_2ec_1036',['TurbViscKOAlg.C',['../_turb_visc_k_o_alg_8_c.html',1,'']]], - ['turbviscksgsalg_2ec_1037',['TurbViscKsgsAlg.C',['../_turb_visc_ksgs_alg_8_c.html',1,'']]], - ['turbviscsmagorinskyalgorithm_2ec_1038',['TurbViscSmagorinskyAlgorithm.C',['../_turb_visc_smagorinsky_algorithm_8_c.html',1,'']]], - ['turbviscsstalg_2ec_1039',['TurbViscSSTAlg.C',['../_turb_visc_s_s_t_alg_8_c.html',1,'']]], - ['turbviscsstlralg_2ec_1040',['TurbViscSSTLRAlg.C',['../_turb_visc_s_s_t_l_r_alg_8_c.html',1,'']]], - ['turbviscwalealgorithm_2ec_1041',['TurbViscWaleAlgorithm.C',['../_turb_visc_wale_algorithm_8_c.html',1,'']]] + ['tabulatedtemperatureauxfunction_2ec_1002',['TabulatedTemperatureAuxFunction.C',['../_tabulated_temperature_aux_function_8_c.html',1,'']]], + ['taylorgreenpressureauxfunction_2ec_1003',['TaylorGreenPressureAuxFunction.C',['../_taylor_green_pressure_aux_function_8_c.html',1,'']]], + ['taylorgreenvelocityauxfunction_2ec_1004',['TaylorGreenVelocityAuxFunction.C',['../_taylor_green_velocity_aux_function_8_c.html',1,'']]], + ['tdrkenodekernel_2ec_1005',['TDRKENodeKernel.C',['../_t_d_r_k_e_node_kernel_8_c.html',1,'']]], + ['temperaturepropalgorithm_2ec_1006',['TemperaturePropAlgorithm.C',['../_temperature_prop_algorithm_8_c.html',1,'']]], + ['tet4cvfem_2ec_1007',['Tet4CVFEM.C',['../_tet4_c_v_f_e_m_8_c.html',1,'']]], + ['thermalconductivityfromprandtlpropalgorithm_2ec_1008',['ThermalConductivityFromPrandtlPropAlgorithm.C',['../_thermal_conductivity_from_prandtl_prop_algorithm_8_c.html',1,'']]], + ['timeintegrator_2ec_1009',['TimeIntegrator.C',['../_time_integrator_8_c.html',1,'']]], + ['tiogablock_2ec_1010',['TiogaBlock.C',['../_tioga_block_8_c.html',1,'']]], + ['tiogaoptions_2ec_1011',['TiogaOptions.C',['../_tioga_options_8_c.html',1,'']]], + ['tiogaref_2ec_1012',['TiogaRef.C',['../_tioga_ref_8_c.html',1,'']]], + ['tiogastkiface_2ec_1013',['TiogaSTKIface.C',['../_tioga_s_t_k_iface_8_c.html',1,'']]], + ['tkekenodekernel_2ec_1014',['TKEKENodeKernel.C',['../_t_k_e_k_e_node_kernel_8_c.html',1,'']]], + ['tkekonodekernel_2ec_1015',['TKEKONodeKernel.C',['../_t_k_e_k_o_node_kernel_8_c.html',1,'']]], + ['tkeksgsnodekernel_2ec_1016',['TKEKsgsNodeKernel.C',['../_t_k_e_ksgs_node_kernel_8_c.html',1,'']]], + ['tkerodinodekernel_2ec_1017',['TKERodiNodeKernel.C',['../_t_k_e_rodi_node_kernel_8_c.html',1,'']]], + ['tkesstamsnodekernel_2ec_1018',['TKESSTAMSNodeKernel.C',['../_t_k_e_s_s_t_a_m_s_node_kernel_8_c.html',1,'']]], + ['tkesstbltm2015nodekernel_2ec_1019',['TKESSTBLTM2015NodeKernel.C',['../_t_k_e_s_s_t_b_l_t_m2015_node_kernel_8_c.html',1,'']]], + ['tkesstdesnodekernel_2ec_1020',['TKESSTDESNodeKernel.C',['../_t_k_e_s_s_t_d_e_s_node_kernel_8_c.html',1,'']]], + ['tkesstiddesnodekernel_2ec_1021',['TKESSTIDDESNodeKernel.C',['../_t_k_e_s_s_t_i_d_d_e_s_node_kernel_8_c.html',1,'']]], + ['tkesstlrnodekernel_2ec_1022',['TKESSTLRNodeKernel.C',['../_t_k_e_s_s_t_l_r_node_kernel_8_c.html',1,'']]], + ['tkesstnodekernel_2ec_1023',['TKESSTNodeKernel.C',['../_t_k_e_s_s_t_node_kernel_8_c.html',1,'']]], + ['tkewallfuncalg_2ec_1024',['TKEWallFuncAlg.C',['../_t_k_e_wall_func_alg_8_c.html',1,'']]], + ['tkewallfuncalgdriver_2ec_1025',['TKEWallFuncAlgDriver.C',['../_t_k_e_wall_func_alg_driver_8_c.html',1,'']]], + ['tornadoauxfunction_2ec_1026',['TornadoAuxFunction.C',['../_tornado_aux_function_8_c.html',1,'']]], + ['totaldissipationrateequationsystem_2ec_1027',['TotalDissipationRateEquationSystem.C',['../_total_dissipation_rate_equation_system_8_c.html',1,'']]], + ['tpetralinearsystem_2ec_1028',['TpetraLinearSystem.C',['../_tpetra_linear_system_8_c.html',1,'']]], + ['tpetralinearsystemhelpers_2ec_1029',['TpetraLinearSystemHelpers.C',['../_tpetra_linear_system_helpers_8_c.html',1,'']]], + ['tpetrasegregatedlinearsystem_2ec_1030',['TpetraSegregatedLinearSystem.C',['../_tpetra_segregated_linear_system_8_c.html',1,'']]], + ['transfer_2ec_1031',['Transfer.C',['../_transfer_8_c.html',1,'']]], + ['transfers_2ec_1032',['Transfers.C',['../_transfers_8_c.html',1,'']]], + ['transportcoefficients_2ec_1033',['TransportCoefficients.C',['../_transport_coefficients_8_c.html',1,'']]], + ['tri32dcvfem_2ec_1034',['Tri32DCVFEM.C',['../_tri32_d_c_v_f_e_m_8_c.html',1,'']]], + ['tri33dcvfem_2ec_1035',['Tri33DCVFEM.C',['../_tri33_d_c_v_f_e_m_8_c.html',1,'']]], + ['turbinesurrogatekernel_2ec_1036',['TurbineSurrogateKernel.C',['../_turbine_surrogate_kernel_8_c.html',1,'']]], + ['turbkineticenergyequationsystem_2ec_1037',['TurbKineticEnergyEquationSystem.C',['../_turb_kinetic_energy_equation_system_8_c.html',1,'']]], + ['turbulenceaveragingpostprocessing_2ec_1038',['TurbulenceAveragingPostProcessing.C',['../_turbulence_averaging_post_processing_8_c.html',1,'']]], + ['turbvisckealg_2ec_1039',['TurbViscKEAlg.C',['../_turb_visc_k_e_alg_8_c.html',1,'']]], + ['turbvisckoalg_2ec_1040',['TurbViscKOAlg.C',['../_turb_visc_k_o_alg_8_c.html',1,'']]], + ['turbviscksgsalg_2ec_1041',['TurbViscKsgsAlg.C',['../_turb_visc_ksgs_alg_8_c.html',1,'']]], + ['turbviscsmagorinskyalgorithm_2ec_1042',['TurbViscSmagorinskyAlgorithm.C',['../_turb_visc_smagorinsky_algorithm_8_c.html',1,'']]], + ['turbviscsstalg_2ec_1043',['TurbViscSSTAlg.C',['../_turb_visc_s_s_t_alg_8_c.html',1,'']]], + ['turbviscsstlralg_2ec_1044',['TurbViscSSTLRAlg.C',['../_turb_visc_s_s_t_l_r_alg_8_c.html',1,'']]], + ['turbviscwalealgorithm_2ec_1045',['TurbViscWaleAlgorithm.C',['../_turb_visc_wale_algorithm_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_13.js b/api_docs/search/files_13.js index 759ce3a87..546bd8b15 100644 --- a/api_docs/search/files_13.js +++ b/api_docs/search/files_13.js @@ -1,5 +1,5 @@ var searchData= [ - ['updateoversetfringealgorithmdriver_2ec_1042',['UpdateOversetFringeAlgorithmDriver.C',['../_update_overset_fringe_algorithm_driver_8_c.html',1,'']]], - ['utilitiesactuator_2ec_1043',['UtilitiesActuator.C',['../_utilities_actuator_8_c.html',1,'']]] + ['updateoversetfringealgorithmdriver_2ec_1046',['UpdateOversetFringeAlgorithmDriver.C',['../_update_overset_fringe_algorithm_driver_8_c.html',1,'']]], + ['utilitiesactuator_2ec_1047',['UtilitiesActuator.C',['../_utilities_actuator_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_14.js b/api_docs/search/files_14.js index 0e155fa41..8ee3a23fe 100644 --- a/api_docs/search/files_14.js +++ b/api_docs/search/files_14.js @@ -1,17 +1,17 @@ var searchData= [ - ['variabledensitycontinuitysrcnodesuppalg_2ec_1044',['VariableDensityContinuitySrcNodeSuppAlg.C',['../_variable_density_continuity_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitymixfracauxfunction_2ec_1045',['VariableDensityMixFracAuxFunction.C',['../_variable_density_mix_frac_aux_function_8_c.html',1,'']]], - ['variabledensitymixfracsrcnodesuppalg_2ec_1046',['VariableDensityMixFracSrcNodeSuppAlg.C',['../_variable_density_mix_frac_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitymomentumsrcnodesuppalg_2ec_1047',['VariableDensityMomentumSrcNodeSuppAlg.C',['../_variable_density_momentum_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitynonisocontinuitysrcnodesuppalg_2ec_1048',['VariableDensityNonIsoContinuitySrcNodeSuppAlg.C',['../_variable_density_non_iso_continuity_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitynonisoenthalpysrcnodesuppalg_2ec_1049',['VariableDensityNonIsoEnthalpySrcNodeSuppAlg.C',['../_variable_density_non_iso_enthalpy_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitynonisomomentumsrcnodesuppalg_2ec_1050',['VariableDensityNonIsoMomentumSrcNodeSuppAlg.C',['../_variable_density_non_iso_momentum_src_node_supp_alg_8_c.html',1,'']]], - ['variabledensitynonisotemperatureauxfunction_2ec_1051',['VariableDensityNonIsoTemperatureAuxFunction.C',['../_variable_density_non_iso_temperature_aux_function_8_c.html',1,'']]], - ['variabledensitypressureauxfunction_2ec_1052',['VariableDensityPressureAuxFunction.C',['../_variable_density_pressure_aux_function_8_c.html',1,'']]], - ['variabledensityvelocityauxfunction_2ec_1053',['VariableDensityVelocityAuxFunction.C',['../_variable_density_velocity_aux_function_8_c.html',1,'']]], - ['vofadvectionedgealg_2ec_1054',['VOFAdvectionEdgeAlg.C',['../_v_o_f_advection_edge_alg_8_c.html',1,'']]], - ['vofgclnodekernel_2ec_1055',['VOFGclNodeKernel.C',['../_v_o_f_gcl_node_kernel_8_c.html',1,'']]], - ['vofmassbdfnodekernel_2ec_1056',['VOFMassBDFNodeKernel.C',['../_v_o_f_mass_b_d_f_node_kernel_8_c.html',1,'']]], - ['volumeoffluidequationsystem_2ec_1057',['VolumeOfFluidEquationSystem.C',['../_volume_of_fluid_equation_system_8_c.html',1,'']]] + ['variabledensitycontinuitysrcnodesuppalg_2ec_1048',['VariableDensityContinuitySrcNodeSuppAlg.C',['../_variable_density_continuity_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitymixfracauxfunction_2ec_1049',['VariableDensityMixFracAuxFunction.C',['../_variable_density_mix_frac_aux_function_8_c.html',1,'']]], + ['variabledensitymixfracsrcnodesuppalg_2ec_1050',['VariableDensityMixFracSrcNodeSuppAlg.C',['../_variable_density_mix_frac_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitymomentumsrcnodesuppalg_2ec_1051',['VariableDensityMomentumSrcNodeSuppAlg.C',['../_variable_density_momentum_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitynonisocontinuitysrcnodesuppalg_2ec_1052',['VariableDensityNonIsoContinuitySrcNodeSuppAlg.C',['../_variable_density_non_iso_continuity_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitynonisoenthalpysrcnodesuppalg_2ec_1053',['VariableDensityNonIsoEnthalpySrcNodeSuppAlg.C',['../_variable_density_non_iso_enthalpy_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitynonisomomentumsrcnodesuppalg_2ec_1054',['VariableDensityNonIsoMomentumSrcNodeSuppAlg.C',['../_variable_density_non_iso_momentum_src_node_supp_alg_8_c.html',1,'']]], + ['variabledensitynonisotemperatureauxfunction_2ec_1055',['VariableDensityNonIsoTemperatureAuxFunction.C',['../_variable_density_non_iso_temperature_aux_function_8_c.html',1,'']]], + ['variabledensitypressureauxfunction_2ec_1056',['VariableDensityPressureAuxFunction.C',['../_variable_density_pressure_aux_function_8_c.html',1,'']]], + ['variabledensityvelocityauxfunction_2ec_1057',['VariableDensityVelocityAuxFunction.C',['../_variable_density_velocity_aux_function_8_c.html',1,'']]], + ['vofadvectionedgealg_2ec_1058',['VOFAdvectionEdgeAlg.C',['../_v_o_f_advection_edge_alg_8_c.html',1,'']]], + ['vofgclnodekernel_2ec_1059',['VOFGclNodeKernel.C',['../_v_o_f_gcl_node_kernel_8_c.html',1,'']]], + ['vofmassbdfnodekernel_2ec_1060',['VOFMassBDFNodeKernel.C',['../_v_o_f_mass_b_d_f_node_kernel_8_c.html',1,'']]], + ['volumeoffluidequationsystem_2ec_1061',['VolumeOfFluidEquationSystem.C',['../_volume_of_fluid_equation_system_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_15.js b/api_docs/search/files_15.js index ab9085d86..c2eabb088 100644 --- a/api_docs/search/files_15.js +++ b/api_docs/search/files_15.js @@ -1,15 +1,15 @@ var searchData= [ - ['walldistedgesolveralg_2ec_1058',['WallDistEdgeSolverAlg.C',['../_wall_dist_edge_solver_alg_8_c.html',1,'']]], - ['walldistelemkernel_2ec_1059',['WallDistElemKernel.C',['../_wall_dist_elem_kernel_8_c.html',1,'']]], - ['walldistequationsystem_2ec_1060',['WallDistEquationSystem.C',['../_wall_dist_equation_system_8_c.html',1,'']]], - ['walldistnodekernel_2ec_1061',['WallDistNodeKernel.C',['../_wall_dist_node_kernel_8_c.html',1,'']]], - ['wallfricvelalgdriver_2ec_1062',['WallFricVelAlgDriver.C',['../_wall_fric_vel_alg_driver_8_c.html',1,'']]], - ['wallfuncgeometryalg_2ec_1063',['WallFuncGeometryAlg.C',['../_wall_func_geometry_alg_8_c.html',1,'']]], - ['waterpropertyevaluator_2ec_1064',['WaterPropertyEvaluator.C',['../_water_property_evaluator_8_c.html',1,'']]], - ['wed6cvfem_2ec_1065',['Wed6CVFEM.C',['../_wed6_c_v_f_e_m_8_c.html',1,'']]], - ['wilcoxkomegaequationsystem_2ec_1066',['WilcoxKOmegaEquationSystem.C',['../_wilcox_k_omega_equation_system_8_c.html',1,'']]], - ['windenergypowerlawauxfunction_2ec_1067',['WindEnergyPowerLawAuxFunction.C',['../_wind_energy_power_law_aux_function_8_c.html',1,'']]], - ['windenergytaylorvortexauxfunction_2ec_1068',['WindEnergyTaylorVortexAuxFunction.C',['../_wind_energy_taylor_vortex_aux_function_8_c.html',1,'']]], - ['windenergytaylorvortexpressureauxfunction_2ec_1069',['WindEnergyTaylorVortexPressureAuxFunction.C',['../_wind_energy_taylor_vortex_pressure_aux_function_8_c.html',1,'']]] + ['walldistedgesolveralg_2ec_1062',['WallDistEdgeSolverAlg.C',['../_wall_dist_edge_solver_alg_8_c.html',1,'']]], + ['walldistelemkernel_2ec_1063',['WallDistElemKernel.C',['../_wall_dist_elem_kernel_8_c.html',1,'']]], + ['walldistequationsystem_2ec_1064',['WallDistEquationSystem.C',['../_wall_dist_equation_system_8_c.html',1,'']]], + ['walldistnodekernel_2ec_1065',['WallDistNodeKernel.C',['../_wall_dist_node_kernel_8_c.html',1,'']]], + ['wallfricvelalgdriver_2ec_1066',['WallFricVelAlgDriver.C',['../_wall_fric_vel_alg_driver_8_c.html',1,'']]], + ['wallfuncgeometryalg_2ec_1067',['WallFuncGeometryAlg.C',['../_wall_func_geometry_alg_8_c.html',1,'']]], + ['waterpropertyevaluator_2ec_1068',['WaterPropertyEvaluator.C',['../_water_property_evaluator_8_c.html',1,'']]], + ['wed6cvfem_2ec_1069',['Wed6CVFEM.C',['../_wed6_c_v_f_e_m_8_c.html',1,'']]], + ['wilcoxkomegaequationsystem_2ec_1070',['WilcoxKOmegaEquationSystem.C',['../_wilcox_k_omega_equation_system_8_c.html',1,'']]], + ['windenergypowerlawauxfunction_2ec_1071',['WindEnergyPowerLawAuxFunction.C',['../_wind_energy_power_law_aux_function_8_c.html',1,'']]], + ['windenergytaylorvortexauxfunction_2ec_1072',['WindEnergyTaylorVortexAuxFunction.C',['../_wind_energy_taylor_vortex_aux_function_8_c.html',1,'']]], + ['windenergytaylorvortexpressureauxfunction_2ec_1073',['WindEnergyTaylorVortexPressureAuxFunction.C',['../_wind_energy_taylor_vortex_pressure_aux_function_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_16.js b/api_docs/search/files_16.js index 26c686051..54e81984a 100644 --- a/api_docs/search/files_16.js +++ b/api_docs/search/files_16.js @@ -1,7 +1,7 @@ var searchData= [ - ['zalesakdiskmassflowratekernel_2ec_1070',['ZalesakDiskMassFlowRateKernel.C',['../_zalesak_disk_mass_flow_rate_kernel_8_c.html',1,'']]], - ['zalesakdiskvofauxfunction_2ec_1071',['ZalesakDiskVOFAuxFunction.C',['../_zalesak_disk_v_o_f_aux_function_8_c.html',1,'']]], - ['zalesakspheremassflowratekernel_2ec_1072',['ZalesakSphereMassFlowRateKernel.C',['../_zalesak_sphere_mass_flow_rate_kernel_8_c.html',1,'']]], - ['zalesakspherevofauxfunction_2ec_1073',['ZalesakSphereVOFAuxFunction.C',['../_zalesak_sphere_v_o_f_aux_function_8_c.html',1,'']]] + ['zalesakdiskmassflowratekernel_2ec_1074',['ZalesakDiskMassFlowRateKernel.C',['../_zalesak_disk_mass_flow_rate_kernel_8_c.html',1,'']]], + ['zalesakdiskvofauxfunction_2ec_1075',['ZalesakDiskVOFAuxFunction.C',['../_zalesak_disk_v_o_f_aux_function_8_c.html',1,'']]], + ['zalesakspheremassflowratekernel_2ec_1076',['ZalesakSphereMassFlowRateKernel.C',['../_zalesak_sphere_mass_flow_rate_kernel_8_c.html',1,'']]], + ['zalesakspherevofauxfunction_2ec_1077',['ZalesakSphereVOFAuxFunction.C',['../_zalesak_sphere_v_o_f_aux_function_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_2.js b/api_docs/search/files_2.js index 1297a6bcb..a5a4b0412 100644 --- a/api_docs/search/files_2.js +++ b/api_docs/search/files_2.js @@ -1,36 +1,36 @@ var searchData= [ - ['calcloads_2ec_732',['CalcLoads.C',['../_calc_loads_8_c.html',1,'']]], - ['chienkepsilonequationsystem_2ec_733',['ChienKEpsilonEquationSystem.C',['../_chien_k_epsilon_equation_system_8_c.html',1,'']]], - ['coefficients_2ec_734',['Coefficients.C',['../_coefficients_8_c.html',1,'']]], - ['computeheattransferedgewallalgorithm_2ec_735',['ComputeHeatTransferEdgeWallAlgorithm.C',['../_compute_heat_transfer_edge_wall_algorithm_8_c.html',1,'']]], - ['computemdotnonconformalalgorithm_2ec_736',['ComputeMdotNonConformalAlgorithm.C',['../_compute_mdot_non_conformal_algorithm_8_c.html',1,'']]], - ['computesstmaxlengthscaleelemalgorithm_2ec_737',['ComputeSSTMaxLengthScaleElemAlgorithm.C',['../_compute_s_s_t_max_length_scale_elem_algorithm_8_c.html',1,'']]], - ['computevectordivergence_2ec_738',['ComputeVectorDivergence.C',['../_compute_vector_divergence_8_c.html',1,'']]], - ['computewallfrictionvelocityalgorithm_2ec_739',['ComputeWallFrictionVelocityAlgorithm.C',['../_compute_wall_friction_velocity_algorithm_8_c.html',1,'']]], - ['conductiondiagonal_2ec_740',['ConductionDiagonal.C',['../_conduction_diagonal_8_c.html',1,'']]], - ['conductionfields_2ec_741',['ConductionFields.C',['../_conduction_fields_8_c.html',1,'']]], - ['conductiongatheredfieldmanager_2ec_742',['ConductionGatheredFieldManager.C',['../_conduction_gathered_field_manager_8_c.html',1,'']]], - ['conductioninterior_2ec_743',['ConductionInterior.C',['../_conduction_interior_8_c.html',1,'']]], - ['conductionjacobipreconditioner_2ec_744',['ConductionJacobiPreconditioner.C',['../_conduction_jacobi_preconditioner_8_c.html',1,'']]], - ['conductionoperator_2ec_745',['ConductionOperator.C',['../_conduction_operator_8_c.html',1,'']]], - ['conductionsolutionupdate_2ec_746',['ConductionSolutionUpdate.C',['../_conduction_solution_update_8_c.html',1,'']]], - ['conductionupdate_2ec_747',['ConductionUpdate.C',['../_conduction_update_8_c.html',1,'']]], - ['constantauxfunction_2ec_748',['ConstantAuxFunction.C',['../_constant_aux_function_8_c.html',1,'']]], - ['constantpropertyevaluator_2ec_749',['ConstantPropertyEvaluator.C',['../_constant_property_evaluator_8_c.html',1,'']]], - ['continuityedgesolveralg_2ec_750',['ContinuityEdgeSolverAlg.C',['../_continuity_edge_solver_alg_8_c.html',1,'']]], - ['continuitygclnodekernel_2ec_751',['ContinuityGclNodeKernel.C',['../_continuity_gcl_node_kernel_8_c.html',1,'']]], - ['continuityinflowelemkernel_2ec_752',['ContinuityInflowElemKernel.C',['../_continuity_inflow_elem_kernel_8_c.html',1,'']]], - ['continuityinterior_2ec_753',['ContinuityInterior.C',['../_continuity_interior_8_c.html',1,'']]], - ['continuitylowspeedcompressiblenodesuppalg_2ec_754',['ContinuityLowSpeedCompressibleNodeSuppAlg.C',['../_continuity_low_speed_compressible_node_supp_alg_8_c.html',1,'']]], - ['continuitymassbdfnodekernel_2ec_755',['ContinuityMassBDFNodeKernel.C',['../_continuity_mass_b_d_f_node_kernel_8_c.html',1,'']]], - ['continuityopenedgekernel_2ec_756',['ContinuityOpenEdgeKernel.C',['../_continuity_open_edge_kernel_8_c.html',1,'']]], - ['continuityoperator_2ec_757',['ContinuityOperator.C',['../_continuity_operator_8_c.html',1,'']]], - ['continuitysolutionupdate_2ec_758',['ContinuitySolutionUpdate.C',['../_continuity_solution_update_8_c.html',1,'']]], - ['convectingtaylorvortexpressureauxfunction_2ec_759',['ConvectingTaylorVortexPressureAuxFunction.C',['../_convecting_taylor_vortex_pressure_aux_function_8_c.html',1,'']]], - ['convectingtaylorvortexvelocityauxfunction_2ec_760',['ConvectingTaylorVortexVelocityAuxFunction.C',['../_convecting_taylor_vortex_velocity_aux_function_8_c.html',1,'']]], - ['copyfieldalgorithm_2ec_761',['CopyFieldAlgorithm.C',['../_copy_field_algorithm_8_c.html',1,'']]], - ['coriolissrc_2ec_762',['CoriolisSrc.C',['../_coriolis_src_8_c.html',1,'']]], - ['courantrealg_2ec_763',['CourantReAlg.C',['../_courant_re_alg_8_c.html',1,'']]], - ['courantrealgdriver_2ec_764',['CourantReAlgDriver.C',['../_courant_re_alg_driver_8_c.html',1,'']]] + ['calcloads_2ec_734',['CalcLoads.C',['../_calc_loads_8_c.html',1,'']]], + ['chienkepsilonequationsystem_2ec_735',['ChienKEpsilonEquationSystem.C',['../_chien_k_epsilon_equation_system_8_c.html',1,'']]], + ['coefficients_2ec_736',['Coefficients.C',['../_coefficients_8_c.html',1,'']]], + ['computeheattransferedgewallalgorithm_2ec_737',['ComputeHeatTransferEdgeWallAlgorithm.C',['../_compute_heat_transfer_edge_wall_algorithm_8_c.html',1,'']]], + ['computemdotnonconformalalgorithm_2ec_738',['ComputeMdotNonConformalAlgorithm.C',['../_compute_mdot_non_conformal_algorithm_8_c.html',1,'']]], + ['computesstmaxlengthscaleelemalgorithm_2ec_739',['ComputeSSTMaxLengthScaleElemAlgorithm.C',['../_compute_s_s_t_max_length_scale_elem_algorithm_8_c.html',1,'']]], + ['computevectordivergence_2ec_740',['ComputeVectorDivergence.C',['../_compute_vector_divergence_8_c.html',1,'']]], + ['computewallfrictionvelocityalgorithm_2ec_741',['ComputeWallFrictionVelocityAlgorithm.C',['../_compute_wall_friction_velocity_algorithm_8_c.html',1,'']]], + ['conductiondiagonal_2ec_742',['ConductionDiagonal.C',['../_conduction_diagonal_8_c.html',1,'']]], + ['conductionfields_2ec_743',['ConductionFields.C',['../_conduction_fields_8_c.html',1,'']]], + ['conductiongatheredfieldmanager_2ec_744',['ConductionGatheredFieldManager.C',['../_conduction_gathered_field_manager_8_c.html',1,'']]], + ['conductioninterior_2ec_745',['ConductionInterior.C',['../_conduction_interior_8_c.html',1,'']]], + ['conductionjacobipreconditioner_2ec_746',['ConductionJacobiPreconditioner.C',['../_conduction_jacobi_preconditioner_8_c.html',1,'']]], + ['conductionoperator_2ec_747',['ConductionOperator.C',['../_conduction_operator_8_c.html',1,'']]], + ['conductionsolutionupdate_2ec_748',['ConductionSolutionUpdate.C',['../_conduction_solution_update_8_c.html',1,'']]], + ['conductionupdate_2ec_749',['ConductionUpdate.C',['../_conduction_update_8_c.html',1,'']]], + ['constantauxfunction_2ec_750',['ConstantAuxFunction.C',['../_constant_aux_function_8_c.html',1,'']]], + ['constantpropertyevaluator_2ec_751',['ConstantPropertyEvaluator.C',['../_constant_property_evaluator_8_c.html',1,'']]], + ['continuityedgesolveralg_2ec_752',['ContinuityEdgeSolverAlg.C',['../_continuity_edge_solver_alg_8_c.html',1,'']]], + ['continuitygclnodekernel_2ec_753',['ContinuityGclNodeKernel.C',['../_continuity_gcl_node_kernel_8_c.html',1,'']]], + ['continuityinflowelemkernel_2ec_754',['ContinuityInflowElemKernel.C',['../_continuity_inflow_elem_kernel_8_c.html',1,'']]], + ['continuityinterior_2ec_755',['ContinuityInterior.C',['../_continuity_interior_8_c.html',1,'']]], + ['continuitylowspeedcompressiblenodesuppalg_2ec_756',['ContinuityLowSpeedCompressibleNodeSuppAlg.C',['../_continuity_low_speed_compressible_node_supp_alg_8_c.html',1,'']]], + ['continuitymassbdfnodekernel_2ec_757',['ContinuityMassBDFNodeKernel.C',['../_continuity_mass_b_d_f_node_kernel_8_c.html',1,'']]], + ['continuityopenedgekernel_2ec_758',['ContinuityOpenEdgeKernel.C',['../_continuity_open_edge_kernel_8_c.html',1,'']]], + ['continuityoperator_2ec_759',['ContinuityOperator.C',['../_continuity_operator_8_c.html',1,'']]], + ['continuitysolutionupdate_2ec_760',['ContinuitySolutionUpdate.C',['../_continuity_solution_update_8_c.html',1,'']]], + ['convectingtaylorvortexpressureauxfunction_2ec_761',['ConvectingTaylorVortexPressureAuxFunction.C',['../_convecting_taylor_vortex_pressure_aux_function_8_c.html',1,'']]], + ['convectingtaylorvortexvelocityauxfunction_2ec_762',['ConvectingTaylorVortexVelocityAuxFunction.C',['../_convecting_taylor_vortex_velocity_aux_function_8_c.html',1,'']]], + ['copyfieldalgorithm_2ec_763',['CopyFieldAlgorithm.C',['../_copy_field_algorithm_8_c.html',1,'']]], + ['coriolissrc_2ec_764',['CoriolisSrc.C',['../_coriolis_src_8_c.html',1,'']]], + ['courantrealg_2ec_765',['CourantReAlg.C',['../_courant_re_alg_8_c.html',1,'']]], + ['courantrealgdriver_2ec_766',['CourantReAlgDriver.C',['../_courant_re_alg_driver_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_3.js b/api_docs/search/files_3.js index ab282456d..c675fba95 100644 --- a/api_docs/search/files_3.js +++ b/api_docs/search/files_3.js @@ -1,9 +1,9 @@ var searchData= [ - ['dataprobepostprocessing_2ec_765',['DataProbePostProcessing.C',['../_data_probe_post_processing_8_c.html',1,'']]], - ['dginfo_2ec_766',['DgInfo.C',['../_dg_info_8_c.html',1,'']]], - ['dirichletbc_2ec_767',['DirichletBC.C',['../_dirichlet_b_c_8_c.html',1,'']]], - ['dropletvelocityauxfunction_2ec_768',['DropletVelocityAuxFunction.C',['../_droplet_velocity_aux_function_8_c.html',1,'']]], - ['dropletvofauxfunction_2ec_769',['DropletVOFAuxFunction.C',['../_droplet_v_o_f_aux_function_8_c.html',1,'']]], - ['dynamicpressureopenalg_2ec_770',['DynamicPressureOpenAlg.C',['../_dynamic_pressure_open_alg_8_c.html',1,'']]] + ['dataprobepostprocessing_2ec_767',['DataProbePostProcessing.C',['../_data_probe_post_processing_8_c.html',1,'']]], + ['dginfo_2ec_768',['DgInfo.C',['../_dg_info_8_c.html',1,'']]], + ['dirichletbc_2ec_769',['DirichletBC.C',['../_dirichlet_b_c_8_c.html',1,'']]], + ['dropletvelocityauxfunction_2ec_770',['DropletVelocityAuxFunction.C',['../_droplet_velocity_aux_function_8_c.html',1,'']]], + ['dropletvofauxfunction_2ec_771',['DropletVOFAuxFunction.C',['../_droplet_v_o_f_aux_function_8_c.html',1,'']]], + ['dynamicpressureopenalg_2ec_772',['DynamicPressureOpenAlg.C',['../_dynamic_pressure_open_alg_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_4.js b/api_docs/search/files_4.js index c2fc9a631..545a0ab5a 100644 --- a/api_docs/search/files_4.js +++ b/api_docs/search/files_4.js @@ -1,21 +1,21 @@ var searchData= [ - ['edge22dcvfem_2ec_771',['Edge22DCVFEM.C',['../_edge22_d_c_v_f_e_m_8_c.html',1,'']]], - ['effdifffluxcoeffalg_2ec_772',['EffDiffFluxCoeffAlg.C',['../_eff_diff_flux_coeff_alg_8_c.html',1,'']]], - ['effectivedifffluxcoeffalgorithm_2ec_773',['EffectiveDiffFluxCoeffAlgorithm.C',['../_effective_diff_flux_coeff_algorithm_8_c.html',1,'']]], - ['effsstdifffluxcoeffalg_2ec_774',['EffSSTDiffFluxCoeffAlg.C',['../_eff_s_s_t_diff_flux_coeff_alg_8_c.html',1,'']]], - ['elemdatarequests_2ec_775',['ElemDataRequests.C',['../_elem_data_requests_8_c.html',1,'']]], - ['elemdatarequestsgpu_2ec_776',['ElemDataRequestsGPU.C',['../_elem_data_requests_g_p_u_8_c.html',1,'']]], - ['enthalpyablforcenodekernel_2ec_777',['EnthalpyABLForceNodeKernel.C',['../_enthalpy_a_b_l_force_node_kernel_8_c.html',1,'']]], - ['enthalpyeffdifffluxcoeffalg_2ec_778',['EnthalpyEffDiffFluxCoeffAlg.C',['../_enthalpy_eff_diff_flux_coeff_alg_8_c.html',1,'']]], - ['enthalpyequationsystem_2ec_779',['EnthalpyEquationSystem.C',['../_enthalpy_equation_system_8_c.html',1,'']]], - ['enthalpylowspeedcompressiblenodesuppalg_2ec_780',['EnthalpyLowSpeedCompressibleNodeSuppAlg.C',['../_enthalpy_low_speed_compressible_node_supp_alg_8_c.html',1,'']]], - ['enthalpypmrsrcnodesuppalg_2ec_781',['EnthalpyPmrSrcNodeSuppAlg.C',['../_enthalpy_pmr_src_node_supp_alg_8_c.html',1,'']]], - ['enthalpypressureworknodesuppalg_2ec_782',['EnthalpyPressureWorkNodeSuppAlg.C',['../_enthalpy_pressure_work_node_supp_alg_8_c.html',1,'']]], - ['enthalpypropertyevaluator_2ec_783',['EnthalpyPropertyEvaluator.C',['../_enthalpy_property_evaluator_8_c.html',1,'']]], - ['enthalpytgradbcelemkernel_2ec_784',['EnthalpyTGradBCElemKernel.C',['../_enthalpy_t_grad_b_c_elem_kernel_8_c.html',1,'']]], - ['enthalpyviscousworknodesuppalg_2ec_785',['EnthalpyViscousWorkNodeSuppAlg.C',['../_enthalpy_viscous_work_node_supp_alg_8_c.html',1,'']]], - ['equationsystem_2ec_786',['EquationSystem.C',['../_equation_system_8_c.html',1,'']]], - ['equationsystems_2ec_787',['EquationSystems.C',['../_equation_systems_8_c.html',1,'']]], - ['extoverset_2ec_788',['ExtOverset.C',['../_ext_overset_8_c.html',1,'']]] + ['edge22dcvfem_2ec_773',['Edge22DCVFEM.C',['../_edge22_d_c_v_f_e_m_8_c.html',1,'']]], + ['effdifffluxcoeffalg_2ec_774',['EffDiffFluxCoeffAlg.C',['../_eff_diff_flux_coeff_alg_8_c.html',1,'']]], + ['effectivedifffluxcoeffalgorithm_2ec_775',['EffectiveDiffFluxCoeffAlgorithm.C',['../_effective_diff_flux_coeff_algorithm_8_c.html',1,'']]], + ['effsstdifffluxcoeffalg_2ec_776',['EffSSTDiffFluxCoeffAlg.C',['../_eff_s_s_t_diff_flux_coeff_alg_8_c.html',1,'']]], + ['elemdatarequests_2ec_777',['ElemDataRequests.C',['../_elem_data_requests_8_c.html',1,'']]], + ['elemdatarequestsgpu_2ec_778',['ElemDataRequestsGPU.C',['../_elem_data_requests_g_p_u_8_c.html',1,'']]], + ['enthalpyablforcenodekernel_2ec_779',['EnthalpyABLForceNodeKernel.C',['../_enthalpy_a_b_l_force_node_kernel_8_c.html',1,'']]], + ['enthalpyeffdifffluxcoeffalg_2ec_780',['EnthalpyEffDiffFluxCoeffAlg.C',['../_enthalpy_eff_diff_flux_coeff_alg_8_c.html',1,'']]], + ['enthalpyequationsystem_2ec_781',['EnthalpyEquationSystem.C',['../_enthalpy_equation_system_8_c.html',1,'']]], + ['enthalpylowspeedcompressiblenodesuppalg_2ec_782',['EnthalpyLowSpeedCompressibleNodeSuppAlg.C',['../_enthalpy_low_speed_compressible_node_supp_alg_8_c.html',1,'']]], + ['enthalpypmrsrcnodesuppalg_2ec_783',['EnthalpyPmrSrcNodeSuppAlg.C',['../_enthalpy_pmr_src_node_supp_alg_8_c.html',1,'']]], + ['enthalpypressureworknodesuppalg_2ec_784',['EnthalpyPressureWorkNodeSuppAlg.C',['../_enthalpy_pressure_work_node_supp_alg_8_c.html',1,'']]], + ['enthalpypropertyevaluator_2ec_785',['EnthalpyPropertyEvaluator.C',['../_enthalpy_property_evaluator_8_c.html',1,'']]], + ['enthalpytgradbcelemkernel_2ec_786',['EnthalpyTGradBCElemKernel.C',['../_enthalpy_t_grad_b_c_elem_kernel_8_c.html',1,'']]], + ['enthalpyviscousworknodesuppalg_2ec_787',['EnthalpyViscousWorkNodeSuppAlg.C',['../_enthalpy_viscous_work_node_supp_alg_8_c.html',1,'']]], + ['equationsystem_2ec_788',['EquationSystem.C',['../_equation_system_8_c.html',1,'']]], + ['equationsystems_2ec_789',['EquationSystems.C',['../_equation_systems_8_c.html',1,'']]], + ['extoverset_2ec_790',['ExtOverset.C',['../_ext_overset_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_5.js b/api_docs/search/files_5.js index 05ce0b585..27a290e95 100644 --- a/api_docs/search/files_5.js +++ b/api_docs/search/files_5.js @@ -1,16 +1,16 @@ var searchData= [ - ['fieldfunctions_2ec_789',['FieldFunctions.C',['../_field_functions_8_c.html',1,'']]], - ['fieldhelpers_2ec_790',['FieldHelpers.C',['../_field_helpers_8_c.html',1,'']]], - ['fieldmanager_2ec_791',['FieldManager.C',['../_field_manager_8_c.html',1,'']]], - ['fieldregistry_2ec_792',['FieldRegistry.C',['../_field_registry_8_c.html',1,'']]], - ['fieldupdatealgdriver_2ec_793',['FieldUpdateAlgDriver.C',['../_field_update_alg_driver_8_c.html',1,'']]], - ['filterdiagonal_2ec_794',['FilterDiagonal.C',['../_filter_diagonal_8_c.html',1,'']]], - ['filterjacobi_2ec_795',['FilterJacobi.C',['../_filter_jacobi_8_c.html',1,'']]], - ['fixpressureatnodealgorithm_2ec_796',['FixPressureAtNodeAlgorithm.C',['../_fix_pressure_at_node_algorithm_8_c.html',1,'']]], - ['flowpastcylindertempauxfunction_2ec_797',['FlowPastCylinderTempAuxFunction.C',['../_flow_past_cylinder_temp_aux_function_8_c.html',1,'']]], - ['framebase_2ec_798',['FrameBase.C',['../_frame_base_8_c.html',1,'']]], - ['framemoving_2ec_799',['FrameMoving.C',['../_frame_moving_8_c.html',1,'']]], - ['framereference_2ec_800',['FrameReference.C',['../_frame_reference_8_c.html',1,'']]], - ['fsiturbine_2ec_801',['FSIturbine.C',['../_f_s_iturbine_8_c.html',1,'']]] + ['fieldfunctions_2ec_791',['FieldFunctions.C',['../_field_functions_8_c.html',1,'']]], + ['fieldhelpers_2ec_792',['FieldHelpers.C',['../_field_helpers_8_c.html',1,'']]], + ['fieldmanager_2ec_793',['FieldManager.C',['../_field_manager_8_c.html',1,'']]], + ['fieldregistry_2ec_794',['FieldRegistry.C',['../_field_registry_8_c.html',1,'']]], + ['fieldupdatealgdriver_2ec_795',['FieldUpdateAlgDriver.C',['../_field_update_alg_driver_8_c.html',1,'']]], + ['filterdiagonal_2ec_796',['FilterDiagonal.C',['../_filter_diagonal_8_c.html',1,'']]], + ['filterjacobi_2ec_797',['FilterJacobi.C',['../_filter_jacobi_8_c.html',1,'']]], + ['fixpressureatnodealgorithm_2ec_798',['FixPressureAtNodeAlgorithm.C',['../_fix_pressure_at_node_algorithm_8_c.html',1,'']]], + ['flowpastcylindertempauxfunction_2ec_799',['FlowPastCylinderTempAuxFunction.C',['../_flow_past_cylinder_temp_aux_function_8_c.html',1,'']]], + ['framebase_2ec_800',['FrameBase.C',['../_frame_base_8_c.html',1,'']]], + ['framemoving_2ec_801',['FrameMoving.C',['../_frame_moving_8_c.html',1,'']]], + ['framereference_2ec_802',['FrameReference.C',['../_frame_reference_8_c.html',1,'']]], + ['fsiturbine_2ec_803',['FSIturbine.C',['../_f_s_iturbine_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_6.js b/api_docs/search/files_6.js index 2a318bb72..8374a8f28 100644 --- a/api_docs/search/files_6.js +++ b/api_docs/search/files_6.js @@ -1,15 +1,15 @@ var searchData= [ - ['gammaequationsystem_2ec_802',['GammaEquationSystem.C',['../_gamma_equation_system_8_c.html',1,'']]], - ['gaussjetvelocityauxfunction_2ec_803',['GaussJetVelocityAuxFunction.C',['../_gauss_jet_velocity_aux_function_8_c.html',1,'']]], - ['gausslegendrequadraturerule_2ec_804',['GaussLegendreQuadratureRule.C',['../_gauss_legendre_quadrature_rule_8_c.html',1,'']]], - ['genericpropalgorithm_2ec_805',['GenericPropAlgorithm.C',['../_generic_prop_algorithm_8_c.html',1,'']]], - ['geometryalgdriver_2ec_806',['GeometryAlgDriver.C',['../_geometry_alg_driver_8_c.html',1,'']]], - ['geometryboundaryalg_2ec_807',['GeometryBoundaryAlg.C',['../_geometry_boundary_alg_8_c.html',1,'']]], - ['geometryinterioralg_2ec_808',['GeometryInteriorAlg.C',['../_geometry_interior_alg_8_c.html',1,'']]], - ['gradientsolutionupdate_2ec_809',['GradientSolutionUpdate.C',['../_gradient_solution_update_8_c.html',1,'']]], - ['greengaussboundaryclosure_2ec_810',['GreenGaussBoundaryClosure.C',['../_green_gauss_boundary_closure_8_c.html',1,'']]], - ['greengaussgradient_2ec_811',['GreenGaussGradient.C',['../_green_gauss_gradient_8_c.html',1,'']]], - ['greengaussgradientinterior_2ec_812',['GreenGaussGradientInterior.C',['../_green_gauss_gradient_interior_8_c.html',1,'']]], - ['greengaussgradientoperator_2ec_813',['GreenGaussGradientOperator.C',['../_green_gauss_gradient_operator_8_c.html',1,'']]] + ['gammaequationsystem_2ec_804',['GammaEquationSystem.C',['../_gamma_equation_system_8_c.html',1,'']]], + ['gaussjetvelocityauxfunction_2ec_805',['GaussJetVelocityAuxFunction.C',['../_gauss_jet_velocity_aux_function_8_c.html',1,'']]], + ['gausslegendrequadraturerule_2ec_806',['GaussLegendreQuadratureRule.C',['../_gauss_legendre_quadrature_rule_8_c.html',1,'']]], + ['genericpropalgorithm_2ec_807',['GenericPropAlgorithm.C',['../_generic_prop_algorithm_8_c.html',1,'']]], + ['geometryalgdriver_2ec_808',['GeometryAlgDriver.C',['../_geometry_alg_driver_8_c.html',1,'']]], + ['geometryboundaryalg_2ec_809',['GeometryBoundaryAlg.C',['../_geometry_boundary_alg_8_c.html',1,'']]], + ['geometryinterioralg_2ec_810',['GeometryInteriorAlg.C',['../_geometry_interior_alg_8_c.html',1,'']]], + ['gradientsolutionupdate_2ec_811',['GradientSolutionUpdate.C',['../_gradient_solution_update_8_c.html',1,'']]], + ['greengaussboundaryclosure_2ec_812',['GreenGaussBoundaryClosure.C',['../_green_gauss_boundary_closure_8_c.html',1,'']]], + ['greengaussgradient_2ec_813',['GreenGaussGradient.C',['../_green_gauss_gradient_8_c.html',1,'']]], + ['greengaussgradientinterior_2ec_814',['GreenGaussGradientInterior.C',['../_green_gauss_gradient_interior_8_c.html',1,'']]], + ['greengaussgradientoperator_2ec_815',['GreenGaussGradientOperator.C',['../_green_gauss_gradient_operator_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_7.js b/api_docs/search/files_7.js index 51342c2a6..e4120e51c 100644 --- a/api_docs/search/files_7.js +++ b/api_docs/search/files_7.js @@ -1,11 +1,11 @@ var searchData= [ - ['hex8cvfem_2ec_814',['Hex8CVFEM.C',['../_hex8_c_v_f_e_m_8_c.html',1,'']]], - ['hex8fem_2ec_815',['Hex8FEM.C',['../_hex8_f_e_m_8_c.html',1,'']]], - ['hexnelementdescription_2ec_816',['HexNElementDescription.C',['../_hex_n_element_description_8_c.html',1,'']]], - ['hypredirectsolver_2ec_817',['HypreDirectSolver.C',['../_hypre_direct_solver_8_c.html',1,'']]], - ['hyprelinearsolverconfig_2ec_818',['HypreLinearSolverConfig.C',['../_hypre_linear_solver_config_8_c.html',1,'']]], - ['hyprelinearsystem_2ec_819',['HypreLinearSystem.C',['../_hypre_linear_system_8_c.html',1,'']]], - ['hypreuvwlinearsystem_2ec_820',['HypreUVWLinearSystem.C',['../_hypre_u_v_w_linear_system_8_c.html',1,'']]], - ['hypreuvwsolver_2ec_821',['HypreUVWSolver.C',['../_hypre_u_v_w_solver_8_c.html',1,'']]] + ['hex8cvfem_2ec_816',['Hex8CVFEM.C',['../_hex8_c_v_f_e_m_8_c.html',1,'']]], + ['hex8fem_2ec_817',['Hex8FEM.C',['../_hex8_f_e_m_8_c.html',1,'']]], + ['hexnelementdescription_2ec_818',['HexNElementDescription.C',['../_hex_n_element_description_8_c.html',1,'']]], + ['hypredirectsolver_2ec_819',['HypreDirectSolver.C',['../_hypre_direct_solver_8_c.html',1,'']]], + ['hyprelinearsolverconfig_2ec_820',['HypreLinearSolverConfig.C',['../_hypre_linear_solver_config_8_c.html',1,'']]], + ['hyprelinearsystem_2ec_821',['HypreLinearSystem.C',['../_hypre_linear_system_8_c.html',1,'']]], + ['hypreuvwlinearsystem_2ec_822',['HypreUVWLinearSystem.C',['../_hypre_u_v_w_linear_system_8_c.html',1,'']]], + ['hypreuvwsolver_2ec_823',['HypreUVWSolver.C',['../_hypre_u_v_w_solver_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_8.js b/api_docs/search/files_8.js index cc78302ff..4ae9f8426 100644 --- a/api_docs/search/files_8.js +++ b/api_docs/search/files_8.js @@ -1,8 +1,8 @@ var searchData= [ - ['idealgaspropertyevaluator_2ec_822',['IdealGasPropertyEvaluator.C',['../_ideal_gas_property_evaluator_8_c.html',1,'']]], - ['initialconditions_2ec_823',['InitialConditions.C',['../_initial_conditions_8_c.html',1,'']]], - ['inputoutputrealm_2ec_824',['InputOutputRealm.C',['../_input_output_realm_8_c.html',1,'']]], - ['inversedualvolumepropalgorithm_2ec_825',['InverseDualVolumePropAlgorithm.C',['../_inverse_dual_volume_prop_algorithm_8_c.html',1,'']]], - ['inversepropalgorithm_2ec_826',['InversePropAlgorithm.C',['../_inverse_prop_algorithm_8_c.html',1,'']]] + ['idealgaspropertyevaluator_2ec_824',['IdealGasPropertyEvaluator.C',['../_ideal_gas_property_evaluator_8_c.html',1,'']]], + ['initialconditions_2ec_825',['InitialConditions.C',['../_initial_conditions_8_c.html',1,'']]], + ['inputoutputrealm_2ec_826',['InputOutputRealm.C',['../_input_output_realm_8_c.html',1,'']]], + ['inversedualvolumepropalgorithm_2ec_827',['InverseDualVolumePropAlgorithm.C',['../_inverse_dual_volume_prop_algorithm_8_c.html',1,'']]], + ['inversepropalgorithm_2ec_828',['InversePropAlgorithm.C',['../_inverse_prop_algorithm_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_9.js b/api_docs/search/files_9.js index f8a2ee938..65df516d2 100644 --- a/api_docs/search/files_9.js +++ b/api_docs/search/files_9.js @@ -1,6 +1,6 @@ var searchData= [ - ['kernelbuilderlog_2ec_827',['KernelBuilderLog.C',['../_kernel_builder_log_8_c.html',1,'']]], - ['kovasznaypressureauxfunction_2ec_828',['KovasznayPressureAuxFunction.C',['../_kovasznay_pressure_aux_function_8_c.html',1,'']]], - ['kovasznayvelocityauxfunction_2ec_829',['KovasznayVelocityAuxFunction.C',['../_kovasznay_velocity_aux_function_8_c.html',1,'']]] + ['kernelbuilderlog_2ec_829',['KernelBuilderLog.C',['../_kernel_builder_log_8_c.html',1,'']]], + ['kovasznaypressureauxfunction_2ec_830',['KovasznayPressureAuxFunction.C',['../_kovasznay_pressure_aux_function_8_c.html',1,'']]], + ['kovasznayvelocityauxfunction_2ec_831',['KovasznayVelocityAuxFunction.C',['../_kovasznay_velocity_aux_function_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_a.js b/api_docs/search/files_a.js index 03fe8a231..f4535c40f 100644 --- a/api_docs/search/files_a.js +++ b/api_docs/search/files_a.js @@ -1,21 +1,21 @@ var searchData= [ - ['lidarpatterns_2ec_830',['LidarPatterns.C',['../_lidar_patterns_8_c.html',1,'']]], - ['linearadvectionmetric_2ec_831',['LinearAdvectionMetric.C',['../_linear_advection_metric_8_c.html',1,'']]], - ['linearareas_2ec_832',['LinearAreas.C',['../_linear_areas_8_c.html',1,'']]], - ['lineardiffusionmetric_2ec_833',['LinearDiffusionMetric.C',['../_linear_diffusion_metric_8_c.html',1,'']]], - ['linearexposedareas_2ec_834',['LinearExposedAreas.C',['../_linear_exposed_areas_8_c.html',1,'']]], - ['linearpropalgorithm_2ec_835',['LinearPropAlgorithm.C',['../_linear_prop_algorithm_8_c.html',1,'']]], - ['linearsolver_2ec_836',['LinearSolver.C',['../_linear_solver_8_c.html',1,'']]], - ['linearsolverconfig_2ec_837',['LinearSolverConfig.C',['../_linear_solver_config_8_c.html',1,'']]], - ['linearsolvers_2ec_838',['LinearSolvers.C',['../_linear_solvers_8_c.html',1,'']]], - ['linearsystem_2ec_839',['LinearSystem.C',['../_linear_system_8_c.html',1,'']]], - ['linearvolume_2ec_840',['LinearVolume.C',['../_linear_volume_8_c.html',1,'']]], - ['lobattoquadraturerule_2ec_841',['LobattoQuadratureRule.C',['../_lobatto_quadrature_rule_8_c.html',1,'']]], - ['localdualnodalvolume_2ec_842',['LocalDualNodalVolume.C',['../_local_dual_nodal_volume_8_c.html',1,'']]], - ['localvolumesearch_2ec_843',['LocalVolumeSearch.C',['../_local_volume_search_8_c.html',1,'']]], - ['lowmachequationsystem_2ec_844',['LowMachEquationSystem.C',['../_low_mach_equation_system_8_c.html',1,'']]], - ['lowmachfields_2ec_845',['LowMachFields.C',['../_low_mach_fields_8_c.html',1,'']]], - ['lowmachgatheredfieldmanager_2ec_846',['LowMachGatheredFieldManager.C',['../_low_mach_gathered_field_manager_8_c.html',1,'']]], - ['lowmachupdate_2ec_847',['LowMachUpdate.C',['../_low_mach_update_8_c.html',1,'']]] + ['lidarpatterns_2ec_832',['LidarPatterns.C',['../_lidar_patterns_8_c.html',1,'']]], + ['linearadvectionmetric_2ec_833',['LinearAdvectionMetric.C',['../_linear_advection_metric_8_c.html',1,'']]], + ['linearareas_2ec_834',['LinearAreas.C',['../_linear_areas_8_c.html',1,'']]], + ['lineardiffusionmetric_2ec_835',['LinearDiffusionMetric.C',['../_linear_diffusion_metric_8_c.html',1,'']]], + ['linearexposedareas_2ec_836',['LinearExposedAreas.C',['../_linear_exposed_areas_8_c.html',1,'']]], + ['linearpropalgorithm_2ec_837',['LinearPropAlgorithm.C',['../_linear_prop_algorithm_8_c.html',1,'']]], + ['linearsolver_2ec_838',['LinearSolver.C',['../_linear_solver_8_c.html',1,'']]], + ['linearsolverconfig_2ec_839',['LinearSolverConfig.C',['../_linear_solver_config_8_c.html',1,'']]], + ['linearsolvers_2ec_840',['LinearSolvers.C',['../_linear_solvers_8_c.html',1,'']]], + ['linearsystem_2ec_841',['LinearSystem.C',['../_linear_system_8_c.html',1,'']]], + ['linearvolume_2ec_842',['LinearVolume.C',['../_linear_volume_8_c.html',1,'']]], + ['lobattoquadraturerule_2ec_843',['LobattoQuadratureRule.C',['../_lobatto_quadrature_rule_8_c.html',1,'']]], + ['localdualnodalvolume_2ec_844',['LocalDualNodalVolume.C',['../_local_dual_nodal_volume_8_c.html',1,'']]], + ['localvolumesearch_2ec_845',['LocalVolumeSearch.C',['../_local_volume_search_8_c.html',1,'']]], + ['lowmachequationsystem_2ec_846',['LowMachEquationSystem.C',['../_low_mach_equation_system_8_c.html',1,'']]], + ['lowmachfields_2ec_847',['LowMachFields.C',['../_low_mach_fields_8_c.html',1,'']]], + ['lowmachgatheredfieldmanager_2ec_848',['LowMachGatheredFieldManager.C',['../_low_mach_gathered_field_manager_8_c.html',1,'']]], + ['lowmachupdate_2ec_849',['LowMachUpdate.C',['../_low_mach_update_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_b.js b/api_docs/search/files_b.js index 3fb4a8225..6721ebb66 100644 --- a/api_docs/search/files_b.js +++ b/api_docs/search/files_b.js @@ -1,58 +1,58 @@ var searchData= [ - ['mapload_2ec_848',['MapLoad.C',['../_map_load_8_c.html',1,'']]], - ['masterelement_2ec_849',['MasterElement.C',['../_master_element_8_c.html',1,'']]], - ['masterelementrepo_2ec_850',['MasterElementRepo.C',['../_master_element_repo_8_c.html',1,'']]], - ['materialproperty_2ec_851',['MaterialProperty.C',['../_material_property_8_c.html',1,'']]], - ['materialpropertydata_2ec_852',['MaterialPropertyData.C',['../_material_property_data_8_c.html',1,'']]], - ['materialpropertys_2ec_853',['MaterialPropertys.C',['../_material_propertys_8_c.html',1,'']]], - ['matrixfreeheatcondequationsystem_2ec_854',['MatrixFreeHeatCondEquationSystem.C',['../_matrix_free_heat_cond_equation_system_8_c.html',1,'']]], - ['matrixfreelowmachequationsystem_2ec_855',['MatrixFreeLowMachEquationSystem.C',['../_matrix_free_low_mach_equation_system_8_c.html',1,'']]], - ['matrixfreesolver_2ec_856',['MatrixFreeSolver.C',['../_matrix_free_solver_8_c.html',1,'']]], - ['maxcourantreynolds_2ec_857',['MaxCourantReynolds.C',['../_max_courant_reynolds_8_c.html',1,'']]], - ['mdotalgdriver_2ec_858',['MdotAlgDriver.C',['../_mdot_alg_driver_8_c.html',1,'']]], - ['mdotdensityaccumalg_2ec_859',['MdotDensityAccumAlg.C',['../_mdot_density_accum_alg_8_c.html',1,'']]], - ['mdotedgealg_2ec_860',['MdotEdgeAlg.C',['../_mdot_edge_alg_8_c.html',1,'']]], - ['mdotinflowalg_2ec_861',['MdotInflowAlg.C',['../_mdot_inflow_alg_8_c.html',1,'']]], - ['mdotopencorrectoralg_2ec_862',['MdotOpenCorrectorAlg.C',['../_mdot_open_corrector_alg_8_c.html',1,'']]], - ['mdotopenedgealg_2ec_863',['MdotOpenEdgeAlg.C',['../_mdot_open_edge_alg_8_c.html',1,'']]], - ['meshmotionalg_2ec_864',['MeshMotionAlg.C',['../_mesh_motion_alg_8_c.html',1,'']]], - ['meshtransformationalg_2ec_865',['MeshTransformationAlg.C',['../_mesh_transformation_alg_8_c.html',1,'']]], - ['meshvelocityalg_2ec_866',['MeshVelocityAlg.C',['../_mesh_velocity_alg_8_c.html',1,'']]], - ['meshvelocityedgealg_2ec_867',['MeshVelocityEdgeAlg.C',['../_mesh_velocity_edge_alg_8_c.html',1,'']]], - ['metrictensorelemalg_2ec_868',['MetricTensorElemAlg.C',['../_metric_tensor_elem_alg_8_c.html',1,'']]], - ['momentumablforcenodekernel_2ec_869',['MomentumABLForceNodeKernel.C',['../_momentum_a_b_l_force_node_kernel_8_c.html',1,'']]], - ['momentumablwallfuncedgekernel_2ec_870',['MomentumABLWallFuncEdgeKernel.C',['../_momentum_a_b_l_wall_func_edge_kernel_8_c.html',1,'']]], - ['momentumablwallfuncmaskutil_2ec_871',['MomentumABLWallFuncMaskUtil.C',['../_momentum_a_b_l_wall_func_mask_util_8_c.html',1,'']]], - ['momentumablwallshearstressedgekernel_2ec_872',['MomentumABLWallShearStressEdgeKernel.C',['../_momentum_a_b_l_wall_shear_stress_edge_kernel_8_c.html',1,'']]], - ['momentumactuatornodekernel_2ec_873',['MomentumActuatorNodeKernel.C',['../_momentum_actuator_node_kernel_8_c.html',1,'']]], - ['momentumbodyforceboxnodekernel_2ec_874',['MomentumBodyForceBoxNodeKernel.C',['../_momentum_body_force_box_node_kernel_8_c.html',1,'']]], - ['momentumbodyforcenodekernel_2ec_875',['MomentumBodyForceNodeKernel.C',['../_momentum_body_force_node_kernel_8_c.html',1,'']]], - ['momentumboussinesqnodekernel_2ec_876',['MomentumBoussinesqNodeKernel.C',['../_momentum_boussinesq_node_kernel_8_c.html',1,'']]], - ['momentumboussinesqrasrcnodesuppalg_2ec_877',['MomentumBoussinesqRASrcNodeSuppAlg.C',['../_momentum_boussinesq_r_a_src_node_supp_alg_8_c.html',1,'']]], - ['momentumbuoyancynodekernel_2ec_878',['MomentumBuoyancyNodeKernel.C',['../_momentum_buoyancy_node_kernel_8_c.html',1,'']]], - ['momentumbuoyancysrcnodesuppalg_2ec_879',['MomentumBuoyancySrcNodeSuppAlg.C',['../_momentum_buoyancy_src_node_supp_alg_8_c.html',1,'']]], - ['momentumcoriolisnodekernel_2ec_880',['MomentumCoriolisNodeKernel.C',['../_momentum_coriolis_node_kernel_8_c.html',1,'']]], - ['momentumdiagonal_2ec_881',['MomentumDiagonal.C',['../_momentum_diagonal_8_c.html',1,'']]], - ['momentumedgepecletalg_2ec_882',['MomentumEdgePecletAlg.C',['../_momentum_edge_peclet_alg_8_c.html',1,'']]], - ['momentumedgesolveralg_2ec_883',['MomentumEdgeSolverAlg.C',['../_momentum_edge_solver_alg_8_c.html',1,'']]], - ['momentumgclnodekernel_2ec_884',['MomentumGclNodeKernel.C',['../_momentum_gcl_node_kernel_8_c.html',1,'']]], - ['momentuminterior_2ec_885',['MomentumInterior.C',['../_momentum_interior_8_c.html',1,'']]], - ['momentumjacobi_2ec_886',['MomentumJacobi.C',['../_momentum_jacobi_8_c.html',1,'']]], - ['momentummassbdfnodekernel_2ec_887',['MomentumMassBDFNodeKernel.C',['../_momentum_mass_b_d_f_node_kernel_8_c.html',1,'']]], - ['momentumopenadvdiffelemkernel_2ec_888',['MomentumOpenAdvDiffElemKernel.C',['../_momentum_open_adv_diff_elem_kernel_8_c.html',1,'']]], - ['momentumopenedgekernel_2ec_889',['MomentumOpenEdgeKernel.C',['../_momentum_open_edge_kernel_8_c.html',1,'']]], - ['momentumoperator_2ec_890',['MomentumOperator.C',['../_momentum_operator_8_c.html',1,'']]], - ['momentumsolutionupdate_2ec_891',['MomentumSolutionUpdate.C',['../_momentum_solution_update_8_c.html',1,'']]], - ['momentumsstamsdiffedgekernel_2ec_892',['MomentumSSTAMSDiffEdgeKernel.C',['../_momentum_s_s_t_a_m_s_diff_edge_kernel_8_c.html',1,'']]], - ['momentumsstamsforcingnodekernel_2ec_893',['MomentumSSTAMSForcingNodeKernel.C',['../_momentum_s_s_t_a_m_s_forcing_node_kernel_8_c.html',1,'']]], - ['momentumsymmetryedgekernel_2ec_894',['MomentumSymmetryEdgeKernel.C',['../_momentum_symmetry_edge_kernel_8_c.html',1,'']]], - ['momentumsymmetryelemkernel_2ec_895',['MomentumSymmetryElemKernel.C',['../_momentum_symmetry_elem_kernel_8_c.html',1,'']]], - ['momentumwallfunctionelemkernel_2ec_896',['MomentumWallFunctionElemKernel.C',['../_momentum_wall_function_elem_kernel_8_c.html',1,'']]], - ['motiondeforminginteriorkernel_2ec_897',['MotionDeformingInteriorKernel.C',['../_motion_deforming_interior_kernel_8_c.html',1,'']]], - ['motionrotationkernel_2ec_898',['MotionRotationKernel.C',['../_motion_rotation_kernel_8_c.html',1,'']]], - ['motionscalingkernel_2ec_899',['MotionScalingKernel.C',['../_motion_scaling_kernel_8_c.html',1,'']]], - ['motiontranslationkernel_2ec_900',['MotionTranslationKernel.C',['../_motion_translation_kernel_8_c.html',1,'']]], - ['motionwaveskernel_2ec_901',['MotionWavesKernel.C',['../_motion_waves_kernel_8_c.html',1,'']]], - ['movingaveragepostprocessor_2ec_902',['MovingAveragePostProcessor.C',['../_moving_average_post_processor_8_c.html',1,'']]] + ['mapload_2ec_850',['MapLoad.C',['../_map_load_8_c.html',1,'']]], + ['masterelement_2ec_851',['MasterElement.C',['../_master_element_8_c.html',1,'']]], + ['masterelementrepo_2ec_852',['MasterElementRepo.C',['../_master_element_repo_8_c.html',1,'']]], + ['materialproperty_2ec_853',['MaterialProperty.C',['../_material_property_8_c.html',1,'']]], + ['materialpropertydata_2ec_854',['MaterialPropertyData.C',['../_material_property_data_8_c.html',1,'']]], + ['materialpropertys_2ec_855',['MaterialPropertys.C',['../_material_propertys_8_c.html',1,'']]], + ['matrixfreeheatcondequationsystem_2ec_856',['MatrixFreeHeatCondEquationSystem.C',['../_matrix_free_heat_cond_equation_system_8_c.html',1,'']]], + ['matrixfreelowmachequationsystem_2ec_857',['MatrixFreeLowMachEquationSystem.C',['../_matrix_free_low_mach_equation_system_8_c.html',1,'']]], + ['matrixfreesolver_2ec_858',['MatrixFreeSolver.C',['../_matrix_free_solver_8_c.html',1,'']]], + ['maxcourantreynolds_2ec_859',['MaxCourantReynolds.C',['../_max_courant_reynolds_8_c.html',1,'']]], + ['mdotalgdriver_2ec_860',['MdotAlgDriver.C',['../_mdot_alg_driver_8_c.html',1,'']]], + ['mdotdensityaccumalg_2ec_861',['MdotDensityAccumAlg.C',['../_mdot_density_accum_alg_8_c.html',1,'']]], + ['mdotedgealg_2ec_862',['MdotEdgeAlg.C',['../_mdot_edge_alg_8_c.html',1,'']]], + ['mdotinflowalg_2ec_863',['MdotInflowAlg.C',['../_mdot_inflow_alg_8_c.html',1,'']]], + ['mdotopencorrectoralg_2ec_864',['MdotOpenCorrectorAlg.C',['../_mdot_open_corrector_alg_8_c.html',1,'']]], + ['mdotopenedgealg_2ec_865',['MdotOpenEdgeAlg.C',['../_mdot_open_edge_alg_8_c.html',1,'']]], + ['meshmotionalg_2ec_866',['MeshMotionAlg.C',['../_mesh_motion_alg_8_c.html',1,'']]], + ['meshtransformationalg_2ec_867',['MeshTransformationAlg.C',['../_mesh_transformation_alg_8_c.html',1,'']]], + ['meshvelocityalg_2ec_868',['MeshVelocityAlg.C',['../_mesh_velocity_alg_8_c.html',1,'']]], + ['meshvelocityedgealg_2ec_869',['MeshVelocityEdgeAlg.C',['../_mesh_velocity_edge_alg_8_c.html',1,'']]], + ['metrictensorelemalg_2ec_870',['MetricTensorElemAlg.C',['../_metric_tensor_elem_alg_8_c.html',1,'']]], + ['momentumablforcenodekernel_2ec_871',['MomentumABLForceNodeKernel.C',['../_momentum_a_b_l_force_node_kernel_8_c.html',1,'']]], + ['momentumablwallfuncedgekernel_2ec_872',['MomentumABLWallFuncEdgeKernel.C',['../_momentum_a_b_l_wall_func_edge_kernel_8_c.html',1,'']]], + ['momentumablwallfuncmaskutil_2ec_873',['MomentumABLWallFuncMaskUtil.C',['../_momentum_a_b_l_wall_func_mask_util_8_c.html',1,'']]], + ['momentumablwallshearstressedgekernel_2ec_874',['MomentumABLWallShearStressEdgeKernel.C',['../_momentum_a_b_l_wall_shear_stress_edge_kernel_8_c.html',1,'']]], + ['momentumactuatornodekernel_2ec_875',['MomentumActuatorNodeKernel.C',['../_momentum_actuator_node_kernel_8_c.html',1,'']]], + ['momentumbodyforceboxnodekernel_2ec_876',['MomentumBodyForceBoxNodeKernel.C',['../_momentum_body_force_box_node_kernel_8_c.html',1,'']]], + ['momentumbodyforcenodekernel_2ec_877',['MomentumBodyForceNodeKernel.C',['../_momentum_body_force_node_kernel_8_c.html',1,'']]], + ['momentumboussinesqnodekernel_2ec_878',['MomentumBoussinesqNodeKernel.C',['../_momentum_boussinesq_node_kernel_8_c.html',1,'']]], + ['momentumboussinesqrasrcnodesuppalg_2ec_879',['MomentumBoussinesqRASrcNodeSuppAlg.C',['../_momentum_boussinesq_r_a_src_node_supp_alg_8_c.html',1,'']]], + ['momentumbuoyancynodekernel_2ec_880',['MomentumBuoyancyNodeKernel.C',['../_momentum_buoyancy_node_kernel_8_c.html',1,'']]], + ['momentumbuoyancysrcnodesuppalg_2ec_881',['MomentumBuoyancySrcNodeSuppAlg.C',['../_momentum_buoyancy_src_node_supp_alg_8_c.html',1,'']]], + ['momentumcoriolisnodekernel_2ec_882',['MomentumCoriolisNodeKernel.C',['../_momentum_coriolis_node_kernel_8_c.html',1,'']]], + ['momentumdiagonal_2ec_883',['MomentumDiagonal.C',['../_momentum_diagonal_8_c.html',1,'']]], + ['momentumedgepecletalg_2ec_884',['MomentumEdgePecletAlg.C',['../_momentum_edge_peclet_alg_8_c.html',1,'']]], + ['momentumedgesolveralg_2ec_885',['MomentumEdgeSolverAlg.C',['../_momentum_edge_solver_alg_8_c.html',1,'']]], + ['momentumgclnodekernel_2ec_886',['MomentumGclNodeKernel.C',['../_momentum_gcl_node_kernel_8_c.html',1,'']]], + ['momentuminterior_2ec_887',['MomentumInterior.C',['../_momentum_interior_8_c.html',1,'']]], + ['momentumjacobi_2ec_888',['MomentumJacobi.C',['../_momentum_jacobi_8_c.html',1,'']]], + ['momentummassbdfnodekernel_2ec_889',['MomentumMassBDFNodeKernel.C',['../_momentum_mass_b_d_f_node_kernel_8_c.html',1,'']]], + ['momentumopenadvdiffelemkernel_2ec_890',['MomentumOpenAdvDiffElemKernel.C',['../_momentum_open_adv_diff_elem_kernel_8_c.html',1,'']]], + ['momentumopenedgekernel_2ec_891',['MomentumOpenEdgeKernel.C',['../_momentum_open_edge_kernel_8_c.html',1,'']]], + ['momentumoperator_2ec_892',['MomentumOperator.C',['../_momentum_operator_8_c.html',1,'']]], + ['momentumsolutionupdate_2ec_893',['MomentumSolutionUpdate.C',['../_momentum_solution_update_8_c.html',1,'']]], + ['momentumsstamsdiffedgekernel_2ec_894',['MomentumSSTAMSDiffEdgeKernel.C',['../_momentum_s_s_t_a_m_s_diff_edge_kernel_8_c.html',1,'']]], + ['momentumsstamsforcingnodekernel_2ec_895',['MomentumSSTAMSForcingNodeKernel.C',['../_momentum_s_s_t_a_m_s_forcing_node_kernel_8_c.html',1,'']]], + ['momentumsymmetryedgekernel_2ec_896',['MomentumSymmetryEdgeKernel.C',['../_momentum_symmetry_edge_kernel_8_c.html',1,'']]], + ['momentumsymmetryelemkernel_2ec_897',['MomentumSymmetryElemKernel.C',['../_momentum_symmetry_elem_kernel_8_c.html',1,'']]], + ['momentumwallfunctionelemkernel_2ec_898',['MomentumWallFunctionElemKernel.C',['../_momentum_wall_function_elem_kernel_8_c.html',1,'']]], + ['motiondeforminginteriorkernel_2ec_899',['MotionDeformingInteriorKernel.C',['../_motion_deforming_interior_kernel_8_c.html',1,'']]], + ['motionrotationkernel_2ec_900',['MotionRotationKernel.C',['../_motion_rotation_kernel_8_c.html',1,'']]], + ['motionscalingkernel_2ec_901',['MotionScalingKernel.C',['../_motion_scaling_kernel_8_c.html',1,'']]], + ['motiontranslationkernel_2ec_902',['MotionTranslationKernel.C',['../_motion_translation_kernel_8_c.html',1,'']]], + ['motionwaveskernel_2ec_903',['MotionWavesKernel.C',['../_motion_waves_kernel_8_c.html',1,'']]], + ['movingaveragepostprocessor_2ec_904',['MovingAveragePostProcessor.C',['../_moving_average_post_processor_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_c.js b/api_docs/search/files_c.js index 0c1da09ed..f4bb2b470 100644 --- a/api_docs/search/files_c.js +++ b/api_docs/search/files_c.js @@ -1,16 +1,16 @@ var searchData= [ - ['naluenv_2ec_903',['NaluEnv.C',['../_nalu_env_8_c.html',1,'']]], - ['naluparsing_2ec_904',['NaluParsing.C',['../_nalu_parsing_8_c.html',1,'']]], - ['ngpalgdriver_2ec_905',['NgpAlgDriver.C',['../_ngp_alg_driver_8_c.html',1,'']]], - ['nodalbuoyancyalgdriver_2ec_906',['NodalBuoyancyAlgDriver.C',['../_nodal_buoyancy_alg_driver_8_c.html',1,'']]], - ['nodalgradalgdriver_2ec_907',['NodalGradAlgDriver.C',['../_nodal_grad_alg_driver_8_c.html',1,'']]], - ['nodalgradbndryelemalg_2ec_908',['NodalGradBndryElemAlg.C',['../_nodal_grad_bndry_elem_alg_8_c.html',1,'']]], - ['nodalgradedgealg_2ec_909',['NodalGradEdgeAlg.C',['../_nodal_grad_edge_alg_8_c.html',1,'']]], - ['nodalgradelemalg_2ec_910',['NodalGradElemAlg.C',['../_nodal_grad_elem_alg_8_c.html',1,'']]], - ['nodalgradpopenboundaryalg_2ec_911',['NodalGradPOpenBoundaryAlg.C',['../_nodal_grad_p_open_boundary_alg_8_c.html',1,'']]], - ['nodemapmaker_2ec_912',['NodeMapMaker.C',['../_node_map_maker_8_c.html',1,'']]], - ['nodeordermap_2ec_913',['NodeOrderMap.C',['../_node_order_map_8_c.html',1,'']]], - ['nonconformalinfo_2ec_914',['NonConformalInfo.C',['../_non_conformal_info_8_c.html',1,'']]], - ['nonconformalmanager_2ec_915',['NonConformalManager.C',['../_non_conformal_manager_8_c.html',1,'']]] + ['naluenv_2ec_905',['NaluEnv.C',['../_nalu_env_8_c.html',1,'']]], + ['naluparsing_2ec_906',['NaluParsing.C',['../_nalu_parsing_8_c.html',1,'']]], + ['ngpalgdriver_2ec_907',['NgpAlgDriver.C',['../_ngp_alg_driver_8_c.html',1,'']]], + ['nodalbuoyancyalgdriver_2ec_908',['NodalBuoyancyAlgDriver.C',['../_nodal_buoyancy_alg_driver_8_c.html',1,'']]], + ['nodalgradalgdriver_2ec_909',['NodalGradAlgDriver.C',['../_nodal_grad_alg_driver_8_c.html',1,'']]], + ['nodalgradbndryelemalg_2ec_910',['NodalGradBndryElemAlg.C',['../_nodal_grad_bndry_elem_alg_8_c.html',1,'']]], + ['nodalgradedgealg_2ec_911',['NodalGradEdgeAlg.C',['../_nodal_grad_edge_alg_8_c.html',1,'']]], + ['nodalgradelemalg_2ec_912',['NodalGradElemAlg.C',['../_nodal_grad_elem_alg_8_c.html',1,'']]], + ['nodalgradpopenboundaryalg_2ec_913',['NodalGradPOpenBoundaryAlg.C',['../_nodal_grad_p_open_boundary_alg_8_c.html',1,'']]], + ['nodemapmaker_2ec_914',['NodeMapMaker.C',['../_node_map_maker_8_c.html',1,'']]], + ['nodeordermap_2ec_915',['NodeOrderMap.C',['../_node_order_map_8_c.html',1,'']]], + ['nonconformalinfo_2ec_916',['NonConformalInfo.C',['../_non_conformal_info_8_c.html',1,'']]], + ['nonconformalmanager_2ec_917',['NonConformalManager.C',['../_non_conformal_manager_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_d.js b/api_docs/search/files_d.js index 87b72bf85..09cfe8b35 100644 --- a/api_docs/search/files_d.js +++ b/api_docs/search/files_d.js @@ -1,11 +1,11 @@ var searchData= [ - ['onetwotenvelocityauxfunction_2ec_916',['OneTwoTenVelocityAuxFunction.C',['../_one_two_ten_velocity_aux_function_8_c.html',1,'']]], - ['openfastfsi_2ec_917',['OpenfastFSI.C',['../_openfast_f_s_i_8_c.html',1,'']]], - ['outputinfo_2ec_918',['OutputInfo.C',['../_output_info_8_c.html',1,'']]], - ['overset_5futils_2ec_919',['overset_utils.C',['../overset__utils_8_c.html',1,'']]], - ['oversetconstraintbase_2ec_920',['OversetConstraintBase.C',['../_overset_constraint_base_8_c.html',1,'']]], - ['oversetinfo_2ec_921',['OversetInfo.C',['../_overset_info_8_c.html',1,'']]], - ['oversetmanager_2ec_922',['OversetManager.C',['../_overset_manager_8_c.html',1,'']]], - ['oversetmanagertioga_2ec_923',['OversetManagerTIOGA.C',['../_overset_manager_t_i_o_g_a_8_c.html',1,'']]] + ['onetwotenvelocityauxfunction_2ec_918',['OneTwoTenVelocityAuxFunction.C',['../_one_two_ten_velocity_aux_function_8_c.html',1,'']]], + ['openfastfsi_2ec_919',['OpenfastFSI.C',['../_openfast_f_s_i_8_c.html',1,'']]], + ['outputinfo_2ec_920',['OutputInfo.C',['../_output_info_8_c.html',1,'']]], + ['overset_5futils_2ec_921',['overset_utils.C',['../overset__utils_8_c.html',1,'']]], + ['oversetconstraintbase_2ec_922',['OversetConstraintBase.C',['../_overset_constraint_base_8_c.html',1,'']]], + ['oversetinfo_2ec_923',['OversetInfo.C',['../_overset_info_8_c.html',1,'']]], + ['oversetmanager_2ec_924',['OversetManager.C',['../_overset_manager_8_c.html',1,'']]], + ['oversetmanagertioga_2ec_925',['OversetManagerTIOGA.C',['../_overset_manager_t_i_o_g_a_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_e.js b/api_docs/search/files_e.js index 04a8aa251..9a90a6f4b 100644 --- a/api_docs/search/files_e.js +++ b/api_docs/search/files_e.js @@ -1,14 +1,14 @@ var searchData= [ - ['pecletfunction_2ec_924',['PecletFunction.C',['../_peclet_function_8_c.html',1,'']]], - ['periodicmanager_2ec_925',['PeriodicManager.C',['../_periodic_manager_8_c.html',1,'']]], - ['perturbedshearlayerauxfunctions_2ec_926',['PerturbedShearLayerAuxFunctions.C',['../_perturbed_shear_layer_aux_functions_8_c.html',1,'']]], - ['polynomialpropertyevaluator_2ec_927',['PolynomialPropertyEvaluator.C',['../_polynomial_property_evaluator_8_c.html',1,'']]], - ['postprocessinginfo_2ec_928',['PostProcessingInfo.C',['../_post_processing_info_8_c.html',1,'']]], - ['projectednodalgradientequationsystem_2ec_929',['ProjectedNodalGradientEquationSystem.C',['../_projected_nodal_gradient_equation_system_8_c.html',1,'']]], - ['promotedelementio_2ec_930',['PromotedElementIO.C',['../_promoted_element_i_o_8_c.html',1,'']]], - ['promotedparthelper_2ec_931',['PromotedPartHelper.C',['../_promoted_part_helper_8_c.html',1,'']]], - ['promoteelement_2ec_932',['PromoteElement.C',['../_promote_element_8_c.html',1,'']]], - ['promoteelementimpl_2ec_933',['PromoteElementImpl.C',['../_promote_element_impl_8_c.html',1,'']]], - ['pyr5cvfem_2ec_934',['Pyr5CVFEM.C',['../_pyr5_c_v_f_e_m_8_c.html',1,'']]] + ['pecletfunction_2ec_926',['PecletFunction.C',['../_peclet_function_8_c.html',1,'']]], + ['periodicmanager_2ec_927',['PeriodicManager.C',['../_periodic_manager_8_c.html',1,'']]], + ['perturbedshearlayerauxfunctions_2ec_928',['PerturbedShearLayerAuxFunctions.C',['../_perturbed_shear_layer_aux_functions_8_c.html',1,'']]], + ['polynomialpropertyevaluator_2ec_929',['PolynomialPropertyEvaluator.C',['../_polynomial_property_evaluator_8_c.html',1,'']]], + ['postprocessinginfo_2ec_930',['PostProcessingInfo.C',['../_post_processing_info_8_c.html',1,'']]], + ['projectednodalgradientequationsystem_2ec_931',['ProjectedNodalGradientEquationSystem.C',['../_projected_nodal_gradient_equation_system_8_c.html',1,'']]], + ['promotedelementio_2ec_932',['PromotedElementIO.C',['../_promoted_element_i_o_8_c.html',1,'']]], + ['promotedparthelper_2ec_933',['PromotedPartHelper.C',['../_promoted_part_helper_8_c.html',1,'']]], + ['promoteelement_2ec_934',['PromoteElement.C',['../_promote_element_8_c.html',1,'']]], + ['promoteelementimpl_2ec_935',['PromoteElementImpl.C',['../_promote_element_impl_8_c.html',1,'']]], + ['pyr5cvfem_2ec_936',['Pyr5CVFEM.C',['../_pyr5_c_v_f_e_m_8_c.html',1,'']]] ]; diff --git a/api_docs/search/files_f.js b/api_docs/search/files_f.js index 9fabaa7aa..47e484c01 100644 --- a/api_docs/search/files_f.js +++ b/api_docs/search/files_f.js @@ -1,6 +1,6 @@ var searchData= [ - ['quad42dcvfem_2ec_935',['Quad42DCVFEM.C',['../_quad42_d_c_v_f_e_m_8_c.html',1,'']]], - ['quad43dcvfem_2ec_936',['Quad43DCVFEM.C',['../_quad43_d_c_v_f_e_m_8_c.html',1,'']]], - ['quadnelementdescription_2ec_937',['QuadNElementDescription.C',['../_quad_n_element_description_8_c.html',1,'']]] + ['quad42dcvfem_2ec_937',['Quad42DCVFEM.C',['../_quad42_d_c_v_f_e_m_8_c.html',1,'']]], + ['quad43dcvfem_2ec_938',['Quad43DCVFEM.C',['../_quad43_d_c_v_f_e_m_8_c.html',1,'']]], + ['quadnelementdescription_2ec_939',['QuadNElementDescription.C',['../_quad_n_element_description_8_c.html',1,'']]] ]; diff --git a/api_docs/search/functions_0.js b/api_docs/search/functions_0.js index c807e15ad..2e1cfa699 100644 --- a/api_docs/search/functions_0.js +++ b/api_docs/search/functions_0.js @@ -1,23 +1,23 @@ var searchData= [ - ['actfastcacherelativevelocities_1074',['ActFastCacheRelativeVelocities',['../namespacesierra_1_1nalu.html#ac1692683b8b4900699ba56c19e230de9',1,'sierra::nalu']]], - ['actsimplecomputeforce_1075',['ActSimpleComputeForce',['../namespacesierra_1_1nalu.html#a679a196d283de747af42379962975d51',1,'sierra::nalu']]], - ['actsimplecomputerelativevelocity_1076',['ActSimpleComputeRelativeVelocity',['../namespacesierra_1_1nalu.html#a7a01dfc7f5b6a122d2c673141d0aed36',1,'sierra::nalu']]], - ['actsimplewritetofile_1077',['ActSimpleWriteToFile',['../namespacesierra_1_1nalu.html#af43d7ea472bcdbd3aa9c2f3d50f62814',1,'sierra::nalu']]], - ['actuator_5ffast_5fparse_1078',['actuator_FAST_parse',['../namespacesierra_1_1nalu.html#a232347e25a369e2a9d69399395d7595a',1,'sierra::nalu']]], - ['actuator_5finstance_5fparse_1079',['actuator_instance_parse',['../namespacesierra_1_1nalu.html#a61ffd7e575003875dbf245fb51f85763',1,'sierra::nalu']]], - ['actuator_5fparse_1080',['actuator_parse',['../namespacesierra_1_1nalu.html#a3639fe1d8b9b9bc9aee0b830a01f4821',1,'sierra::nalu']]], - ['actuator_5fsimple_5fparse_1081',['actuator_Simple_parse',['../namespacesierra_1_1nalu.html#aafaab75ec2020ae04b48437d6c327ddb',1,'sierra::nalu']]], - ['add_5fbase_5fnodes_5fto_5felem_5fconnectivity_1082',['add_base_nodes_to_elem_connectivity',['../namespacesierra_1_1nalu_1_1impl.html#ae6720cbaa235cf567e575fed546715f6',1,'sierra::nalu::impl']]], - ['add_5fdownward_5frelations_1083',['add_downward_relations',['../namespacesierra_1_1nalu.html#a71949810b9e3121e9c8d71aa37667572',1,'sierra::nalu']]], - ['add_5fedge_5fnodes_5fto_5felem_5fconnectivity_1084',['add_edge_nodes_to_elem_connectivity',['../namespacesierra_1_1nalu_1_1impl.html#ab6e844ba25fa300615b6eaff4fbd2f76',1,'sierra::nalu::impl']]], - ['add_5fface_5fnodes_5fto_5felem_5fconnectivity_1085',['add_face_nodes_to_elem_connectivity',['../namespacesierra_1_1nalu_1_1impl.html#a2f8faed9ca3979d3ab77ad6ed5cfe711',1,'sierra::nalu::impl']]], - ['add_5flengths_5fto_5fcomm_1086',['add_lengths_to_comm',['../namespacesierra_1_1nalu.html#a0cdeed18f0820cfa7ac7dfac2b6c85e1',1,'sierra::nalu']]], - ['add_5flengths_5fto_5fcomm_5ftpet_1087',['add_lengths_to_comm_tpet',['../namespacesierra_1_1nalu.html#a143b376259b5ee45e58509009a8a29e6',1,'sierra::nalu']]], - ['add_5fprocs_5fto_5fneighbors_1088',['add_procs_to_neighbors',['../namespacesierra_1_1nalu.html#a5a1b448ba4d0327cff98958fcdcd8dd1',1,'sierra::nalu']]], - ['add_5frange_5fnodes_5fto_5fsharers_5fof_5fdomain_5fnodes_1089',['add_range_nodes_to_sharers_of_domain_nodes',['../namespacesierra_1_1nalu.html#ad80f3b5523ad4b9c8fb18d479f3a3bb1',1,'sierra::nalu']]], - ['add_5fto_5flength_1090',['add_to_length',['../namespacesierra_1_1nalu.html#a3637f70b19142ef9e3b96310c78b2c51',1,'sierra::nalu']]], - ['add_5ftpetra_5fsolution_5fvector_5fto_5fstk_5ffield_1091',['add_tpetra_solution_vector_to_stk_field',['../namespacesierra_1_1nalu_1_1matrix__free.html#af43c52b701c4da9e539dea4b855eec2e',1,'sierra::nalu::matrix_free']]], - ['add_5fvolume_5fnodes_5fto_5felem_5fconnectivity_1092',['add_volume_nodes_to_elem_connectivity',['../namespacesierra_1_1nalu_1_1impl.html#af79fec6d9feee480ee40e19c7cd8af97',1,'sierra::nalu::impl']]], - ['adjust_5flhs_5frow_1093',['adjust_lhs_row',['../namespacesierra_1_1nalu.html#a88c25820400bff64c6f27c4154d57e1a',1,'sierra::nalu']]] + ['actfastcacherelativevelocities_1078',['ActFastCacheRelativeVelocities',['../namespacesierra_1_1nalu.html#ac1692683b8b4900699ba56c19e230de9',1,'sierra::nalu']]], + ['actsimplecomputeforce_1079',['ActSimpleComputeForce',['../namespacesierra_1_1nalu.html#a679a196d283de747af42379962975d51',1,'sierra::nalu']]], + ['actsimplecomputerelativevelocity_1080',['ActSimpleComputeRelativeVelocity',['../namespacesierra_1_1nalu.html#a7a01dfc7f5b6a122d2c673141d0aed36',1,'sierra::nalu']]], + ['actsimplewritetofile_1081',['ActSimpleWriteToFile',['../namespacesierra_1_1nalu.html#af43d7ea472bcdbd3aa9c2f3d50f62814',1,'sierra::nalu']]], + ['actuator_5ffast_5fparse_1082',['actuator_FAST_parse',['../namespacesierra_1_1nalu.html#a232347e25a369e2a9d69399395d7595a',1,'sierra::nalu']]], + ['actuator_5finstance_5fparse_1083',['actuator_instance_parse',['../namespacesierra_1_1nalu.html#a61ffd7e575003875dbf245fb51f85763',1,'sierra::nalu']]], + ['actuator_5fparse_1084',['actuator_parse',['../namespacesierra_1_1nalu.html#a3639fe1d8b9b9bc9aee0b830a01f4821',1,'sierra::nalu']]], + ['actuator_5fsimple_5fparse_1085',['actuator_Simple_parse',['../namespacesierra_1_1nalu.html#aafaab75ec2020ae04b48437d6c327ddb',1,'sierra::nalu']]], + ['add_5fbase_5fnodes_5fto_5felem_5fconnectivity_1086',['add_base_nodes_to_elem_connectivity',['../namespacesierra_1_1nalu_1_1impl.html#ae6720cbaa235cf567e575fed546715f6',1,'sierra::nalu::impl']]], + ['add_5fdownward_5frelations_1087',['add_downward_relations',['../namespacesierra_1_1nalu.html#a71949810b9e3121e9c8d71aa37667572',1,'sierra::nalu']]], + ['add_5fedge_5fnodes_5fto_5felem_5fconnectivity_1088',['add_edge_nodes_to_elem_connectivity',['../namespacesierra_1_1nalu_1_1impl.html#ab6e844ba25fa300615b6eaff4fbd2f76',1,'sierra::nalu::impl']]], + ['add_5fface_5fnodes_5fto_5felem_5fconnectivity_1089',['add_face_nodes_to_elem_connectivity',['../namespacesierra_1_1nalu_1_1impl.html#a2f8faed9ca3979d3ab77ad6ed5cfe711',1,'sierra::nalu::impl']]], + ['add_5flengths_5fto_5fcomm_1090',['add_lengths_to_comm',['../namespacesierra_1_1nalu.html#a0cdeed18f0820cfa7ac7dfac2b6c85e1',1,'sierra::nalu']]], + ['add_5flengths_5fto_5fcomm_5ftpet_1091',['add_lengths_to_comm_tpet',['../namespacesierra_1_1nalu.html#a143b376259b5ee45e58509009a8a29e6',1,'sierra::nalu']]], + ['add_5fprocs_5fto_5fneighbors_1092',['add_procs_to_neighbors',['../namespacesierra_1_1nalu.html#a5a1b448ba4d0327cff98958fcdcd8dd1',1,'sierra::nalu']]], + ['add_5frange_5fnodes_5fto_5fsharers_5fof_5fdomain_5fnodes_1093',['add_range_nodes_to_sharers_of_domain_nodes',['../namespacesierra_1_1nalu.html#ad80f3b5523ad4b9c8fb18d479f3a3bb1',1,'sierra::nalu']]], + ['add_5fto_5flength_1094',['add_to_length',['../namespacesierra_1_1nalu.html#a3637f70b19142ef9e3b96310c78b2c51',1,'sierra::nalu']]], + ['add_5ftpetra_5fsolution_5fvector_5fto_5fstk_5ffield_1095',['add_tpetra_solution_vector_to_stk_field',['../namespacesierra_1_1nalu_1_1matrix__free.html#af43c52b701c4da9e539dea4b855eec2e',1,'sierra::nalu::matrix_free']]], + ['add_5fvolume_5fnodes_5fto_5felem_5fconnectivity_1096',['add_volume_nodes_to_elem_connectivity',['../namespacesierra_1_1nalu_1_1impl.html#af79fec6d9feee480ee40e19c7cd8af97',1,'sierra::nalu::impl']]], + ['adjust_5flhs_5frow_1097',['adjust_lhs_row',['../namespacesierra_1_1nalu.html#a88c25820400bff64c6f27c4154d57e1a',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_1.js b/api_docs/search/functions_1.js index 5a24970b5..50ec9e632 100644 --- a/api_docs/search/functions_1.js +++ b/api_docs/search/functions_1.js @@ -1,12 +1,12 @@ var searchData= [ - ['base_5fedge_5fparts_1094',['base_edge_parts',['../namespacesierra_1_1nalu.html#a1f197e3ddd7939dcc177eedddb4cc0a8',1,'sierra::nalu']]], - ['base_5felem_5fpart_5ffrom_5fsuper_5felem_5fpart_1095',['base_elem_part_from_super_elem_part',['../namespacesierra_1_1nalu.html#ae2678832a137f389335a78bebc306faf',1,'sierra::nalu']]], - ['base_5felem_5fparts_1096',['base_elem_parts',['../namespacesierra_1_1nalu.html#a141d17ca3bfe130ca7faacb18aa82ea2',1,'sierra::nalu']]], - ['base_5felement_5fpart_5fname_1097',['base_element_part_name',['../namespacesierra_1_1nalu.html#ab8d054e0cab2b8bbae47f2b6115c4fd5',1,'sierra::nalu']]], - ['base_5fface_5fparts_1098',['base_face_parts',['../namespacesierra_1_1nalu.html#ae175c0d1ed220bef8ba13832d7b77740',1,'sierra::nalu']]], - ['base_5franked_5fparts_1099',['base_ranked_parts',['../namespacesierra_1_1nalu.html#a04a9d43df3d14892774b75dfff49d200',1,'sierra::nalu']]], - ['bind_5fif_5fvalid_1100',['bind_if_valid',['../namespacesierra_1_1nalu.html#afe352e4f165ff8d0a41ece6d54bbd14f',1,'sierra::nalu']]], - ['blade_5fbelongs_5fon_5fthis_5frank_1101',['blade_belongs_on_this_rank',['../namespacesierra_1_1nalu.html#ab3de774b18e8cd2952adfa39ca3f3e51',1,'sierra::nalu']]], - ['bucket_5floop_1102',['bucket_loop',['../namespacesierra_1_1nalu_1_1impl.html#a5f7feae85c7bb1d1ea63af8fc4d07f88',1,'sierra::nalu::impl']]] + ['base_5fedge_5fparts_1098',['base_edge_parts',['../namespacesierra_1_1nalu.html#a1f197e3ddd7939dcc177eedddb4cc0a8',1,'sierra::nalu']]], + ['base_5felem_5fpart_5ffrom_5fsuper_5felem_5fpart_1099',['base_elem_part_from_super_elem_part',['../namespacesierra_1_1nalu.html#ae2678832a137f389335a78bebc306faf',1,'sierra::nalu']]], + ['base_5felem_5fparts_1100',['base_elem_parts',['../namespacesierra_1_1nalu.html#a141d17ca3bfe130ca7faacb18aa82ea2',1,'sierra::nalu']]], + ['base_5felement_5fpart_5fname_1101',['base_element_part_name',['../namespacesierra_1_1nalu.html#ab8d054e0cab2b8bbae47f2b6115c4fd5',1,'sierra::nalu']]], + ['base_5fface_5fparts_1102',['base_face_parts',['../namespacesierra_1_1nalu.html#ae175c0d1ed220bef8ba13832d7b77740',1,'sierra::nalu']]], + ['base_5franked_5fparts_1103',['base_ranked_parts',['../namespacesierra_1_1nalu.html#a04a9d43df3d14892774b75dfff49d200',1,'sierra::nalu']]], + ['bind_5fif_5fvalid_1104',['bind_if_valid',['../namespacesierra_1_1nalu.html#afe352e4f165ff8d0a41ece6d54bbd14f',1,'sierra::nalu']]], + ['blade_5fbelongs_5fon_5fthis_5frank_1105',['blade_belongs_on_this_rank',['../namespacesierra_1_1nalu.html#ab3de774b18e8cd2952adfa39ca3f3e51',1,'sierra::nalu']]], + ['bucket_5floop_1106',['bucket_loop',['../namespacesierra_1_1nalu_1_1impl.html#a5f7feae85c7bb1d1ea63af8fc4d07f88',1,'sierra::nalu::impl']]] ]; diff --git a/api_docs/search/functions_10.js b/api_docs/search/functions_10.js index 92f0b2447..c7d388659 100644 --- a/api_docs/search/functions_10.js +++ b/api_docs/search/functions_10.js @@ -1,11 +1,11 @@ var searchData= [ - ['radau_5frule_1244',['radau_rule',['../namespacesierra_1_1nalu_1_1details.html#ad951330ee91d95a4f7fcab39f7c3ed42',1,'sierra::nalu::details']]], - ['register_5fbc_1245',['register_bc',['../namespacesierra_1_1nalu.html#a16867da3a1cae5f50cb9c160cf3621e6',1,'sierra::nalu']]], - ['registry_1246',['Registry',['../namespacesierra_1_1nalu.html#af4910e77b479bd4308f3802301e2a1f5',1,'sierra::nalu']]], - ['regularize_5fapex_1247',['regularize_apex',['../namespacesierra_1_1nalu.html#a7f4de7580297109eae74b22cfcb958d5',1,'sierra::nalu']]], - ['remove_5finvalid_5findices_1248',['remove_invalid_indices',['../namespacesierra_1_1nalu.html#a5a86f33c0ca9a9dffc3c2ddc521becf6',1,'sierra::nalu']]], - ['reset_5frow_1249',['reset_row',['../namespacesierra_1_1nalu.html#ade34fe071f32533fe554ff620e8c8a5c',1,'sierra::nalu']]], - ['reset_5frows_1250',['reset_rows',['../namespacesierra_1_1nalu.html#a35f6da7042e54a52ccf97612c8a06232',1,'sierra::nalu']]], - ['resize_5fstd_5fvector_1251',['resize_std_vector',['../namespacesierra_1_1nalu_1_1actuator__utils.html#a9751c1d77051750a9cc72196e2d6db1a',1,'sierra::nalu::actuator_utils']]] + ['radau_5frule_1248',['radau_rule',['../namespacesierra_1_1nalu_1_1details.html#ad951330ee91d95a4f7fcab39f7c3ed42',1,'sierra::nalu::details']]], + ['register_5fbc_1249',['register_bc',['../namespacesierra_1_1nalu.html#a16867da3a1cae5f50cb9c160cf3621e6',1,'sierra::nalu']]], + ['registry_1250',['Registry',['../namespacesierra_1_1nalu.html#af4910e77b479bd4308f3802301e2a1f5',1,'sierra::nalu']]], + ['regularize_5fapex_1251',['regularize_apex',['../namespacesierra_1_1nalu.html#a7f4de7580297109eae74b22cfcb958d5',1,'sierra::nalu']]], + ['remove_5finvalid_5findices_1252',['remove_invalid_indices',['../namespacesierra_1_1nalu.html#a5a86f33c0ca9a9dffc3c2ddc521becf6',1,'sierra::nalu']]], + ['reset_5frow_1253',['reset_row',['../namespacesierra_1_1nalu.html#ade34fe071f32533fe554ff620e8c8a5c',1,'sierra::nalu']]], + ['reset_5frows_1254',['reset_rows',['../namespacesierra_1_1nalu.html#a35f6da7042e54a52ccf97612c8a06232',1,'sierra::nalu']]], + ['resize_5fstd_5fvector_1255',['resize_std_vector',['../namespacesierra_1_1nalu_1_1actuator__utils.html#a9751c1d77051750a9cc72196e2d6db1a',1,'sierra::nalu::actuator_utils']]] ]; diff --git a/api_docs/search/functions_11.js b/api_docs/search/functions_11.js index 0b62f38d0..1a0117fcf 100644 --- a/api_docs/search/functions_11.js +++ b/api_docs/search/functions_11.js @@ -1,25 +1,25 @@ var searchData= [ - ['segment_5fgenerator_5ftypes_1252',['segment_generator_types',['../namespacesierra_1_1nalu.html#afe6914cbd0c47cab470ae033c0e79862',1,'sierra::nalu']]], - ['segregated_5fsum_5finto_1253',['segregated_sum_into',['../namespacesierra_1_1nalu.html#a66c7314e9ef8ef936ff591d2e7452477',1,'sierra::nalu']]], - ['segregated_5fsum_5finto_5frow_1254',['segregated_sum_into_row',['../namespacesierra_1_1nalu.html#ab41515299d1eb18ba72688670d53e912',1,'sierra::nalu']]], - ['set_5fcoordinates_5fhex_1255',['set_coordinates_hex',['../namespacesierra_1_1nalu_1_1impl.html#a79cf64aafa6c5ca90f1e229e3ab1a64c',1,'sierra::nalu::impl']]], - ['shifted_5fpyr_5fderiv_1256',['shifted_pyr_deriv',['../namespacesierra_1_1nalu.html#a477cfc57bed160caf9c5613600c20cb5',1,'sierra::nalu']]], - ['simd_5fnode_5fmap_1257',['simd_node_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#abf8f0341cb023a69e37eb7961b6d97ab',1,'sierra::nalu::matrix_free']]], - ['simd_5fnode_5foffsets_1258',['simd_node_offsets',['../namespacesierra_1_1nalu_1_1matrix__free.html#a0820e6b1161c4c9b2888acebd8cfe1bf',1,'sierra::nalu::matrix_free']]], - ['sort_5fconnections_1259',['sort_connections',['../namespacesierra_1_1nalu.html#a88a2b25ab79b3ffe2c9e770e914deb1e',1,'sierra::nalu']]], - ['sortintlowhigh_1260',['sortIntLowHigh',['../structsierra_1_1nalu_1_1sort_int_low_high.html#a9a70ff93faba136fc58637399a5f58eb',1,'sierra::nalu::sortIntLowHigh']]], - ['spherical_5fcap_5fquadrature_1261',['spherical_cap_quadrature',['../namespacesierra_1_1nalu_1_1details.html#ac76c7eac0ae85b27e6b95f54361b932d',1,'sierra::nalu::details']]], - ['spherical_5fcap_5fradau_1262',['spherical_cap_radau',['../namespacesierra_1_1nalu_1_1details.html#aa741aef68c579dca57a7fa09412afc32',1,'sierra::nalu::details']]], - ['spherical_5fcap_5ftruncated_5fnormal_1263',['spherical_cap_truncated_normal',['../namespacesierra_1_1nalu_1_1details.html#a846f30d76c79bdeba662e227b83b1685',1,'sierra::nalu::details']]], - ['stk_5fedge_5findex_1264',['stk_edge_index',['../namespacesierra_1_1nalu.html#acdb2abaa493a9e12e8b0f860b9472df4',1,'sierra::nalu']]], - ['sum_5finto_1265',['sum_into',['../namespacesierra_1_1nalu.html#a8bfd9d89cd1b349a145d1e5921ef64b5',1,'sierra::nalu']]], - ['sum_5finto_5frow_1266',['sum_into_row',['../namespacesierra_1_1nalu.html#a6107340a2a7f2cf2ff643f5438ea06cf',1,'sierra::nalu']]], - ['sum_5finto_5frow_5fvec_5f3_1267',['sum_into_row_vec_3',['../namespacesierra_1_1nalu.html#a45348c785e27f57ce7428d86b2d87304',1,'sierra::nalu']]], - ['super_5felem_5fpart_1268',['super_elem_part',['../namespacesierra_1_1nalu.html#afe88de34b5c31f6d37f05f18d1b88aa2',1,'sierra::nalu::super_elem_part(const stk::mesh::Part &part)'],['../namespacesierra_1_1nalu.html#a7f01979bc505724e60559e5e1b603be4',1,'sierra::nalu::super_elem_part(const stk::mesh::Part *part)']]], - ['super_5felem_5fpart_5fvector_1269',['super_elem_part_vector',['../namespacesierra_1_1nalu.html#a11fbf627b180dcaaf227ddb72654fc58',1,'sierra::nalu']]], - ['super_5felement_5fpart_5fname_1270',['super_element_part_name',['../namespacesierra_1_1nalu.html#ac100c11650a55c3106aa4586fbb1bac7',1,'sierra::nalu']]], - ['super_5felement_5fsuffix_1271',['super_element_suffix',['../namespacesierra_1_1nalu.html#a4a8a61c2894c4a7f84534811814c6d07',1,'sierra::nalu']]], - ['super_5fsubset_5fpart_1272',['super_subset_part',['../namespacesierra_1_1nalu.html#a36782be0268c132b9998bde2dffb15de',1,'sierra::nalu::super_subset_part(const stk::mesh::Part &part, int numElemNodes, int numSideNodes)'],['../namespacesierra_1_1nalu.html#a3ccf279ec1c5b969b4ee5f92a2926c5f',1,'sierra::nalu::super_subset_part(const stk::mesh::Part &part)']]], - ['super_5fsubset_5fpart_5fname_1273',['super_subset_part_name',['../namespacesierra_1_1nalu.html#a3e6cc8344aa85a8f0e4590fcd91132b6',1,'sierra::nalu::super_subset_part_name(std::string base_name)'],['../namespacesierra_1_1nalu.html#a86f1b88cf795773b533056731e5a8b49',1,'sierra::nalu::super_subset_part_name(std::string base_name, int, int)']]] + ['segment_5fgenerator_5ftypes_1256',['segment_generator_types',['../namespacesierra_1_1nalu.html#afe6914cbd0c47cab470ae033c0e79862',1,'sierra::nalu']]], + ['segregated_5fsum_5finto_1257',['segregated_sum_into',['../namespacesierra_1_1nalu.html#a66c7314e9ef8ef936ff591d2e7452477',1,'sierra::nalu']]], + ['segregated_5fsum_5finto_5frow_1258',['segregated_sum_into_row',['../namespacesierra_1_1nalu.html#ab41515299d1eb18ba72688670d53e912',1,'sierra::nalu']]], + ['set_5fcoordinates_5fhex_1259',['set_coordinates_hex',['../namespacesierra_1_1nalu_1_1impl.html#a79cf64aafa6c5ca90f1e229e3ab1a64c',1,'sierra::nalu::impl']]], + ['shifted_5fpyr_5fderiv_1260',['shifted_pyr_deriv',['../namespacesierra_1_1nalu.html#a477cfc57bed160caf9c5613600c20cb5',1,'sierra::nalu']]], + ['simd_5fnode_5fmap_1261',['simd_node_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#abf8f0341cb023a69e37eb7961b6d97ab',1,'sierra::nalu::matrix_free']]], + ['simd_5fnode_5foffsets_1262',['simd_node_offsets',['../namespacesierra_1_1nalu_1_1matrix__free.html#a0820e6b1161c4c9b2888acebd8cfe1bf',1,'sierra::nalu::matrix_free']]], + ['sort_5fconnections_1263',['sort_connections',['../namespacesierra_1_1nalu.html#a88a2b25ab79b3ffe2c9e770e914deb1e',1,'sierra::nalu']]], + ['sortintlowhigh_1264',['sortIntLowHigh',['../structsierra_1_1nalu_1_1sort_int_low_high.html#a9a70ff93faba136fc58637399a5f58eb',1,'sierra::nalu::sortIntLowHigh']]], + ['spherical_5fcap_5fquadrature_1265',['spherical_cap_quadrature',['../namespacesierra_1_1nalu_1_1details.html#ac76c7eac0ae85b27e6b95f54361b932d',1,'sierra::nalu::details']]], + ['spherical_5fcap_5fradau_1266',['spherical_cap_radau',['../namespacesierra_1_1nalu_1_1details.html#aa741aef68c579dca57a7fa09412afc32',1,'sierra::nalu::details']]], + ['spherical_5fcap_5ftruncated_5fnormal_1267',['spherical_cap_truncated_normal',['../namespacesierra_1_1nalu_1_1details.html#a846f30d76c79bdeba662e227b83b1685',1,'sierra::nalu::details']]], + ['stk_5fedge_5findex_1268',['stk_edge_index',['../namespacesierra_1_1nalu.html#acdb2abaa493a9e12e8b0f860b9472df4',1,'sierra::nalu']]], + ['sum_5finto_1269',['sum_into',['../namespacesierra_1_1nalu.html#a8bfd9d89cd1b349a145d1e5921ef64b5',1,'sierra::nalu']]], + ['sum_5finto_5frow_1270',['sum_into_row',['../namespacesierra_1_1nalu.html#a6107340a2a7f2cf2ff643f5438ea06cf',1,'sierra::nalu']]], + ['sum_5finto_5frow_5fvec_5f3_1271',['sum_into_row_vec_3',['../namespacesierra_1_1nalu.html#a45348c785e27f57ce7428d86b2d87304',1,'sierra::nalu']]], + ['super_5felem_5fpart_1272',['super_elem_part',['../namespacesierra_1_1nalu.html#afe88de34b5c31f6d37f05f18d1b88aa2',1,'sierra::nalu::super_elem_part(const stk::mesh::Part &part)'],['../namespacesierra_1_1nalu.html#a7f01979bc505724e60559e5e1b603be4',1,'sierra::nalu::super_elem_part(const stk::mesh::Part *part)']]], + ['super_5felem_5fpart_5fvector_1273',['super_elem_part_vector',['../namespacesierra_1_1nalu.html#a11fbf627b180dcaaf227ddb72654fc58',1,'sierra::nalu']]], + ['super_5felement_5fpart_5fname_1274',['super_element_part_name',['../namespacesierra_1_1nalu.html#ac100c11650a55c3106aa4586fbb1bac7',1,'sierra::nalu']]], + ['super_5felement_5fsuffix_1275',['super_element_suffix',['../namespacesierra_1_1nalu.html#a4a8a61c2894c4a7f84534811814c6d07',1,'sierra::nalu']]], + ['super_5fsubset_5fpart_1276',['super_subset_part',['../namespacesierra_1_1nalu.html#a36782be0268c132b9998bde2dffb15de',1,'sierra::nalu::super_subset_part(const stk::mesh::Part &part, int numElemNodes, int numSideNodes)'],['../namespacesierra_1_1nalu.html#a3ccf279ec1c5b969b4ee5f92a2926c5f',1,'sierra::nalu::super_subset_part(const stk::mesh::Part &part)']]], + ['super_5fsubset_5fpart_5fname_1277',['super_subset_part_name',['../namespacesierra_1_1nalu.html#a3e6cc8344aa85a8f0e4590fcd91132b6',1,'sierra::nalu::super_subset_part_name(std::string base_name)'],['../namespacesierra_1_1nalu.html#a86f1b88cf795773b533056731e5a8b49',1,'sierra::nalu::super_subset_part_name(std::string base_name, int, int)']]] ]; diff --git a/api_docs/search/functions_12.js b/api_docs/search/functions_12.js index b14a99af0..b9e672fc8 100644 --- a/api_docs/search/functions_12.js +++ b/api_docs/search/functions_12.js @@ -1,11 +1,11 @@ var searchData= [ - ['tensor_5fedge_5findex_1274',['tensor_edge_index',['../namespacesierra_1_1nalu.html#a725d5c4f0bccdb772c28011a92f1208b',1,'sierra::nalu']]], - ['tet_5fderiv_1275',['tet_deriv',['../namespacesierra_1_1nalu.html#a7b08fb1709c3b1d6abfd014581f6ed0f',1,'sierra::nalu']]], - ['tet_5fgradient_5foperator_1276',['tet_gradient_operator',['../namespacesierra_1_1nalu.html#a9c7d7f8645564e7ae68042f79e770640',1,'sierra::nalu']]], - ['teuchos_5fcommunicator_1277',['teuchos_communicator',['../namespacesierra_1_1nalu_1_1matrix__free.html#a5809942d00cbae736134dd3f476c4966',1,'sierra::nalu::matrix_free']]], - ['transform_5fto_5fsuper_5felem_5fpart_5fvector_1278',['transform_to_super_elem_part_vector',['../namespacesierra_1_1nalu.html#a18137dc89b0a5ab4e49951d85cd32e63',1,'sierra::nalu']]], - ['tri_5fderivative_1279',['tri_derivative',['../namespacesierra_1_1nalu.html#a164c8906b260dfb3898250a1a83b2561',1,'sierra::nalu']]], - ['tri_5fgradient_5foperator_1280',['tri_gradient_operator',['../namespacesierra_1_1nalu.html#a856bf14876fdfa0ecfa747b6e351bf6a',1,'sierra::nalu']]], - ['truncated_5fnormal_5frule_1281',['truncated_normal_rule',['../namespacesierra_1_1nalu_1_1details.html#ad92400b7977b34f8382f03d0196dfaeb',1,'sierra::nalu::details']]] + ['tensor_5fedge_5findex_1278',['tensor_edge_index',['../namespacesierra_1_1nalu.html#a725d5c4f0bccdb772c28011a92f1208b',1,'sierra::nalu']]], + ['tet_5fderiv_1279',['tet_deriv',['../namespacesierra_1_1nalu.html#a7b08fb1709c3b1d6abfd014581f6ed0f',1,'sierra::nalu']]], + ['tet_5fgradient_5foperator_1280',['tet_gradient_operator',['../namespacesierra_1_1nalu.html#a9c7d7f8645564e7ae68042f79e770640',1,'sierra::nalu']]], + ['teuchos_5fcommunicator_1281',['teuchos_communicator',['../namespacesierra_1_1nalu_1_1matrix__free.html#a5809942d00cbae736134dd3f476c4966',1,'sierra::nalu::matrix_free']]], + ['transform_5fto_5fsuper_5felem_5fpart_5fvector_1282',['transform_to_super_elem_part_vector',['../namespacesierra_1_1nalu.html#a18137dc89b0a5ab4e49951d85cd32e63',1,'sierra::nalu']]], + ['tri_5fderivative_1283',['tri_derivative',['../namespacesierra_1_1nalu.html#a164c8906b260dfb3898250a1a83b2561',1,'sierra::nalu']]], + ['tri_5fgradient_5foperator_1284',['tri_gradient_operator',['../namespacesierra_1_1nalu.html#a856bf14876fdfa0ecfa747b6e351bf6a',1,'sierra::nalu']]], + ['truncated_5fnormal_5frule_1285',['truncated_normal_rule',['../namespacesierra_1_1nalu_1_1details.html#ad92400b7977b34f8382f03d0196dfaeb',1,'sierra::nalu::details']]] ]; diff --git a/api_docs/search/functions_13.js b/api_docs/search/functions_13.js index 1185c1b4f..03a75abb6 100644 --- a/api_docs/search/functions_13.js +++ b/api_docs/search/functions_13.js @@ -1,6 +1,6 @@ var searchData= [ - ['wed_5fderiv_1282',['wed_deriv',['../namespacesierra_1_1nalu.html#a72895cea697be2883b53061b7fb097f8',1,'sierra::nalu']]], - ['wed_5fgradient_5foperator_1283',['wed_gradient_operator',['../namespacesierra_1_1nalu.html#a6251d183410b252ff345179c0dd1b549',1,'sierra::nalu']]], - ['wed_5fshape_5ffcn_1284',['wed_shape_fcn',['../namespacesierra_1_1nalu.html#a6e721b7894636853c3e3f0ada05ba99c',1,'sierra::nalu']]] + ['wed_5fderiv_1286',['wed_deriv',['../namespacesierra_1_1nalu.html#a72895cea697be2883b53061b7fb097f8',1,'sierra::nalu']]], + ['wed_5fgradient_5foperator_1287',['wed_gradient_operator',['../namespacesierra_1_1nalu.html#a6251d183410b252ff345179c0dd1b549',1,'sierra::nalu']]], + ['wed_5fshape_5ffcn_1288',['wed_shape_fcn',['../namespacesierra_1_1nalu.html#a6e721b7894636853c3e3f0ada05ba99c',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_2.js b/api_docs/search/functions_2.js index 8193b271b..7cb3d8472 100644 --- a/api_docs/search/functions_2.js +++ b/api_docs/search/functions_2.js @@ -1,31 +1,31 @@ var searchData= [ - ['case_5finsensitive_5fcompare_1103',['case_insensitive_compare',['../namespacesierra_1_1nalu.html#ab82a71a55ab4b1cedc735ef78c0cf264',1,'sierra::nalu']]], - ['check_5fnc_5ferror_1104',['check_nc_error',['../namespacesierra_1_1nalu.html#a1bcf097790b4d2784df09f393d5e3e9f',1,'sierra::nalu::check_nc_error(int code, std::string msg)'],['../namespacesierra_1_1nalu.html#a0fe2a89beadd74719902e62b68b94ad1',1,'sierra::nalu::check_nc_error(int code)']]], - ['check_5fpart_5ftopo_1105',['check_part_topo',['../namespacesierra_1_1nalu.html#a57a66749dab4c3b9180a654b3cc9eae4',1,'sierra::nalu']]], - ['check_5fparts_5ffor_5fpromotion_1106',['check_parts_for_promotion',['../namespacesierra_1_1nalu.html#ad54057fa64930d07c770ea5fefa2a44f',1,'sierra::nalu']]], - ['choose_5fconsistent_5fnode_5fid_1107',['choose_consistent_node_id',['../namespacesierra_1_1nalu_1_1impl.html#a9e51eaddbf8b8e4f51b90b8e7f43d86a',1,'sierra::nalu::impl']]], - ['communicate_5fremote_5fcolumns_1108',['communicate_remote_columns',['../namespacesierra_1_1nalu.html#ad776c7e2f15ce17bf3558c5eab2c0060',1,'sierra::nalu']]], - ['communicate_5fto_5ffill_5frecv_5fghosts_5fto_5fremove_1109',['communicate_to_fill_recv_ghosts_to_remove',['../namespacesierra_1_1nalu.html#ad97dc42972bc269f7ca420b78867434d',1,'sierra::nalu']]], - ['compareentitybyid_1110',['CompareEntityById',['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#a0621eea0aa495029a8ad619b30cadcac',1,'sierra::nalu::CompareEntityById::CompareEntityById(const stk::mesh::BulkData &mesh, const GlobalIdFieldType *naluGlobalId)'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#a0621eea0aa495029a8ad619b30cadcac',1,'sierra::nalu::CompareEntityById::CompareEntityById(const stk::mesh::BulkData &mesh, const GlobalIdFieldType *naluGlobalId)']]], - ['compareentityequalbyid_1111',['CompareEntityEqualById',['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#af2642d56b598f0a07d5b5445f8463ee8',1,'sierra::nalu::CompareEntityEqualById::CompareEntityEqualById(const stk::mesh::BulkData &mesh, const GlobalIdFieldType *naluGlobalId)'],['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#af2642d56b598f0a07d5b5445f8463ee8',1,'sierra::nalu::CompareEntityEqualById::CompareEntityEqualById(const stk::mesh::BulkData &mesh, const GlobalIdFieldType *naluGlobalId)']]], - ['comparegausspoint_1112',['compareGaussPoint',['../structsierra_1_1nalu_1_1compare_gauss_point.html#ac6fea39464ed0f6efe630424a98ed40a',1,'sierra::nalu::compareGaussPoint']]], - ['compute_5fblade_5fdistributions_1113',['compute_blade_distributions',['../namespacesierra_1_1nalu.html#a4b8e844556f136441dbb890831162dab',1,'sierra::nalu']]], - ['compute_5fdistance_1114',['compute_distance',['../namespacesierra_1_1nalu_1_1actuator__utils.html#ac262e48180befd40abaf4184d672cf2b',1,'sierra::nalu::actuator_utils']]], - ['compute_5fedge_5fscalar_5fdivergence_1115',['compute_edge_scalar_divergence',['../namespacesierra_1_1nalu.html#a87405a5dbc3e64111f03df280c97b753',1,'sierra::nalu']]], - ['compute_5fprecise_5fghosting_5flists_1116',['compute_precise_ghosting_lists',['../namespacesierra_1_1nalu.html#ac3e81534bcd56a6e57d5ebac9ee71fde',1,'sierra::nalu']]], - ['compute_5fscalar_5fdivergence_1117',['compute_scalar_divergence',['../namespacesierra_1_1nalu.html#aca0a4bc68f8e151f17b8cf04ccc4d8e7',1,'sierra::nalu']]], - ['compute_5fvector_5fdivergence_1118',['compute_vector_divergence',['../namespacesierra_1_1nalu.html#aed5c82caca42e7b46ae7914b73d5bf30',1,'sierra::nalu']]], - ['compute_5fvolumes_1119',['compute_volumes',['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a364b6dd2b3f63b2a11c695f866dfe23d',1,'sierra::nalu::matrix_free::impl']]], - ['connectivity_5fmap_5ffor_5fparent_5frank_1120',['connectivity_map_for_parent_rank',['../namespacesierra_1_1nalu_1_1impl.html#ae322d93cd193a8f860de86f1b1888bfb',1,'sierra::nalu::impl']]], - ['copy_5fstk_5ffield_5fto_5fowned_5ftpetra_5fvector_1121',['copy_stk_field_to_owned_tpetra_vector',['../namespacesierra_1_1nalu_1_1matrix__free.html#a6a6f1747a0e27332510c6324d21297e1',1,'sierra::nalu::matrix_free']]], - ['count_5fentities_1122',['count_entities',['../namespacesierra_1_1nalu.html#af38891f26fa334dee9e63c41e492020e',1,'sierra::nalu']]], - ['create_5fboundary_5felements_1123',['create_boundary_elements',['../namespacesierra_1_1nalu_1_1impl.html#affbc37cb56394242a0f3d9d195c53530',1,'sierra::nalu::impl']]], - ['create_5fnodes_5ffor_5fconnectivity_5fmap_1124',['create_nodes_for_connectivity_map',['../namespacesierra_1_1nalu_1_1impl.html#ad615df17fdff8073a61c58bcac4f9bc5',1,'sierra::nalu::impl']]], - ['create_5fpromoted_5fboundary_5felements_1125',['create_promoted_boundary_elements',['../namespacesierra_1_1nalu_1_1promotion.html#a4ab6c79bff4e60d3dd324d0604361c8c',1,'sierra::nalu::promotion']]], - ['create_5fsuper_5felements_1126',['create_super_elements',['../namespacesierra_1_1nalu_1_1impl.html#af4775e0bdab10edd0e8bbb01b0ebbfd5',1,'sierra::nalu::impl']]], - ['create_5ftensor_5fproduct_5fhex_5felements_1127',['create_tensor_product_hex_elements',['../namespacesierra_1_1nalu_1_1promotion.html#a2b7b3c46f5e31b59bae02a14db5acd12',1,'sierra::nalu::promotion']]], - ['createboundingspheres_1128',['CreateBoundingSpheres',['../namespacesierra_1_1nalu.html#a4ef79789ca90427a2ab8289398ebbc80',1,'sierra::nalu']]], - ['createelementboxes_1129',['CreateElementBoxes',['../namespacesierra_1_1nalu.html#abd20d9fd079a0957922b76c28d90826c',1,'sierra::nalu']]], - ['cross_1130',['cross',['../namespacesierra_1_1nalu.html#ab7d645bc5d1eb4671d757f06185256e9',1,'sierra::nalu']]] + ['case_5finsensitive_5fcompare_1107',['case_insensitive_compare',['../namespacesierra_1_1nalu.html#ab82a71a55ab4b1cedc735ef78c0cf264',1,'sierra::nalu']]], + ['check_5fnc_5ferror_1108',['check_nc_error',['../namespacesierra_1_1nalu.html#a1bcf097790b4d2784df09f393d5e3e9f',1,'sierra::nalu::check_nc_error(int code, std::string msg)'],['../namespacesierra_1_1nalu.html#a0fe2a89beadd74719902e62b68b94ad1',1,'sierra::nalu::check_nc_error(int code)']]], + ['check_5fpart_5ftopo_1109',['check_part_topo',['../namespacesierra_1_1nalu.html#a57a66749dab4c3b9180a654b3cc9eae4',1,'sierra::nalu']]], + ['check_5fparts_5ffor_5fpromotion_1110',['check_parts_for_promotion',['../namespacesierra_1_1nalu.html#ad54057fa64930d07c770ea5fefa2a44f',1,'sierra::nalu']]], + ['choose_5fconsistent_5fnode_5fid_1111',['choose_consistent_node_id',['../namespacesierra_1_1nalu_1_1impl.html#a9e51eaddbf8b8e4f51b90b8e7f43d86a',1,'sierra::nalu::impl']]], + ['communicate_5fremote_5fcolumns_1112',['communicate_remote_columns',['../namespacesierra_1_1nalu.html#ad776c7e2f15ce17bf3558c5eab2c0060',1,'sierra::nalu']]], + ['communicate_5fto_5ffill_5frecv_5fghosts_5fto_5fremove_1113',['communicate_to_fill_recv_ghosts_to_remove',['../namespacesierra_1_1nalu.html#ad97dc42972bc269f7ca420b78867434d',1,'sierra::nalu']]], + ['compareentitybyid_1114',['CompareEntityById',['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#a0621eea0aa495029a8ad619b30cadcac',1,'sierra::nalu::CompareEntityById::CompareEntityById(const stk::mesh::BulkData &mesh, const GlobalIdFieldType *naluGlobalId)'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#a0621eea0aa495029a8ad619b30cadcac',1,'sierra::nalu::CompareEntityById::CompareEntityById(const stk::mesh::BulkData &mesh, const GlobalIdFieldType *naluGlobalId)']]], + ['compareentityequalbyid_1115',['CompareEntityEqualById',['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#af2642d56b598f0a07d5b5445f8463ee8',1,'sierra::nalu::CompareEntityEqualById::CompareEntityEqualById(const stk::mesh::BulkData &mesh, const GlobalIdFieldType *naluGlobalId)'],['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#af2642d56b598f0a07d5b5445f8463ee8',1,'sierra::nalu::CompareEntityEqualById::CompareEntityEqualById(const stk::mesh::BulkData &mesh, const GlobalIdFieldType *naluGlobalId)']]], + ['comparegausspoint_1116',['compareGaussPoint',['../structsierra_1_1nalu_1_1compare_gauss_point.html#ac6fea39464ed0f6efe630424a98ed40a',1,'sierra::nalu::compareGaussPoint']]], + ['compute_5fblade_5fdistributions_1117',['compute_blade_distributions',['../namespacesierra_1_1nalu.html#a4b8e844556f136441dbb890831162dab',1,'sierra::nalu']]], + ['compute_5fdistance_1118',['compute_distance',['../namespacesierra_1_1nalu_1_1actuator__utils.html#ac262e48180befd40abaf4184d672cf2b',1,'sierra::nalu::actuator_utils']]], + ['compute_5fedge_5fscalar_5fdivergence_1119',['compute_edge_scalar_divergence',['../namespacesierra_1_1nalu.html#a87405a5dbc3e64111f03df280c97b753',1,'sierra::nalu']]], + ['compute_5fprecise_5fghosting_5flists_1120',['compute_precise_ghosting_lists',['../namespacesierra_1_1nalu.html#ac3e81534bcd56a6e57d5ebac9ee71fde',1,'sierra::nalu']]], + ['compute_5fscalar_5fdivergence_1121',['compute_scalar_divergence',['../namespacesierra_1_1nalu.html#aca0a4bc68f8e151f17b8cf04ccc4d8e7',1,'sierra::nalu']]], + ['compute_5fvector_5fdivergence_1122',['compute_vector_divergence',['../namespacesierra_1_1nalu.html#aed5c82caca42e7b46ae7914b73d5bf30',1,'sierra::nalu']]], + ['compute_5fvolumes_1123',['compute_volumes',['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a364b6dd2b3f63b2a11c695f866dfe23d',1,'sierra::nalu::matrix_free::impl']]], + ['connectivity_5fmap_5ffor_5fparent_5frank_1124',['connectivity_map_for_parent_rank',['../namespacesierra_1_1nalu_1_1impl.html#ae322d93cd193a8f860de86f1b1888bfb',1,'sierra::nalu::impl']]], + ['copy_5fstk_5ffield_5fto_5fowned_5ftpetra_5fvector_1125',['copy_stk_field_to_owned_tpetra_vector',['../namespacesierra_1_1nalu_1_1matrix__free.html#a6a6f1747a0e27332510c6324d21297e1',1,'sierra::nalu::matrix_free']]], + ['count_5fentities_1126',['count_entities',['../namespacesierra_1_1nalu.html#af38891f26fa334dee9e63c41e492020e',1,'sierra::nalu']]], + ['create_5fboundary_5felements_1127',['create_boundary_elements',['../namespacesierra_1_1nalu_1_1impl.html#affbc37cb56394242a0f3d9d195c53530',1,'sierra::nalu::impl']]], + ['create_5fnodes_5ffor_5fconnectivity_5fmap_1128',['create_nodes_for_connectivity_map',['../namespacesierra_1_1nalu_1_1impl.html#ad615df17fdff8073a61c58bcac4f9bc5',1,'sierra::nalu::impl']]], + ['create_5fpromoted_5fboundary_5felements_1129',['create_promoted_boundary_elements',['../namespacesierra_1_1nalu_1_1promotion.html#a4ab6c79bff4e60d3dd324d0604361c8c',1,'sierra::nalu::promotion']]], + ['create_5fsuper_5felements_1130',['create_super_elements',['../namespacesierra_1_1nalu_1_1impl.html#af4775e0bdab10edd0e8bbb01b0ebbfd5',1,'sierra::nalu::impl']]], + ['create_5ftensor_5fproduct_5fhex_5felements_1131',['create_tensor_product_hex_elements',['../namespacesierra_1_1nalu_1_1promotion.html#a2b7b3c46f5e31b59bae02a14db5acd12',1,'sierra::nalu::promotion']]], + ['createboundingspheres_1132',['CreateBoundingSpheres',['../namespacesierra_1_1nalu.html#a4ef79789ca90427a2ab8289398ebbc80',1,'sierra::nalu']]], + ['createelementboxes_1133',['CreateElementBoxes',['../namespacesierra_1_1nalu.html#abd20d9fd079a0957922b76c28d90826c',1,'sierra::nalu']]], + ['cross_1134',['cross',['../namespacesierra_1_1nalu.html#ab7d645bc5d1eb4671d757f06185256e9',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_3.js b/api_docs/search/functions_3.js index a9345a434..e855fd7b2 100644 --- a/api_docs/search/functions_3.js +++ b/api_docs/search/functions_3.js @@ -1,13 +1,13 @@ var searchData= [ - ['ddot_1131',['ddot',['../namespacesierra_1_1nalu.html#a51c5fb1eff2d96c3cdf48f76142ea59b',1,'sierra::nalu']]], - ['destroy_5fentities_1132',['destroy_entities',['../namespacesierra_1_1nalu_1_1impl.html#a45a502707f5f8f54163ae6fd11763cf4',1,'sierra::nalu::impl']]], - ['destroy_5fentity_1133',['destroy_entity',['../namespacesierra_1_1nalu_1_1impl.html#a945d4fd5dfaaad7fd1f516c780ea1644',1,'sierra::nalu::impl']]], - ['determine_5fmax_5fpeclet_5ffactor_1134',['determine_max_peclet_factor',['../namespacesierra_1_1nalu.html#a5a2ecfaeb87c065c885b58e239d73dcf',1,'sierra::nalu']]], - ['determine_5fmax_5fpeclet_5fnumber_1135',['determine_max_peclet_number',['../namespacesierra_1_1nalu.html#aa1a604e208c252d4e6540021c4312050',1,'sierra::nalu']]], - ['dirichlet_5fdiagonal_1136',['dirichlet_diagonal',['../namespacesierra_1_1nalu_1_1matrix__free.html#a27d2e7908ba2d99c9e60ca0af8e292bd',1,'sierra::nalu::matrix_free']]], - ['dirichlet_5flinearized_1137',['dirichlet_linearized',['../namespacesierra_1_1nalu_1_1matrix__free.html#a76dea165acbb78d7456be9033e27f6e5',1,'sierra::nalu::matrix_free']]], - ['dirichlet_5fresidual_1138',['dirichlet_residual',['../namespacesierra_1_1nalu_1_1matrix__free.html#a5ac8f207c2458679ac6fc0b519ec4ba7',1,'sierra::nalu::matrix_free::dirichlet_residual(const_node_offset_view dirichlet_bc_offsets, const_node_scalar_view qp1, const_node_scalar_view qbc, int max_owned_row_lid, tpetra_view_type yout)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#abf77a2f6cad0d2bc7764baaf515848cf',1,'sierra::nalu::matrix_free::dirichlet_residual(const_node_offset_view dirichlet_bc_offsets, const_node_vector_view qp1, const_node_vector_view qbc, int max_owned_row_lid, tpetra_view_type yout)']]], - ['dot_1139',['dot',['../namespacesierra_1_1nalu.html#a0a7b54980fb28c2292eb0e128e2cbb29',1,'sierra::nalu']]], - ['dot5_1140',['dot5',['../namespacesierra_1_1nalu.html#a1a77ad4ca0a968380176f11204290310',1,'sierra::nalu']]] + ['ddot_1135',['ddot',['../namespacesierra_1_1nalu.html#a51c5fb1eff2d96c3cdf48f76142ea59b',1,'sierra::nalu']]], + ['destroy_5fentities_1136',['destroy_entities',['../namespacesierra_1_1nalu_1_1impl.html#a45a502707f5f8f54163ae6fd11763cf4',1,'sierra::nalu::impl']]], + ['destroy_5fentity_1137',['destroy_entity',['../namespacesierra_1_1nalu_1_1impl.html#a945d4fd5dfaaad7fd1f516c780ea1644',1,'sierra::nalu::impl']]], + ['determine_5fmax_5fpeclet_5ffactor_1138',['determine_max_peclet_factor',['../namespacesierra_1_1nalu.html#a5a2ecfaeb87c065c885b58e239d73dcf',1,'sierra::nalu']]], + ['determine_5fmax_5fpeclet_5fnumber_1139',['determine_max_peclet_number',['../namespacesierra_1_1nalu.html#aa1a604e208c252d4e6540021c4312050',1,'sierra::nalu']]], + ['dirichlet_5fdiagonal_1140',['dirichlet_diagonal',['../namespacesierra_1_1nalu_1_1matrix__free.html#a27d2e7908ba2d99c9e60ca0af8e292bd',1,'sierra::nalu::matrix_free']]], + ['dirichlet_5flinearized_1141',['dirichlet_linearized',['../namespacesierra_1_1nalu_1_1matrix__free.html#a76dea165acbb78d7456be9033e27f6e5',1,'sierra::nalu::matrix_free']]], + ['dirichlet_5fresidual_1142',['dirichlet_residual',['../namespacesierra_1_1nalu_1_1matrix__free.html#a5ac8f207c2458679ac6fc0b519ec4ba7',1,'sierra::nalu::matrix_free::dirichlet_residual(const_node_offset_view dirichlet_bc_offsets, const_node_scalar_view qp1, const_node_scalar_view qbc, int max_owned_row_lid, tpetra_view_type yout)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#abf77a2f6cad0d2bc7764baaf515848cf',1,'sierra::nalu::matrix_free::dirichlet_residual(const_node_offset_view dirichlet_bc_offsets, const_node_vector_view qp1, const_node_vector_view qbc, int max_owned_row_lid, tpetra_view_type yout)']]], + ['dot_1143',['dot',['../namespacesierra_1_1nalu.html#a0a7b54980fb28c2292eb0e128e2cbb29',1,'sierra::nalu']]], + ['dot5_1144',['dot5',['../namespacesierra_1_1nalu.html#a1a77ad4ca0a968380176f11204290310',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_4.js b/api_docs/search/functions_4.js index 31db9d229..027881d17 100644 --- a/api_docs/search/functions_4.js +++ b/api_docs/search/functions_4.js @@ -1,15 +1,15 @@ var searchData= [ - ['epsilon_5fparsing_1141',['epsilon_parsing',['../namespacesierra_1_1nalu.html#a44fa71b9a7e7b6c2c1aee86830a92921',1,'sierra::nalu']]], - ['executecoarsesearch_1142',['ExecuteCoarseSearch',['../namespacesierra_1_1nalu.html#aaca7a124d9fc37ce71f786765a4b4107',1,'sierra::nalu']]], - ['executefinesearch_1143',['ExecuteFineSearch',['../namespacesierra_1_1nalu.html#a2cfc16b4b9b40f2d2da263fa0c8af9e5',1,'sierra::nalu']]], - ['exodus_5fhex27_5fnode_5fmap_1144',['exodus_hex27_node_map',['../namespacesierra_1_1nalu.html#a30a657942ed232254e470535be0bd729',1,'sierra::nalu']]], - ['expect_5fmap_1145',['expect_map',['../namespacesierra_1_1nalu.html#a3d1c8311a12456dcc094490b6f9b1a51',1,'sierra::nalu']]], - ['expect_5fnull_1146',['expect_null',['../namespacesierra_1_1nalu.html#a51e13474ce49dc450bf94e409c63f9cd',1,'sierra::nalu']]], - ['expect_5fscalar_1147',['expect_scalar',['../namespacesierra_1_1nalu.html#a0bb968f35c4be1b30e97042de5973665',1,'sierra::nalu']]], - ['expect_5fsequence_1148',['expect_sequence',['../namespacesierra_1_1nalu.html#a2709756e7be748e01468ecaebf797893',1,'sierra::nalu']]], - ['expect_5ftype_1149',['expect_type',['../namespacesierra_1_1nalu.html#a7ae79c4f3d6e10d30f1d3ae6778b8a4f',1,'sierra::nalu']]], - ['explicit_5ftype_5finstantiator_5flegacy_1150',['EXPLICIT_TYPE_INSTANTIATOR_LEGACY',['../namespacesierra_1_1nalu.html#aed50ad711e9c4dccdad287d2ddf5f716',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_LEGACY(int)'],['../namespacesierra_1_1nalu.html#a999db6a248a3e8b5098a4666dc974e09',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_LEGACY(TpetIdType)'],['../namespacesierra_1_1nalu.html#a986f3532e6f2e0621a19fede23b36b5b',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_LEGACY(LocalId)'],['../namespacesierra_1_1nalu.html#a10edd14ba1d09b4077142e5752102caa',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_LEGACY(stk::mesh::EntityId)'],['../namespacesierra_1_1nalu.html#a44b44fe7de92b9efc148727939d9961e',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_LEGACY(double)']]], - ['explicit_5ftype_5finstantiator_5fngp_1151',['EXPLICIT_TYPE_INSTANTIATOR_NGP',['../namespacesierra_1_1nalu.html#a44eb181cb193aea4c502ff46fafa2d32',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_NGP(int)'],['../namespacesierra_1_1nalu.html#a9b524b8e82d70e67e9627fd1b0a11ffd',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_NGP(double)'],['../namespacesierra_1_1nalu.html#ae6814e775a69584b284d59ffb063fb64',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_NGP(stk::mesh::EntityId)']]], - ['exposed_5fside_5fto_5fsuper_5felem_5fmap_1152',['exposed_side_to_super_elem_map',['../namespacesierra_1_1nalu_1_1impl.html#a96f1ba5c809d2a991c32646126b5889d',1,'sierra::nalu::impl']]] + ['epsilon_5fparsing_1145',['epsilon_parsing',['../namespacesierra_1_1nalu.html#a44fa71b9a7e7b6c2c1aee86830a92921',1,'sierra::nalu']]], + ['executecoarsesearch_1146',['ExecuteCoarseSearch',['../namespacesierra_1_1nalu.html#aaca7a124d9fc37ce71f786765a4b4107',1,'sierra::nalu']]], + ['executefinesearch_1147',['ExecuteFineSearch',['../namespacesierra_1_1nalu.html#a2cfc16b4b9b40f2d2da263fa0c8af9e5',1,'sierra::nalu']]], + ['exodus_5fhex27_5fnode_5fmap_1148',['exodus_hex27_node_map',['../namespacesierra_1_1nalu.html#a30a657942ed232254e470535be0bd729',1,'sierra::nalu']]], + ['expect_5fmap_1149',['expect_map',['../namespacesierra_1_1nalu.html#a3d1c8311a12456dcc094490b6f9b1a51',1,'sierra::nalu']]], + ['expect_5fnull_1150',['expect_null',['../namespacesierra_1_1nalu.html#a51e13474ce49dc450bf94e409c63f9cd',1,'sierra::nalu']]], + ['expect_5fscalar_1151',['expect_scalar',['../namespacesierra_1_1nalu.html#a0bb968f35c4be1b30e97042de5973665',1,'sierra::nalu']]], + ['expect_5fsequence_1152',['expect_sequence',['../namespacesierra_1_1nalu.html#a2709756e7be748e01468ecaebf797893',1,'sierra::nalu']]], + ['expect_5ftype_1153',['expect_type',['../namespacesierra_1_1nalu.html#a7ae79c4f3d6e10d30f1d3ae6778b8a4f',1,'sierra::nalu']]], + ['explicit_5ftype_5finstantiator_5flegacy_1154',['EXPLICIT_TYPE_INSTANTIATOR_LEGACY',['../namespacesierra_1_1nalu.html#aed50ad711e9c4dccdad287d2ddf5f716',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_LEGACY(int)'],['../namespacesierra_1_1nalu.html#a999db6a248a3e8b5098a4666dc974e09',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_LEGACY(TpetIdType)'],['../namespacesierra_1_1nalu.html#a986f3532e6f2e0621a19fede23b36b5b',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_LEGACY(LocalId)'],['../namespacesierra_1_1nalu.html#a10edd14ba1d09b4077142e5752102caa',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_LEGACY(stk::mesh::EntityId)'],['../namespacesierra_1_1nalu.html#a44b44fe7de92b9efc148727939d9961e',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_LEGACY(double)']]], + ['explicit_5ftype_5finstantiator_5fngp_1155',['EXPLICIT_TYPE_INSTANTIATOR_NGP',['../namespacesierra_1_1nalu.html#a44eb181cb193aea4c502ff46fafa2d32',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_NGP(int)'],['../namespacesierra_1_1nalu.html#a9b524b8e82d70e67e9627fd1b0a11ffd',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_NGP(double)'],['../namespacesierra_1_1nalu.html#ae6814e775a69584b284d59ffb063fb64',1,'sierra::nalu::EXPLICIT_TYPE_INSTANTIATOR_NGP(stk::mesh::EntityId)']]], + ['exposed_5fside_5fto_5fsuper_5felem_5fmap_1156',['exposed_side_to_super_elem_map',['../namespacesierra_1_1nalu_1_1impl.html#a96f1ba5c809d2a991c32646126b5889d',1,'sierra::nalu::impl']]] ]; diff --git a/api_docs/search/functions_5.js b/api_docs/search/functions_5.js index a9ee12b43..85436e587 100644 --- a/api_docs/search/functions_5.js +++ b/api_docs/search/functions_5.js @@ -1,16 +1,16 @@ var searchData= [ - ['face_5ftopology_5ffor_5forder_1153',['face_topology_for_order',['../namespacesierra_1_1nalu.html#aa3f75ac338ce3e31e5cdc6774213cb35',1,'sierra::nalu']]], - ['field_5faxpby_1154',['field_axpby',['../namespacesierra_1_1nalu.html#abd9a8fedd1b1b862cf448e9e635a8d57',1,'sierra::nalu']]], - ['field_5fcopy_1155',['field_copy',['../namespacesierra_1_1nalu.html#a3df340da7575ac62dd83469a76852e18',1,'sierra::nalu']]], - ['field_5ffill_1156',['field_fill',['../namespacesierra_1_1nalu.html#aa38257e01a84127a7d3e217eb2f5dbca',1,'sierra::nalu']]], - ['field_5fgather_1157',['field_gather',['../namespacesierra_1_1nalu_1_1matrix__free.html#a7dae32fff63eb8acf6c686c8ad75adec',1,'sierra::nalu::matrix_free::field_gather(const_node_mesh_index_view conn, const stk::mesh::NgpField< double > &field, node_scalar_view simd_node_field)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a84d9f02a4f388215376831bef8a4df28',1,'sierra::nalu::matrix_free::field_gather(const_node_mesh_index_view conn, const stk::mesh::NgpField< double > &field, node_vector_view simd_node_field)']]], - ['field_5findex_5fcopy_1158',['field_index_copy',['../namespacesierra_1_1nalu.html#a02dd05cecf061445d21c28e2404d9ea0',1,'sierra::nalu']]], - ['field_5fscale_1159',['field_scale',['../namespacesierra_1_1nalu.html#ad934610f444cc40ba37f8de4ad7cc676',1,'sierra::nalu']]], - ['fill_5fin_5fextra_5fdof_5frows_5fper_5fnode_1160',['fill_in_extra_dof_rows_per_node',['../namespacesierra_1_1nalu.html#ac6947fbb39006eec1526272839f8222b',1,'sierra::nalu']]], - ['fill_5fintg_5fexp_5fface_5fshift_1161',['fill_intg_exp_face_shift',['../namespacesierra_1_1nalu.html#a06f2b182b7fd4a3c237736557f93d55d',1,'sierra::nalu']]], - ['fill_5fneighbor_5fprocs_1162',['fill_neighbor_procs',['../namespacesierra_1_1nalu.html#af54578f7e6bd82e7f38541c3e3f8e700',1,'sierra::nalu']]], - ['fill_5fowned_5fand_5fshared_5fthen_5fnonowned_5fordered_5fby_5fproc_1163',['fill_owned_and_shared_then_nonowned_ordered_by_proc',['../namespacesierra_1_1nalu.html#af96be14292cdc5c056ff9cc6b1c57714',1,'sierra::nalu']]], - ['fill_5fpre_5freq_5fdata_1164',['fill_pre_req_data',['../namespacesierra_1_1nalu.html#a856730db92b49b370480dcc1046aeaae',1,'sierra::nalu::fill_pre_req_data(const ElemDataRequestsGPU &dataNeeded, const stk::mesh::NgpMesh &ngpMesh, stk::mesh::EntityRank entityRank, stk::mesh::Entity entity, ScratchViews< T, DeviceTeamHandleType, DeviceShmem > &prereqData)'],['../namespacesierra_1_1nalu.html#ae7bb21154cda433d189c88b7a64c3c1e',1,'sierra::nalu::fill_pre_req_data(const ElemDataRequestsGPU &dataNeeded, const stk::mesh::NgpMesh &ngpMesh, stk::mesh::EntityRank entityRank, stk::mesh::Entity entity, ScratchViews< double, DeviceTeamHandleType, DeviceShmem > &prereqData)'],['../namespacesierra_1_1nalu.html#a3abec435e40cf18715747e7bc4de3bec',1,'sierra::nalu::fill_pre_req_data(const ElemDataRequestsGPU &dataNeeded, const stk::mesh::NgpMesh &ngpMesh, stk::mesh::EntityRank entityRank, stk::mesh::Entity entity, ScratchViews< DoubleType, DeviceTeamHandleType, DeviceShmem > &prereqData)']]], - ['fill_5fsend_5fghosts_5fto_5fremove_5ffrom_5fghosting_1165',['fill_send_ghosts_to_remove_from_ghosting',['../namespacesierra_1_1nalu.html#a2f8849c2cbefcb19222c4255f0ee5668',1,'sierra::nalu']]] + ['face_5ftopology_5ffor_5forder_1157',['face_topology_for_order',['../namespacesierra_1_1nalu.html#aa3f75ac338ce3e31e5cdc6774213cb35',1,'sierra::nalu']]], + ['field_5faxpby_1158',['field_axpby',['../namespacesierra_1_1nalu.html#abd9a8fedd1b1b862cf448e9e635a8d57',1,'sierra::nalu']]], + ['field_5fcopy_1159',['field_copy',['../namespacesierra_1_1nalu.html#a3df340da7575ac62dd83469a76852e18',1,'sierra::nalu']]], + ['field_5ffill_1160',['field_fill',['../namespacesierra_1_1nalu.html#aa38257e01a84127a7d3e217eb2f5dbca',1,'sierra::nalu']]], + ['field_5fgather_1161',['field_gather',['../namespacesierra_1_1nalu_1_1matrix__free.html#a7dae32fff63eb8acf6c686c8ad75adec',1,'sierra::nalu::matrix_free::field_gather(const_node_mesh_index_view conn, const stk::mesh::NgpField< double > &field, node_scalar_view simd_node_field)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a84d9f02a4f388215376831bef8a4df28',1,'sierra::nalu::matrix_free::field_gather(const_node_mesh_index_view conn, const stk::mesh::NgpField< double > &field, node_vector_view simd_node_field)']]], + ['field_5findex_5fcopy_1162',['field_index_copy',['../namespacesierra_1_1nalu.html#a02dd05cecf061445d21c28e2404d9ea0',1,'sierra::nalu']]], + ['field_5fscale_1163',['field_scale',['../namespacesierra_1_1nalu.html#ad934610f444cc40ba37f8de4ad7cc676',1,'sierra::nalu']]], + ['fill_5fin_5fextra_5fdof_5frows_5fper_5fnode_1164',['fill_in_extra_dof_rows_per_node',['../namespacesierra_1_1nalu.html#ac6947fbb39006eec1526272839f8222b',1,'sierra::nalu']]], + ['fill_5fintg_5fexp_5fface_5fshift_1165',['fill_intg_exp_face_shift',['../namespacesierra_1_1nalu.html#a06f2b182b7fd4a3c237736557f93d55d',1,'sierra::nalu']]], + ['fill_5fneighbor_5fprocs_1166',['fill_neighbor_procs',['../namespacesierra_1_1nalu.html#af54578f7e6bd82e7f38541c3e3f8e700',1,'sierra::nalu']]], + ['fill_5fowned_5fand_5fshared_5fthen_5fnonowned_5fordered_5fby_5fproc_1167',['fill_owned_and_shared_then_nonowned_ordered_by_proc',['../namespacesierra_1_1nalu.html#af96be14292cdc5c056ff9cc6b1c57714',1,'sierra::nalu']]], + ['fill_5fpre_5freq_5fdata_1168',['fill_pre_req_data',['../namespacesierra_1_1nalu.html#a856730db92b49b370480dcc1046aeaae',1,'sierra::nalu::fill_pre_req_data(const ElemDataRequestsGPU &dataNeeded, const stk::mesh::NgpMesh &ngpMesh, stk::mesh::EntityRank entityRank, stk::mesh::Entity entity, ScratchViews< T, DeviceTeamHandleType, DeviceShmem > &prereqData)'],['../namespacesierra_1_1nalu.html#ae7bb21154cda433d189c88b7a64c3c1e',1,'sierra::nalu::fill_pre_req_data(const ElemDataRequestsGPU &dataNeeded, const stk::mesh::NgpMesh &ngpMesh, stk::mesh::EntityRank entityRank, stk::mesh::Entity entity, ScratchViews< double, DeviceTeamHandleType, DeviceShmem > &prereqData)'],['../namespacesierra_1_1nalu.html#a3abec435e40cf18715747e7bc4de3bec',1,'sierra::nalu::fill_pre_req_data(const ElemDataRequestsGPU &dataNeeded, const stk::mesh::NgpMesh &ngpMesh, stk::mesh::EntityRank entityRank, stk::mesh::Entity entity, ScratchViews< DoubleType, DeviceTeamHandleType, DeviceShmem > &prereqData)']]], + ['fill_5fsend_5fghosts_5fto_5fremove_5ffrom_5fghosting_1169',['fill_send_ghosts_to_remove_from_ghosting',['../namespacesierra_1_1nalu.html#a2f8849c2cbefcb19222c4255f0ee5668',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_6.js b/api_docs/search/functions_6.js index 3995b01ea..f45783631 100644 --- a/api_docs/search/functions_6.js +++ b/api_docs/search/functions_6.js @@ -1,24 +1,24 @@ var searchData= [ - ['gather_5felem_5fnode_5ffield_1166',['gather_elem_node_field',['../namespacesierra_1_1nalu.html#a75c9d44f985b599889ddef84b7de20b9',1,'sierra::nalu::gather_elem_node_field(const NGPDoubleFieldType &field, const stk::mesh::NgpMesh &ngpMesh, int scalarsPerNode, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, ViewType &shmemView)'],['../namespacesierra_1_1nalu.html#abf6883346c11fb4050017af7971b7643',1,'sierra::nalu::gather_elem_node_field(const stk::mesh::FieldBase &field, int numNodes, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, SharedMemView< double * > &shmemView)'],['../namespacesierra_1_1nalu.html#a1848e755c1be73f8a80e7511215856d3',1,'sierra::nalu::gather_elem_node_field(const stk::mesh::FieldBase &field, int numNodes, int scalarsPerNode, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, SharedMemView< double ** > &shmemView)'],['../namespacesierra_1_1nalu.html#aa7679dfe836b16ba0a91df659603f1a7',1,'sierra::nalu::gather_elem_node_field(const NGPDoubleFieldType &field, const stk::mesh::NgpMesh &ngpMesh, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, ViewType &shmemView)']]], - ['gather_5felem_5fnode_5ffield_5f3d_1167',['gather_elem_node_field_3D',['../namespacesierra_1_1nalu.html#a346d457b0b4c34e8dcb873ddba548895',1,'sierra::nalu::gather_elem_node_field_3D(const NGPDoubleFieldType &field, const stk::mesh::NgpMesh &ngpMesh, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, ViewType &shmemView)'],['../namespacesierra_1_1nalu.html#ab6517b7c091931246d4619c44bd2bd1c',1,'sierra::nalu::gather_elem_node_field_3D(const stk::mesh::FieldBase &field, int numNodes, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, SharedMemView< double ** > &shmemView)']]], - ['gather_5felem_5fnode_5ftensor_5ffield_1168',['gather_elem_node_tensor_field',['../namespacesierra_1_1nalu.html#aa084c7e926e032f6c9a9e88e9e56e9fb',1,'sierra::nalu::gather_elem_node_tensor_field(const NGPDoubleFieldType &field, const stk::mesh::NgpMesh &ngpMesh, int numNodes, int tensorDim1, int tensorDim2, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, ViewType &shmemView)'],['../namespacesierra_1_1nalu.html#a4b04610c11e32d3870903320fdab31c1',1,'sierra::nalu::gather_elem_node_tensor_field(const stk::mesh::FieldBase &field, int numNodes, int tensorDim1, int tensorDim2, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, SharedMemView< double *** > &shmemView)']]], - ['gather_5felem_5ftensor_5ffield_1169',['gather_elem_tensor_field',['../namespacesierra_1_1nalu.html#ae30a2a2ba8320a530d1981dad788c831',1,'sierra::nalu::gather_elem_tensor_field(const NGPDoubleFieldType &field, stk::mesh::FastMeshIndex elem, int tensorDim1, int tensorDim2, ViewType &shmemView)'],['../namespacesierra_1_1nalu.html#aaa52daa51b5762b490e65435cccf15b3',1,'sierra::nalu::gather_elem_tensor_field(const stk::mesh::FieldBase &field, stk::mesh::Entity elem, int tensorDim1, int tensorDim2, SharedMemView< double ** > &shmemView)']]], - ['gather_5felem_5fvector_5ffield_1170',['gather_elem_vector_field',['../namespacesierra_1_1nalu.html#a84c2291252064c3553d930d22f925e54',1,'sierra::nalu']]], - ['gather_5ffield_1171',['gather_field',['../namespacesierra_1_1nalu_1_1actuator__utils.html#afcde9e3825e05986e8b2e7eecf2d97ed',1,'sierra::nalu::actuator_utils']]], - ['gather_5ffield_5ffor_5finterp_1172',['gather_field_for_interp',['../namespacesierra_1_1nalu_1_1actuator__utils.html#a7edd450583e3233d7b171447fbf7cbad',1,'sierra::nalu::actuator_utils']]], - ['gauss_5flobatto_5flegendre_5fabscissae_1173',['gauss_lobatto_legendre_abscissae',['../namespacesierra_1_1nalu_1_1matrix__free.html#aa41f897001ed994b51a1d72c8f9e76f8',1,'sierra::nalu::matrix_free::gauss_lobatto_legendre_abscissae(int p, int n)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a5d840de00a4278cd8143b4148e9ab7ec',1,'sierra::nalu::matrix_free::gauss_lobatto_legendre_abscissae(int p)']]], - ['gaussian_5fprojection_1174',['Gaussian_projection',['../namespacesierra_1_1nalu_1_1actuator__utils.html#a4b7c5df52a50b2a41f6589ba1997a50a',1,'sierra::nalu::actuator_utils::Gaussian_projection(int nDim, double *dis, const Coordinates &epsilon)'],['../namespacesierra_1_1nalu_1_1actuator__utils.html#ab7ae68a4a81292b301f6b4727c433a9d',1,'sierra::nalu::actuator_utils::Gaussian_projection(int nDim, double *dis, double *epsilon)']]], - ['get_5fand_5fsync_5fngp_5ffield_1175',['get_and_sync_ngp_field',['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ac756d3b57f85b77fc254ab9c08c7217b',1,'sierra::nalu::matrix_free::impl']]], - ['get_5fbackward_5fcompatible_5ftype_1176',['get_backward_compatible_type',['../namespacesierra_1_1nalu.html#a1c36074a5872d820a8dab3f8d3cccdf7',1,'sierra::nalu']]], - ['get_5felem_5ftopo_1177',['get_elem_topo',['../namespacesierra_1_1nalu.html#a53fd489e11770b60def43760d9437617',1,'sierra::nalu']]], - ['get_5fentity_5fmaster_1178',['get_entity_master',['../namespacesierra_1_1nalu.html#afa19b7238d33d7f9340147496d56b201',1,'sierra::nalu']]], - ['get_5fneighbor_5findex_1179',['get_neighbor_index',['../namespacesierra_1_1nalu.html#ae2c28eb2d2a7ed084532f7d6b8f8a957',1,'sierra::nalu']]], - ['get_5fngp_5ffield_1180',['get_ngp_field',['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ae9b726e7fdbe79dde9bac85c083d515d',1,'sierra::nalu::matrix_free::impl::get_ngp_field()'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a0a826530b7c1ec5573f66cf51a6c3266',1,'sierra::nalu::matrix_free::get_ngp_field()']]], - ['get_5fnum_5fscalars_5fpre_5freq_5fdata_1181',['get_num_scalars_pre_req_data',['../namespacesierra_1_1nalu.html#a1da3098d1bc0a355eeb1f956a1ef7541',1,'sierra::nalu']]], - ['get_5foverset_5ffield_5fdata_1182',['get_overset_field_data',['../namespacesierra_1_1nalu_1_1overset__utils.html#a0ff069a7a35c349a75cd14462161a895',1,'sierra::nalu::overset_utils']]], - ['get_5fpromoted_5felem_5ftopo_1183',['get_promoted_elem_topo',['../namespacesierra_1_1nalu.html#ac5d676b952097285988e2dccf4012dee',1,'sierra::nalu']]], - ['get_5fsymmetry_5fdata_1184',['get_symmetry_data',['../namespacesierra_1_1nalu.html#aeea78404b37afc2b58241300779b658d',1,'sierra::nalu']]], - ['get_5fsynced_5fngp_5ffield_1185',['get_synced_ngp_field',['../namespacesierra_1_1nalu_1_1matrix__free.html#a68f5ac83c40664feb0131463de70842e',1,'sierra::nalu::matrix_free']]], - ['getdofstatus_5fimpl_1186',['getDofStatus_impl',['../namespacesierra_1_1nalu.html#add7ef66edd1c4fbeb7220ca2a7f83513',1,'sierra::nalu']]] + ['gather_5felem_5fnode_5ffield_1170',['gather_elem_node_field',['../namespacesierra_1_1nalu.html#a75c9d44f985b599889ddef84b7de20b9',1,'sierra::nalu::gather_elem_node_field(const NGPDoubleFieldType &field, const stk::mesh::NgpMesh &ngpMesh, int scalarsPerNode, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, ViewType &shmemView)'],['../namespacesierra_1_1nalu.html#abf6883346c11fb4050017af7971b7643',1,'sierra::nalu::gather_elem_node_field(const stk::mesh::FieldBase &field, int numNodes, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, SharedMemView< double * > &shmemView)'],['../namespacesierra_1_1nalu.html#a1848e755c1be73f8a80e7511215856d3',1,'sierra::nalu::gather_elem_node_field(const stk::mesh::FieldBase &field, int numNodes, int scalarsPerNode, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, SharedMemView< double ** > &shmemView)'],['../namespacesierra_1_1nalu.html#aa7679dfe836b16ba0a91df659603f1a7',1,'sierra::nalu::gather_elem_node_field(const NGPDoubleFieldType &field, const stk::mesh::NgpMesh &ngpMesh, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, ViewType &shmemView)']]], + ['gather_5felem_5fnode_5ffield_5f3d_1171',['gather_elem_node_field_3D',['../namespacesierra_1_1nalu.html#a346d457b0b4c34e8dcb873ddba548895',1,'sierra::nalu::gather_elem_node_field_3D(const NGPDoubleFieldType &field, const stk::mesh::NgpMesh &ngpMesh, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, ViewType &shmemView)'],['../namespacesierra_1_1nalu.html#ab6517b7c091931246d4619c44bd2bd1c',1,'sierra::nalu::gather_elem_node_field_3D(const stk::mesh::FieldBase &field, int numNodes, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, SharedMemView< double ** > &shmemView)']]], + ['gather_5felem_5fnode_5ftensor_5ffield_1172',['gather_elem_node_tensor_field',['../namespacesierra_1_1nalu.html#aa084c7e926e032f6c9a9e88e9e56e9fb',1,'sierra::nalu::gather_elem_node_tensor_field(const NGPDoubleFieldType &field, const stk::mesh::NgpMesh &ngpMesh, int numNodes, int tensorDim1, int tensorDim2, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, ViewType &shmemView)'],['../namespacesierra_1_1nalu.html#a4b04610c11e32d3870903320fdab31c1',1,'sierra::nalu::gather_elem_node_tensor_field(const stk::mesh::FieldBase &field, int numNodes, int tensorDim1, int tensorDim2, const stk::mesh::NgpMesh::ConnectedNodes &elemNodes, SharedMemView< double *** > &shmemView)']]], + ['gather_5felem_5ftensor_5ffield_1173',['gather_elem_tensor_field',['../namespacesierra_1_1nalu.html#ae30a2a2ba8320a530d1981dad788c831',1,'sierra::nalu::gather_elem_tensor_field(const NGPDoubleFieldType &field, stk::mesh::FastMeshIndex elem, int tensorDim1, int tensorDim2, ViewType &shmemView)'],['../namespacesierra_1_1nalu.html#aaa52daa51b5762b490e65435cccf15b3',1,'sierra::nalu::gather_elem_tensor_field(const stk::mesh::FieldBase &field, stk::mesh::Entity elem, int tensorDim1, int tensorDim2, SharedMemView< double ** > &shmemView)']]], + ['gather_5felem_5fvector_5ffield_1174',['gather_elem_vector_field',['../namespacesierra_1_1nalu.html#a84c2291252064c3553d930d22f925e54',1,'sierra::nalu']]], + ['gather_5ffield_1175',['gather_field',['../namespacesierra_1_1nalu_1_1actuator__utils.html#afcde9e3825e05986e8b2e7eecf2d97ed',1,'sierra::nalu::actuator_utils']]], + ['gather_5ffield_5ffor_5finterp_1176',['gather_field_for_interp',['../namespacesierra_1_1nalu_1_1actuator__utils.html#a7edd450583e3233d7b171447fbf7cbad',1,'sierra::nalu::actuator_utils']]], + ['gauss_5flobatto_5flegendre_5fabscissae_1177',['gauss_lobatto_legendre_abscissae',['../namespacesierra_1_1nalu_1_1matrix__free.html#aa41f897001ed994b51a1d72c8f9e76f8',1,'sierra::nalu::matrix_free::gauss_lobatto_legendre_abscissae(int p, int n)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a5d840de00a4278cd8143b4148e9ab7ec',1,'sierra::nalu::matrix_free::gauss_lobatto_legendre_abscissae(int p)']]], + ['gaussian_5fprojection_1178',['Gaussian_projection',['../namespacesierra_1_1nalu_1_1actuator__utils.html#a4b7c5df52a50b2a41f6589ba1997a50a',1,'sierra::nalu::actuator_utils::Gaussian_projection(int nDim, double *dis, const Coordinates &epsilon)'],['../namespacesierra_1_1nalu_1_1actuator__utils.html#ab7ae68a4a81292b301f6b4727c433a9d',1,'sierra::nalu::actuator_utils::Gaussian_projection(int nDim, double *dis, double *epsilon)']]], + ['get_5fand_5fsync_5fngp_5ffield_1179',['get_and_sync_ngp_field',['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ac756d3b57f85b77fc254ab9c08c7217b',1,'sierra::nalu::matrix_free::impl']]], + ['get_5fbackward_5fcompatible_5ftype_1180',['get_backward_compatible_type',['../namespacesierra_1_1nalu.html#a1c36074a5872d820a8dab3f8d3cccdf7',1,'sierra::nalu']]], + ['get_5felem_5ftopo_1181',['get_elem_topo',['../namespacesierra_1_1nalu.html#a53fd489e11770b60def43760d9437617',1,'sierra::nalu']]], + ['get_5fentity_5fmaster_1182',['get_entity_master',['../namespacesierra_1_1nalu.html#afa19b7238d33d7f9340147496d56b201',1,'sierra::nalu']]], + ['get_5fneighbor_5findex_1183',['get_neighbor_index',['../namespacesierra_1_1nalu.html#ae2c28eb2d2a7ed084532f7d6b8f8a957',1,'sierra::nalu']]], + ['get_5fngp_5ffield_1184',['get_ngp_field',['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ae9b726e7fdbe79dde9bac85c083d515d',1,'sierra::nalu::matrix_free::impl::get_ngp_field()'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a0a826530b7c1ec5573f66cf51a6c3266',1,'sierra::nalu::matrix_free::get_ngp_field()']]], + ['get_5fnum_5fscalars_5fpre_5freq_5fdata_1185',['get_num_scalars_pre_req_data',['../namespacesierra_1_1nalu.html#a1da3098d1bc0a355eeb1f956a1ef7541',1,'sierra::nalu']]], + ['get_5foverset_5ffield_5fdata_1186',['get_overset_field_data',['../namespacesierra_1_1nalu_1_1overset__utils.html#a0ff069a7a35c349a75cd14462161a895',1,'sierra::nalu::overset_utils']]], + ['get_5fpromoted_5felem_5ftopo_1187',['get_promoted_elem_topo',['../namespacesierra_1_1nalu.html#ac5d676b952097285988e2dccf4012dee',1,'sierra::nalu']]], + ['get_5fsymmetry_5fdata_1188',['get_symmetry_data',['../namespacesierra_1_1nalu.html#aeea78404b37afc2b58241300779b658d',1,'sierra::nalu']]], + ['get_5fsynced_5fngp_5ffield_1189',['get_synced_ngp_field',['../namespacesierra_1_1nalu_1_1matrix__free.html#a68f5ac83c40664feb0131463de70842e',1,'sierra::nalu::matrix_free']]], + ['getdofstatus_5fimpl_1190',['getDofStatus_impl',['../namespacesierra_1_1nalu.html#add7ef66edd1c4fbeb7220ca2a7f83513',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_7.js b/api_docs/search/functions_7.js index ba20f3d28..8cf9d5d85 100644 --- a/api_docs/search/functions_7.js +++ b/api_docs/search/functions_7.js @@ -1,6 +1,6 @@ var searchData= [ - ['hex8_5fderivative_1187',['hex8_derivative',['../namespacesierra_1_1nalu.html#a948ff37bfa16c1a6a9f6c0483af74259',1,'sierra::nalu']]], - ['hex8_5fshape_5ffcn_1188',['hex8_shape_fcn',['../namespacesierra_1_1nalu.html#a7694a8b2019bb17a5f9d14e549ac2dc9',1,'sierra::nalu']]], - ['hex_5fgradient_5foperator_1189',['hex_gradient_operator',['../namespacesierra_1_1nalu.html#ac35a82d0eb05b48dffa4e8c28c7ded35',1,'sierra::nalu']]] + ['hex8_5fderivative_1191',['hex8_derivative',['../namespacesierra_1_1nalu.html#a948ff37bfa16c1a6a9f6c0483af74259',1,'sierra::nalu']]], + ['hex8_5fshape_5ffcn_1192',['hex8_shape_fcn',['../namespacesierra_1_1nalu.html#a7694a8b2019bb17a5f9d14e549ac2dc9',1,'sierra::nalu']]], + ['hex_5fgradient_5foperator_1193',['hex_gradient_operator',['../namespacesierra_1_1nalu.html#ac35a82d0eb05b48dffa4e8c28c7ded35',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_8.js b/api_docs/search/functions_8.js index d0231ff02..afb8192cf 100644 --- a/api_docs/search/functions_8.js +++ b/api_docs/search/functions_8.js @@ -1,17 +1,17 @@ var searchData= [ - ['index_5fedge_5fnodes_1190',['index_edge_nodes',['../namespacesierra_1_1nalu_1_1impl.html#af287648b9b223c83f160823409000a4f',1,'sierra::nalu::impl']]], - ['index_5fface_5fnodes_1191',['index_face_nodes',['../namespacesierra_1_1nalu_1_1impl.html#ad60ea1e81878d44d742155e943b86ccc',1,'sierra::nalu::impl']]], - ['insert_5fcommunicated_5fcol_5findices_1192',['insert_communicated_col_indices',['../namespacesierra_1_1nalu.html#a18f21548e563c5d249f666c9d077d264',1,'sierra::nalu']]], - ['insert_5fsingle_5fdof_5frow_5finto_5fgraph_1193',['insert_single_dof_row_into_graph',['../namespacesierra_1_1nalu.html#a9a0574d769dc8d145dc3c1e8babcc889',1,'sierra::nalu']]], - ['instantiate_5falg_1194',['INSTANTIATE_ALG',['../namespacesierra_1_1nalu.html#a63ea328433b74e8cf01e67c55c0189aa',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsTri3_2D)'],['../namespacesierra_1_1nalu.html#ae93e070e29535c4ca0ba2e402d5f1771',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsQuad4_2D)'],['../namespacesierra_1_1nalu.html#aa99c3dafae87a68a62d498c6170c5e4e',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsWed6)'],['../namespacesierra_1_1nalu.html#a548dcd13c3d8616c8d2983564d6c628c',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsPyr5)'],['../namespacesierra_1_1nalu.html#a4db87bf4630d57c8442266195e318131',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsTet4)'],['../namespacesierra_1_1nalu.html#a501652ce34b805214b6cecf1c13a52d2',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsHex8)'],['../namespacesierra_1_1nalu.html#a427d95db810af78ee76eebc797034abb',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsEdge_2D)'],['../namespacesierra_1_1nalu.html#a51d75e7cc9d67bdd798704a55efc2983',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsQuad4)'],['../namespacesierra_1_1nalu.html#acd0e51e67d117052ef3c60b4453f9268',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsTri3)']]], - ['instantiate_5fpolyclass_1195',['INSTANTIATE_POLYCLASS',['../namespacesierra_1_1nalu_1_1matrix__free.html#a0c839bf4e32e2511e622e3ece9dc13d4',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ComputeGradient)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a91e46391a2e17d6596e5d7ee63a33198',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(MomentumSolutionUpdate)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#ae2a66ed18b0643be6f83060e442191f2',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(MomentumLinearizedResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a118002c1051b41a558e58c1a28dc93e9',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(MomentumResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a9daa82c093d1f54c63e0dd2be6d0ebfc',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(MomentumJacobiOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#acaa5c2031cb3f7de19f5267ba91791df',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(LowMachUpdate)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a153d3fd54d7e334ccbc6ac8a5c1ae9af',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(LowMachGatheredFieldManager)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#ab51c4161a94b9bc87dd245c28b35ed4b',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(GradientLinearizedResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#aa2cc79e73e681fbff393ba46f93ea9e8',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(GradientResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a809f82288f12c9b7b1b030ffd8bd97bc',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(GreenGaussGradient)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a6d66ac61b016cf7394e52c2cd7b36858',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(FilterJacobiOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a51473c43201c26eb8ecf6fbd7ec94642',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ContinuitySolutionUpdate)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#aad9677b0ebe723f0d87fba79ffd39e8a',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ContinuityLinearizedResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a7821e001a918cce001d89f598b622836',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ContinuityResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#acbea689c87ef39f877729891a2d41c3c',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ConductionUpdate)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#aadfe41a6cd01ec80f5677791966b8cef',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ConductionLinearizedResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a6dc8e83e575ed8535136d927ab400f7d',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ConductionResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a2a2a74e0287f2c0e96a37c1a390b307d',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(JacobiOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a546c2859a1faf00eb845808a8aebeb98',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ConductionGatheredFieldManager)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#ac409a85b1ff6452d2765d38116e143d1',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(GradientSolutionUpdate)']]], - ['instantiate_5fpolystruct_1196',['INSTANTIATE_POLYSTRUCT',['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a70c43b10c72a67ad4824798d32721748',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(momentum_linearized_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#abcd2dbc89f7e89a8a124f713bf5ae64d',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(face_offsets_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#affbff5f335cc43ed31ba20d6cbf6be45',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(momentum_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a6005b54329210cdaf1dda78c3efa3560',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(advdiff_diagonal_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a7b2617d2850ba700ad571076e5d5989c',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(max_local_courant_reynolds_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ac4d54b4dea676b693362ddeb91616586',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(gather_required_lowmach_fields_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a86fa525f67f8010cb30d567b060b5e4c',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(local_dual_nodal_volume_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html#a6d74e1802ec4613dafb7475b3a8d0686',1,'sierra::nalu::matrix_free::geom::impl::INSTANTIATE_POLYSTRUCT()'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a4faa9698caabdf66ac48e77a1ee4c92a',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(scalar_neumann_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ab08bba24240f65a416dbbaad3f949c56',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(assemble_sparsified_edge_laplacian_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a7578c52131ffd18a34097b5f43acde56',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(stk_connectivity_map_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a91c0f1e805030debc6140f27f7aada43',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(create_offset_map_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ab5f2c2ee9de53f5ce60cf6d60a88adf5',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(face_node_map_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ab52a413821827676e5f5e15245b5ce36',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(field_gather_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a1f29740b6f4493abde36f7ba753cc434',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(transport_coefficients_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ae4e65c5539dc68cc9614824cd239643b',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(conduction_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html#a9952af9ba406d94c0baa579efca23513',1,'sierra::nalu::matrix_free::geom::impl::INSTANTIATE_POLYSTRUCT()'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a2181916e8949923547917ec9c5c37e09',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(conduction_diagonal_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a15305f116fd7ea39f677c4f7a41b151a',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(gather_required_conduction_fields_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a97e89d3756f13e91efd4e610a62f5e7c',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(conduction_linearized_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#aab9e71965c5bf818a714861148880b8a',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYSTRUCT(ConductionOffsetViews)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a0386706fcdcdc8114450bd7b0ee5427f',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYSTRUCT(ConductionSolutionUpdate)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a4ca2f251a2e51428d464ff530077e47e',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(continuity_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ab8a69982d80343ca0f90d192b795a6af',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(continuity_linearized_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a2ba6fc428d2cbac4c9300b50f6c1603c',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(filter_diagonal_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a6d515d9b8325099001504d4e27ba1b0b',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(gradient_boundary_closure_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a9718d3634c8502144cb4a7786f7914b6',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(gradient_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#aa8bcc8f17ed49bca5aca9b5fee96427a',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(filter_linearized_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html#a4beeaae42452a629971da3d6cf446682',1,'sierra::nalu::matrix_free::geom::impl::INSTANTIATE_POLYSTRUCT(linear_advection_metric_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html#a785be93057a3aa0a9e0622e9b43597c9',1,'sierra::nalu::matrix_free::geom::impl::INSTANTIATE_POLYSTRUCT(linear_areas_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html#a5999699b85e6117a625aa73cd38675b3',1,'sierra::nalu::matrix_free::geom::impl::INSTANTIATE_POLYSTRUCT(exposed_areas_t)']]], - ['interpolate_5fcoordinate_1197',['interpolate_coordinate',['../namespacesierra_1_1nalu_1_1impl.html#a6257b9bd7d269c9505756fcd7bf0e0eb',1,'sierra::nalu::impl']]], - ['interpolate_5ffield_1198',['interpolate_field',['../namespacesierra_1_1nalu_1_1actuator__utils.html#aa6c74e76bac5b5f56eabb7359ea48864',1,'sierra::nalu::actuator_utils']]], - ['interpolate_5fvalue_1199',['interpolate_value',['../namespacesierra_1_1nalu_1_1impl.html#af7da90888eaf3e46dd0c7b5439d3c8ac',1,'sierra::nalu::impl']]], - ['is_5froot_1200',['is_root',['../namespacesierra_1_1nalu.html#a9cdc98191ff46518ce80379c62865a82',1,'sierra::nalu']]], - ['is_5fside_1201',['is_side',['../namespacesierra_1_1nalu.html#af6e155f78643c966a7b841bde4c2f13b',1,'sierra::nalu']]], - ['is_5fsuper_1202',['is_super',['../namespacesierra_1_1nalu.html#afd9ff0e56577b1fa82d6c50f58985451',1,'sierra::nalu']]], - ['is_5fsuper_5fside_1203',['is_super_side',['../namespacesierra_1_1nalu.html#a5c87028d097b647b5691f2ed59b796fb',1,'sierra::nalu']]] + ['index_5fedge_5fnodes_1194',['index_edge_nodes',['../namespacesierra_1_1nalu_1_1impl.html#af287648b9b223c83f160823409000a4f',1,'sierra::nalu::impl']]], + ['index_5fface_5fnodes_1195',['index_face_nodes',['../namespacesierra_1_1nalu_1_1impl.html#ad60ea1e81878d44d742155e943b86ccc',1,'sierra::nalu::impl']]], + ['insert_5fcommunicated_5fcol_5findices_1196',['insert_communicated_col_indices',['../namespacesierra_1_1nalu.html#a18f21548e563c5d249f666c9d077d264',1,'sierra::nalu']]], + ['insert_5fsingle_5fdof_5frow_5finto_5fgraph_1197',['insert_single_dof_row_into_graph',['../namespacesierra_1_1nalu.html#a9a0574d769dc8d145dc3c1e8babcc889',1,'sierra::nalu']]], + ['instantiate_5falg_1198',['INSTANTIATE_ALG',['../namespacesierra_1_1nalu.html#a63ea328433b74e8cf01e67c55c0189aa',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsTri3_2D)'],['../namespacesierra_1_1nalu.html#ae93e070e29535c4ca0ba2e402d5f1771',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsQuad4_2D)'],['../namespacesierra_1_1nalu.html#aa99c3dafae87a68a62d498c6170c5e4e',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsWed6)'],['../namespacesierra_1_1nalu.html#a548dcd13c3d8616c8d2983564d6c628c',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsPyr5)'],['../namespacesierra_1_1nalu.html#a4db87bf4630d57c8442266195e318131',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsTet4)'],['../namespacesierra_1_1nalu.html#a501652ce34b805214b6cecf1c13a52d2',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsHex8)'],['../namespacesierra_1_1nalu.html#a427d95db810af78ee76eebc797034abb',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsEdge_2D)'],['../namespacesierra_1_1nalu.html#a51d75e7cc9d67bdd798704a55efc2983',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsQuad4)'],['../namespacesierra_1_1nalu.html#acd0e51e67d117052ef3c60b4453f9268',1,'sierra::nalu::INSTANTIATE_ALG(AlgTraitsTri3)']]], + ['instantiate_5fpolyclass_1199',['INSTANTIATE_POLYCLASS',['../namespacesierra_1_1nalu_1_1matrix__free.html#a0c839bf4e32e2511e622e3ece9dc13d4',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ComputeGradient)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a91e46391a2e17d6596e5d7ee63a33198',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(MomentumSolutionUpdate)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#ae2a66ed18b0643be6f83060e442191f2',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(MomentumLinearizedResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a118002c1051b41a558e58c1a28dc93e9',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(MomentumResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a9daa82c093d1f54c63e0dd2be6d0ebfc',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(MomentumJacobiOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#acaa5c2031cb3f7de19f5267ba91791df',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(LowMachUpdate)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a153d3fd54d7e334ccbc6ac8a5c1ae9af',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(LowMachGatheredFieldManager)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#ab51c4161a94b9bc87dd245c28b35ed4b',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(GradientLinearizedResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#aa2cc79e73e681fbff393ba46f93ea9e8',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(GradientResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a809f82288f12c9b7b1b030ffd8bd97bc',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(GreenGaussGradient)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a6d66ac61b016cf7394e52c2cd7b36858',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(FilterJacobiOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a51473c43201c26eb8ecf6fbd7ec94642',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ContinuitySolutionUpdate)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#aad9677b0ebe723f0d87fba79ffd39e8a',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ContinuityLinearizedResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a7821e001a918cce001d89f598b622836',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ContinuityResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#acbea689c87ef39f877729891a2d41c3c',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ConductionUpdate)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#aadfe41a6cd01ec80f5677791966b8cef',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ConductionLinearizedResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a6dc8e83e575ed8535136d927ab400f7d',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ConductionResidualOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a2a2a74e0287f2c0e96a37c1a390b307d',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(JacobiOperator)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a546c2859a1faf00eb845808a8aebeb98',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(ConductionGatheredFieldManager)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#ac409a85b1ff6452d2765d38116e143d1',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYCLASS(GradientSolutionUpdate)']]], + ['instantiate_5fpolystruct_1200',['INSTANTIATE_POLYSTRUCT',['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a70c43b10c72a67ad4824798d32721748',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(momentum_linearized_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#abcd2dbc89f7e89a8a124f713bf5ae64d',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(face_offsets_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#affbff5f335cc43ed31ba20d6cbf6be45',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(momentum_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a6005b54329210cdaf1dda78c3efa3560',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(advdiff_diagonal_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a7b2617d2850ba700ad571076e5d5989c',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(max_local_courant_reynolds_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ac4d54b4dea676b693362ddeb91616586',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(gather_required_lowmach_fields_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a86fa525f67f8010cb30d567b060b5e4c',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(local_dual_nodal_volume_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html#a6d74e1802ec4613dafb7475b3a8d0686',1,'sierra::nalu::matrix_free::geom::impl::INSTANTIATE_POLYSTRUCT()'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a4faa9698caabdf66ac48e77a1ee4c92a',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(scalar_neumann_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ab08bba24240f65a416dbbaad3f949c56',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(assemble_sparsified_edge_laplacian_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a7578c52131ffd18a34097b5f43acde56',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(stk_connectivity_map_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a91c0f1e805030debc6140f27f7aada43',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(create_offset_map_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ab5f2c2ee9de53f5ce60cf6d60a88adf5',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(face_node_map_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ab52a413821827676e5f5e15245b5ce36',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(field_gather_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a1f29740b6f4493abde36f7ba753cc434',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(transport_coefficients_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ae4e65c5539dc68cc9614824cd239643b',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(conduction_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html#a9952af9ba406d94c0baa579efca23513',1,'sierra::nalu::matrix_free::geom::impl::INSTANTIATE_POLYSTRUCT()'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a2181916e8949923547917ec9c5c37e09',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(conduction_diagonal_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a15305f116fd7ea39f677c4f7a41b151a',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(gather_required_conduction_fields_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a97e89d3756f13e91efd4e610a62f5e7c',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(conduction_linearized_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#aab9e71965c5bf818a714861148880b8a',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYSTRUCT(ConductionOffsetViews)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a0386706fcdcdc8114450bd7b0ee5427f',1,'sierra::nalu::matrix_free::INSTANTIATE_POLYSTRUCT(ConductionSolutionUpdate)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a4ca2f251a2e51428d464ff530077e47e',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(continuity_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#ab8a69982d80343ca0f90d192b795a6af',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(continuity_linearized_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a2ba6fc428d2cbac4c9300b50f6c1603c',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(filter_diagonal_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a6d515d9b8325099001504d4e27ba1b0b',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(gradient_boundary_closure_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#a9718d3634c8502144cb4a7786f7914b6',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(gradient_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html#aa8bcc8f17ed49bca5aca9b5fee96427a',1,'sierra::nalu::matrix_free::impl::INSTANTIATE_POLYSTRUCT(filter_linearized_residual_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html#a4beeaae42452a629971da3d6cf446682',1,'sierra::nalu::matrix_free::geom::impl::INSTANTIATE_POLYSTRUCT(linear_advection_metric_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html#a785be93057a3aa0a9e0622e9b43597c9',1,'sierra::nalu::matrix_free::geom::impl::INSTANTIATE_POLYSTRUCT(linear_areas_t)'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html#a5999699b85e6117a625aa73cd38675b3',1,'sierra::nalu::matrix_free::geom::impl::INSTANTIATE_POLYSTRUCT(exposed_areas_t)']]], + ['interpolate_5fcoordinate_1201',['interpolate_coordinate',['../namespacesierra_1_1nalu_1_1impl.html#a6257b9bd7d269c9505756fcd7bf0e0eb',1,'sierra::nalu::impl']]], + ['interpolate_5ffield_1202',['interpolate_field',['../namespacesierra_1_1nalu_1_1actuator__utils.html#aa6c74e76bac5b5f56eabb7359ea48864',1,'sierra::nalu::actuator_utils']]], + ['interpolate_5fvalue_1203',['interpolate_value',['../namespacesierra_1_1nalu_1_1impl.html#af7da90888eaf3e46dd0c7b5439d3c8ac',1,'sierra::nalu::impl']]], + ['is_5froot_1204',['is_root',['../namespacesierra_1_1nalu.html#a9cdc98191ff46518ce80379c62865a82',1,'sierra::nalu']]], + ['is_5fside_1205',['is_side',['../namespacesierra_1_1nalu.html#af6e155f78643c966a7b841bde4c2f13b',1,'sierra::nalu']]], + ['is_5fsuper_1206',['is_super',['../namespacesierra_1_1nalu.html#afd9ff0e56577b1fa82d6c50f58985451',1,'sierra::nalu']]], + ['is_5fsuper_5fside_1207',['is_super_side',['../namespacesierra_1_1nalu.html#a5c87028d097b647b5691f2ed59b796fb',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_9.js b/api_docs/search/functions_9.js index 7a50ece84..5751086a9 100644 --- a/api_docs/search/functions_9.js +++ b/api_docs/search/functions_9.js @@ -1,5 +1,5 @@ var searchData= [ - ['keep_5felems_5fnot_5falready_5fghosted_1204',['keep_elems_not_already_ghosted',['../namespacesierra_1_1nalu.html#aad46a0a20939f63f8765d9b84d765b99',1,'sierra::nalu']]], - ['keep_5fonly_5felems_1205',['keep_only_elems',['../namespacesierra_1_1nalu.html#a4aefe387e8f3e2cc4d78e644871523ba',1,'sierra::nalu']]] + ['keep_5felems_5fnot_5falready_5fghosted_1208',['keep_elems_not_already_ghosted',['../namespacesierra_1_1nalu.html#aad46a0a20939f63f8765d9b84d765b99',1,'sierra::nalu']]], + ['keep_5fonly_5felems_1209',['keep_only_elems',['../namespacesierra_1_1nalu.html#a4aefe387e8f3e2cc4d78e644871523ba',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_a.js b/api_docs/search/functions_a.js index 4f881fd00..6d3d90688 100644 --- a/api_docs/search/functions_a.js +++ b/api_docs/search/functions_a.js @@ -1,6 +1,6 @@ var searchData= [ - ['line_5faverage_1206',['line_average',['../namespacesierra_1_1nalu.html#a0f4a87e00f003d81a2c4ff29affb3ac5',1,'sierra::nalu']]], - ['line_5fintersection_5fwith_5fbox_1207',['line_intersection_with_box',['../namespacesierra_1_1nalu_1_1details.html#a85b191f8d4328ed3ddd5957cb3e4d7bd',1,'sierra::nalu::details']]], - ['local_5ffield_5finterpolation_1208',['local_field_interpolation',['../namespacesierra_1_1nalu.html#a2886563cd4a3869474548d1417c9b9de',1,'sierra::nalu']]] + ['line_5faverage_1210',['line_average',['../namespacesierra_1_1nalu.html#a0f4a87e00f003d81a2c4ff29affb3ac5',1,'sierra::nalu']]], + ['line_5fintersection_5fwith_5fbox_1211',['line_intersection_with_box',['../namespacesierra_1_1nalu_1_1details.html#a85b191f8d4328ed3ddd5957cb3e4d7bd',1,'sierra::nalu::details']]], + ['local_5ffield_5finterpolation_1212',['local_field_interpolation',['../namespacesierra_1_1nalu.html#a2886563cd4a3869474548d1417c9b9de',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_b.js b/api_docs/search/functions_b.js index 97610a08a..38778922b 100644 --- a/api_docs/search/functions_b.js +++ b/api_docs/search/functions_b.js @@ -1,16 +1,16 @@ var searchData= [ - ['make_5fbase_5fnodes_5fto_5felem_5fmap_5fat_5fboundary_1209',['make_base_nodes_to_elem_map_at_boundary',['../namespacesierra_1_1nalu_1_1impl.html#a8f18da19873da411ab2f62f8aa86589f',1,'sierra::nalu::impl']]], - ['make_5fnode_5fmap_5fhex_1210',['make_node_map_hex',['../namespacesierra_1_1nalu.html#a8231ea50321f66d8ca84321ab3089c3c',1,'sierra::nalu']]], - ['make_5fnode_5fmap_5fquad_1211',['make_node_map_quad',['../namespacesierra_1_1nalu.html#a2f16b37d1c021c8127acf853865488a8',1,'sierra::nalu']]], - ['make_5fowned_5fand_5fshared_5frow_5fmap_1212',['make_owned_and_shared_row_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#a266e9decf11b7b747f008fde0fefdcb0',1,'sierra::nalu::matrix_free']]], - ['make_5fowned_5frow_5fmap_1213',['make_owned_row_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#a86a9b06ea6ec3da5eb9c52b090cafc99',1,'sierra::nalu::matrix_free']]], - ['make_5fowned_5fshared_5fconstrained_5frow_5fmap_1214',['make_owned_shared_constrained_row_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#ac5ec9ec2519d227647dbd9f2d6f69a1f',1,'sierra::nalu::matrix_free']]], - ['make_5fradar_5fgrid_1215',['make_radar_grid',['../namespacesierra_1_1nalu_1_1details.html#a06527c78fbad35be88266f2c01f143e6',1,'sierra::nalu::details']]], - ['make_5fsegment_5fgenerator_1216',['make_segment_generator',['../namespacesierra_1_1nalu.html#a2208c729cb664373b20b0b9bf46557db',1,'sierra::nalu::make_segment_generator(SegmentType type)'],['../namespacesierra_1_1nalu.html#a61d0c594418ea0816c82b34a6c74bd33',1,'sierra::nalu::make_segment_generator(const std::string &name)']]], - ['make_5fside_5fnode_5fordinal_5fmap_5fhex_1217',['make_side_node_ordinal_map_hex',['../namespacesierra_1_1nalu.html#aa8f4d57651fa8dfdb0dd8238011fbc72',1,'sierra::nalu']]], - ['make_5fstk_5flid_5fto_5ftpetra_5flid_5fmap_1218',['make_stk_lid_to_tpetra_lid_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#adb5d491afed7e213524993ba6ee4d76d',1,'sierra::nalu::matrix_free']]], - ['mapbladeload_1219',['mapBladeLoad',['../namespacefsi.html#ac5c4efc2fc956deec5506ebd0b20a732',1,'fsi']]], - ['maptowerload_1220',['mapTowerLoad',['../namespacefsi.html#a24893f29ce3bd236f5f7e4544abef224',1,'fsi']]], - ['max_5fextent_1221',['max_extent',['../namespacesierra_1_1nalu.html#a795a1753fcba9ef5616d9cf86ae544a1',1,'sierra::nalu']]] + ['make_5fbase_5fnodes_5fto_5felem_5fmap_5fat_5fboundary_1213',['make_base_nodes_to_elem_map_at_boundary',['../namespacesierra_1_1nalu_1_1impl.html#a8f18da19873da411ab2f62f8aa86589f',1,'sierra::nalu::impl']]], + ['make_5fnode_5fmap_5fhex_1214',['make_node_map_hex',['../namespacesierra_1_1nalu.html#a8231ea50321f66d8ca84321ab3089c3c',1,'sierra::nalu']]], + ['make_5fnode_5fmap_5fquad_1215',['make_node_map_quad',['../namespacesierra_1_1nalu.html#a2f16b37d1c021c8127acf853865488a8',1,'sierra::nalu']]], + ['make_5fowned_5fand_5fshared_5frow_5fmap_1216',['make_owned_and_shared_row_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#a266e9decf11b7b747f008fde0fefdcb0',1,'sierra::nalu::matrix_free']]], + ['make_5fowned_5frow_5fmap_1217',['make_owned_row_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#a86a9b06ea6ec3da5eb9c52b090cafc99',1,'sierra::nalu::matrix_free']]], + ['make_5fowned_5fshared_5fconstrained_5frow_5fmap_1218',['make_owned_shared_constrained_row_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#ac5ec9ec2519d227647dbd9f2d6f69a1f',1,'sierra::nalu::matrix_free']]], + ['make_5fradar_5fgrid_1219',['make_radar_grid',['../namespacesierra_1_1nalu_1_1details.html#a06527c78fbad35be88266f2c01f143e6',1,'sierra::nalu::details']]], + ['make_5fsegment_5fgenerator_1220',['make_segment_generator',['../namespacesierra_1_1nalu.html#a2208c729cb664373b20b0b9bf46557db',1,'sierra::nalu::make_segment_generator(SegmentType type)'],['../namespacesierra_1_1nalu.html#a61d0c594418ea0816c82b34a6c74bd33',1,'sierra::nalu::make_segment_generator(const std::string &name)']]], + ['make_5fside_5fnode_5fordinal_5fmap_5fhex_1221',['make_side_node_ordinal_map_hex',['../namespacesierra_1_1nalu.html#aa8f4d57651fa8dfdb0dd8238011fbc72',1,'sierra::nalu']]], + ['make_5fstk_5flid_5fto_5ftpetra_5flid_5fmap_1222',['make_stk_lid_to_tpetra_lid_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#adb5d491afed7e213524993ba6ee4d76d',1,'sierra::nalu::matrix_free']]], + ['mapbladeload_1223',['mapBladeLoad',['../namespacefsi.html#ac5c4efc2fc956deec5506ebd0b20a732',1,'fsi']]], + ['maptowerload_1224',['mapTowerLoad',['../namespacefsi.html#a24893f29ce3bd236f5f7e4544abef224',1,'fsi']]], + ['max_5fextent_1225',['max_extent',['../namespacesierra_1_1nalu.html#a795a1753fcba9ef5616d9cf86ae544a1',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_c.js b/api_docs/search/functions_c.js index 08c1d4a3a..89ae9a35b 100644 --- a/api_docs/search/functions_c.js +++ b/api_docs/search/functions_c.js @@ -1,4 +1,4 @@ var searchData= [ - ['node_5fmap_1222',['node_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#a52fd5531948634ab10e19f465e3a2cad',1,'sierra::nalu::matrix_free']]] + ['node_5fmap_1226',['node_map',['../namespacesierra_1_1nalu_1_1matrix__free.html#a52fd5531948634ab10e19f465e3a2cad',1,'sierra::nalu::matrix_free']]] ]; diff --git a/api_docs/search/functions_d.js b/api_docs/search/functions_d.js index 27dec4549..198c680fd 100644 --- a/api_docs/search/functions_d.js +++ b/api_docs/search/functions_d.js @@ -1,9 +1,9 @@ var searchData= [ - ['octohedron_5fvolume_5fby_5ftriangle_5ffacets_1223',['octohedron_volume_by_triangle_facets',['../namespacesierra_1_1nalu.html#a5137676090f4bbb442f628b507993695',1,'sierra::nalu']]], - ['only_5fsuper_5felem_5fparts_1224',['only_super_elem_parts',['../namespacesierra_1_1nalu.html#a3c504f08283a643e34de5fc4fe6c5e23',1,'sierra::nalu']]], - ['only_5fsuper_5fparts_1225',['only_super_parts',['../namespacesierra_1_1nalu.html#ac55180852458de028e9700e183a9e6de',1,'sierra::nalu']]], - ['only_5fsuper_5fside_5fparts_1226',['only_super_side_parts',['../namespacesierra_1_1nalu.html#a64dc7ab0e0c9a9d6531862e1d8c88355',1,'sierra::nalu']]], - ['operator_28_29_1227',['operator()',['../structsierra_1_1nalu_1_1compare_gauss_point.html#aa99c03e41f4cc25583184cd38b200243',1,'sierra::nalu::compareGaussPoint::operator()(const uint64_t i, const std::pair< theKey, theKey > &p)'],['../structsierra_1_1nalu_1_1compare_gauss_point.html#a7b2f018b4847020df0e92d7585e75bea',1,'sierra::nalu::compareGaussPoint::operator()(const std::pair< theKey, theKey > &p, const uint64_t i)'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#ae9980bfb47b7299bfde4c0f2ff029d89',1,'sierra::nalu::CompareEntityById::operator()(const Connection &c0, const Connection &c1)'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#ac4cfabd4ff8baf450691cb845772a2e0',1,'sierra::nalu::CompareEntityById::operator()(const stk::mesh::Entity &e0, const stk::mesh::Entity &e1)'],['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#a08f60178d385fcfbd00e06ed98f446eb',1,'sierra::nalu::CompareEntityEqualById::operator()()'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#ae9980bfb47b7299bfde4c0f2ff029d89',1,'sierra::nalu::CompareEntityById::operator()(const Connection &c0, const Connection &c1)'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#ac4cfabd4ff8baf450691cb845772a2e0',1,'sierra::nalu::CompareEntityById::operator()(const stk::mesh::Entity &e0, const stk::mesh::Entity &e1)'],['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#a08f60178d385fcfbd00e06ed98f446eb',1,'sierra::nalu::CompareEntityEqualById::operator()()'],['../structsierra_1_1nalu_1_1sort_int_low_high.html#af2488f2a10771e8d16c248a951aa451f',1,'sierra::nalu::sortIntLowHigh::operator()()']]], - ['operator_3e_3e_1228',['operator>>',['../namespacesierra_1_1nalu.html#ab2b64dbaa56fdfa3aeb12402923442ca',1,'sierra::nalu::operator>>(const YAML::Node &node, std::map< std::string, std::vector< double >> &mapName)'],['../namespacesierra_1_1nalu.html#aeb18aa0c266eca3cdb18d1273becf854',1,'sierra::nalu::operator>>(const YAML::Node &node, std::map< std::string, std::vector< std::string >> &mapName)'],['../namespacesierra_1_1nalu.html#adf4b5d3a69d559ca31163416e680e8bf',1,'sierra::nalu::operator>>(const YAML::Node &node, std::map< std::string, std::string > &mapName)'],['../namespacesierra_1_1nalu.html#a9e442ced55667e225df14fc1aebc59f6',1,'sierra::nalu::operator>>(const YAML::Node &node, std::map< std::string, double > &mapName)'],['../namespacesierra_1_1nalu.html#a0abdc7ffb62a9d8d7f6406227f14daa8',1,'sierra::nalu::operator>>(const YAML::Node &node, std::map< std::string, bool > &mapName)'],['../namespacesierra_1_1nalu.html#a4efedf70db3c37b37a071a6564f54637',1,'sierra::nalu::operator>>(const YAML::Node &node, ConstantInitialConditionData &constIC)'],['../namespacesierra_1_1nalu.html#a5f33ed32862c37f49836ca1da9618817',1,'sierra::nalu::operator>>(const YAML::Node &node, StringFunctionInitialConditionData &fcnIC)'],['../namespacesierra_1_1nalu.html#a2c8cf76ebca7a1664c3f8a8551e8403d',1,'sierra::nalu::operator>>(const YAML::Node &node, UserFunctionInitialConditionData &fcnIC)'],['../namespacesierra_1_1nalu.html#abb40574d62ffdebccaf1469ab76e0f3e',1,'sierra::nalu::operator>>(const YAML::Node &node, NonConformalBoundaryConditionData &nonConformalBC)'],['../namespacesierra_1_1nalu.html#a40d219d2cad771b4b4f01e4762da41b0',1,'sierra::nalu::operator>>(const YAML::Node &node, PeriodicBoundaryConditionData &periodicBC)'],['../namespacesierra_1_1nalu.html#adc506580e74bd71809af6bb79fdcf79a',1,'sierra::nalu::operator>>(const YAML::Node &node, ABLTopBoundaryConditionData &abltopBC)'],['../namespacesierra_1_1nalu.html#a28aa9446130b960dfc255f3341d05649',1,'sierra::nalu::operator>>(const YAML::Node &node, SymmetryBoundaryConditionData &symmetryBC)'],['../namespacesierra_1_1nalu.html#ae5ef5f791ddc55c0df316be0d5ca9daf',1,'sierra::nalu::operator>>(const YAML::Node &node, OversetBoundaryConditionData &oversetBC)'],['../namespacesierra_1_1nalu.html#a4fc6f3fd4e0be2bbb7994ea393f2bf20',1,'sierra::nalu::operator>>(const YAML::Node &node, OpenBoundaryConditionData &openBC)'],['../namespacesierra_1_1nalu.html#ab2a22238255c3dd2f26c7ce159ef9774',1,'sierra::nalu::operator>>(const YAML::Node &node, InflowBoundaryConditionData &inflowBC)'],['../namespacesierra_1_1nalu.html#ae98959b258209a2182db4d15c2af103c',1,'sierra::nalu::operator>>(const YAML::Node &node, WallBoundaryConditionData &wallBC)']]] + ['octohedron_5fvolume_5fby_5ftriangle_5ffacets_1227',['octohedron_volume_by_triangle_facets',['../namespacesierra_1_1nalu.html#a5137676090f4bbb442f628b507993695',1,'sierra::nalu']]], + ['only_5fsuper_5felem_5fparts_1228',['only_super_elem_parts',['../namespacesierra_1_1nalu.html#a3c504f08283a643e34de5fc4fe6c5e23',1,'sierra::nalu']]], + ['only_5fsuper_5fparts_1229',['only_super_parts',['../namespacesierra_1_1nalu.html#ac55180852458de028e9700e183a9e6de',1,'sierra::nalu']]], + ['only_5fsuper_5fside_5fparts_1230',['only_super_side_parts',['../namespacesierra_1_1nalu.html#a64dc7ab0e0c9a9d6531862e1d8c88355',1,'sierra::nalu']]], + ['operator_28_29_1231',['operator()',['../structsierra_1_1nalu_1_1compare_gauss_point.html#aa99c03e41f4cc25583184cd38b200243',1,'sierra::nalu::compareGaussPoint::operator()(const uint64_t i, const std::pair< theKey, theKey > &p)'],['../structsierra_1_1nalu_1_1compare_gauss_point.html#a7b2f018b4847020df0e92d7585e75bea',1,'sierra::nalu::compareGaussPoint::operator()(const std::pair< theKey, theKey > &p, const uint64_t i)'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#ae9980bfb47b7299bfde4c0f2ff029d89',1,'sierra::nalu::CompareEntityById::operator()(const Connection &c0, const Connection &c1)'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#ac4cfabd4ff8baf450691cb845772a2e0',1,'sierra::nalu::CompareEntityById::operator()(const stk::mesh::Entity &e0, const stk::mesh::Entity &e1)'],['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#a08f60178d385fcfbd00e06ed98f446eb',1,'sierra::nalu::CompareEntityEqualById::operator()()'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#ae9980bfb47b7299bfde4c0f2ff029d89',1,'sierra::nalu::CompareEntityById::operator()(const Connection &c0, const Connection &c1)'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#ac4cfabd4ff8baf450691cb845772a2e0',1,'sierra::nalu::CompareEntityById::operator()(const stk::mesh::Entity &e0, const stk::mesh::Entity &e1)'],['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#a08f60178d385fcfbd00e06ed98f446eb',1,'sierra::nalu::CompareEntityEqualById::operator()()'],['../structsierra_1_1nalu_1_1sort_int_low_high.html#af2488f2a10771e8d16c248a951aa451f',1,'sierra::nalu::sortIntLowHigh::operator()()']]], + ['operator_3e_3e_1232',['operator>>',['../namespacesierra_1_1nalu.html#ab2b64dbaa56fdfa3aeb12402923442ca',1,'sierra::nalu::operator>>(const YAML::Node &node, std::map< std::string, std::vector< double >> &mapName)'],['../namespacesierra_1_1nalu.html#aeb18aa0c266eca3cdb18d1273becf854',1,'sierra::nalu::operator>>(const YAML::Node &node, std::map< std::string, std::vector< std::string >> &mapName)'],['../namespacesierra_1_1nalu.html#adf4b5d3a69d559ca31163416e680e8bf',1,'sierra::nalu::operator>>(const YAML::Node &node, std::map< std::string, std::string > &mapName)'],['../namespacesierra_1_1nalu.html#a9e442ced55667e225df14fc1aebc59f6',1,'sierra::nalu::operator>>(const YAML::Node &node, std::map< std::string, double > &mapName)'],['../namespacesierra_1_1nalu.html#a0abdc7ffb62a9d8d7f6406227f14daa8',1,'sierra::nalu::operator>>(const YAML::Node &node, std::map< std::string, bool > &mapName)'],['../namespacesierra_1_1nalu.html#a4efedf70db3c37b37a071a6564f54637',1,'sierra::nalu::operator>>(const YAML::Node &node, ConstantInitialConditionData &constIC)'],['../namespacesierra_1_1nalu.html#a5f33ed32862c37f49836ca1da9618817',1,'sierra::nalu::operator>>(const YAML::Node &node, StringFunctionInitialConditionData &fcnIC)'],['../namespacesierra_1_1nalu.html#a2c8cf76ebca7a1664c3f8a8551e8403d',1,'sierra::nalu::operator>>(const YAML::Node &node, UserFunctionInitialConditionData &fcnIC)'],['../namespacesierra_1_1nalu.html#abb40574d62ffdebccaf1469ab76e0f3e',1,'sierra::nalu::operator>>(const YAML::Node &node, NonConformalBoundaryConditionData &nonConformalBC)'],['../namespacesierra_1_1nalu.html#a40d219d2cad771b4b4f01e4762da41b0',1,'sierra::nalu::operator>>(const YAML::Node &node, PeriodicBoundaryConditionData &periodicBC)'],['../namespacesierra_1_1nalu.html#adc506580e74bd71809af6bb79fdcf79a',1,'sierra::nalu::operator>>(const YAML::Node &node, ABLTopBoundaryConditionData &abltopBC)'],['../namespacesierra_1_1nalu.html#a28aa9446130b960dfc255f3341d05649',1,'sierra::nalu::operator>>(const YAML::Node &node, SymmetryBoundaryConditionData &symmetryBC)'],['../namespacesierra_1_1nalu.html#ae5ef5f791ddc55c0df316be0d5ca9daf',1,'sierra::nalu::operator>>(const YAML::Node &node, OversetBoundaryConditionData &oversetBC)'],['../namespacesierra_1_1nalu.html#a4fc6f3fd4e0be2bbb7994ea393f2bf20',1,'sierra::nalu::operator>>(const YAML::Node &node, OpenBoundaryConditionData &openBC)'],['../namespacesierra_1_1nalu.html#ab2a22238255c3dd2f26c7ce159ef9774',1,'sierra::nalu::operator>>(const YAML::Node &node, InflowBoundaryConditionData &inflowBC)'],['../namespacesierra_1_1nalu.html#ae98959b258209a2182db4d15c2af103c',1,'sierra::nalu::operator>>(const YAML::Node &node, WallBoundaryConditionData &wallBC)']]] ]; diff --git a/api_docs/search/functions_e.js b/api_docs/search/functions_e.js index f900725c0..bab0fc235 100644 --- a/api_docs/search/functions_e.js +++ b/api_docs/search/functions_e.js @@ -1,16 +1,16 @@ var searchData= [ - ['parse_5fradar_5ffilter_1229',['parse_radar_filter',['../namespacesierra_1_1nalu_1_1details.html#a2a946e0695bc8f1b19bbb035c0a3ed7b',1,'sierra::nalu::details']]], - ['part_5fvector_5fis_5fvalid_5fand_5fnonempty_1230',['part_vector_is_valid_and_nonempty',['../namespacesierra_1_1nalu.html#a5ee3cbeccbaf1d18499b42c085fb971f',1,'sierra::nalu']]], - ['perform_5fparallel_5fconsolidation_5fof_5fnode_5fids_1231',['perform_parallel_consolidation_of_node_ids',['../namespacesierra_1_1nalu_1_1impl.html#a4dec633f91dd8e1c3567d94041753cc6',1,'sierra::nalu::impl']]], - ['plane_5fsweep_1232',['plane_sweep',['../namespacesierra_1_1nalu.html#a302332010e8057b4fa00d1a762b2a4a5',1,'sierra::nalu']]], - ['polyhedral_5fvolume_5fby_5ffaces_1233',['polyhedral_volume_by_faces',['../namespacesierra_1_1nalu.html#a29ba5f8c8d12cc079bb1d825edac9ad9',1,'sierra::nalu']]], - ['populate_5fdnv_5fstates_1234',['populate_dnv_states',['../namespacesierra_1_1nalu.html#a2d2c61267a116b0578f8ee86296793cb',1,'sierra::nalu']]], - ['populate_5fghost_5fcomm_5fprocs_1235',['populate_ghost_comm_procs',['../namespacesierra_1_1nalu.html#a36338e08955cd9f8fbb63d1778f42c4a',1,'sierra::nalu']]], - ['populate_5fglobal_5fid_5ffield_1236',['populate_global_id_field',['../namespacesierra_1_1nalu_1_1matrix__free.html#a0cecba1e8006760223e9f1c133da6eeb',1,'sierra::nalu::matrix_free::populate_global_id_field(const stk::mesh::NgpMesh &mesh, const stk::mesh::Selector &active_linsys, stk::mesh::NgpField< typename Tpetra::Map<>::global_ordinal_type > gids)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a8fa9345f7230148776442fc7236350bd',1,'sierra::nalu::matrix_free::populate_global_id_field(const stk::mesh::BulkData &bulk, const stk::mesh::Selector &active_linsys, stk::mesh::NgpField< typename Tpetra::Map<>::global_ordinal_type > gids)']]], - ['promote_5felements_5fhex_1237',['promote_elements_hex',['../namespacesierra_1_1nalu_1_1impl.html#a9ac427b81ca1bb60d75807e0fd1753cc',1,'sierra::nalu::impl']]], - ['pyr_5fderiv_1238',['pyr_deriv',['../namespacesierra_1_1nalu.html#a7aae86c0410f97d8c5f90791f0a3476a',1,'sierra::nalu']]], - ['pyr_5fgradient_5foperator_1239',['pyr_gradient_operator',['../namespacesierra_1_1nalu.html#aaf7ce409b78d68bf385b6c88104a0362',1,'sierra::nalu']]], - ['pyramid_5fshape_5ffcn_1240',['pyramid_shape_fcn',['../namespacesierra_1_1nalu.html#a9664aca16736cabe3906a6f5c84e1876',1,'sierra::nalu']]], - ['pyramid_5fshifted_5fshape_5ffcn_1241',['pyramid_shifted_shape_fcn',['../namespacesierra_1_1nalu.html#a20752a1ea8d77a5e9532b6bca8848738',1,'sierra::nalu']]] + ['parse_5fradar_5ffilter_1233',['parse_radar_filter',['../namespacesierra_1_1nalu_1_1details.html#a2a946e0695bc8f1b19bbb035c0a3ed7b',1,'sierra::nalu::details']]], + ['part_5fvector_5fis_5fvalid_5fand_5fnonempty_1234',['part_vector_is_valid_and_nonempty',['../namespacesierra_1_1nalu.html#a5ee3cbeccbaf1d18499b42c085fb971f',1,'sierra::nalu']]], + ['perform_5fparallel_5fconsolidation_5fof_5fnode_5fids_1235',['perform_parallel_consolidation_of_node_ids',['../namespacesierra_1_1nalu_1_1impl.html#a4dec633f91dd8e1c3567d94041753cc6',1,'sierra::nalu::impl']]], + ['plane_5fsweep_1236',['plane_sweep',['../namespacesierra_1_1nalu.html#a302332010e8057b4fa00d1a762b2a4a5',1,'sierra::nalu']]], + ['polyhedral_5fvolume_5fby_5ffaces_1237',['polyhedral_volume_by_faces',['../namespacesierra_1_1nalu.html#a29ba5f8c8d12cc079bb1d825edac9ad9',1,'sierra::nalu']]], + ['populate_5fdnv_5fstates_1238',['populate_dnv_states',['../namespacesierra_1_1nalu.html#a2d2c61267a116b0578f8ee86296793cb',1,'sierra::nalu']]], + ['populate_5fghost_5fcomm_5fprocs_1239',['populate_ghost_comm_procs',['../namespacesierra_1_1nalu.html#a36338e08955cd9f8fbb63d1778f42c4a',1,'sierra::nalu']]], + ['populate_5fglobal_5fid_5ffield_1240',['populate_global_id_field',['../namespacesierra_1_1nalu_1_1matrix__free.html#a0cecba1e8006760223e9f1c133da6eeb',1,'sierra::nalu::matrix_free::populate_global_id_field(const stk::mesh::NgpMesh &mesh, const stk::mesh::Selector &active_linsys, stk::mesh::NgpField< typename Tpetra::Map<>::global_ordinal_type > gids)'],['../namespacesierra_1_1nalu_1_1matrix__free.html#a8fa9345f7230148776442fc7236350bd',1,'sierra::nalu::matrix_free::populate_global_id_field(const stk::mesh::BulkData &bulk, const stk::mesh::Selector &active_linsys, stk::mesh::NgpField< typename Tpetra::Map<>::global_ordinal_type > gids)']]], + ['promote_5felements_5fhex_1241',['promote_elements_hex',['../namespacesierra_1_1nalu_1_1impl.html#a9ac427b81ca1bb60d75807e0fd1753cc',1,'sierra::nalu::impl']]], + ['pyr_5fderiv_1242',['pyr_deriv',['../namespacesierra_1_1nalu.html#a7aae86c0410f97d8c5f90791f0a3476a',1,'sierra::nalu']]], + ['pyr_5fgradient_5foperator_1243',['pyr_gradient_operator',['../namespacesierra_1_1nalu.html#aaf7ce409b78d68bf385b6c88104a0362',1,'sierra::nalu']]], + ['pyramid_5fshape_5ffcn_1244',['pyramid_shape_fcn',['../namespacesierra_1_1nalu.html#a9664aca16736cabe3906a6f5c84e1876',1,'sierra::nalu']]], + ['pyramid_5fshifted_5fshape_5ffcn_1245',['pyramid_shifted_shape_fcn',['../namespacesierra_1_1nalu.html#a20752a1ea8d77a5e9532b6bca8848738',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/functions_f.js b/api_docs/search/functions_f.js index 60d3921c6..1217b610f 100644 --- a/api_docs/search/functions_f.js +++ b/api_docs/search/functions_f.js @@ -1,5 +1,5 @@ var searchData= [ - ['quad_5fderivative_1242',['quad_derivative',['../namespacesierra_1_1nalu.html#a0f8b369dcbf90b26da7114163794accc',1,'sierra::nalu']]], - ['quad_5fgradient_5foperator_1243',['quad_gradient_operator',['../namespacesierra_1_1nalu.html#aa6ad051eff2c307b7776582e3e9cbf69',1,'sierra::nalu']]] + ['quad_5fderivative_1246',['quad_derivative',['../namespacesierra_1_1nalu.html#a0f8b369dcbf90b26da7114163794accc',1,'sierra::nalu']]], + ['quad_5fgradient_5foperator_1247',['quad_gradient_operator',['../namespacesierra_1_1nalu.html#aa6ad051eff2c307b7776582e3e9cbf69',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/namespaces_0.js b/api_docs/search/namespaces_0.js index 2ea0b3948..778239dfd 100644 --- a/api_docs/search/namespaces_0.js +++ b/api_docs/search/namespaces_0.js @@ -1,4 +1,4 @@ var searchData= [ - ['fsi_657',['fsi',['../namespacefsi.html',1,'']]] + ['fsi_659',['fsi',['../namespacefsi.html',1,'']]] ]; diff --git a/api_docs/search/namespaces_1.js b/api_docs/search/namespaces_1.js index b51e24095..8e5cb4fcf 100644 --- a/api_docs/search/namespaces_1.js +++ b/api_docs/search/namespaces_1.js @@ -1,12 +1,12 @@ var searchData= [ - ['actuator_5futils_658',['actuator_utils',['../namespacesierra_1_1nalu_1_1actuator__utils.html',1,'sierra::nalu']]], - ['details_659',['details',['../namespacesierra_1_1nalu_1_1details.html',1,'sierra::nalu']]], - ['geom_660',['geom',['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom.html',1,'sierra::nalu::matrix_free']]], - ['impl_661',['impl',['../namespacesierra_1_1nalu_1_1impl.html',1,'sierra::nalu::impl'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html',1,'sierra::nalu::matrix_free::geom::impl'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html',1,'sierra::nalu::matrix_free::impl']]], - ['matrix_5ffree_662',['matrix_free',['../namespacesierra_1_1nalu_1_1matrix__free.html',1,'sierra::nalu']]], - ['nalu_663',['nalu',['../namespacesierra_1_1nalu.html',1,'sierra']]], - ['overset_5futils_664',['overset_utils',['../namespacesierra_1_1nalu_1_1overset__utils.html',1,'sierra::nalu']]], - ['promotion_665',['promotion',['../namespacesierra_1_1nalu_1_1promotion.html',1,'sierra::nalu']]], - ['sierra_666',['sierra',['../namespacesierra.html',1,'']]] + ['actuator_5futils_660',['actuator_utils',['../namespacesierra_1_1nalu_1_1actuator__utils.html',1,'sierra::nalu']]], + ['details_661',['details',['../namespacesierra_1_1nalu_1_1details.html',1,'sierra::nalu']]], + ['geom_662',['geom',['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom.html',1,'sierra::nalu::matrix_free']]], + ['impl_663',['impl',['../namespacesierra_1_1nalu_1_1impl.html',1,'sierra::nalu::impl'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1geom_1_1impl.html',1,'sierra::nalu::matrix_free::geom::impl'],['../namespacesierra_1_1nalu_1_1matrix__free_1_1impl.html',1,'sierra::nalu::matrix_free::impl']]], + ['matrix_5ffree_664',['matrix_free',['../namespacesierra_1_1nalu_1_1matrix__free.html',1,'sierra::nalu']]], + ['nalu_665',['nalu',['../namespacesierra_1_1nalu.html',1,'sierra']]], + ['overset_5futils_666',['overset_utils',['../namespacesierra_1_1nalu_1_1overset__utils.html',1,'sierra::nalu']]], + ['promotion_667',['promotion',['../namespacesierra_1_1nalu_1_1promotion.html',1,'sierra::nalu']]], + ['sierra_668',['sierra',['../namespacesierra.html',1,'']]] ]; diff --git a/api_docs/search/namespaces_2.js b/api_docs/search/namespaces_2.js index a51d101ae..c630762e8 100644 --- a/api_docs/search/namespaces_2.js +++ b/api_docs/search/namespaces_2.js @@ -1,4 +1,4 @@ var searchData= [ - ['tioga_5fnalu_667',['tioga_nalu',['../namespacetioga__nalu.html',1,'']]] + ['tioga_5fnalu_669',['tioga_nalu',['../namespacetioga__nalu.html',1,'']]] ]; diff --git a/api_docs/search/namespaces_3.js b/api_docs/search/namespaces_3.js index d35b7d196..da45b4789 100644 --- a/api_docs/search/namespaces_3.js +++ b/api_docs/search/namespaces_3.js @@ -1,4 +1,4 @@ var searchData= [ - ['yaml_668',['YAML',['../namespace_y_a_m_l.html',1,'']]] + ['yaml_670',['YAML',['../namespace_y_a_m_l.html',1,'']]] ]; diff --git a/api_docs/search/variables_0.js b/api_docs/search/variables_0.js index 424bac9e9..afd958695 100644 --- a/api_docs/search/variables_0.js +++ b/api_docs/search/variables_0.js @@ -1,5 +1,5 @@ var searchData= [ - ['dim_1285',['dim',['../namespacesierra_1_1nalu.html#ac2666716cee53ddf96dbc72df0e69845',1,'sierra::nalu']]], - ['do_5fwrap_1286',['do_wrap',['../_perturbed_shear_layer_aux_functions_8_c.html#af7e5dbf94cd233a2bd9f6f750f45e829',1,'PerturbedShearLayerAuxFunctions.C']]] + ['dim_1289',['dim',['../namespacesierra_1_1nalu.html#ac2666716cee53ddf96dbc72df0e69845',1,'sierra::nalu']]], + ['do_5fwrap_1290',['do_wrap',['../_perturbed_shear_layer_aux_functions_8_c.html#af7e5dbf94cd233a2bd9f6f750f45e829',1,'PerturbedShearLayerAuxFunctions.C']]] ]; diff --git a/api_docs/search/variables_1.js b/api_docs/search/variables_1.js index 9192c931a..7a76282a8 100644 --- a/api_docs/search/variables_1.js +++ b/api_docs/search/variables_1.js @@ -1,4 +1,4 @@ var searchData= [ - ['inv_5finitial_5fvorticity_5fthickness_1287',['inv_initial_vorticity_thickness',['../_perturbed_shear_layer_aux_functions_8_c.html#a07a2307e27a0522b86087dfbb0bf62f5',1,'PerturbedShearLayerAuxFunctions.C']]] + ['inv_5finitial_5fvorticity_5fthickness_1291',['inv_initial_vorticity_thickness',['../_perturbed_shear_layer_aux_functions_8_c.html#a07a2307e27a0522b86087dfbb0bf62f5',1,'PerturbedShearLayerAuxFunctions.C']]] ]; diff --git a/api_docs/search/variables_2.js b/api_docs/search/variables_2.js index f00cc1891..4ad325ca7 100644 --- a/api_docs/search/variables_2.js +++ b/api_docs/search/variables_2.js @@ -1,4 +1,4 @@ var searchData= [ - ['lhs_1288',['lhs',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a9561de8c9a44099ccc05118cac283863',1,'AssembleNGPNodeSolverAlgorithm.C']]] + ['lhs_1292',['lhs',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a9561de8c9a44099ccc05118cac283863',1,'AssembleNGPNodeSolverAlgorithm.C']]] ]; diff --git a/api_docs/search/variables_3.js b/api_docs/search/variables_3.js index 2676b0715..c47424662 100644 --- a/api_docs/search/variables_3.js +++ b/api_docs/search/variables_3.js @@ -1,5 +1,5 @@ var searchData= [ - ['m_5fmesh_1289',['m_mesh',['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#a0db97a7c3c19d50d4880b9c8e6a459cc',1,'sierra::nalu::CompareEntityEqualById::m_mesh()'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#ae47081551ae8bb9de2128428dbd5bb0e',1,'sierra::nalu::CompareEntityById::m_mesh()']]], - ['m_5fnaluglobalid_1290',['m_naluGlobalId',['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#a14a9096ab6e166f89e699dbab55973b7',1,'sierra::nalu::CompareEntityEqualById::m_naluGlobalId()'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#a9a1e2d8e89801615c882846f1ce04bab',1,'sierra::nalu::CompareEntityById::m_naluGlobalId()']]] + ['m_5fmesh_1293',['m_mesh',['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#a0db97a7c3c19d50d4880b9c8e6a459cc',1,'sierra::nalu::CompareEntityEqualById::m_mesh()'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#ae47081551ae8bb9de2128428dbd5bb0e',1,'sierra::nalu::CompareEntityById::m_mesh()']]], + ['m_5fnaluglobalid_1294',['m_naluGlobalId',['../structsierra_1_1nalu_1_1_compare_entity_equal_by_id.html#a14a9096ab6e166f89e699dbab55973b7',1,'sierra::nalu::CompareEntityEqualById::m_naluGlobalId()'],['../structsierra_1_1nalu_1_1_compare_entity_by_id.html#a9a1e2d8e89801615c882846f1ce04bab',1,'sierra::nalu::CompareEntityById::m_naluGlobalId()']]] ]; diff --git a/api_docs/search/variables_4.js b/api_docs/search/variables_4.js index 81150cae5..1fb6fa451 100644 --- a/api_docs/search/variables_4.js +++ b/api_docs/search/variables_4.js @@ -1,6 +1,6 @@ var searchData= [ - ['ngpnodes_1291',['ngpNodes',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a8ae78296f280b2a9dd3fc7e059adef48',1,'AssembleNGPNodeSolverAlgorithm.C']]], - ['nodeid_1292',['nodeID',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a91ed7fb02393e91fba56191c256a4ddd',1,'AssembleNGPNodeSolverAlgorithm.C']]], - ['num_5fip_1293',['NUM_IP',['../namespacesierra_1_1nalu.html#a31e8fac32f75b9726b2d5f64f9e5fd95',1,'sierra::nalu']]] + ['ngpnodes_1295',['ngpNodes',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a8ae78296f280b2a9dd3fc7e059adef48',1,'AssembleNGPNodeSolverAlgorithm.C']]], + ['nodeid_1296',['nodeID',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a91ed7fb02393e91fba56191c256a4ddd',1,'AssembleNGPNodeSolverAlgorithm.C']]], + ['num_5fip_1297',['NUM_IP',['../namespacesierra_1_1nalu.html#a31e8fac32f75b9726b2d5f64f9e5fd95',1,'sierra::nalu']]] ]; diff --git a/api_docs/search/variables_5.js b/api_docs/search/variables_5.js index 0fafe1fcc..167a8f237 100644 --- a/api_docs/search/variables_5.js +++ b/api_docs/search/variables_5.js @@ -1,5 +1,5 @@ var searchData= [ - ['perturb_5fmag_1294',['perturb_mag',['../_perturbed_shear_layer_aux_functions_8_c.html#aa39c8ed88366ced02ad03e1756ab2ca3',1,'PerturbedShearLayerAuxFunctions.C']]], - ['pi_1295',['pi',['../namespacesierra_1_1nalu_1_1actuator__utils.html#a8798567e1e637d95a12cd97d6bab2a3e',1,'sierra::nalu::actuator_utils']]] + ['perturb_5fmag_1298',['perturb_mag',['../_perturbed_shear_layer_aux_functions_8_c.html#aa39c8ed88366ced02ad03e1756ab2ca3',1,'PerturbedShearLayerAuxFunctions.C']]], + ['pi_1299',['pi',['../namespacesierra_1_1nalu_1_1actuator__utils.html#a8798567e1e637d95a12cd97d6bab2a3e',1,'sierra::nalu::actuator_utils']]] ]; diff --git a/api_docs/search/variables_6.js b/api_docs/search/variables_6.js index af44eaea3..99342e20d 100644 --- a/api_docs/search/variables_6.js +++ b/api_docs/search/variables_6.js @@ -1,4 +1,4 @@ var searchData= [ - ['rhs_1296',['rhs',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a334d9fe2ab5f77f0b8bd96eaa89a9377',1,'AssembleNGPNodeSolverAlgorithm.C']]] + ['rhs_1300',['rhs',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a334d9fe2ab5f77f0b8bd96eaa89a9377',1,'AssembleNGPNodeSolverAlgorithm.C']]] ]; diff --git a/api_docs/search/variables_7.js b/api_docs/search/variables_7.js index 46c68f86b..a0f9308aa 100644 --- a/api_docs/search/variables_7.js +++ b/api_docs/search/variables_7.js @@ -1,8 +1,8 @@ var searchData= [ - ['scratchids_1297',['scratchIds',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#ab71e52108ebfb445abe42c4e1b4ec58a',1,'AssembleNGPNodeSolverAlgorithm.C']]], - ['size_5fratio_5fx_1298',['size_ratio_x',['../_perturbed_shear_layer_aux_functions_8_c.html#a9c87e5d31d7a790c0b998a4a557bda1f',1,'PerturbedShearLayerAuxFunctions.C']]], - ['size_5fratio_5fy_1299',['size_ratio_y',['../_perturbed_shear_layer_aux_functions_8_c.html#a4c91cf3ea735e6cb7c78ce348d189403',1,'PerturbedShearLayerAuxFunctions.C']]], - ['size_5fratio_5fz_1300',['size_ratio_z',['../_perturbed_shear_layer_aux_functions_8_c.html#a71b64ab91a1075d0da8f15c164a14225',1,'PerturbedShearLayerAuxFunctions.C']]], - ['sortpermutation_1301',['sortPermutation',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a9763514840c202b7cc306a4bc6205329',1,'AssembleNGPNodeSolverAlgorithm.C']]] + ['scratchids_1301',['scratchIds',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#ab71e52108ebfb445abe42c4e1b4ec58a',1,'AssembleNGPNodeSolverAlgorithm.C']]], + ['size_5fratio_5fx_1302',['size_ratio_x',['../_perturbed_shear_layer_aux_functions_8_c.html#a9c87e5d31d7a790c0b998a4a557bda1f',1,'PerturbedShearLayerAuxFunctions.C']]], + ['size_5fratio_5fy_1303',['size_ratio_y',['../_perturbed_shear_layer_aux_functions_8_c.html#a4c91cf3ea735e6cb7c78ce348d189403',1,'PerturbedShearLayerAuxFunctions.C']]], + ['size_5fratio_5fz_1304',['size_ratio_z',['../_perturbed_shear_layer_aux_functions_8_c.html#a71b64ab91a1075d0da8f15c164a14225',1,'PerturbedShearLayerAuxFunctions.C']]], + ['sortpermutation_1305',['sortPermutation',['../_assemble_n_g_p_node_solver_algorithm_8_c.html#a9763514840c202b7cc306a4bc6205329',1,'AssembleNGPNodeSolverAlgorithm.C']]] ]; diff --git a/api_docs/search/variables_8.js b/api_docs/search/variables_8.js index 8e71f2c86..6b6949d39 100644 --- a/api_docs/search/variables_8.js +++ b/api_docs/search/variables_8.js @@ -1,5 +1,5 @@ var searchData= [ - ['t0_5f_1302',['t0_',['../_matrix_free_low_mach_equation_system_8_c.html#a35bce11319e51cdabfdbd8be5d95a721',1,'MatrixFreeLowMachEquationSystem.C']]], - ['timer_5f_1303',['timer_',['../_matrix_free_low_mach_equation_system_8_c.html#af69f4c96956f81c6cda9ead6dc16316a',1,'MatrixFreeLowMachEquationSystem.C']]] + ['t0_5f_1306',['t0_',['../_matrix_free_low_mach_equation_system_8_c.html#a35bce11319e51cdabfdbd8be5d95a721',1,'MatrixFreeLowMachEquationSystem.C']]], + ['timer_5f_1307',['timer_',['../_matrix_free_low_mach_equation_system_8_c.html#af69f4c96956f81c6cda9ead6dc16316a',1,'MatrixFreeLowMachEquationSystem.C']]] ]; diff --git a/api_docs/search/variables_9.js b/api_docs/search/variables_9.js index 7bf55b09d..8571b7e45 100644 --- a/api_docs/search/variables_9.js +++ b/api_docs/search/variables_9.js @@ -1,6 +1,6 @@ var searchData= [ - ['v0_1304',['v0',['../_lidar_patterns_8_c.html#a9d30747f282fcf3cf96f805b675e28c2',1,'LidarPatterns.C']]], - ['v1_1305',['v1',['../_lidar_patterns_8_c.html#a85c5ca749db7f4ea1897745aaae53ea4',1,'LidarPatterns.C']]], - ['v2_1306',['v2',['../_lidar_patterns_8_c.html#a25f4f6f41e71398d2454691d64c7fc67',1,'LidarPatterns.C']]] + ['v0_1308',['v0',['../_lidar_patterns_8_c.html#a9d30747f282fcf3cf96f805b675e28c2',1,'LidarPatterns.C']]], + ['v1_1309',['v1',['../_lidar_patterns_8_c.html#a85c5ca749db7f4ea1897745aaae53ea4',1,'LidarPatterns.C']]], + ['v2_1310',['v2',['../_lidar_patterns_8_c.html#a25f4f6f41e71398d2454691d64c7fc67',1,'LidarPatterns.C']]] ]; diff --git a/objects.inv b/objects.inv index 207f36f66..922ac4a29 100644 Binary files a/objects.inv and b/objects.inv differ diff --git a/searchindex.js b/searchindex.js index 63ac660e0..3e620e6ce 100644 --- a/searchindex.js +++ b/searchindex.js @@ -1 +1 @@ -Search.setIndex({"alltitles": {"2-D Topologies": [[4, "id1"]], "2D Steady Laplace Operator": [[51, "d-steady-laplace-operator"]], "2D Unsteady Uniform Property: Convecting Decaying Taylor Vortex": [[51, null]], "3-D Topologies": [[4, "d-topologies"]], "3D Hybrid 1x1x1 Cube: Laplace": [[51, "d-hybrid-1x1x1-cube-laplace"]], "3D Hybrid 1x2x10 Duct: Specified Pressure Drop": [[51, "d-hybrid-1x2x10-duct-specified-pressure-drop"]], "3D Steady Laplace Operator with Nonconformal Interface": [[51, "d-steady-laplace-operator-with-nonconformal-interface"]], "3D Steady Non-isothermal with Buoyancy": [[51, "d-steady-non-isothermal-with-buoyancy"]], "3D Steady Non-uniform with Buoyancy": [[51, "d-steady-non-uniform-with-buoyancy"]], "ABL Forcing": [[42, null], [43, "abl-forcing"]], "ABL Forcing Source Terms": [[32, "abl-forcing-source-terms"]], "ABL Utilities": [[7, "abl-utilities"]], "ABL Wall Function": [[20, "abl-wall-function"]], "AMS of the Atmospheric Boundary Layer": [[20, "ams-of-the-atmospheric-boundary-layer"]], "AMS with SST Mixing Length Limiter": [[32, "ams-with-sst-mixing-length-limiter"]], "Active Model Split (AMS) Formulation": [[32, "active-model-split-ams-formulation"]], "Actuator Sources": [[1, null]], "Actuator Turbine Model": [[43, "actuator-turbine-model"], [46, null]], "Actuator line simulations coupled to OpenFAST": [[51, "actuator-line-simulations-coupled-to-openfast"]], "Adaptivity": [[18, null]], "Adding Testing Machines to CDash": [[14, "adding-testing-machines-to-cdash"]], "Adding Tests to Nalu-Wind": [[14, "adding-tests-to-nalu-wind"]], "Advection Stabilization": [[19, null]], "Application Verification Test; ABL Precursor/Subsequent": [[51, "application-verification-test-abl-precursor-subsequent"]], "Application Verification Test; Convecting Taylor Vortex": [[51, "application-verification-test-convecting-taylor-vortex"]], "Approximations for the Schur complement": [[36, "approximations-for-the-schur-complement"]], "Asymptotic Expansion": [[25, "asymptotic-expansion"]], "Atmospheric Boundary Layer Surface Conditions": [[20, "atmospheric-boundary-layer-surface-conditions"]], "Atmospheric Boundary Layer Top Conditions": [[20, "atmospheric-boundary-layer-top-conditions"]], "Auxiliary Functions": [[7, null]], "Averaging functions": [[32, "averaging-functions"]], "Boost v1.68.0": [[37, "boost-v1-68-0"]], "Boundary Conditions": [[43, "boundary-conditions"]], "Boundary Layer Statistics": [[43, "boundary-layer-statistics"]], "Boussinesq Buoyancy Model": [[32, "boussinesq-buoyancy-model"]], "Boussinesq Verification": [[51, "boussinesq-verification"]], "Buckets": [[21, "buckets"]], "Build": [[37, "build"], [37, "id1"]], "Build Nalu-Wind ParaView Catalyst Adapter": [[37, "build-nalu-wind-paraview-catalyst-adapter"]], "Building Nalu-Wind": [[39, null]], "Building Nalu-Wind Manually": [[37, null]], "Building Nalu-Wind Semi-Automatically Using Spack": [[38, null]], "Building inside Docker Container": [[38, "building-inside-docker-container"]], "Building the Documentation": [[8, null]], "CMake v3.12.4": [[37, "cmake-v3-12-4"]], "CVFEM Dual Mesh": [[23, "cvfem-dual-mesh"]], "CVFEM and FEM Interface": [[4, null]], "Code Abstractions": [[21, null]], "Common options": [[43, "common-options"]], "Connectivity": [[21, "connectivity"]], "Conservation of Energy": [[32, "conservation-of-energy"]], "Conservation of Mass": [[32, "conservation-of-mass"]], "Conservation of Momentum": [[32, "conservation-of-momentum"]], "Conservation of Species": [[32, "conservation-of-species"]], "Continuity": [[20, "continuity"], [20, "id1"], [20, "id16"]], "Continuity, Mixture Fraction, Enthalpy, Species, k_{sgs}, k and \\omega": [[20, "continuity-mixture-fraction-enthalpy-species-k-sgs-k-and-omega"]], "Continuous Integration": [[12, "continuous-integration"]], "Contributing to Nalu-Wind": [[10, null]], "Convecting Taylor Vortex": [[7, "convecting-taylor-vortex"]], "Coupling Approach": [[22, null]], "Daily Regression Tests": [[12, "daily-regression-tests"]], "Data probes": [[43, "data-probes"]], "Definition of the test function": [[31, "definition-of-the-test-function"]], "Density": [[30, "density"]], "Detached Eddy Simulation (DES) Formulation": [[32, "detached-eddy-simulation-des-formulation"]], "Developer Manual": [[11, null]], "Developer Workflow": [[15, null]], "Development Build of Nalu-Wind": [[38, "development-build-of-nalu-wind"]], "Development Infrastructure": [[12, null]], "Diffusion": [[23, "diffusion"]], "Discretization Approach": [[23, null]], "Docker Container": [[12, "docker-container"]], "Dynamic Hybrid Diagnostics": [[32, "dynamic-hybrid-diagnostics"]], "Earth Coriolis Force": [[32, "earth-coriolis-force"]], "Edge-Based Discretization": [[23, "edge-based-discretization"]], "Enthalpy": [[20, "enthalpy"]], "Equation Systems": [[2, null], [43, "equation-systems"]], "EquationSystem": [[21, "equationsystem"]], "Error in temperature": [[51, "id28"]], "Error in x-component of velocity": [[51, "id25"]], "Error in y-component of velocity": [[51, "id26"]], "Error in z-component of velocity": [[51, "id27"]], "Errors due to Splitting and Stabilization": [[22, "errors-due-to-splitting-and-stabilization"]], "Examining Exodus-II Files": [[44, "examining-exodus-ii-files"]], "Exodus-II File Format": [[44, null]], "Expected result": [[48, "expected-result"], [48, "id2"]], "Field Data Access": [[21, "field-data-access"]], "Field Data Registration": [[21, "field-data-registration"]], "Filtered Mixture Fraction": [[32, "filtered-mixture-fraction"]], "Finite Element SUPG Form": [[31, "finite-element-supg-form"]], "Fixed Wing Verification Problem": [[51, "fixed-wing-verification-problem"]], "Fluid-Structure Interaction": [[43, "fluid-structure-interaction"]], "Forcing Term": [[32, "forcing-term"]], "General Findings": [[27, "general-findings"]], "General Pointwise Tips": [[41, "general-pointwise-tips"]], "GitHub Actions": [[12, "github-actions"]], "Governing Equations": [[36, "governing-equations"]], "HDF5 v1.10.4": [[37, "hdf5-v1-10-4"]], "HYPRE": [[37, "hypre"]], "High Level Nalu-Wind Abstractions": [[21, "high-level-nalu-wind-abstractions"]], "Higher Order 2D Steady Uniform Property: Taylor Vortex": [[51, "higher-order-2d-steady-uniform-property-taylor-vortex"]], "Homebrew": [[37, "homebrew"]], "Hybrid RANS/LES Models": [[35, "hybrid-rans-les-models"]], "Implementation Details": [[20, "implementation-details"]], "Inflow Boundary Condition": [[20, "inflow-boundary-condition"], [43, "inflow-boundary-condition"]], "Inflow-Outflow Capability": [[20, "inflow-outflow-capability"]], "Infrastructure Unit Test": [[51, "infrastructure-unit-test"]], "Initial & Boundary Conditions": [[36, "initial-boundary-conditions"]], "Initial conditions": [[36, "initial-conditions"], [43, "initial-conditions"]], "Inlet conditions": [[36, "inlet-conditions"]], "Install the Tools": [[8, "install-the-tools"]], "Intensity": [[20, "intensity"]], "Introduction": [[41, "introduction"], [50, null]], "Invoking Nalu-Wind - Command-line options": [[45, null]], "Kovasznay 2-D Flow": [[7, "kovasznay-2-d-flow"]], "Lame Properties": [[30, "lame-properties"]], "Lessons Learned": [[41, "lessons-learned"]], "Lessons Learned from Meshing the McAlister Case": [[41, null]], "Libxml2 v2.9.8": [[37, "libxml2-v2-9-8"]], "Linear Solver Interface": [[6, "linear-solver-interface"]], "Linear Solvers": [[43, "linear-solvers"]], "Linear Solvers Interface": [[3, "linear-solvers-interface"]], "Linear Solvers and Systems Interface": [[3, null]], "Linear Systems": [[3, "linear-systems"]], "Linux and OSX": [[37, "linux-and-osx"]], "Local or Projected NSO Diffusive Flux Coefficient": [[27, "local-or-projected-nso-diffusive-flux-coefficient"]], "Low Mach Number Derivation": [[25, null]], "Mac OS X or Linux": [[38, "mac-os-x-or-linux"]], "Make the Docs": [[8, "make-the-docs"]], "Material Properties": [[43, "material-properties"]], "Mesh Motion": [[43, "mesh-motion"]], "Mesh Motion/Displacement Utilities": [[7, "mesh-motion-displacement-utilities"]], "Mesh Transformation": [[43, "mesh-transformation"]], "Meshes": [[41, "meshes"]], "Meta and Bulk Data": [[21, "meta-and-bulk-data"]], "Mixture Fraction": [[20, "mixture-fraction"]], "Mixture Fraction, Enthalpy, Species, k_{sgs}, k and \\omega": [[20, "mixture-fraction-enthalpy-species-k-sgs-k-and-omega"]], "Momentum": [[20, "momentum"], [20, "id17"], [20, "id18"]], "Momentum Stress": [[23, "momentum-stress"]], "Momentum and Pressure": [[51, "momentum-and-pressure"]], "Momentum, Mixture Fraction, Enthalpy, Species, k_{sgs}, k and \\omega": [[20, "momentum-mixture-fraction-enthalpy-species-k-sgs-k-and-omega"]], "Monin-Obukhov Theory": [[20, "monin-obukhov-theory"]], "Moving Mesh": [[32, "moving-mesh"]], "Multi-Physics": [[26, null]], "NREL\u2019s Eagle Machine": [[38, "nrel-s-eagle-machine"]], "NSO Based on Kinetic Energy Residual": [[27, "nso-based-on-kinetic-energy-residual"]], "NSO as a Turbulence Model": [[27, "nso-as-a-turbulence-model"]], "Nalu Style Guide": [[13, null]], "Nalu-Wind": [[37, "nalu-wind"]], "Nalu-Wind - Theory Manual": [[24, null]], "Nalu-Wind - Verification Manual": [[49, null]], "Nalu-Wind Documentation": [[0, null]], "Nalu-Wind Input File": [[43, null]], "Nalu-Wind \u2013 Actuator Disk Model via OpenFAST": [[36, "nalu-wind-actuator-disk-model-via-openfast"]], "Nalu-Wind \u2013 OpenFAST Coupling Algorithm": [[36, "nalu-wind-openfast-coupling-algorithm"]], "NetCDF v4.6.1": [[37, "netcdf-v4-6-1"]], "NetCDF v4.6.1 and Parallel NetCDF v1.8.0": [[37, "netcdf-v4-6-1-and-parallel-netcdf-v1-8-0"]], "Non-Conformal Boundary": [[43, "non-conformal-boundary"]], "Non-conformal Boundary Condition": [[20, "non-conformal-boundary-condition"]], "Nonlinear Stabilization Operator (NSO)": [[27, null]], "Notes on Geometry": [[41, "notes-on-geometry"]], "Numerical Discretization & Stabilization": [[36, "numerical-discretization-stabilization"]], "One Equation k^{sgs}": [[35, "one-equation-k-sgs"]], "Open Boundary Condition": [[20, "open-boundary-condition"], [43, "open-boundary-condition"]], "Open Boundary Condition With Outflow Thermal Stratification": [[51, "open-boundary-condition-with-outflow-thermal-stratification"]], "Other Exodus-II Utilities": [[44, "other-exodus-ii-utilities"]], "Outlet conditions": [[36, "outlet-conditions"]], "Output Options": [[43, "output-options"]], "Overset": [[28, null]], "Overset Grid Assembly using Native STK Search": [[28, "overset-grid-assembly-using-native-stk-search"]], "Overset Grid Assembly using TIOGA": [[28, "overset-grid-assembly-using-tioga"]], "ParaView Catalyst": [[37, "paraview-catalyst"]], "Parabolic Temperature Profile: Equal Specified Temperature Gradients": [[51, "parabolic-temperature-profile-equal-specified-temperature-gradients"]], "Parallel NetCDF v1.8.0": [[37, "parallel-netcdf-v1-8-0"]], "Parallel Rules": [[21, "parallel-rules"]], "Parts": [[21, "parts"]], "Periodic Boundary Condition": [[20, "periodic-boundary-condition"], [43, "periodic-boundary-condition"]], "Physics Realm Options": [[43, "physics-realm-options"]], "Post-Processing Utilities": [[5, null]], "Post-processing": [[43, "post-processing"]], "Precursor-based Simulations": [[51, "precursor-based-simulations"]], "Preparation": [[48, "preparation"]], "Pressure Stabilization": [[29, null]], "Projected Nodal Gradients": [[23, "projected-nodal-gradients"]], "Projected nodal gradients": [[51, "projected-nodal-gradients"]], "Prolongation and Restriction": [[18, "prolongation-and-restriction"]], "Property Evaluations": [[30, null]], "Pure Edge-based Upwind Method": [[31, "pure-edge-based-upwind-method"]], "RANS Model Suite": [[32, "rans-model-suite"]], "RANS Models": [[35, "rans-models"]], "RTE Stabilization": [[31, null]], "Radiative Transport Equation": [[32, "radiative-transport-equation"]], "Realm": [[21, "realm"]], "Realms": [[6, "realms"]], "References": [[41, "references"], [52, null]], "Regression Test Case": [[48, "regression-test-case"]], "Restart Options": [[43, "restart-options"]], "Review of Prandtl, Schmidt and Unity Lewis Number": [[32, "review-of-prandtl-schmidt-and-unity-lewis-number"]], "Run CMake Configure": [[8, "run-cmake-configure"]], "Running": [[48, "running"], [48, "id1"]], "Running Nalu-Wind": [[47, null]], "Running Tests Locally": [[14, "running-tests-locally"]], "SST Mixing Length Limiter": [[32, "sst-mixing-length-limiter"]], "SST of the Atmospheric Boundary Layer": [[20, "sst-of-the-atmospheric-boundary-layer"]], "Selectors": [[21, "selectors"]], "Shear Stress Transport (SST) Formulation": [[32, "shear-stress-transport-sst-formulation"]], "Sierra Toolkit Abstractions": [[21, "sierra-toolkit-abstractions"]], "Simple Linear Temperature Profile: Equal and Opposite Specified Temperature Gradients": [[51, "simple-linear-temperature-profile-equal-and-opposite-specified-temperature-gradients"]], "Simulation \u2013 Nalu Top-level Interface": [[6, null]], "Simulations": [[43, "simulations"]], "Solid Stress": [[20, "solid-stress"], [32, "solid-stress"]], "Solution Options": [[43, "solution-options"]], "Solver Configuration": [[3, "solver-configuration"]], "Source Code Documentation": [[9, null]], "Source Term Quadrature": [[51, "source-term-quadrature"]], "Species": [[20, "species"]], "Specific Heat": [[30, "specific-heat"]], "Specified Boundary-Normal Temperature Gradient Option": [[20, "specified-boundary-normal-temperature-gradient-option"]], "Specified Normal Temperature Gradient Boundary Condition": [[51, "specified-normal-temperature-gradient-boundary-condition"]], "Split subgrid model stress": [[32, "split-subgrid-model-stress"]], "Standard Smagorinsky LES Model": [[35, "standard-smagorinsky-les-model"]], "State": [[21, "state"]], "Statistics of Current Mesh (grid07_conformal10.exo)": [[41, "statistics-of-current-mesh-grid07-conformal10-exo"]], "Steady Taylor Vortex": [[7, "steady-taylor-vortex"]], "Steady Thermal MMS (2-D and 3-D)": [[7, "steady-thermal-mms-2-d-and-3-d"]], "Step 1": [[38, "step-1"], [38, "id1"]], "Step 2": [[38, "step-2"], [38, "id2"]], "Step 3": [[38, "step-3"], [38, "id3"]], "Step 4": [[38, "step-4"], [38, "id4"]], "Step 5": [[38, "step-5"], [38, "id5"]], "Step 6": [[38, "step-6"], [38, "id6"]], "Stratified MMS": [[51, "stratified-mms"]], "Strong Symmetry Boundary Condition": [[20, "strong-symmetry-boundary-condition"]], "Subgrid-Scale Kinetic Energy One-Equation LES Model": [[32, "subgrid-scale-kinetic-energy-one-equation-les-model"]], "SuperLU v4.3": [[37, "superlu-v4-3"]], "Supported Boundary Conditions": [[20, null]], "Supported Equation Set": [[32, null]], "Surface Mesh": [[41, "surface-mesh"]], "Symmetry Boundary Condition": [[43, "symmetry-boundary-condition"]], "Temperature Gradient Capability": [[20, "temperature-gradient-capability"]], "Temporal Order Of Accuracy Results": [[51, "temporal-order-of-accuracy-results"]], "Terrain (Wall) boundary condition": [[36, "terrain-wall-boundary-condition"]], "Testing Nalu-Wind": [[14, null]], "The Role of \\dot m": [[29, "the-role-of-dot-m"]], "The form of \\tau": [[31, "the-form-of-tau"]], "Thermal Heat Conduction": [[20, "thermal-heat-conduction"], [32, "thermal-heat-conduction"]], "Time Integration": [[6, "time-integration"]], "Time Integration Options": [[43, "time-integration-options"]], "Time and Source Terms": [[23, "time-and-source-terms"]], "Time discretization": [[33, null]], "Time stepping scheme": [[36, "time-stepping-scheme"]], "Time-step Control Options": [[43, "time-step-control-options"]], "Top boundary condition": [[36, "top-boundary-condition"]], "Topological Support": [[34, null]], "Transfers": [[6, "transfers"], [43, "transfers"]], "Trilinos": [[37, "trilinos"]], "Turbulence Modeling": [[35, null], [36, "turbulence-modeling"]], "Turbulence averaging": [[43, "turbulence-averaging"]], "Turbulent Kinetic Energy and Specific Dissipation SST High Reynolds Number Boundary conditions": [[20, "turbulent-kinetic-energy-and-specific-dissipation-sst-high-reynolds-number-boundary-conditions"]], "Turbulent Kinetic Energy and Specific Dissipation SST Low Reynolds Number Boundary conditions": [[20, "turbulent-kinetic-energy-and-specific-dissipation-sst-low-reynolds-number-boundary-conditions"]], "Turbulent Kinetic Energy, k_{sgs} LES model": [[20, "turbulent-kinetic-energy-k-sgs-les-model"]], "Underrelaxation for momentum and scalar transport": [[36, "underrelaxation-for-momentum-and-scalar-transport"]], "Unit Tests": [[48, "unit-tests"]], "Unit tests": [[51, "unit-tests"]], "Updating Reference Data for Your Machine": [[14, "updating-reference-data-for-your-machine"]], "User Manual": [[40, null]], "Verifying that the installation of Nalu-Wind works": [[48, null]], "Viscosity": [[30, "viscosity"]], "Wall Adapting Local Eddy-Viscosity, WALE": [[35, "wall-adapting-local-eddy-viscosity-wale"]], "Wall Boundary Condition": [[43, "wall-boundary-condition"]], "Wall Boundary Conditions": [[20, "wall-boundary-conditions"]], "Wall Distance Computation": [[32, "wall-distance-computation"]], "Wall Models": [[35, "wall-models"]], "Weak Symmetry Boundary Condition": [[20, "weak-symmetry-boundary-condition"]], "Wind Energy Modeling": [[36, null]], "Wind Turbine Modeling": [[36, "wind-turbine-modeling"]], "Writing Developer Documentation": [[16, null]], "Writing User Documentation": [[17, null]], "YAML-CPP 0.6.2": [[37, "yaml-cpp-0-6-2"]], "Zlib v1.2.11": [[37, "zlib-v1-2-11"]]}, "docnames": ["index", "source/developer/apidocs/actuatorsources", "source/developer/apidocs/eqsystems", "source/developer/apidocs/linsys", "source/developer/apidocs/masterelem", "source/developer/apidocs/postprocess", "source/developer/apidocs/realms", "source/developer/apidocs/userfunc", "source/developer/build_doc", "source/developer/code", "source/developer/contrib", "source/developer/index", "source/developer/infra", "source/developer/style", "source/developer/testing", "source/developer/workflow", "source/developer/write_developer_doc", "source/developer/write_user_doc", "source/theory/adaptivity", "source/theory/advectionStabilization", "source/theory/boundaryConditions", "source/theory/codeAbstractions", "source/theory/couplingApproach", "source/theory/discretizationApproach", "source/theory/index", "source/theory/lowMachNumberDerivation", "source/theory/multiPhysics", "source/theory/nso", "source/theory/overset", "source/theory/pressureStabilization", "source/theory/propertyEvaluation", "source/theory/rteStabilization", "source/theory/supportedEquationSet", "source/theory/timeDiscretization", "source/theory/topologicalSupport", "source/theory/turbulenceModeling", "source/theory/windEnergy", "source/user/build_manually", "source/user/build_spack", "source/user/building", "source/user/index", "source/user/nalu_run/McAlisterLessonsLearned", "source/user/nalu_run/abl_forcing", "source/user/nalu_run/nalu_inp", "source/user/nalu_run/nalu_mesh", "source/user/nalu_run/nalux", "source/user/nalu_run/turbine_modeling", "source/user/running", "source/user/verify_installation", "source/verification/index", "source/verification/introduction", "source/verification/verification", "zrefs"], "envversion": {"sphinx": 62, "sphinx.domains.c": 3, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 9, "sphinx.domains.index": 1, "sphinx.domains.javascript": 3, "sphinx.domains.math": 2, "sphinx.domains.python": 4, "sphinx.domains.rst": 2, "sphinx.domains.std": 2}, "filenames": ["index.rst", "source/developer/apidocs/actuatorsources.rst", "source/developer/apidocs/eqsystems.rst", "source/developer/apidocs/linsys.rst", "source/developer/apidocs/masterelem.rst", "source/developer/apidocs/postprocess.rst", "source/developer/apidocs/realms.rst", "source/developer/apidocs/userfunc.rst", "source/developer/build_doc.rst", "source/developer/code.rst", "source/developer/contrib.rst", "source/developer/index.rst", "source/developer/infra.rst", "source/developer/style.rst", "source/developer/testing.rst", "source/developer/workflow.rst", "source/developer/write_developer_doc.rst", "source/developer/write_user_doc.rst", "source/theory/adaptivity.rst", "source/theory/advectionStabilization.rst", "source/theory/boundaryConditions.rst", "source/theory/codeAbstractions.rst", "source/theory/couplingApproach.rst", "source/theory/discretizationApproach.rst", "source/theory/index.rst", "source/theory/lowMachNumberDerivation.rst", "source/theory/multiPhysics.rst", "source/theory/nso.rst", "source/theory/overset.rst", "source/theory/pressureStabilization.rst", "source/theory/propertyEvaluation.rst", "source/theory/rteStabilization.rst", "source/theory/supportedEquationSet.rst", "source/theory/timeDiscretization.rst", "source/theory/topologicalSupport.rst", "source/theory/turbulenceModeling.rst", "source/theory/windEnergy.rst", "source/user/build_manually.rst", "source/user/build_spack.rst", "source/user/building.rst", "source/user/index.rst", "source/user/nalu_run/McAlisterLessonsLearned.rst", "source/user/nalu_run/abl_forcing.rst", "source/user/nalu_run/nalu_inp.rst", "source/user/nalu_run/nalu_mesh.rst", "source/user/nalu_run/nalux.rst", "source/user/nalu_run/turbine_modeling.rst", "source/user/running.rst", "source/user/verify_installation.rst", "source/verification/index.rst", "source/verification/introduction.rst", "source/verification/verification.rst", "zrefs.rst"], "indexentries": {"--debug": [[45, "cmdoption-naluX-D", false]], "--help": [[45, "cmdoption-naluX-h", false]], "--input-deck": [[45, "cmdoption-naluX-i", false]], "--log-file": [[45, "cmdoption-naluX-o", false]], "--pprint": [[45, "cmdoption-naluX-p", false]], "--version": [[45, "cmdoption-naluX-v", false]], "-d": [[45, "cmdoption-naluX-D", false]], "-h": [[45, "cmdoption-naluX-h", false]], "-i": [[45, "cmdoption-naluX-i", false]], "-o": [[45, "cmdoption-naluX-o", false]], "-p": [[45, "cmdoption-naluX-p", false]], "-v": [[45, "cmdoption-naluX-v", false]], "nalux command line option": [[45, "cmdoption-naluX-D", false], [45, "cmdoption-naluX-h", false], [45, "cmdoption-naluX-i", false], [45, "cmdoption-naluX-o", false], [45, "cmdoption-naluX-p", false], [45, "cmdoption-naluX-v", false]]}, "objects": {"naluX": [[45, 0, 1, "cmdoption-naluX-D", "--debug"], [45, 0, 1, "cmdoption-naluX-h", "--help"], [45, 0, 1, "cmdoption-naluX-i", "--input-deck"], [45, 0, 1, "cmdoption-naluX-o", "--log-file"], [45, 0, 1, "cmdoption-naluX-p", "--pprint"], [45, 0, 1, "cmdoption-naluX-v", "--version"], [45, 0, 1, "cmdoption-naluX-D", "-D"], [45, 0, 1, "cmdoption-naluX-h", "-h"], [45, 0, 1, "cmdoption-naluX-i", "-i"], [45, 0, 1, "cmdoption-naluX-o", "-o"], [45, 0, 1, "cmdoption-naluX-p", "-p"], [45, 0, 1, "cmdoption-naluX-v", "-v"]]}, "objnames": {"0": ["std", "cmdoption", "program option"]}, "objtypes": {"0": "std:cmdoption"}, "terms": {"": [8, 14, 16, 20, 22, 27, 28, 30, 31, 32, 35, 36, 37, 39, 40, 43, 45, 51], "0": [14, 16, 19, 20, 21, 22, 25, 27, 28, 31, 32, 35, 36, 38, 41, 43, 44, 46, 48, 51], "00": [18, 51], "000": 51, "0000001": 14, "0001": 14, "00027": 32, "001": [20, 51], "00125": 51, "0015": 41, "0025": [41, 51], "0025m": 41, "003": [20, 41], "003m": 41, "005": 51, "00e": 51, "01": [19, 20, 32, 51], "01515": 41, "016": 51, "025": 51, "02e": 51, "03": 51, "035672821": 51, "0356751138": 51, "0356751139": 51, "03e": 51, "04": 51, "04e": 51, "05": 51, "05e": 51, "06": 51, "06848e": 51, "06e": 51, "075": 32, "08": 32, "0828": 32, "0856": 32, "09": [32, 51], "09e": 51, "0e": 51, "0m": 51, "0x": 22, "1": [14, 16, 18, 19, 20, 22, 23, 25, 27, 28, 29, 31, 32, 33, 35, 36, 41, 43, 46, 51], "10": [14, 20, 27, 28, 31, 32, 36, 38, 41, 43, 51], "100": [43, 46, 51], "1000": [41, 51], "10000": 32, "1000000": 20, "100x100": 51, "101": 28, "101325": 51, "10e": 51, "10m": 51, "11": [14, 20, 27, 38, 51], "11256e": 51, "12": [19, 31, 32, 36, 38, 41, 51], "121": 20, "125": 51, "128": 51, "12e": 51, "13": [12, 36, 38, 41, 51], "13225e": 51, "13e": 51, "14": 51, "15": [20, 31, 36, 51], "15065e": 51, "15668e": 51, "158m": 41, "16": [20, 37, 51], "17": [18, 20, 35, 51], "170": 41, "177": 41, "17804": 51, "17e": 51, "18": [20, 51], "180": 51, "188486": 51, "18e": 51, "19": [20, 41, 51], "192m": 41, "1978": 25, "1982": 25, "1984": 35, "1987": 23, "1991": [27, 41], "1996": 23, "1997": 32, "1998": [32, 35], "19e": 51, "1e": 43, "1m": [41, 51], "1x1": 51, "1x1x1": [0, 49], "1x2x10": [0, 49], "2": [9, 14, 16, 18, 19, 20, 22, 23, 25, 27, 28, 31, 32, 35, 36, 41, 43, 46, 51], "20": [20, 41, 43, 46, 51], "200": 19, "2000": 19, "2002": [36, 51], "2003": [24, 32, 49], "2005": [31, 32], "2006": [23, 29, 36], "2007": 32, "2008": 29, "200x200": 51, "2010": [20, 24, 49], "2011": 20, "2012": 36, "2013": 32, "2014": [23, 29, 51], "2015": [20, 27], "2016": 36, "2017": 27, "2020": [32, 35], "2021": 32, "21": 20, "22": [32, 41], "225": [43, 46], "22e": 51, "23": 20, "23e": 51, "24": [20, 35], "25": [20, 43, 51], "250": [43, 46], "2500": 20, "250k": 51, "26": 20, "27": [20, 23], "27e": 51, "29": 20, "29277e": 51, "2_": [25, 35], "2b": 51, "2d": [0, 20, 23, 49], "2h": 51, "2x": 22, "3": [9, 14, 16, 18, 19, 20, 22, 23, 25, 27, 28, 31, 32, 35, 36, 41, 43, 51], "30": [20, 51], "300": [43, 51], "3000": 51, "30077e": 51, "300k": 51, "30m": 41, "310": 51, "31211e": 51, "3151": 41, "31e": 51, "32": 51, "325": 35, "33": 41, "33067e": 51, "34": 31, "346": 41, "35": 20, "350k": 51, "38": 51, "39": 20, "3b": 51, "3d": [0, 23, 49], "3mm": 41, "4": [14, 19, 20, 22, 27, 28, 29, 31, 32, 35, 36, 41, 51], "40": [43, 51], "400k": 51, "400x400": 51, "41": 20, "42": 20, "44": 32, "45000": 22, "4620": 51, "46e": 51, "47e": 51, "4b": 51, "4x": 22, "5": [19, 20, 22, 23, 28, 32, 35, 36, 41, 43, 46, 51], "50": [43, 46, 51], "500": [28, 32], "50e": 51, "52": 41, "54e": 51, "56": 37, "58m": 41, "5m": [41, 51], "6": [14, 19, 20, 23, 28, 31, 32, 36, 51], "60785e": 51, "61": [20, 32], "63": 20, "63e": 51, "64": 51, "64e": 51, "65e": 51, "66": 14, "66m": 51, "68103e": 51, "68e": 51, "6x": 22, "7": [20, 27, 28, 32, 36, 37, 38, 41, 51], "70": 32, "70e": 51, "73": 41, "739208802178716": 51, "73e": 51, "74": 20, "75": 43, "768": 20, "77e": 51, "78": 32, "78e": 51, "7x": 22, "8": [14, 19, 20, 21, 23, 28, 32, 36, 41, 44, 51], "80": 51, "800": 51, "845": 32, "85": [20, 32], "856": 32, "86596e": 51, "866": 41, "89": 18, "8m": 51, "8n": 31, "9": [14, 20, 23, 28, 31, 32, 36, 38, 41, 51], "90": [20, 43, 46], "91e": 51, "92e": 51, "93": 18, "94": 18, "97517e": 51, "98249e": 51, "99e": 51, "A": [6, 16, 18, 19, 20, 21, 22, 23, 25, 26, 27, 28, 29, 31, 32, 33, 35, 36, 41, 43, 44, 51], "And": [16, 28], "As": [14, 18, 20, 21, 22, 23, 27, 28, 31, 32, 33, 35, 36, 43, 51], "At": [14, 21, 30, 31, 36, 48, 51], "By": [29, 32, 36, 43, 51], "For": [8, 12, 14, 19, 20, 21, 22, 23, 25, 26, 27, 28, 29, 30, 31, 32, 34, 35, 36, 37, 38, 41, 44, 45, 47, 50, 51], "If": [8, 10, 14, 20, 21, 22, 25, 32, 36, 37, 38, 45], "In": [8, 14, 18, 19, 20, 21, 22, 23, 25, 26, 27, 28, 29, 31, 32, 33, 34, 35, 36, 37, 38, 41, 43, 48, 50, 51], "It": [12, 16, 19, 20, 32, 35, 36, 38, 41, 48, 51], "Its": [12, 20], "No": [10, 13, 51], "Not": 20, "ON": [8, 14, 37], "Of": [44, 49], "On": [8, 23, 28, 37, 51], "One": [20, 23, 24, 36, 41, 43, 46], "Or": 14, "Such": [21, 51], "That": 38, "The": [1, 8, 9, 12, 14, 16, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 32, 33, 34, 35, 36, 37, 38, 41, 42, 43, 44, 45, 50, 51], "Then": [14, 48], "There": [10, 12, 14, 18, 20, 23, 38, 41, 42, 43, 51], "These": [14, 20, 21, 28, 29, 36, 37, 38], "To": [14, 20, 21, 32, 36, 37, 38, 48], "With": [0, 20, 21, 32, 49], "_": [20, 23, 25, 27, 31, 32, 36, 51], "_0": [20, 23, 25], "_1": [23, 25, 32], "_2": [25, 32], "_3": 32, "_c": [20, 36], "_extens": 8, "_i": [20, 25, 29, 31, 32, 36], "_j": [19, 20, 25, 32, 36], "_k": [19, 23, 25, 32], "_l": 23, "_n": 32, "_r": [23, 32], "_root_dir": 37, "_t": 32, "_user_data": 43, "_w": 20, "_x86_64": 37, "a_": 36, "a_1": 32, "a_h": 51, "a_i": [20, 23, 32], "a_j": [19, 20, 23, 51], "a_k": [23, 51], "a_w": 20, "a_x": [23, 32], "a_z": [32, 51], "ab": 20, "abil": [8, 20, 21, 23, 32, 36, 51], "abl": [9, 14, 16, 24, 28, 36, 37, 38, 45, 46, 47, 49], "abl_": 20, "abl_forc": [20, 42, 43], "abl_mesh": [20, 44], "ablneutraledg": 48, "abltop": [20, 36], "abltop_boundary_condit": 20, "abltop_user_data": 20, "about": [18, 20, 21, 23, 32, 44], "abov": [14, 19, 20, 21, 22, 23, 27, 29, 31, 32, 36, 37, 41, 44, 51], "absenc": 20, "absolut": [20, 36], "absorb": 32, "absorpt": 32, "abstract": [0, 6, 24], "academ": [28, 32], "acceler": [20, 32], "accept": [35, 41, 43], "access": 38, "accommod": 32, "accomod": [19, 43, 46], "accomplish": 51, "accord": 38, "account": 32, "accoust": [25, 27], "accumul": [20, 51], "accur": [20, 23, 35, 36, 51], "accuraci": [23, 25, 31, 32, 35, 41, 49, 50], "achiev": [20, 23, 26, 32, 36], "acoust": [25, 30, 32], "acro": 44, "across": [20, 36, 37, 41, 43, 51], "act": [20, 25, 27, 32, 35, 43], "action": 44, "activ": [19, 20, 21, 23, 24, 27, 35, 36, 51], "actlinefast": [43, 46], "actlinesimpl": 51, "actlinesimplengp": 51, "actual": [20, 43], "actuat": [0, 9, 11, 47, 49], "actuatorlinefast": [1, 36], "ad": [10, 11, 12, 19, 20, 31, 32, 36, 38, 51], "adapt": [0, 24, 43], "adcock": 32, "add": [13, 14, 20, 31, 36, 37, 38], "add_test_r": 14, "addit": [20, 21, 27, 28, 31, 32, 36, 38, 41, 43, 47, 51], "addition": [12, 32, 35], "adequ": [28, 31, 51], "adequaci": [20, 32], "adher": 38, "adhoc": 32, "adiabat": [20, 28], "adjac": [18, 19, 41], "admit": [25, 32], "adv": 31, "adv_": 19, "advanc": [26, 32, 36], "advantag": [14, 23, 41], "advect": [0, 20, 22, 23, 24, 27, 29, 31, 32, 36, 41, 51], "adventag": 20, "advers": 35, "aero": [36, 51], "aerodyn": 51, "aerodynam": [24, 36, 49, 51], "affect": [23, 32, 50], "afford": 33, "aforement": 27, "after": [14, 28, 36, 38, 42, 43, 51], "aftosmi": 18, "again": [19, 20, 21, 23, 30, 31, 32, 35, 48, 51], "against": [14, 51], "agre": 51, "agreement": 51, "aid": 32, "air": [20, 51], "air_dens": [43, 46], "airfoil": [41, 51], "al": [32, 35], "alg": 22, "algebra": [29, 50, 51], "algorith": 22, "algorithm": [20, 21, 22, 23, 28, 32, 50, 51], "align": [20, 28, 32], "all": [8, 12, 14, 19, 20, 21, 23, 25, 27, 28, 29, 32, 35, 36, 37, 38, 43, 45, 48, 51], "allevi": 36, "alloc": 38, "allow": [12, 14, 16, 19, 20, 21, 23, 26, 29, 32, 36, 37, 38, 51], "almost": [14, 20], "alon": 51, "along": [14, 18, 20, 23, 24, 25, 28, 29, 32, 36, 43, 44, 47, 49, 51], "alpha": [19, 31, 32, 51], "alpha_": [19, 32, 51], "alpha_h": 20, "alpha_u": 32, "alreadi": [8, 21, 23, 26, 37, 38, 45], "also": [14, 17, 18, 20, 21, 22, 23, 26, 27, 28, 29, 32, 34, 35, 36, 37, 38, 41, 43, 44, 51], "altern": [19, 27, 29, 31, 32, 35, 36], "although": [20, 21, 22, 23, 32, 33, 35, 37, 51], "alwai": [10, 13, 20, 32, 36, 51], "am": [24, 35], "amb": 32, "ambient": 25, "amount": [14, 32], "amplifi": 20, "amsalgdriv": 32, "an": [6, 12, 14, 16, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 35, 36, 37, 41, 43, 44, 47, 49, 50, 51], "analog": 32, "analysi": 36, "analyt": [20, 22, 50, 51], "analyz": 47, "angl": [32, 41, 51], "angular": 32, "ani": [16, 20, 23, 28, 31, 32, 35, 36, 38, 43, 46, 51], "anisotrop": 32, "annot": 16, "anoth": [6, 16, 20, 28, 32, 41, 44], "anothermethod": 16, "ansatz": 31, "answer": [16, 22], "anticip": 22, "antisymmetr": 27, "anytim": 21, "anywher": 20, "aoa_tabl": 51, "appar": [23, 51], "appear": [20, 22, 23, 32, 42, 43, 51], "appl": 38, "appli": [20, 21, 27, 31, 32, 35, 36, 41, 43, 51], "applic": [8, 20, 23, 24, 26, 32, 35, 36, 37, 41, 49], "apporach": 31, "appraoch": [18, 23], "approach": [0, 18, 19, 20, 24, 27, 28, 29, 30, 31, 32, 33, 35, 36, 41, 51], "approaxim": 29, "appropri": [10, 20, 31, 32, 33, 36, 51], "approx": [20, 32, 41], "approxim": [20, 22, 29, 31, 32, 35, 37, 51], "apprpriat": 36, "apt": 8, "ar": [6, 8, 12, 14, 18, 19, 20, 21, 22, 23, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 41, 42, 43, 44, 50, 51], "arbitrari": [21, 23, 28, 51], "arc": 36, "archetyp": 14, "architectur": 43, "archiv": 38, "area": [20, 21, 23, 32, 36, 51], "aren": 8, "arg_": 32, "argon": 37, "aris": [18, 23, 25], "around": [36, 41], "arrai": [22, 35], "arriv": 21, "artif": 27, "artifici": 27, "asc": 22, "asid": 32, "ask": 10, "aspect": [20, 22, 23, 37, 41, 51], "assembl": [20, 21, 23, 28, 29, 33], "assembli": [18, 20, 23, 24, 49], "assess": [32, 50, 51], "assign": [28, 35, 51], "associ": [18, 20, 32, 36, 41], "assum": [20, 21, 25, 30, 31, 32, 36, 38, 51], "assumpt": [20, 30, 32, 36], "ast": 32, "asymptot": [19, 24, 35], "atmospher": [24, 28, 32, 36, 44, 51], "attack": 51, "attempt": [32, 45], "attribut": 32, "augment": [20, 29], "author": 41, "authorship": 20, "auto": [16, 44], "autom": 20, "automat": [16, 17, 20], "automatic_decomposition_typ": 43, "autonom": 21, "auxiliari": [9, 11, 32], "av": 21, "avail": [14, 16, 20, 36, 38, 43, 44, 45, 47], "averag": [20, 23, 35, 47, 51], "avoid": [13, 20, 25, 27, 31], "awai": [20, 32, 41], "ax": 28, "axi": [20, 51], "az": 32, "azimuth": [32, 36], "b": [16, 19, 20, 21, 36, 51], "b2": 37, "ba": 20, "back": [22, 28, 32, 38, 44, 51], "background": 28, "backslash": 20, "backward": [20, 32, 33, 36, 51], "balanc": [25, 32, 41, 51], "bamg_": 43, "band": 30, "bar": [20, 23, 25, 27, 29, 32, 35, 36, 51], "base": [0, 8, 12, 14, 18, 19, 20, 21, 24, 26, 28, 29, 30, 32, 34, 35, 36, 37, 43, 44, 45, 49], "baselin": [37, 51], "bash": [37, 38], "bashrc": 38, "basi": [23, 32, 36, 51], "basic": [28, 51], "batch": 38, "baum": 25, "bautista": 20, "bc": [20, 21, 31, 32, 36, 43], "bc_6": 43, "bc_inflow": 43, "bc_left": 43, "bc_lower": 20, "bc_open": 43, "bc_right": 43, "bc_terrain": 43, "bc_top": 43, "bc_upper": 20, "bdf2": [21, 32, 33, 36, 51], "bdylayervelocitysampl": 20, "becaus": [20, 32, 35, 36, 38, 41, 51], "becom": [25, 32, 36, 41], "been": [14, 18, 20, 21, 22, 23, 25, 27, 28, 31, 32, 35, 38, 51], "befor": [21, 28, 35, 36, 37], "began": [24, 49], "begin": [21, 22, 25, 28, 32, 35, 36, 51], "begin_nod": 21, "behav": [25, 28, 43], "behavior": [25, 35, 36, 45, 51], "being": [14, 20, 26, 28, 32, 35, 38, 48, 50], "belo": 43, "below": [16, 19, 20, 21, 22, 31, 32, 35, 36, 37, 41, 43, 51], "benchmark": 50, "bend": 36, "benefici": 41, "benefit": 38, "best": [0, 11, 27, 51], "beta": [20, 31, 32, 51], "beta_": 32, "beta_1": [20, 32], "beta_2": 32, "beta_h": 20, "beta_i": 32, "beta_m": 20, "better": [10, 13, 23, 32, 36, 41, 51], "between": [16, 18, 19, 20, 21, 23, 26, 27, 28, 29, 32, 35, 36, 41, 43, 50, 51], "beyond": [43, 46], "bf": [22, 31, 32, 36], "bibtex": 8, "bigint": 37, "billion": 37, "bin": 37, "binari": [32, 48], "bla": 14, "black": [32, 51], "blade": [28, 32, 36, 41, 43, 51], "blade0": 51, "blaslib": 37, "blend": [19, 20, 23, 27, 31, 32, 36, 51], "block": [20, 21, 22, 28, 32, 41, 44, 51], "block_1": [21, 43], "blockag": [36, 41], "blue": 28, "bmatrix": 32, "bodi": [28, 32, 36, 51], "boldsymbol": 35, "boltzmann": 32, "bool": [8, 14, 16, 37], "boolean": 20, "boomeramg": 43, "boost": [14, 20], "boost_1_68_0": 37, "boost_build_intal": 37, "boost_build_on": 37, "boost_root_dir": 37, "bootstrap": 37, "both": [19, 20, 22, 23, 28, 31, 32, 33, 36, 41, 43, 51], "bottom": [18, 20, 23, 51], "bottomwal": 44, "botzmann": 32, "bound": [20, 22, 28, 32, 35, 51], "boundari": [0, 18, 21, 22, 23, 24, 28, 31, 32, 34, 35, 41, 44, 47, 49], "boundary_condit": [20, 43], "boundary_layer_statist": 43, "boundreault": 20, "boussinesq": [0, 36, 49], "box": [20, 28, 35, 41, 51], "bracket": 32, "branch": [14, 23, 37], "break": 32, "breath": 8, "breviti": [37, 44], "brew": [8, 37], "brief": [16, 22, 28, 36, 43, 44, 51], "briefli": [36, 43, 51], "broken": [31, 36, 48], "brought": 32, "bruner": 41, "bucketvector": 21, "buffer": 20, "build": [0, 11, 12, 14, 40, 48, 51], "built": [17, 21, 22, 38], "bulkdata": 21, "bulkdata_": 21, "bullet": 21, "buoyanc": [0, 20, 36, 49], "buoyant": 32, "c": [9, 16, 20, 21, 32, 37, 38, 51], "c_": [19, 20, 25, 27, 32, 35], "c_0": 51, "c_compil": 37, "c_d": [36, 51], "c_f": 32, "c_i": 32, "c_l": 51, "c_p": [20, 32, 36, 51], "c_w": 35, "cach": [37, 38], "calcul": [14, 20, 25, 27, 32, 36, 43, 50, 51], "call": [13, 20, 23, 32, 35, 45], "camel": 13, "can": [6, 14, 16, 17, 19, 20, 21, 22, 23, 25, 27, 28, 29, 31, 32, 33, 35, 36, 37, 38, 41, 42, 43, 44, 45, 46, 48, 50, 51], "candid": 51, "cannot": [20, 25, 28, 32], "canon": [23, 41], "cap": [20, 36, 51], "capabl": [10, 14, 24, 28, 32, 36, 38, 49, 51], "capac": 32, "captur": [23, 27, 31, 32, 35, 41, 51], "care": [20, 23, 35], "carefulli": 35, "carri": [20, 27, 32], "cartesian": [18, 20, 25], "cartoon": 20, "cascad": 35, "case": [13, 14, 19, 20, 21, 23, 26, 28, 31, 32, 36, 37, 39, 40, 43, 47, 51], "cast": 22, "catalyst": 44, "catalyst_ioss_adapter_root_dir": 37, "cataylst": [44, 47], "categori": 14, "cauchi": 32, "caus": [20, 41, 48], "causal": 32, "cc": 37, "cd": [19, 37, 38, 48], "cd_": 32, "cd_tabl": 51, "cdash": [11, 12], "cdmremot": 37, "cdot": 32, "cell": [19, 20, 23, 32, 36, 41, 51], "cellar": 37, "center": [18, 23, 31, 32, 36, 51], "central": [19, 20, 28, 35, 51], "centroid": [23, 41], "certain": [32, 36, 43], "certainli": 27, "cfd": 21, "cfl": 22, "cflag": 37, "chang": [8, 18, 19, 20, 25, 32, 36, 38, 41, 43, 46, 48, 51], "channel": [20, 51], "channel_coarse_": 44, "char": 16, "character": [20, 51], "characterist": [20, 25, 35], "check": [12, 14, 21, 37, 38], "checkout": [8, 14, 37, 38], "checkpoint": 43, "chemic": 32, "chien": 32, "chien1982predict": 32, "child": [1, 18], "choic": [18, 19, 20, 21, 22, 23, 27, 32, 51], "choos": [14, 23, 35, 43, 46], "chord": [41, 51], "chord_tabl": 51, "chosen": [14, 31, 32, 51], "chri": 41, "cht": 26, "churchfield": 36, "ci": 12, "circ": [25, 32, 36, 51], "circul": 51, "circular": 28, "cite": [18, 20, 23, 24, 25, 27, 29, 31, 32, 35, 36, 49, 51], "civita": 32, "cl_tabl": 51, "clang": [12, 38], "class": [1, 13, 16, 20, 23, 28, 31, 36], "classic": [18, 19, 20, 22, 23, 27, 31, 32, 35, 51], "clean": [21, 37], "cleanli": 48, "cleanup": 37, "clear": [23, 51], "clip": 27, "clockwis": 51, "clone": [14, 37, 38, 51], "close": [25, 27, 32, 41], "closer": [27, 35, 51], "closest": 51, "closur": [27, 31, 32, 35, 36, 51], "cm": 51, "cmake": [11, 14, 38], "cmakecach": 37, "cmakefil": 37, "cmakelist": 14, "cmm": 51, "co": [20, 32, 51], "coars": [28, 51], "coarser": 51, "code": [0, 10, 11, 12, 16, 18, 20, 23, 24, 26, 27, 28, 31, 32, 35, 36, 38, 44, 48, 49, 50, 51], "codebas": 28, "coeffici": [20, 24, 25, 30, 32, 35, 36, 51], "coeffieci": 32, "coincid": 43, "collabor": 12, "collect": [12, 21, 23, 25, 28], "colloc": 32, "color": [28, 51], "column": [23, 28], "com": [14, 16, 21, 37, 38], "combin": [8, 18, 19, 20, 22, 23, 27, 29, 37, 44, 51], "combust": [24, 32, 49], "come": [8, 20, 21, 36, 38], "comfort": 38, "command": [8, 14, 20, 23, 32, 37, 40, 43, 44, 47, 48], "comment": 16, "commerci": [21, 44], "commit": [12, 14], "common": [20, 21, 23, 26, 32, 36, 47], "commonli": [20, 23, 32, 36], "commonplac": 23, "commun": [23, 41], "commut": 27, "compact": 31, "compar": [20, 27, 36, 41, 43, 50, 51], "comparis": 50, "comparison": [50, 51], "compars": 51, "compat": [20, 51], "compet": 20, "compil": [14, 37, 38, 44], "complet": [8, 14, 27, 28, 32, 35, 41, 43], "complex": [20, 28, 31, 35, 36, 47], "compon": [20, 23, 25, 32, 35, 43], "componnet": 23, "composit": [30, 32], "compress": [25, 27, 30, 32], "compris": 35, "compromis": [20, 51], "comput": [6, 14, 18, 19, 20, 24, 27, 31, 35, 36, 43, 44, 47, 51], "concept": [23, 26, 29, 36], "conclus": 22, "condit": [0, 18, 21, 23, 24, 31, 32, 35, 47, 49], "conduct": [21, 22, 24, 25, 28, 43, 51], "confid": 51, "config": [37, 38], "configur": [9, 11, 14, 18, 20, 28, 37, 38, 43, 47, 51], "confin": [14, 20, 32], "confirm": 51, "conform": [14, 24, 41, 47], "confus": 31, "conjug": [20, 26, 32], "connect": [20, 23, 28], "connected_nod": 21, "consequ": [25, 51], "conserv": [18, 20, 24, 26, 29, 36, 41], "consid": [20, 21, 22, 23, 25, 28, 32, 50, 51], "consider": 23, "consist": [14, 20, 21, 23, 27, 28, 32, 33, 41, 51], "consolid": 23, "const": [13, 16, 21], "const_iter": 21, "constant": [19, 20, 23, 25, 27, 30, 31, 32, 35, 36, 43, 51], "constrain": 18, "constraint": [18, 20, 28, 34, 38, 43], "construct": [18, 20, 23, 28, 36], "consult": [44, 51], "contain": [6, 11, 20, 21, 23, 25, 32, 35, 36, 39, 40, 43, 44, 48, 51], "content": [32, 44], "context": [22, 27, 32, 36, 43], "continu": [11, 18, 22, 23, 25, 27, 29, 32, 36], "continuosli": 38, "continuum": 50, "contour": 28, "contravari": 27, "contribut": [0, 11, 20, 23, 25, 31, 32, 33, 36], "control": [18, 23, 31, 32, 35, 36, 45, 47, 51], "convect": [0, 9, 20, 49], "convecting_taylor_vortex": 51, "conveni": 36, "convent": [20, 36], "converg": [20, 22, 23, 36, 41, 43, 51], "convergence_toler": 43, "convers": 51, "convert": [36, 51], "convolut": 35, "coordin": [20, 25, 32], "copi": [14, 16, 21, 37, 38], "cor": 32, "core": [22, 51], "corioli": 36, "corner": [31, 51], "correct": [14, 20, 23, 32, 36, 37, 38, 41, 51], "correctli": [37, 38, 50], "corrector": 22, "correl": 32, "correspond": [14, 22, 32, 38, 51], "cost": [20, 35], "couett": 20, "could": [8, 20, 28, 43, 48], "count": [21, 41], "counterpart": [28, 32], "coupl": [0, 1, 20, 21, 23, 24, 26, 32, 49], "courant": [36, 43, 51], "cours": 32, "covari": 27, "cover": [36, 41], "coverag": 51, "cp": 37, "cpp": [8, 12, 14, 38], "cpu": 37, "creat": [8, 14, 16, 18, 20, 21, 28, 37, 38, 48, 51], "creation": [21, 51], "cross": [32, 51], "crossflow": 18, "ctest": [12, 14], "ctestlist": 14, "ctestnightlyscript": 14, "ctesttestfil": 14, "ctr": 20, "cube": [0, 32, 49], "cubit": 44, "current": [12, 14, 20, 23, 27, 28, 32, 34, 36, 37, 43, 45, 47, 51], "curv": [20, 51], "curvatur": 36, "custom": [21, 43], "cut": 28, "cvem": 51, "cvfem": [9, 11, 20, 24, 27, 29, 31, 32, 33, 34, 36, 51], "cxx": 37, "cxx_compil": 37, "cxxflag": 37, "cycl": 51, "cylind": 28, "d": [9, 16, 19, 20, 22, 23, 27, 29, 31, 32, 35, 36, 45, 51], "d_": 35, "d_k": 32, "d_t": 32, "damp": 20, "dampen": 35, "dap": 37, "dash": 51, "dat": 20, "data": [6, 13, 20, 24, 28, 32, 44, 47, 49, 51], "data_prob": 43, "databas": [32, 44], "davidson": 32, "dboost_include_dir": 37, "dboost_library_dir": 37, "dboostlib_include_dir": 37, "dboostlib_library_dir": 37, "dcmake_build_typ": [8, 37, 38], "dcmake_cc_compil": 37, "dcmake_cxx_compil": 37, "dcmake_cxx_flag": 37, "dcmake_install_prefix": 37, "dco": [23, 27, 31], "de": 24, "deal": 18, "debat": 20, "debug": [43, 45, 46], "debug_output": 51, "decai": [0, 32, 49], "decent": 23, "decid": 41, "deck": [36, 45], "declar": 21, "declare_field": 21, "decomp": 44, "decompos": [31, 32, 35, 44], "decomposit": [28, 32], "decoupl": [25, 31, 32], "decreas": 20, "default": [14, 20, 32, 35, 36, 37, 38, 43], "defici": 32, "defin": [14, 16, 18, 19, 20, 21, 23, 26, 27, 29, 31, 32, 35, 38, 43, 50, 51], "definit": [12, 18, 20, 21, 22, 23, 24, 25, 32, 43], "deform": [32, 51], "degrad": 51, "degre": [20, 29, 31, 41, 51], "delai": 23, "delet": 48, "delin": 20, "delta": [19, 31, 32, 33, 35, 36, 51], "delta_": [20, 25, 27, 32, 35, 36], "demonstr": [20, 23, 51], "denable_document": [8, 37], "denable_hypr": 37, "denable_openfast": 37, "denable_paraview_catalyst": 37, "denable_test": [14, 37], "denable_tioga": 37, "denomin": 27, "denot": [19, 31, 32], "densiti": [20, 21, 22, 24, 25, 32, 33, 35, 36, 43, 49, 51], "density_": 21, "densityn_": 21, "densitynm1_": 21, "densitynp1": 21, "densitynp1_": 21, "depend": [14, 20, 32, 35, 37, 38, 43, 51], "depict": 28, "deplet": 32, "deploi": [18, 23], "deploy": 18, "deprec": 51, "dept": 41, "depth": 16, "deriv": [0, 20, 23, 24, 27, 29, 31, 32, 36, 51], "describ": [8, 12, 14, 15, 16, 18, 20, 21, 23, 28, 29, 32, 36, 37, 38, 41, 43, 45, 47, 51], "descript": [16, 20, 23, 28, 35, 36, 43, 44, 51], "design": [8, 13, 21, 23, 24, 26, 32, 36, 49, 51], "desir": [20, 21, 22, 23, 32, 35, 36, 43, 50, 51], "destructor": 16, "detach": 24, "detail": [16, 21, 22, 32, 35, 36, 43, 44, 51], "determin": [20, 21, 23, 25, 27, 28, 32, 36, 43, 44, 45, 50, 51], "develop": [0, 14, 20, 21, 27, 28, 32, 36, 37, 39, 40, 44, 51], "deviat": [14, 36, 38], "deviator": 32, "dextra_build_nam": 14, "dg": [20, 41, 51], "dhdf5_no_system_path": 37, "dhdf5_root": 37, "dhost_nam": 14, "dhypre_dir": 37, "diagon": [20, 29, 36], "dial": 19, "dictat": [14, 20], "dictionari": 43, "dif": 14, "diff": [31, 37], "differ": [12, 18, 19, 20, 22, 23, 25, 27, 28, 29, 32, 35, 37, 41, 43, 47, 50, 51], "differenc": 27, "differenti": [23, 31, 32], "difficult": [14, 19, 20], "diffuion": 51, "diffus": [20, 22, 24, 29, 30, 32, 36, 51], "diffusion": 29, "dilut": 36, "dimens": [20, 44], "dimension": [19, 20, 25, 28, 51], "dimensionless": [20, 25], "direct": [20, 23, 24, 31, 32, 36, 43, 45, 49, 51], "directli": [16, 20, 32, 35, 38], "directori": [8, 14, 37, 38, 43, 45, 48], "dirichlet": [20, 21, 31, 51], "disabl": 37, "disadvantag": 41, "discontinu": [20, 23, 27, 31, 41], "discret": [0, 20, 21, 22, 24, 29, 31, 32, 43, 50, 51], "discuss": [20, 32, 36, 37], "dispar": [20, 26], "dispers": 18, "displac": [9, 20, 32], "displai": [32, 51], "dissip": [19, 32, 35], "distanc": [16, 19, 20, 23, 24, 36, 51], "distinct": 50, "distinguish": 50, "distort": 51, "distribut": [20, 31, 36, 51], "disturb": 20, "diverg": [25, 31, 32, 36], "divid": [18, 25, 27, 36], "divis": 18, "dkokkos_enable_deprecated_cod": 37, "dmpi_cxx_compil": 37, "dmpi_use_compiler_wrapp": 37, "dmpiexec_preflag": 37, "dmuelu_enable_kokkos_refactor": 37, "dn": [32, 51], "dnetcdf_root": 37, "dnightly_dir": 14, "do": [13, 14, 18, 20, 35, 37, 38, 48, 51], "doc": 11, "docker": [11, 39, 40], "dockerhub": 12, "document": [10, 11, 12, 14, 15, 36, 41, 43, 44], "doe": [12, 14, 16, 20, 21, 23, 35, 36, 37, 38, 43], "doesn": 14, "dof": [20, 23, 28, 33, 51], "domain": [6, 14, 20, 31, 32, 36, 41, 43, 51], "domin": [20, 32, 36, 41], "domino": [20, 23, 27, 29, 36, 51], "don": 37, "done": [14, 20, 23, 27, 32, 38, 51], "donor": 28, "donoth": 16, "dopenfast_dir": 37, "dosometh": 16, "dot": [8, 19, 20, 24, 27, 32, 36], "doubl": [13, 21], "down": [22, 35, 38], "download": [16, 38, 48], "downstream": [20, 36, 41], "downward": 21, "downwash": 51, "doxygen": [8, 9, 16, 37], "doxylink": 8, "dp": 20, "dparaview_catalyst_install_path": 37, "dparaview_dir": 37, "dpnetcdf_include_dir": 37, "dpnetcdf_library_dir": 37, "dpnetcdf_root": 37, "drag": [36, 51], "drive": [32, 36, 43], "driven": [18, 35], "drop": [0, 20, 31, 32, 49], "dry_run": [43, 46], "dsuperlu_include_dir": 37, "dsuperlu_library_dir": 37, "dt": 16, "dtdx": 51, "dtdy": 51, "dtdz": 51, "dtest_toler": 14, "dtioga_dir": 37, "dtpetra_inst_complex_doubl": 37, "dtpetra_inst_doubl": 37, "dtpetra_inst_seri": 37, "dtpl_enable_bla": 37, "dtpl_enable_boost": 37, "dtpl_enable_hdf5": 37, "dtpl_enable_mpi": 37, "dtpl_enable_netcdf": 37, "dtpl_enable_pnetcdf": 37, "dtpl_enable_superlu": 37, "dtpl_enable_zlib": 37, "dtpl_netcdf_parallel": 37, "dtrilinos_allow_no_packag": 37, "dtrilinos_assert_missing_packag": 37, "dtrilinos_dir": [8, 14, 37, 38], "dtrilinos_enable_all_optional_packag": 37, "dtrilinos_enable_ameso": 37, "dtrilinos_enable_amesos2": 37, "dtrilinos_enable_aztecoo": 37, "dtrilinos_enable_belo": 37, "dtrilinos_enable_cxx11": 37, "dtrilinos_enable_epetra": 37, "dtrilinos_enable_epetraext": 37, "dtrilinos_enable_explicit_instanti": 37, "dtrilinos_enable_gtest": 37, "dtrilinos_enable_ifpack": 37, "dtrilinos_enable_ifpack2": 37, "dtrilinos_enable_kokkoskernel": 37, "dtrilinos_enable_ml": 37, "dtrilinos_enable_muelu": 37, "dtrilinos_enable_seacasepu": 37, "dtrilinos_enable_seacasexodiff": 37, "dtrilinos_enable_seacasexodu": 37, "dtrilinos_enable_seacasioss": 37, "dtrilinos_enable_seacasnemslic": 37, "dtrilinos_enable_seacasnemspread": 37, "dtrilinos_enable_stk": 37, "dtrilinos_enable_test": 37, "dtrilinos_enable_tpetra": 37, "dtrilinos_enable_zoltan": 37, "dtrilinos_enable_zoltan2": 37, "dual": [20, 24, 30, 32, 33, 36, 51], "dual_nodal_volum": 43, "ducro": 35, "duct": [0, 49], "due": [14, 20, 23, 24, 31, 32, 35, 36, 37, 41, 50, 51], "durat": [43, 51], "dure": [28, 32, 36, 37, 43, 44, 45], "dv": [23, 29, 32, 33, 51], "dx": [20, 23], "dx_k": [23, 51], "dx_l": [23, 51], "dx_x": 23, "dx_y": 23, "dxpetra_enable_kokkos_refactor": 37, "dy": 23, "dyaml_dir": [8, 14, 37, 38], "dyer": 20, "dynam": [23, 25, 35], "dz": 20, "dzlib_include_dir": 37, "dzlib_library_dir": 37, "e": [8, 13, 19, 20, 21, 22, 23, 25, 27, 28, 31, 32, 36, 37, 38, 43, 44, 51], "e4": 12, "each": [14, 19, 20, 21, 22, 23, 25, 26, 28, 29, 31, 32, 36, 37, 43, 50, 51], "eagl": [37, 39, 40], "earlier": [14, 37], "earth": 36, "eas": 41, "easi": 20, "easier": [36, 48], "easili": [20, 21, 51], "east": 32, "eb_nam": 44, "ebvc": [20, 23, 27, 29, 31, 51], "eclips": 13, "ecpe4": [12, 38], "ed": 21, "eddi": [24, 27, 51], "edg": [18, 19, 20, 21, 24, 29, 32, 34, 36, 41, 51], "edge_area_vector": 21, "edge_bucket": 21, "edge_rank": 21, "edgeareavec": 21, "edgeareavec_": 21, "edit": [37, 38], "editor": 13, "educ": 22, "edward": [24, 49], "eff": [20, 27, 51], "effect": [20, 32, 36, 41, 51], "effici": [23, 35, 51], "effort": [21, 24, 27, 41, 49], "ei": 20, "eigenvalu": [27, 32], "eight": 23, "einstein": 25, "either": [14, 19, 20, 23, 29, 30, 31, 32, 33, 35, 36, 41, 51], "el": 35, "elast": [32, 36, 51], "elem": 21, "elem_bucket": 21, "element": [18, 19, 20, 21, 23, 24, 27, 28, 29, 32, 34, 36, 41, 44, 51], "element_continuity_eq": 23, "element_rank": 21, "element_source_term": 43, "elev": 20, "elimin": [20, 31, 36, 41], "ellipt": [41, 51], "els": [21, 32], "elsewher": 36, "embed": [16, 28, 36], "emerg": 21, "emiss": 32, "emit": 32, "emphasi": [22, 31, 51], "empir": [20, 32], "emploi": 51, "enabl": [14, 37, 44, 45], "enclos": 28, "end": [16, 21, 22, 28, 32, 35, 36, 48, 51], "endif": 16, "energi": [0, 24, 25, 26, 35, 41, 44, 49, 51], "enforc": [20, 21, 25, 32, 36, 43, 51], "engin": 32, "enough": [20, 32, 43, 46], "ensur": [19, 28, 29, 32, 36, 41, 51], "enter": [20, 51], "enthalpi": [21, 23, 25, 26, 27, 30, 32, 36, 51], "entir": [20, 36, 37, 38], "entiti": [21, 28], "entrain": 20, "entrainment_method": 43, "entranc": 51, "entri": [8, 20, 28, 29, 36, 43], "env": 38, "environ": [32, 38], "environment": 32, "epetra": [24, 49], "epic": 16, "epsilon": [20, 22, 25, 32, 36, 43, 46, 51], "epsilon_": [32, 36], "epsilon_d": 36, "epu": 44, "eq": [23, 27, 29, 31, 36], "equal": [20, 22, 31, 32, 49], "equat": [0, 6, 9, 11, 18, 19, 20, 21, 23, 24, 25, 26, 27, 28, 29, 31, 41, 47, 50, 51], "equation_system": 43, "equationsystemvector": 21, "equationsystemvector_": 21, "equiangl": 41, "equilibrium": [20, 36], "equiv": [32, 35, 51], "equival": [35, 36], "equivolum": 41, "eras": 38, "error": [14, 18, 20, 21, 24, 27, 35, 36, 37, 43, 50], "especi": [20, 37], "essenti": [16, 35], "establish": 14, "estim": 50, "et": 32, "eta": [19, 20, 32], "etal": [32, 35], "etc": [13, 14, 19, 20, 21, 32, 37, 38, 43, 44, 51], "euler": [32, 33, 36, 51], "eulerian": 32, "evalu": [0, 19, 20, 21, 22, 23, 24, 26, 27, 29, 32, 33, 36, 50, 51], "even": [19, 30, 35, 38, 41, 51], "evenli": 36, "eventu": 41, "everi": [12, 14, 17, 28, 32, 43, 50], "everydai": 16, "everywher": 36, "evid": [32, 51], "evolut": 36, "evolv": [24, 49], "exact": [14, 19, 50, 51], "exactli": [43, 51], "examin": [40, 47], "exampl": [8, 14, 16, 20, 21, 23, 27, 28, 32, 36, 38, 41, 43, 44, 45, 50, 51], "example_h": 16, "exampleclass": 16, "exampleclass_h": 16, "exawind": [12, 37, 38], "exce": 36, "excel": 23, "except": [10, 19, 23, 36, 37, 41], "exception": 16, "exec": 37, "execut": [13, 32, 36, 37, 43, 47], "exercis": 21, "exist": [6, 8, 14, 16, 18, 20, 21, 22, 23, 31, 36, 37, 38, 45, 50, 51], "exit": [45, 48, 51], "exo": 47, "exodu": [6, 20, 21, 40, 43, 47], "exp": 20, "expand": [25, 41], "expand_box_percentag": 43, "expans": [24, 32, 51], "expect": [20, 21, 26, 32, 35, 36, 37, 51], "expens": [35, 36], "experi": [23, 41], "experiment": [32, 51], "expert": 36, "explain": 32, "explic": 27, "explicit": [22, 51], "explicitli": [20, 32], "exploit": 23, "explor": [18, 25, 27], "exponenti": 20, "export": 38, "expos": [20, 21, 31, 34], "express": [14, 20, 23, 32, 51], "extend": [18, 20, 23, 28, 36, 51], "extens": [8, 12, 31, 37, 43, 45, 46, 51], "extent": [28, 32], "exterior": 28, "extern": [12, 28, 32, 38], "external_data": 51, "external_data_provid": 51, "external_field_provid": 51, "extra": [22, 37], "extra_arg": 37, "extract": [6, 9, 16, 21, 38, 43, 47], "extrapol": [19, 23], "extrud": 51, "extrus": 41, "f": [16, 20, 22, 32, 36, 37], "f_": [20, 32], "f_2": 32, "f_c": 32, "f_d": 36, "f_i": [20, 32, 36], "f_j": 20, "f_k": 20, "f_w": 20, "f_x": [20, 23], "f_y": [20, 23], "face": [18, 19, 20, 21, 23, 31, 34, 41, 43, 44], "face_bucket": 21, "facet": [20, 31], "facilit": 20, "fact": [20, 31, 51], "factor": [19, 20, 22, 32, 33, 36, 41, 48, 51], "fail": 14, "failur": [14, 48], "fairli": 41, "fall": 36, "fals": [43, 46, 51], "familiar": [28, 36, 41], "fanswer": 16, "far": [20, 22, 36, 41, 43], "farm": [36, 51], "fashion": 35, "fast": [20, 25], "fast_input_filenam": [43, 46], "faster": [23, 38], "fastest": 32, "favor": 20, "favr": [32, 35, 36], "fc": 37, "fcflag": 37, "featur": [10, 20, 36], "feel": 21, "fem": [9, 11, 20, 31, 51], "fem_diff": 43, "femhc": [14, 43], "few": 48, "fewer": 41, "fft": 20, "fickian": 32, "fidel": 51, "field": [13, 20, 23, 28, 32, 36, 43, 44, 51], "field_data": 21, "field_of_st": 21, "fieldoutputtyp": 21, "figur": [18, 19, 20, 23, 28, 32, 36, 51], "file": [9, 14, 16, 19, 20, 21, 23, 30, 32, 36, 37, 38, 40, 42, 45, 47, 48, 51], "filenam": 45, "filepath": 37, "filesystem": 37, "filter": [20, 23, 24, 27, 35, 36], "final": [14, 20, 21, 22, 23, 27, 28, 31, 32, 35, 36, 41, 51], "find": [24, 28, 32, 37, 38, 51], "fine": [27, 29, 31, 36, 51], "finer": 35, "finit": [18, 20, 23, 24, 27, 36, 51], "first": [8, 14, 20, 21, 23, 27, 31, 32, 36, 37, 41, 43, 48, 51], "fit": [20, 28, 36], "five": [22, 23, 51], "fix": [0, 20, 21, 32, 36, 43, 49], "flag": [20, 28, 37, 43, 44], "flame": 32, "flat": [20, 32, 36], "flexibl": 36, "float": 16, "flow": [9, 18, 20, 21, 22, 23, 24, 25, 27, 28, 29, 32, 35, 36, 41, 43, 44, 49, 51], "fluctuat": [20, 32, 35], "fluid": [20, 21, 25, 26, 32, 36, 47, 51], "fluidrealm": 20, "flux": [18, 20, 24, 30, 31, 32, 36, 51], "fold": 22, "folder": 48, "follow": [12, 13, 14, 19, 20, 21, 22, 23, 25, 27, 28, 31, 32, 34, 36, 37, 38, 42, 43, 44, 48, 51], "footnot": 20, "forc": [13, 20, 23, 24, 36, 47, 51], "forget": 37, "forgiv": 22, "form": [16, 18, 19, 20, 22, 23, 24, 25, 27, 28, 29, 30, 32, 35, 43, 51], "formal": [23, 27, 32], "format": [12, 13, 16, 17, 40, 41, 43, 47], "former": 27, "formul": [20, 24, 27, 31, 35, 51], "formula": [20, 51], "fortran": 37, "forum": 23, "forward": 32, "found": [8, 20, 25, 27, 37, 41], "foundat": 51, "four": [18, 23, 51], "fourier": 20, "fourth": [19, 20, 22, 23, 27, 29, 51], "fpic": 37, "fquestion": 16, "fr": 25, "frac": [16, 19, 20, 23, 25, 27, 29, 31, 32, 33, 35, 36, 51], "fraction": [23, 24, 27, 30, 51], "frame": [22, 51], "framework": [20, 31, 32], "free": [22, 32, 35, 36, 51], "freedom": [20, 29, 31], "freestream": [20, 32], "frequenc": [43, 51], "frequent": [23, 31], "friction": 20, "fring": 28, "from": [6, 9, 12, 13, 14, 18, 19, 20, 21, 22, 23, 25, 27, 28, 29, 32, 33, 35, 36, 37, 38, 40, 43, 44, 45, 46, 47, 50, 51], "front": 44, "froud": 25, "fsi": [26, 32, 36], "fsi_interfac": 32, "fst": [43, 46], "fsync": 37, "fuego": 36, "fuegotheorymanu": 36, "fuel": 32, "full": [10, 19, 20, 21, 22, 23, 25, 28, 29, 31, 32, 35, 36, 41, 43, 44, 51], "fulli": [10, 20, 22, 25, 28, 32, 34, 35, 41, 51], "functin": 51, "function": [9, 11, 14, 16, 18, 19, 21, 23, 24, 27, 30, 35, 36, 43, 51], "fund": 22, "fundament": 20, "further": [41, 51], "furthermor": [20, 36, 44, 51], "futur": [18, 20, 32, 36, 43, 46], "fy15": 22, "g": [8, 13, 20, 21, 22, 23, 27, 28, 31, 32, 35, 36, 37, 38, 43, 44], "g_": [27, 31], "g_0": 51, "g_h": 51, "g_i": [25, 29, 32, 36, 51], "g_j": [20, 23, 27, 29, 51], "g_l": [23, 51], "g_x": 23, "g_y": 23, "ga": [23, 24, 25, 30, 32, 36, 49, 51], "gain": 36, "galerkin": [19, 20, 27, 31, 41], "gamma": [16, 19, 20, 23, 25, 27, 31, 32, 51], "gamma_": [20, 23, 51], "gamma_1": [32, 33, 36], "gamma_2": [32, 33, 36], "gamma_3": [32, 33, 36], "gamma_h": 20, "gamma_i": [31, 32, 33, 36], "gamma_m": 20, "gather": [21, 35, 36], "gaurante": 51, "gauss": [20, 23, 27, 29, 51], "gaussian": 36, "gcc": [12, 14, 37, 38], "gcd": 19, "gcl": 32, "ge": 32, "gener": [1, 16, 17, 18, 19, 20, 21, 22, 23, 24, 26, 28, 31, 32, 33, 34, 35, 36, 37, 38, 40, 43, 44, 45, 47, 49, 51], "genericfieldtyp": 21, "genesi": 27, "geometr": [30, 32], "geometri": [28, 36, 47], "geophys": 32, "geostroph": [20, 32], "gerkema_et": 32, "german": [24, 49], "get": [8, 13, 20, 32, 36, 38], "get_bucket": 21, "get_field": 21, "get_inactive_selector": 21, "get_m": 13, "get_part": 21, "get_surface_master_el": 21, "gfem": 31, "ghost": 21, "git": [14, 37, 38, 48], "github": [17, 21, 23, 37, 38], "gitlab": 12, "give": [20, 41, 51], "given": [19, 20, 21, 22, 23, 27, 30, 31, 32, 35, 36, 41, 44, 51], "global": [20, 25, 32, 36, 51], "gmre": 43, "go": 20, "gold": 14, "good": [16, 20, 21, 41, 51], "googl": 16, "govern": [24, 32, 43, 50, 51], "gpu": 38, "gradient": [0, 19, 21, 24, 25, 27, 29, 31, 32, 34, 35, 36, 41, 49], "grain": 20, "graph": 20, "graphic": 20, "graphviz": 8, "graviti": [20, 25, 32, 43, 51], "gravity_vector_compon": 43, "great": [32, 36, 51], "greater": [22, 31, 51], "green": [23, 28, 32, 51], "grei": 20, "grid": [20, 24, 32, 35, 41, 50, 51], "grid07_conformal10": 47, "grid_dimens": 20, "gross": 41, "ground": 22, "group": [20, 25, 31], "growth": 41, "guarante": 20, "guard": 18, "guermond": 27, "guid": [0, 11], "gz": [37, 38], "h": [14, 16, 18, 19, 20, 25, 31, 32, 37, 44, 45, 51], "h_1": 32, "h_2": 32, "h_3": 32, "h_i": 32, "h_k": 32, "h_o": 51, "ha": [14, 18, 19, 20, 21, 22, 23, 24, 25, 27, 28, 31, 32, 35, 36, 37, 38, 41, 42, 43, 44, 49, 50, 51], "had": 51, "haer": [32, 35], "haeringaiaa": 32, "half": [20, 32], "halv": 20, "hand": [20, 21, 28, 31, 32, 37, 41], "handl": [23, 28, 35], "hang": 18, "happen": 28, "hat": [19, 20, 27, 29, 32, 36], "have": [14, 18, 20, 21, 22, 23, 28, 31, 32, 36, 37, 38, 41, 48, 50, 51], "hdf5": [14, 30], "hdf5_root_dir": 37, "header": [16, 38, 44], "health": 16, "heat": [21, 24, 25, 26, 28, 31, 36, 43, 51], "heat_flux": 43, "heatconduct": 43, "heavili": 32, "heavisid": 31, "height": [20, 32, 36, 42, 43, 51], "held": 36, "helio": 28, "helium": 51, "help": [16, 38, 45], "henc": [14, 25, 36, 51], "here": [10, 13, 14, 16, 17, 20, 22, 23, 28, 29, 32, 36, 37, 38, 41, 43, 44, 51], "hereiam_": 13, "heroux": [24, 49], "heterogen": 18, "heurist": 41, "hex": [23, 28, 34, 36, 41, 43, 46, 51], "hex8": 20, "hexahedr": [21, 23, 41, 51], "hexahedra": 41, "hierarchi": [18, 36], "high": [19, 23, 24, 28, 36, 41, 51], "higher": [0, 19, 23, 27, 29, 31, 44, 49], "highest": [27, 51], "highli": [23, 51], "histori": [36, 37], "hmmm": 13, "hoc": 31, "hold": [21, 51], "hole": 28, "homasterel": 51, "home": 38, "homebrew": [8, 38], "homegen": 21, "homepag": 0, "homogen": [21, 51], "hook": [32, 37], "hopefulli": [31, 36, 38], "horizont": [20, 36], "horizontal_bc": 20, "host": 14, "hour": 38, "how": [0, 8, 11, 14, 16, 20, 21, 28, 36, 38, 47], "howev": [13, 18, 20, 21, 23, 24, 26, 27, 31, 32, 34, 36, 37, 38, 41, 48, 49, 51], "hpcmp": 28, "html": [8, 17], "http": [12, 16, 17, 37, 38], "hub": [20, 28], "human": 16, "hwthread": 37, "hybrid": [0, 19, 23, 24, 28, 34, 36, 41, 49], "hydro": [36, 51], "hydrocarbon": 32, "hydrostat": [25, 36], "hyperbol": 19, "hypothesi": [25, 32], "hypr": [12, 43], "hypre_root_dir": 37, "i": [1, 6, 8, 9, 10, 12, 13, 14, 16, 17, 18, 19, 20, 21, 22, 23, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 41, 43, 44, 45, 46, 48, 50, 51], "i_": 20, "i_2": 16, "i_b": 32, "i_k": 31, "ib": 21, "iblank": 28, "ic_1": 43, "icm": 21, "id": 20, "idea": 13, "ideal": [19, 20, 23, 25, 30, 32, 36, 41, 48, 51], "ident": [19, 35], "identifi": [20, 32], "ifdef": 18, "ifndef": 16, "ignor": [23, 32, 36], "ii": [6, 21, 36, 40, 43, 47], "iii": 36, "ij": [20, 23, 25, 27, 31, 32, 35, 36], "ijk": [32, 36], "ik": [20, 32], "il": 20, "illustr": [23, 51], "imag": 36, "imax": 20, "immedi": [41, 51], "impact": [32, 36], "impart": 20, "implement": [14, 19, 21, 22, 23, 26, 27, 28, 31, 32, 34, 35, 36, 43, 51], "impli": [19, 29, 32, 48], "implic": 32, "implicit": [20, 22, 28, 32, 51], "implicitli": 20, "import": [20, 23, 32, 36, 41, 51], "impos": [36, 51], "imposit": 20, "improv": [27, 36], "inact": 28, "inc": 37, "incid": 32, "includ": [10, 14, 19, 20, 21, 23, 24, 25, 26, 27, 29, 31, 32, 37, 41, 49, 51], "inclus": [29, 32, 43, 51], "incom": [20, 31, 32, 36], "incomplet": 43, "incompress": [25, 36, 41], "inconsist": 32, "incorpor": 32, "increas": [20, 41, 51], "increment": [22, 29, 51], "independ": [20, 28, 35, 36, 51], "index": [8, 20, 23, 36], "indic": [16, 18, 19, 20, 25, 28, 51], "individu": 29, "induc": [32, 51], "inertia": [32, 36], "infer": 32, "infinit": 51, "infinitesim": [32, 51], "inflow": [21, 24, 32, 36, 47, 51], "inflow_boundary_condit": 43, "inflow_user_data": 43, "influenc": 36, "info": [12, 38], "inform": [16, 20, 21, 28, 35, 36, 43, 44, 48], "infrastructur": [0, 11, 14, 21, 49], "infrustructur": 51, "infti": [20, 25, 27, 32, 35, 36, 51], "inher": 23, "inherantli": 23, "init": [14, 43, 46, 48], "initi": [24, 28, 32, 41, 47, 51], "initial_condit": [36, 43], "initial_work": 32, "inlcud": 51, "inlet": [20, 43, 44, 51], "inlin": 16, "inner": 28, "inpfil": [36, 42, 43], "input": [6, 14, 19, 20, 21, 23, 30, 32, 36, 40, 42, 44, 45, 46, 47, 48, 51], "input_output": 51, "inputoutputrealm": 6, "insid": [28, 39, 40, 41, 51], "inspect": [27, 51], "instal": [11, 12, 14, 37, 38, 39, 40, 44], "install_nalu_eagl": 38, "install_nalu_gcc_mac": 38, "install_script": 38, "instanc": [6, 32, 43], "instantan": 32, "instead": [20, 32, 43], "instruct": [14, 17, 37, 38], "int": [16, 19, 20, 21, 23, 29, 31, 32, 33, 36, 51], "int_": [16, 20, 27, 31, 32, 35], "int_0": 36, "integ": [16, 28, 43], "integr": [9, 11, 19, 20, 23, 28, 29, 31, 32, 33, 35, 36, 40, 47, 51], "integrand": 32, "intel": [14, 38], "intend": [20, 37], "intens": [31, 32, 35], "intent": 51, "interact": [6, 32, 36, 47], "interest": [21, 23, 27, 36, 41, 44, 51], "interestingli": [21, 27, 51], "interfac": [0, 9, 11, 20, 21, 26, 36, 41, 49], "interior": [20, 28, 36, 41, 44], "intermedi": [28, 32], "intern": [20, 21, 25, 28, 32, 36], "interpol": [18, 19, 20, 22, 23, 26, 27, 28, 29, 31, 32, 51], "interpret": [32, 36], "intersect": 20, "interv": 51, "intial": [14, 16], "introduc": [20, 32], "introduct": [0, 32, 40, 47, 49, 51], "intuit": 31, "invers": [20, 23, 25, 27, 30, 32, 36, 51], "investig": 41, "invoc": [43, 44, 45], "invok": [32, 40, 44, 47], "involv": [20, 21, 26, 32, 43, 50], "inward": 51, "io": [12, 17, 21, 51], "ioss": 37, "ip": [19, 23, 51], "irradi": [20, 32], "irrot": 20, "ish": 28, "isn": 41, "iso": 32, "isoparametr": 20, "isotherm": [0, 30, 32, 49], "isotrop": [27, 31, 32, 35, 41, 51], "isotropi": 41, "issu": [8, 27, 32, 50], "itarget": 21, "item": 16, "iter": [20, 21, 23, 29, 31, 32, 36, 50], "its": [16, 20, 28, 31, 32, 35, 36, 38, 41, 51], "itself": [14, 16, 23, 28, 32, 51], "iv": 36, "j": [20, 21, 23, 32, 36, 37, 51], "jacobian": 20, "jam": 37, "jasek": 23, "jbeder": 37, "jet": [18, 20, 22, 51], "ji": 35, "jk": 32, "jmax": 20, "jofr": 27, "just": [16, 20, 38, 44, 51], "k": [16, 18, 21, 23, 24, 25, 32, 36, 41, 51], "k1": 32, "k2": 32, "k_": [23, 24, 25, 32], "k_t": 20, "kallinderi": 18, "kappa": [20, 32], "kappa_": [20, 51], "karman": 20, "katzplotkin": 51, "kd": 44, "ke": 27, "keep": [14, 41, 51], "kei": [31, 43], "kept": 32, "kernal": 27, "kernel": [27, 32, 36, 51], "keyword": [20, 23], "kg": 51, "kinet": [24, 25, 35, 36, 44], "kirchoff": 32, "kj": 32, "kk": [32, 35], "km": 20, "kmax": 20, "know": 14, "knowledg": 20, "known": [20, 23, 32, 35, 51], "koblitz": 32, "kokko": 21, "kolmogorov": 32, "kovasznai": 9, "kspace": 43, "l": [14, 19, 20, 22, 23, 25, 32, 35, 36, 37, 51], "l0": 51, "l1": 51, "l2": [23, 29, 51], "l_": [19, 27, 32, 51], "l_1": [22, 36, 51], "l_2": [21, 22, 23, 27, 36, 51], "l_e": 32, "l_i": 22, "l_j": 19, "l_o": 51, "l_t": 32, "labatto": 20, "label": [12, 14, 28], "laboratori": [36, 41, 51], "lack": [20, 41], "lag": [23, 36, 51], "lambda": [19, 20, 32, 51], "lambda_": 20, "lambda_w": 20, "lame": [24, 32], "laminar": [20, 32, 35, 51], "langl": [20, 32], "lapack": 14, "laplac": [0, 20, 22, 49], "larg": [14, 20, 25, 32, 35, 36, 37, 41, 43, 46, 51], "larger": [20, 23, 35, 41, 51], "lario": 27, "last": [32, 51], "lastli": 51, "late": 22, "later": [14, 20, 27, 51], "latest": [14, 37, 38], "latitud": 32, "latter": 36, "launch": 13, "law": [20, 25, 32, 35, 51], "layer": [22, 24, 28, 32, 36, 41, 44, 47, 51], "layout": 21, "lbla": 37, "ld_library_path": 37, "ldflag": 37, "ldot": 25, "le": [19, 23, 24, 27, 36, 41, 51], "lead": [18, 20, 25, 31, 32, 36, 41], "learn": [21, 40, 47], "least": [23, 31, 41, 43], "leav": [20, 32], "leer": 19, "left": [16, 19, 20, 22, 23, 25, 29, 31, 32, 35, 36, 51], "legendr": 20, "lend": 23, "length": [20, 21, 25, 29, 35, 36, 41, 43, 51], "less": [20, 22, 23, 25, 31, 38, 51], "lesser": 32, "lesson": [40, 47], "let": 22, "level": [9, 11, 16, 18, 24, 28, 32, 38, 43, 51], "leverag": [21, 32, 51], "levi": 32, "lewi": [24, 30], "lh": 23, "li": [20, 28], "lib": 37, "lib64": 37, "librari": [12, 14, 28, 36, 37, 38, 43, 44, 51], "liekli": 21, "lift": 51, "light": 28, "like": [8, 14, 21, 27, 32, 38, 43, 51], "likewis": 21, "limit": [19, 21, 22, 23, 25, 27, 28, 41], "line": [0, 1, 14, 20, 23, 31, 32, 36, 38, 40, 43, 44, 47, 48, 49], "linear": [9, 11, 18, 19, 20, 23, 26, 27, 28, 29, 31, 32, 36, 37, 40, 47, 49], "linear_solv": 43, "linearli": [20, 51], "link": [16, 36, 37, 44], "linux": [8, 14, 39, 40], "list": [14, 16, 37, 38, 43, 51], "literatur": [20, 29], "littl": [20, 25], "live": [16, 21, 28], "ll": 25, "llnl": 37, "lmm": 51, "ln": 20, "load": [13, 21, 36, 38, 44, 45, 51], "local": [11, 17, 20, 21, 24, 25, 29, 32, 37, 51], "locally_owned_part": 21, "locat": [8, 14, 19, 20, 23, 28, 32, 35, 36, 37, 38, 41, 43, 51], "log": [14, 20, 38, 45, 48], "logarithm": 20, "logic": 13, "login": 38, "long": [35, 36, 41, 43, 46, 51], "longer": 16, "look": [8, 14, 16, 21, 27, 43], "loop": [21, 22, 23, 33], "loos": 21, "loss": 36, "lot": [16, 41], "low": [0, 19, 21, 22, 23, 24, 27, 32, 41, 43, 51], "lower": [14, 20, 21, 25, 32, 51], "lowmach": 21, "lowmacheo": 21, "lowmacheom": 23, "lowmachequationsystem": 21, "lr": 22, "lump": [23, 33, 51], "m": [19, 20, 24, 32, 36, 37, 41, 51], "m43": 32, "ma": 25, "mac": [8, 37, 39, 40], "mach": [0, 21, 22, 23, 24, 27, 32, 43, 51], "machin": [11, 12, 17, 37, 39, 40], "machine_on": [43, 46], "machine_zero": [43, 46], "machineri": 51, "maco": 38, "made": [22, 32, 50], "magenta": 28, "magnitud": [20, 25, 32, 50, 51], "mai": [14, 20, 21, 22, 23, 26, 27, 32, 37, 38, 41, 51], "main": [8, 14, 20, 32], "maintain": [18, 23, 28, 32, 36, 51], "major": [28, 32, 35], "make": [11, 14, 19, 20, 23, 28, 36, 37, 38, 48, 51], "make_inc": 37, "manag": [8, 12, 13, 20, 23, 28, 37, 38], "mandatori": 28, "mangl": 37, "mani": [14, 17, 21, 22, 23, 32, 37, 51], "manifest": 20, "manipul": 32, "manner": [18, 23, 31], "manual": [0, 16, 20, 23, 35, 36, 39, 43, 51], "manufactur": [23, 50, 51], "map": [20, 28, 31, 32, 36, 43, 44, 51], "mapvar": 44, "march": 37, "markdown": 16, "marker": 16, "martinez": [31, 36], "mask": 28, "mass": [18, 20, 21, 23, 24, 27, 29, 30, 33, 36, 51], "mass_flow_r": 21, "mass_flow_rate_sc": 21, "massflowr": 21, "massflowrate_": 21, "massiv": [24, 49], "master": [12, 14, 18, 20, 21, 37], "masterel": [21, 28, 51], "match": [14, 20, 32, 35, 37, 41, 51], "materi": [30, 32, 47], "material_properti": 43, "math": 20, "mathbb": 32, "mathbf": [27, 29, 32, 36, 51], "mathcal": [32, 35], "mathemat": [20, 32, 35, 41], "mathrm": [32, 35, 36, 51], "matrix": [20, 23, 24, 27, 28, 33, 49, 51], "mavripli": 18, "max": [19, 32, 41, 51], "max_": 32, "max_iter": 43, "maximum": [32, 41, 51], "mcal1991": 41, "mcalist": [40, 47], "mdot": 21, "mean": [14, 20, 25, 32, 36, 38, 50], "meant": [16, 20], "measur": [20, 32, 41], "mechan": [20, 21, 32], "media": [26, 31], "meet": 20, "member": 13, "menter": 32, "mention": 43, "mere": [14, 38], "mesc": 21, "mesh": [6, 9, 14, 18, 20, 21, 24, 26, 28, 29, 30, 34, 36, 40, 44, 47, 48, 51], "mesh_adapt": 44, "mesh_mot": [32, 43], "mesh_transform": 43, "mesh_veloc": 43, "mesoscal": [32, 36], "messag": 45, "metadata": [21, 44], "metadata_": 21, "method": [13, 16, 20, 21, 22, 23, 24, 26, 27, 29, 32, 35, 36, 43, 50, 51], "methodologi": [23, 28, 50, 51], "metric": [27, 28, 31, 32, 41], "mid": [23, 36, 51], "midpoint": [19, 20, 23, 29], "might": [20, 21, 28, 31, 32, 36, 47], "mimic": [32, 51], "min": 32, "minim": [23, 36], "minimum": [19, 20, 25, 32, 41], "misleadingli": 41, "miss": [20, 21], "mistak": 50, "mix": [20, 23, 28, 29, 35, 41, 51], "mixtur": [22, 23, 24, 27, 30, 51], "mixturefract": 21, "mkdir": 37, "mm": [9, 49], "mode": [14, 43], "model": [0, 18, 19, 24, 25, 28, 30, 37, 41, 47, 50, 51], "modif": [20, 32, 36], "modifi": [19, 20, 28, 31, 32, 37, 38], "modul": [18, 20, 26, 31, 36, 37, 38, 51], "modulu": 32, "moin": 35, "molecular": [20, 25, 32, 36], "momementum": 22, "moment": [14, 32, 48], "momentum": [22, 24, 25, 27, 29, 35, 42, 43, 49], "momentumequationsystem": 21, "momentumsstamsdiffedgekernel": 32, "momentumsstamsforcingnodekernel": 32, "monin": 43, "monolith": [21, 22], "monoton": [19, 23, 51], "more": [12, 16, 18, 20, 21, 23, 27, 31, 32, 35, 36, 38, 41, 43, 44, 47, 51], "moreov": [20, 26, 32, 51], "moser": 32, "most": [20, 23, 35, 36, 38, 41, 44, 48, 50, 51], "mostli": [23, 37, 38, 41], "motion": [9, 25, 28, 30, 32, 47, 51], "motiv": 51, "move": [20, 24, 25, 51], "mpi": [28, 37, 44, 45], "mpi_base_dir": 37, "mpi_root_dir": 37, "mpicc": 37, "mpich": 37, "mpicxx": 37, "mpiexec": 37, "mpif77": 37, "mpif90": 37, "mtune": 37, "mu": [20, 25, 27, 32, 51], "mu_": [23, 25, 31, 32], "mu_a": [31, 32], "mu_t": [32, 35], "much": [16, 35, 38, 51], "muelu": 47, "multi": [0, 20, 24], "multiphys": 26, "multipl": [6, 20, 26, 28, 36, 43], "multiscal": [29, 31], "multitud": 27, "muscl": 27, "must": [16, 18, 20, 21, 22, 25, 32, 35, 36, 37, 43, 51], "myhc": 43, "myoption": 43, "mytest": 14, "n": [19, 20, 21, 22, 23, 31, 32, 33, 36, 51], "n_": [32, 36], "n_b": 36, "n_every_checkpoint": [43, 46], "n_i": [20, 27, 29, 31, 32, 36, 51], "n_j": [20, 23, 31, 32, 36], "n_k": [20, 28, 32], "n_r": 36, "n_simpleblad": 51, "n_turbines_glob": [43, 46, 51], "n_x": 20, "n_y": 20, "na": 51, "nabla": [20, 32], "naca": 41, "naca0018": 41, "nacel": [28, 36], "nacelle_area": [43, 46], "nacelle_cd": [43, 46], "nalu": [1, 8, 9, 11, 12, 15, 17, 20, 22, 23, 26, 28, 29, 32, 35, 40, 41, 44, 51], "nalu_build_dir": 37, "nalu_output": 44, "nalu_root_dir": 37, "nalu_wind_dir": 14, "nalu_wind_testing_dir": 14, "naluwindutil": [36, 44], "nalux": [37, 43, 45, 48], "name": [13, 14, 19, 20, 21, 25, 37, 42, 43, 44, 45], "name_nod_var": 44, "nanosecond": 32, "nasa": [30, 32, 41], "nation": [36, 41, 51], "nativ": [24, 37], "natur": [14, 20, 23, 31, 35, 41], "navier": [36, 43], "ncdump": 44, "ndim": 21, "ne": [25, 32, 35], "nearest": [20, 36], "nearli": [36, 41, 51], "necessari": [28, 32, 36, 37, 38, 43, 51], "necessarili": [20, 36, 48], "need": [8, 13, 14, 20, 21, 23, 25, 28, 32, 36, 37, 38, 41], "neg": 31, "neglect": [20, 25, 32, 36, 51], "neglig": [20, 36], "neighbor": [18, 28], "neq": [20, 36], "nest": 16, "net": 20, "netcdf": [14, 44], "netcdf_root_dir": 37, "netlib": 14, "neutral": [20, 45], "new": [10, 14, 18, 21, 27, 28, 32, 37, 48], "newest": 38, "newli": 28, "newton": 36, "newtonian": 25, "next": [14, 36, 37, 38, 51], "ngp": [21, 51], "ni": 21, "nice": [37, 38], "nightli": [0, 14, 51], "nint": 32, "nm1": 21, "noc": 51, "nodal": [18, 19, 20, 21, 24, 27, 29, 31, 32, 44, 49], "node": [18, 19, 20, 21, 23, 27, 28, 31, 32, 33, 35, 36, 38, 41, 43, 44, 51], "node_bucket": 21, "node_rank": 21, "node_rel": 21, "nodeset": 21, "nomenclatur": [28, 36], "non": [0, 13, 18, 23, 24, 27, 30, 31, 32, 35, 36, 38, 41, 47, 49], "non_conformal_boundary_condit": 43, "non_conformal_user_data": 43, "nonconform": [0, 20, 49], "nondimension": 25, "nonetheless": 32, "nonlinear": [0, 22, 23, 24], "nor": 41, "norm": [14, 20, 51], "normal": [0, 19, 28, 31, 32, 35, 36, 49], "normal_temperature_gradi": [20, 36], "north": 32, "notabl": 51, "notat": [25, 32], "note": [14, 16, 19, 20, 21, 22, 23, 25, 27, 28, 29, 31, 32, 35, 36, 37, 38, 45, 47, 51], "noth": 48, "notic": 20, "notion": [29, 32], "novel": 16, "novelti": 41, "now": [23, 27, 31, 32, 37, 38, 42, 43, 48, 51], "np1": 21, "nrel": [12, 14, 36, 37, 39, 40, 51], "nso": [0, 24], "nu": [19, 20, 27, 32], "nu_": 32, "nu_t": 32, "nuanc": [18, 22], "null": 21, "nullptr": 21, "nullspac": 20, "num_force_pts_blad": [43, 46, 51], "num_force_pts_tow": [43, 46], "num_nod": 21, "num_swept_pt": 36, "number": [0, 19, 21, 22, 24, 27, 28, 29, 30, 31, 36, 41, 43, 44, 46, 51], "number_of_st": 21, "numer": [19, 20, 24, 32, 43, 51], "numip": 21, "numstat": 21, "o": [8, 20, 28, 36, 37, 39, 40, 45], "o2": 37, "o3": 37, "object": [32, 38, 50, 51], "observ": [20, 32, 51], "obstacl": 20, "obtain": [20, 21, 22, 23, 27, 29, 31, 32, 35, 36, 50, 51], "obukhov": 43, "obviou": 20, "occur": [18, 20, 21, 26, 28, 32, 51], "od": 32, "off": [20, 21, 32, 37, 51], "offici": [14, 38], "offset": 51, "often": [20, 32, 36, 50, 51], "oftentim": 20, "oga": 28, "ok": 41, "old": 37, "older": 37, "oliv": 32, "omega": [27, 32, 36, 51], "omega1": 32, "omega2": 32, "omega_": 32, "omega_ju_k": [32, 36], "omit": [20, 32], "onc": [14, 16, 21], "one": [14, 18, 19, 20, 21, 23, 25, 28, 31, 32, 33, 35, 37, 38, 43, 44, 48, 51], "ongo": 32, "onli": [10, 14, 16, 20, 21, 23, 25, 27, 28, 29, 30, 32, 35, 36, 37, 42, 43, 44, 46, 51], "onto": [32, 36], "oo": 27, "op": 20, "open": [0, 18, 21, 22, 24, 28, 29, 34, 36, 44, 47, 49], "open_boundary_condit": 43, "open_user_data": 43, "openfast": [0, 1, 12, 43, 46, 49], "openfast_root_dir": 37, "openfoam": 36, "openmp": 37, "openmpi": [14, 37, 38], "oper": [0, 18, 19, 20, 21, 22, 23, 24, 26, 31, 32, 34, 36, 49], "oppor": 21, "oppos": [20, 51], "opposit": [36, 49], "opt1": 43, "optim": [14, 23, 43], "option": [18, 19, 23, 27, 29, 32, 36, 37, 38, 40, 42, 44, 46, 47, 51], "orchestr": 43, "order": [0, 19, 20, 21, 22, 23, 25, 27, 29, 31, 32, 33, 36, 37, 41, 43, 44, 49, 50], "ordin": [31, 32], "orient": [20, 28], "origin": [14, 20, 23, 25, 28, 31, 32, 36, 41, 51], "orphan": 28, "orthogon": [20, 23, 51], "osx": [38, 39, 40], "other": [14, 17, 20, 21, 22, 23, 28, 31, 32, 33, 35, 36, 37, 40, 41, 43, 47, 50, 51], "otherwis": [16, 32, 35, 37, 50], "our": [14, 22, 23, 41, 51], "out": [14, 20, 28, 31, 32, 35, 37, 38, 41, 51], "outer": [22, 28, 36, 51], "outflow": [0, 36, 49], "outgo": 31, "outlet": [20, 43, 44], "outlfow": 20, "outlin": [19, 51], "output": [14, 16, 21, 36, 44, 45, 47, 48, 51], "output_data_base_nam": 43, "output_format": 20, "output_frequ": 43, "output_level": 43, "output_node_set": 43, "output_vari": 43, "outsid": [31, 38], "outward": [20, 31, 32], "outwardli": 20, "over": [18, 20, 21, 23, 25, 28, 29, 32, 33, 35, 36, 43, 51], "overal": [20, 23, 25, 28, 35, 51], "overbar": 25, "overlap": 28, "overli": 51, "overlin": [20, 27, 32, 35], "overset": [0, 20, 24], "oversubscrib": 37, "oversubscribe_flag": 37, "overview": [20, 21, 32, 51], "overwrit": 14, "overwritten": 45, "own": [8, 14, 21, 26, 28, 37, 38, 51], "ownership": 21, "p": [20, 22, 23, 25, 27, 29, 32, 36, 45, 51], "p1": 51, "p1_zero_alpha_dir": 51, "p2": 51, "p_": [25, 32, 36], "p_0": 25, "p_1": [25, 51], "p_2": 51, "p_areavec": 21, "p_b": 32, "p_densiti": 21, "p_i": 32, "p_k": [20, 32], "p_o": 51, "pa": 51, "packag": [8, 14, 21, 28, 32, 37, 38, 51], "page": 37, "pair": [20, 43], "paolucci": 25, "paper": [22, 27, 29, 32, 41], "parabol": 49, "paralel": 44, "parallel": [14, 20, 24, 28, 44, 45, 49, 51], "parallel_netcdf_root_dir": 37, "param": 16, "paramet": [16, 19, 20, 25, 26, 27, 29, 31, 32, 43, 51], "paraview": [44, 47], "paraview_vers": 37, "paraviewcatalystiossadapt": 37, "parent": [18, 20], "part": [20, 23, 31, 32, 36, 43, 44], "parti": [12, 14, 38, 51], "partial": [19, 20, 23, 25, 27, 29, 31, 32, 33, 35, 36, 51], "partial_k": 32, "particip": [26, 28, 32, 43], "particl": 32, "particlar": 22, "particular": [14, 19, 20, 21, 26, 31, 32, 36, 43, 44, 51], "partit": 22, "partner": 32, "partvec_": 21, "pass": [14, 20, 32, 37, 41, 48], "past": [28, 51], "patch": [18, 21, 23, 51], "path": [8, 14, 37, 38, 41], "pathtompi": 37, "pathtonaluprojectdir": 37, "pde": [21, 27, 32, 35], "pe": 19, "peclet": [19, 27], "peer": 10, "peform": [10, 23], "penal": 20, "penalti": 20, "per": [14, 23, 28, 36, 51], "percept": [18, 44], "percis": 27, "perform": [20, 28, 32, 36, 41, 44, 51], "period": [21, 24, 32, 42, 47, 51], "periodic3d": 43, "periodic_user_data": 43, "permit": 34, "perpendicular": 20, "person": 16, "perspect": [36, 51], "perturb": [25, 27, 32, 36], "perus": 51, "phantom": 25, "phase": [24, 32, 37, 49], "phenomena": 32, "phi": [19, 20, 23, 27, 28, 32, 33, 35, 36, 51], "phi_": [19, 23, 51], "phi_0": 23, "phi_1": [23, 32], "phi_2": 32, "phi_h": 20, "phi_k": [19, 23, 28, 51], "phi_l": [23, 51], "phi_m": 20, "phi_r": [23, 51], "physic": [0, 13, 20, 21, 24, 29, 32, 35, 40, 41, 47, 51], "pi": [20, 31, 32, 36, 51], "pi_": 20, "picard": [22, 32, 36], "pick": 38, "piec": [23, 32], "piecewis": [20, 27, 31, 51], "piecwis": 51, "pimpl": 36, "pip": 8, "pip2": 8, "pipe": 51, "piv": 51, "pkg": 38, "place": [14, 18, 20, 28, 31, 37], "plan": 35, "plane": [20, 22, 32, 43, 44], "plant": 32, "plat": 37, "platform": 37, "pleas": [35, 37, 44], "plif": 51, "plot": [23, 51], "plu": 27, "plug": 21, "plume": 51, "pm": 32, "pmr": [20, 21, 26], "pnetcdf": 37, "png": 23, "point": [8, 19, 20, 21, 23, 26, 27, 28, 29, 31, 32, 33, 36, 38, 51], "pointer": 21, "pointwis": [21, 40, 44, 47], "poisson": [18, 20, 23, 32, 36, 37, 51], "polic": 13, "polymorph": 13, "polynomi": [23, 30], "poor": [23, 41, 51], "popul": 37, "porjectin": 22, "portion": [20, 32, 35, 41, 51], "pose": [20, 28], "posit": [20, 32, 36], "possibl": [13, 18, 20, 32, 38, 43, 46, 51], "possibli": [21, 37, 48], "post": [9, 11, 14, 20, 23, 28, 47, 51], "post_process": 43, "postul": 20, "potenti": [20, 36, 41], "potential_flow_bc": 20, "power": 50, "pprint": 45, "pr": [25, 32, 51], "practic": [0, 11, 20, 29, 50], "prandtl": [24, 25, 27, 51], "pre": [20, 21, 23, 32, 36, 38], "pre_iter_work": 32, "preceed": [20, 51], "precis": 21, "precondition": [37, 43, 47], "precurosr": 51, "precursor": [0, 32, 36, 49], "precusor": [36, 51], "predefin": 28, "predetermin": 32, "predict": [24, 31, 32, 35, 36, 49, 51], "predictor": [22, 36], "prefer": [20, 22, 25, 26, 27, 37, 38, 41], "prefix": [37, 42, 43], "preliminari": 44, "prepar": [37, 38], "prescrib": [20, 23, 32], "prescript": 20, "presenc": [20, 35, 36], "present": [20, 30, 32, 33, 35, 36, 43], "preserv": 41, "pressur": [0, 20, 21, 22, 23, 24, 25, 27, 32, 35, 36, 37, 41, 43, 49], "prevail": 32, "prevent": [20, 35, 41], "previou": [28, 32, 36, 51], "previous": [14, 32, 43, 51], "primari": [32, 36, 51], "primarili": 32, "prime": 20, "primer": 17, "primit": [23, 25, 29], "principl": 20, "print": [14, 44, 45, 48], "prior": 19, "priori": 51, "privat": [13, 16], "probabl": 32, "probe": 47, "problem": [0, 25, 27, 32, 35, 36, 37, 38, 41, 43, 49, 50], "problemat": 51, "proce": [28, 32], "procedur": [18, 20, 23, 28, 32, 35, 36], "proceed": 20, "process": [9, 11, 14, 16, 20, 23, 28, 32, 36, 37, 47, 50, 51], "procno": [43, 46], "produc": [32, 37, 41], "product": [10, 19, 20, 27, 29, 32, 37, 51], "profil": [20, 32, 36, 38, 43, 49], "program": [20, 28, 44], "program_opt": 37, "project": [0, 11, 12, 19, 20, 21, 22, 24, 29, 32, 36, 37, 44, 49], "prolong": 24, "promot": [23, 44], "prone": 27, "proof": 23, "propag": [14, 25, 32], "proper": [21, 32, 51], "properli": [35, 51], "properti": [0, 20, 24, 25, 31, 32, 35, 47, 49], "proport": [25, 30, 32, 35, 36], "propos": [27, 36, 50], "protect": 16, "prototyp": [18, 20, 24, 49], "prove": 51, "provid": [6, 14, 16, 19, 20, 21, 23, 27, 28, 29, 30, 31, 32, 35, 36, 37, 38, 43, 44, 45, 47, 50, 51], "provision": 29, "pseudo": 19, "psi": [16, 20], "psi_h": 20, "psi_m": 20, "psuedo": [19, 23], "public": [12, 16, 23, 32, 41], "pull": [10, 12], "pundit": 28, "pure": [19, 23, 24, 51], "purg": 38, "purpos": [21, 32, 36, 43], "push": [10, 12, 41], "put": 21, "put_field_on_mesh": 21, "pyramid": [34, 41, 51], "python": [8, 37, 38], "q": [20, 25, 32, 36], "q_": 20, "q_i": [25, 32], "q_j": [20, 25, 31, 32, 36], "q_n": 20, "qquad": 32, "quad": [18, 20, 23, 25, 34, 35, 36, 41], "quadrat": [23, 51], "quadratur": [23, 31, 49], "quadrilater": 23, "qualiti": [19, 23, 41], "quantit": 50, "quantiti": [19, 20, 21, 23, 31, 32, 51], "queri": 51, "question": [16, 20, 44, 51], "quickli": 38, "quit": 50, "r": [14, 19, 23, 25, 27, 29, 31, 32, 36, 41, 51], "r0": 51, "r1": 51, "r2": 51, "r3": 51, "r4": 51, "r_": 19, "r_j": [19, 36], "r_k": [27, 32], "radi": [20, 24, 31], "radial": 36, "radiat": [26, 31, 32], "radiatit": 32, "radii": 36, "radiu": 36, "ran": [19, 20, 24, 36], "rang": [22, 23, 33, 44, 51], "rangl": [20, 32], "rank": [21, 28, 44, 45], "rank_t": 21, "rans_abl_bc": 20, "rans_below_k": 20, "rare": [23, 32], "rate": [18, 20, 21, 27, 29, 32, 35, 36, 41, 51], "rather": [16, 18, 20, 27, 32, 35, 51], "ratio": [23, 25, 32, 36, 41, 51], "raw": 19, "rcb": 43, "re": [20, 25, 27, 32, 38], "reaction": 32, "read": [16, 21, 36, 41, 51], "readabl": 16, "reader": [16, 27, 32, 35], "readili": 23, "readthedoc": 17, "real": 16, "realiz": [23, 31, 32, 51], "realli": [32, 38], "realm": [9, 13, 20, 23, 26, 32, 40, 47, 51], "realm_": 21, "realm_1": 43, "reason": [32, 41], "reat": 22, "rebuild": [12, 38], "recal": 32, "recent": [20, 22, 23, 32, 51], "recept": 28, "receptor": 28, "recev": 28, "recipi": 28, "recogn": 23, "recommend": [16, 23, 37, 38], "reconstruct": [18, 29], "recov": [20, 51], "recoveri": 21, "rectangular": 28, "recurs": 14, "recycl": 51, "recylc": 51, "red": 51, "redirect": 45, "reduc": [20, 23, 28, 31, 32, 51], "reduct": [23, 28, 32], "ref": [20, 32, 51], "refer": [0, 10, 17, 20, 21, 27, 28, 30, 32, 35, 36, 37, 40, 43, 47, 51], "referenc": 51, "reference_height": 20, "reference_temperatur": 43, "reference_veloc": 20, "refin": [18, 20, 28, 41, 44, 50, 51], "refinementerror": 51, "reflect": [14, 32], "reg_test": [14, 48], "regard": [14, 43], "regardless": 32, "regex": 37, "regim": [20, 51], "region": [20, 27, 28, 32, 35, 36, 41, 51], "regist": 21, "register_edge_field": 21, "register_nodal_field": 21, "register_wall_bc": 21, "registr": 13, "regress": [10, 14, 39, 40, 51], "regular": [14, 51], "rehm": 25, "rel": [20, 22, 23, 32, 41, 51], "relat": [14, 20, 21, 23, 25, 32, 35, 36, 43], "relationship": [20, 21, 31, 32], "relax": [22, 23, 27, 32, 36], "relaxation_factor": [20, 42, 43], "releas": [8, 37, 38], "relev": 44, "reli": 32, "remain": [25, 32, 50, 51], "remedi": [32, 34, 51], "remov": [13, 18, 20, 28, 37, 44], "render": 43, "renew": [36, 51], "repeat": [19, 25, 35], "replac": 32, "replic": 35, "repo": [8, 14, 17, 37, 38], "repo_url": 14, "report": 41, "repositori": [8, 14], "repres": [19, 20, 21, 22, 23, 24, 26, 27, 31, 32, 33, 35, 36, 41, 43, 49, 51], "represent": [20, 32, 36, 50], "reproduc": 36, "request": [10, 12, 43, 44], "requir": [14, 16, 18, 20, 21, 23, 25, 26, 27, 28, 29, 31, 32, 35, 36, 37, 38, 41, 43, 44, 47, 50, 51], "reres": 6, "rerun": 14, "research": [24, 28, 32, 49], "resembl": 27, "resid": 20, "residu": [20, 23, 24, 29, 31], "resolut": [20, 31, 32, 35, 41, 51], "resolv": [20, 21, 25, 31, 32, 35, 36, 41], "resourc": 32, "respect": [18, 20, 23, 32, 36, 51], "respons": [19, 26, 32], "restart": [44, 46, 47], "restart_filenam": [43, 46], "restartdriverinitfast": [43, 46], "restor": 36, "restrict": [20, 24, 36, 41, 51], "restructur": 17, "result": [0, 12, 14, 16, 19, 20, 22, 23, 25, 27, 28, 31, 32, 35, 36, 41, 43, 47, 49], "retain": [20, 32, 36, 51], "retent": 31, "return": [13, 16], "reus": 12, "reveal": 50, "revers": 44, "review": [10, 24, 36, 51], "revis": 14, "rex": 41, "reynold": [22, 23, 25, 32, 36, 51], "rf": 37, "rho": [19, 20, 23, 25, 27, 29, 32, 33, 35, 36, 51], "rho_": [20, 25, 32, 36], "rich": 32, "right": [16, 18, 19, 20, 22, 23, 25, 29, 31, 32, 35, 36, 51], "rigor": 50, "rm": [19, 20, 25, 31, 32, 36, 37, 51], "roach": 50, "robust": 23, "rodi": 32, "rogallo": 35, "role": 24, "roll": 38, "root": [20, 31], "rotat": [28, 32, 36], "rotor": [28, 36, 41], "rotorcraft": 41, "rough": [20, 36], "roughness_height": [20, 43], "round": [41, 51], "routin": [20, 21, 28], "row": [19, 20, 23, 28, 37], "rst": 17, "rte": [0, 20, 24, 26, 27, 32], "rule": [23, 51], "run": [0, 10, 11, 12, 13, 22, 23, 27, 35, 37, 38, 40, 43, 46, 51], "runtim": [37, 45], "runtime_error": 21, "rush": 10, "s_": [23, 27, 32, 35], "s_i": [20, 31, 32], "s_j": 31, "s_locally_owned_union": 21, "s_sourc": 20, "sai": 20, "sake": 22, "salmon": 28, "same": [14, 18, 20, 21, 22, 23, 25, 28, 32, 35, 37, 42, 43, 51], "sampl": [16, 20, 36, 43], "sand": 20, "sandia": 41, "satisfi": [18, 36], "satisifi": 14, "save": [21, 36, 51], "sc": [32, 51], "scalar": [20, 27, 31, 32, 44], "scalarfieldtyp": 21, "scale": [20, 22, 23, 24, 25, 27, 29, 31, 35, 36, 41, 43, 51], "scatter": [31, 32], "scenario": 43, "schemat": [36, 51], "scheme": [18, 19, 20, 21, 22, 23, 24, 27, 29, 31, 32, 33, 34, 43, 50, 51], "schmidt": [24, 27], "schneider": 23, "scienc": 37, "scope": 21, "script": [14, 37, 38], "seaca": [37, 44], "search": [20, 24, 36, 43, 51], "search_method": [43, 46, 51], "search_target_part": [43, 46, 51], "sec": [32, 36], "second": [19, 20, 22, 23, 27, 31, 32, 33, 36, 43, 51], "second_order_accuraci": 43, "secondari": [32, 51], "section": [10, 20, 21, 27, 28, 30, 31, 32, 35, 36, 41, 43, 44, 47, 51], "sector": [18, 24, 26, 49], "see": [12, 14, 19, 20, 21, 23, 27, 32, 35, 36, 38, 43, 44, 51], "seek": 32, "seem": [20, 22, 27], "seen": [14, 51], "segment": [23, 36], "segreg": 22, "select": [20, 21, 25, 28], "selectunion": 21, "senc": 23, "sens": [14, 16, 20], "sensit": [22, 23, 28, 32, 51], "sent": 36, "separ": [14, 20, 28, 35], "seri": [18, 25, 29, 41, 51], "serial": 37, "serv": [21, 41, 43, 44, 51], "servo": [36, 51], "set": [0, 6, 14, 16, 18, 19, 20, 21, 23, 24, 25, 26, 27, 28, 29, 31, 35, 36, 37, 38, 41, 43, 44, 46, 47, 51], "set_field_output_typ": 21, "setup": [13, 28, 36, 38, 43, 47], "seven": 23, "sever": [32, 35, 38, 43, 44, 45], "sf": 36, "sg": [18, 23, 24, 27, 32, 43], "sget": 32, "sgr": 32, "sh": [37, 38], "shade": 51, "shakib": 27, "shape": [18, 20, 23, 51], "share": [21, 26, 27, 37, 38], "shared_constraint": 38, "sharper": 27, "shear": [20, 25, 35], "shell": 38, "shen": 36, "shift": [19, 23, 29, 51], "short": 20, "shorten": 38, "shorter": [32, 51], "should": [8, 14, 16, 20, 21, 27, 28, 32, 35, 37, 38, 41, 42, 43, 48, 51], "show": [14, 16, 28, 32, 36, 37, 41, 43, 44, 51], "shown": [14, 16, 18, 19, 20, 23, 27, 28, 31, 32, 36, 37, 38, 43, 51], "side": [18, 20, 21, 32, 43, 44, 51], "side_rank": 21, "siderank": 21, "sideset": 21, "sierra": [1, 6, 24, 31, 38, 49, 51], "sigma": [20, 31, 32], "sigma_": 32, "sigma_k": 32, "sign": [20, 51], "signal": [25, 37], "signifi": 29, "signific": [36, 51], "significantli": [21, 32, 35, 51], "silli": 13, "sim": 20, "sim1": 43, "similar": [14, 18, 20, 22, 31, 35, 36, 37, 51], "similarli": 32, "simpl": [20, 21, 22, 23, 28, 30, 32, 33, 35, 36, 44, 49], "simplest": [20, 32, 44, 47], "simpli": [19, 20, 21, 23, 27, 28, 29, 31, 32, 33, 34, 35, 51], "simplic": 35, "simplif": 51, "simplifi": [20, 32, 35, 51], "simstart": [43, 46], "simul": [0, 1, 9, 11, 20, 22, 24, 25, 28, 35, 36, 40, 44, 46, 47, 49], "sin": [20, 32, 51], "sinc": [14, 20, 21, 25, 31, 32, 35, 50, 51], "singl": [14, 20, 21, 23, 30, 32, 36, 44, 51], "singular": 25, "site": 14, "situ": [37, 44, 47], "situat": [20, 32, 38, 51], "siumul": 51, "six": 44, "size": [20, 21, 32, 35, 36, 41, 51], "size_t": 21, "size_typ": 21, "sketch": 20, "skew": [19, 23, 41, 51], "skin": 28, "skip": [8, 37, 48], "slab": 20, "slave": 20, "slice": 32, "slide": 20, "slight": [20, 51], "slightli": [22, 41], "slip": [20, 36, 41, 51], "slope": 51, "slow": 22, "slowdown": 22, "smagorinski": [24, 32, 36], "small": [20, 21, 25, 32, 35, 41], "smaller": [32, 35, 51], "smallest": 35, "smooth": [20, 30, 32], "smoother": 20, "smoothli": 32, "snapshot": [12, 38], "snippet": [43, 44], "snl": 23, "so": [14, 16, 23, 25, 32, 35, 36, 37, 38, 43, 51], "soft": 32, "softwar": [14, 44], "sole": [6, 23], "solid": [23, 24, 28, 51], "solonoid": 23, "solut": [19, 20, 23, 28, 32, 35, 36, 44, 47, 50, 51], "solution_norm": 43, "solution_opt": [20, 43], "solutionnormpostprocess": 13, "solv": [6, 20, 21, 22, 23, 26, 28, 29, 31, 32, 35, 36, 37, 43, 47, 50, 51], "solve_scalar": 43, "solver": [9, 11, 20, 36, 37, 40, 47], "solver_system_specif": 43, "some": [8, 12, 13, 20, 21, 23, 26, 32, 36, 37, 38, 41, 44, 51], "someprotectedmethod": 16, "someth": [8, 16, 37, 38, 41], "sometim": 35, "soon": 51, "soot": 32, "sophist": 51, "sorensen": 36, "sort": 21, "sourc": [0, 11, 12, 16, 20, 24, 27, 28, 31, 36, 37, 38, 42, 43, 44, 49], "source_term": 20, "sowfa": 36, "space": [20, 25, 28, 32, 35, 36, 41, 50, 51], "spack": [8, 12, 14, 37, 39, 40], "spack_root": 38, "spalart": 32, "span": 51, "spanwis": 20, "spatial": [21, 23, 25, 32, 35, 51], "spatial_dimens": 21, "speak": 21, "spec": 20, "speci": [24, 30], "special": [6, 13, 16, 18, 20, 23, 43], "specif": [18, 19, 21, 22, 23, 24, 25, 27, 28, 31, 32, 37, 38, 43, 44, 46, 51], "specifi": [0, 19, 23, 32, 36, 38, 43, 49], "specific_heat": 43, "spectral": 23, "spectrum": 32, "speed": [22, 25, 32, 51], "sphere": 28, "sphinx": [8, 16, 17], "sphinx_rtd_them": 8, "sphinxcontrib": 8, "split": [18, 20, 21, 24, 25, 26, 31, 35, 36, 51], "spread": [36, 51], "sqrt": [16, 20, 25, 27, 32, 36, 51], "squar": [20, 25, 31, 35, 41], "src": 37, "ss_name": 44, "sst": 24, "sstamsaveragesalg": 32, "stabil": [0, 20, 23, 24, 32, 43, 51], "stabl": [20, 23, 51], "stabli": [20, 51], "stage": 38, "stai": 25, "standard": [19, 20, 21, 22, 23, 24, 27, 30, 31, 32, 36, 51], "standardtimeintegr": 43, "start": [19, 20, 31, 32, 37, 43, 46], "start_tim": 43, "state": [14, 19, 20, 23, 25, 28, 32, 33, 51], "statement": 31, "staten": 21, "statenm1": 21, "statenp1": 21, "static": [20, 26, 27, 32, 51], "static_cast": 21, "station": 51, "stationari": [36, 51], "statist": [35, 36, 47, 51], "statu": [21, 28], "std": [21, 37], "steadi": [0, 9, 22, 32, 49], "steady_2d_therm": 43, "steep": 41, "stencil": [19, 20, 23, 51], "step": [20, 22, 24, 28, 29, 32, 37, 47, 51], "stiff": 32, "still": [27, 32, 36, 51], "stk": [20, 21, 24, 26, 51], "stk_doc_test": 51, "stk_kdtree": [43, 46, 51], "stoke": [25, 36, 43], "stop": [43, 46], "storag": 29, "store": [20, 29, 32, 44], "straight": [32, 36], "straightforward": 35, "strain": [27, 32, 35], "strategi": 28, "stratif": [0, 20, 49], "stratifi": [20, 36, 49], "stream": [32, 36], "streamlin": 36, "streamwis": [20, 51], "strength": 20, "stress": [24, 25, 27, 36], "strickli": 23, "stricter": 41, "string": [21, 37, 45], "strong": [24, 32], "stronger": 20, "strongli": [20, 23, 36], "structu": 41, "structur": [20, 21, 23, 24, 31, 32, 35, 36, 41, 44, 47, 49, 51], "studi": [22, 51], "style": [0, 11, 12], "sub": [18, 19, 20, 23, 32, 36, 43], "subcontrol": [19, 23, 27, 29, 51], "subgrid": [24, 27, 35, 36], "sublay": 20, "submit": 14, "submodul": [14, 48], "subsect": [42, 43], "subsequ": [21, 36, 44, 49], "subset": [6, 14, 20, 25, 43, 51], "substantail": 23, "substitut": [20, 23, 31, 32], "subtl": 32, "subtract": [20, 25, 27, 32], "succe": 38, "success": [32, 48, 50, 51], "successfulli": [8, 38], "sucv": 31, "sudo": 8, "suffer": 51, "suffici": 28, "suggest": [15, 20, 25, 27], "suit": [10, 24, 51], "suitabl": [19, 27, 28, 31], "sum": [19, 23, 28, 29, 31, 32, 51], "sum_": [20, 27, 32, 36], "summari": [22, 48], "summat": [25, 36], "summer": 20, "superbuild": 37, "superior": 51, "superlu": 14, "superlu43": 37, "superlu_4": 37, "superlu_root_dir": 37, "superluroot": 37, "supg": 24, "supplement": 32, "suppli": [20, 32, 36], "support": [0, 10, 18, 19, 21, 23, 24, 26, 27, 28, 29, 30, 35, 36, 37, 38, 41, 44, 49, 51], "sure": 37, "surfac": [19, 21, 23, 24, 26, 27, 28, 29, 31, 32, 36, 47, 51], "surface_1": [21, 43], "surface_2": 43, "surface_6": 43, "surface_7": 43, "surface_77": 43, "sust": 32, "sutherland": 30, "sweep": 36, "swept": 36, "switch": 20, "symbol": 32, "symmetr": [19, 27, 31, 41], "symmetri": [21, 24, 34, 36, 47, 51], "symmetry_bc_penalty_factor": 20, "symmetry_boundary_condit": [20, 43], "symmetry_typ": 20, "symmetry_user_data": [20, 43], "syntax": [16, 20], "syrinx": 31, "system": [9, 11, 12, 18, 20, 21, 22, 23, 26, 28, 32, 33, 36, 37, 38, 41, 47, 50, 51], "t": [8, 14, 16, 20, 23, 25, 27, 29, 31, 32, 33, 35, 36, 37, 41, 43, 46, 51], "t_": [20, 25, 27, 32, 51], "t_0": 51, "t_end": [43, 46], "t_i": 20, "t_max": [43, 46], "t_start": [43, 46], "t_w": [20, 32], "t_x": 20, "tab": 13, "tabl": [19, 20, 30, 32, 43, 51], "tabul": 51, "tag": [20, 28], "tailor": 16, "takahashi": 41, "take": [18, 19, 20, 23, 27, 31, 32, 42, 43, 48, 51], "taken": [20, 32, 35], "tall": 51, "talor": 51, "tan": 20, "tangeant": 19, "tangenti": 20, "tanh": [19, 32], "tap": 37, "tar": [32, 37, 38], "target_nam": [20, 43], "target_part_format": [42, 43], "targetnam": 21, "targetpart": 21, "tau": [20, 22, 24, 25, 27, 29, 32, 36], "tau_": [20, 23, 25, 31, 32, 36], "tau_1": 36, "tau_2": [22, 36], "tau_3": [22, 36], "tau_i": 22, "tau_w": 20, "taylor": [0, 9, 32, 49], "team": 36, "technic": 41, "techniqu": [18, 23, 25, 32, 50, 51], "tee": 37, "temperatur": [0, 25, 28, 30, 32, 36, 42, 43, 49], "temperaur": 36, "templat": [13, 21, 38], "tempor": [32, 35, 49], "temporari": 14, "ten": 51, "tensor": [23, 25, 27, 31, 32, 35], "tensori": 32, "ter": 35, "term": [19, 20, 22, 24, 25, 27, 28, 29, 31, 35, 36, 41, 43, 49], "termin": 20, "termination_step_count": 43, "terrain": [20, 32, 43], "test": [0, 10, 11, 18, 20, 21, 23, 24, 27, 32, 37, 38, 39, 40, 41, 49], "test01": [43, 46], "test02": [43, 46], "test_fil": [14, 48], "testb": 21, "tet": [20, 28, 34, 41, 51], "tet4": 20, "tetrahedr": [18, 41, 51], "tetrahedra": 41, "text": [16, 17, 20, 32], "textrm": [36, 51], "tg": 32, "th": [20, 25, 27, 32], "than": [20, 22, 23, 28, 31, 32, 35, 41, 43, 51], "theeqsi": 43, "thei": [14, 18, 20, 22, 23, 25, 32, 35, 36, 37, 38, 50, 51], "them": [13, 18, 21, 22, 32, 37, 38, 47, 48], "themselv": 28, "theoret": [32, 36], "theori": [0, 23, 27, 32, 36, 51], "theory_abltop_bc": 20, "theprivatedata_": 13, "therebi": 31, "therefor": [8, 14, 19, 20, 21, 23, 27, 28, 29, 31, 35, 36, 38, 41, 44, 51], "therfor": 20, "thermal": [0, 9, 21, 24, 25, 26, 31, 49], "thermal_conduct": 43, "thermodynam": [25, 32], "thermophys": 25, "theta": [16, 20, 32, 36], "theta_": [20, 32], "theta_i": 36, "thetopo": 21, "thexahedr": 51, "thi": [8, 10, 12, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 29, 31, 32, 33, 35, 36, 37, 38, 41, 43, 45, 47, 48, 49, 51], "thick": [20, 36], "thicker": 20, "thin": [20, 32, 51], "thing": [12, 16, 37], "third": [12, 14, 19, 23, 38, 51], "thorough": 36, "those": [20, 21, 25, 28, 36, 41], "thread": 37, "three": [20, 28, 30, 32, 33, 51], "threshold": 36, "through": [18, 20, 21, 23, 26, 31, 32, 36, 38, 41, 51], "throughout": [32, 51], "throw": [21, 37], "thu": [20, 22, 23, 32, 36, 50], "thurgood": 31, "ti_1": 43, "tieszen": 32, "tild": [19, 20, 31, 35], "time": [0, 9, 13, 14, 17, 20, 22, 24, 25, 27, 29, 32, 35, 38, 40, 41, 44, 46, 47, 50, 51], "time_integr": 43, "time_step": 43, "time_step_control": 43, "time_step_count": 43, "time_stepping_typ": 43, "timescal": 32, "timestep": [32, 36, 43, 51], "tioga": 24, "tioga_root_dir": 37, "tiom": 51, "tip": [40, 47, 51], "tipe": 41, "tke": [32, 36], "tmdot": 21, "togeth": [20, 25], "toler": [14, 35, 43], "too": 16, "tool": [11, 20, 24, 28, 32, 36, 38, 44, 49, 51], "toolkit": [24, 49, 51], "top": [9, 11, 14, 23, 24, 43, 51], "topolog": [0, 18, 24], "topologi": [9, 18, 20, 21, 23, 28, 33, 41, 51], "topwal": 44, "tossa": 36, "tossas2017": 36, "tot": 32, "total": [20, 25, 32, 36, 41, 44, 51], "total_pressur": 43, "touch": [21, 32], "tow": 20, "toward": 12, "tower": [36, 41, 43], "tpetra": [24, 43, 49], "tpl": [14, 20, 28, 37, 38], "tquad": 51, "tquad4": 51, "trac": 37, "traceless": 32, "track": 36, "tradeoff": 35, "tradit": [18, 24, 32, 41, 49], "trail": 41, "tran": 19, "transfer": [9, 20, 21, 26, 28, 32, 36, 40, 47, 51], "transform": [20, 27, 32, 47], "transient": [22, 32, 51], "transit": [18, 19, 35, 36, 41], "transition": 22, "translat": 43, "transmiss": 32, "transport": [18, 19, 20, 24, 26, 27, 29, 30], "treat": [18, 20, 32], "treatment": [32, 36], "tri": [34, 38], "triangular": [41, 51], "trigger": 36, "trilino": [8, 14, 21, 24, 38, 44, 47, 49, 51], "trilinos_install_dir": 14, "trilinos_root_dir": 37, "tripl": 32, "tropic": 32, "troubl": 21, "true": [20, 32], "truerestart": [43, 46], "truli": 16, "truncat": 44, "try": [13, 38], "tucker2003": 32, "tune": 35, "tunnel": 41, "turb_id": [43, 46], "turbin": [1, 20, 24, 28, 32, 47, 51], "turbine0": [43, 46], "turbine1": [43, 46], "turbine_base_po": [43, 46], "turbine_hub_po": [43, 46], "turbine_nam": [43, 46], "turbkineticenergi": 21, "turbul": [0, 21, 22, 23, 24, 32, 44, 47, 49, 51], "turbulence_averag": 43, "turbulent_k": 44, "turn": [20, 37, 51], "twenti": 51, "twist": 51, "twist_tabl": 51, "two": [12, 18, 19, 20, 21, 23, 25, 28, 30, 31, 32, 36, 42, 43, 44, 51], "txt": [14, 37], "type": [6, 14, 19, 20, 21, 25, 30, 35, 36, 42, 43, 46, 51], "typic": [18, 21, 26, 32, 35, 36, 37, 41, 51], "u": [16, 20, 22, 25, 29, 32, 36, 51], "u_": [19, 20, 25, 32, 36, 51], "u_h": 20, "u_i": [19, 20, 23, 25, 27, 29, 32, 35, 36], "u_j": [19, 20, 23, 25, 27, 32, 35, 36], "u_k": [25, 27, 32, 35], "u_n": 32, "u_o": 51, "u_ot": 51, "u_t": 16, "u_u": 32, "u_x": 23, "ubuntu": 12, "ultim": 14, "un": [19, 27], "unam": 37, "unbeliev": 16, "unchang": 32, "uncomfort": 38, "under": [20, 32, 35, 36, 38, 43, 51], "underbrac": 36, "underli": [21, 23, 32, 51], "underscor": 13, "understand": [18, 36, 41, 44, 47], "understood": 32, "underwai": [27, 31], "unfortun": 51, "uniform": [0, 20, 22, 27, 30, 36, 49], "uniformli": [20, 36, 51], "uniqu": [20, 32], "unit": [10, 12, 14, 20, 21, 27, 32, 36, 39, 40, 49], "uniti": [19, 20, 22, 24, 28, 30, 31, 51], "unittestx": 48, "unknown": [32, 50], "unless": [13, 20, 51], "unlik": [20, 28, 35, 43], "unrefin": 18, "unresolv": 32, "unscal": 25, "unspecifi": [43, 46, 51], "unsplit": 25, "unstabl": 20, "unsteadi": [0, 35, 49], "unstructur": [18, 21, 23, 24, 41, 49, 51], "until": 51, "unus": 43, "unweight": 35, "uo": 12, "up": [21, 22, 23, 28, 32, 36, 38, 41, 44, 47], "updat": [17, 36, 48], "upper": [20, 23, 36, 51], "upstream": [20, 36, 41], "upw": [19, 27], "upward": 21, "upwind": [19, 20, 23, 24, 27], "urg": 36, "us": [8, 9, 12, 13, 14, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 27, 29, 30, 31, 32, 33, 35, 36, 37, 41, 43, 44, 45, 50, 51], "usag": [18, 19, 20, 23, 24, 26, 27, 31, 43, 49, 51], "use_abl_wall_funct": 43, "use_consolidated_solver_algorithm": 43, "use_edg": [23, 43], "useless": 41, "user": [0, 11, 16, 19, 20, 21, 22, 28, 32, 36, 37, 38, 43, 44, 45, 47, 51], "user_const": 20, "user_data": 36, "user_function_nam": 43, "usr": 37, "usual": [32, 35, 36, 38, 41], "util": [8, 9, 11, 14, 36, 38, 40, 47], "v": [16, 20, 28, 31, 32, 35, 36, 44, 45, 51], "v7": 37, "v_i": 32, "v_j": 32, "v_k": 32, "v_o": 51, "v_ot": 51, "valid": [20, 28, 32, 51], "valu": [16, 18, 19, 20, 23, 27, 28, 29, 30, 31, 32, 33, 35, 36, 43, 51], "van": 19, "varepsilon": [32, 51], "vari": [14, 19, 20, 25, 32, 35, 36, 43, 51], "variabl": [18, 19, 20, 22, 23, 24, 25, 32, 35, 37, 42, 43, 44, 49], "variabledensitymm": 51, "variat": [20, 25, 29, 31, 32, 35, 36], "varibal": 28, "varieti": [18, 21, 23, 24, 31, 49, 50, 51], "variou": [16, 20, 32, 43, 44, 45, 47, 48], "varphi": 20, "vast": 32, "ve": 38, "vec": [20, 36], "vector": [19, 20, 21, 23, 25, 32, 36, 43, 44, 51], "vector_3d": 21, "vectorfieldtyp": 21, "veloc": [20, 21, 22, 23, 25, 27, 28, 29, 32, 35, 36, 43, 44], "velocity_i": [20, 44], "velocity_x": [20, 44], "velocity_z": [20, 44], "velocityrtm": 21, "verbos": [14, 45], "veri": [20, 21, 22, 23, 27, 51], "verif": [0, 10, 23, 36, 50], "verifi": [39, 40, 51], "version": [12, 14, 17, 37, 38, 45, 51], "vertex": [18, 20, 23, 31, 36, 51], "vertic": [20, 32, 36], "veryusefulmethod": 16, "vi": 36, "via": [6, 19, 20, 27, 32, 43], "viabl": 27, "vicin": 41, "view": [23, 27, 29, 32, 41], "vii": 36, "viii": 36, "virtual": [20, 21], "viscos": [20, 24, 25, 27, 32, 43, 51], "viscou": [20, 23, 25, 32, 36, 41, 51], "visit": 44, "visual": [37, 44, 47], "visualizatt": 28, "vm": [27, 29, 31], "void": [16, 21], "volum": [18, 20, 21, 23, 26, 28, 30, 31, 32, 33, 35, 36, 41, 51], "volumetr": [23, 36], "von": 20, "vortex": [0, 9, 32, 41, 49], "vortic": [28, 32], "vv": 14, "w": [20, 23, 25, 27, 31, 41, 51], "w_i": [23, 31, 51], "w_k": 31, "w_o": 51, "wa": [21, 22, 27, 28, 31, 32, 41, 45, 48, 51], "wai": [14, 20, 35, 38, 41, 51], "wait": 38, "wake": 36, "wale": [24, 32], "walk": 21, "wall": [21, 22, 24, 41, 47, 51], "wall_boundary_condit": [20, 43], "wall_friction_velocity_bip": 21, "wall_user_data": [20, 43], "wallbcdata": 21, "wallboundaryconditiondata": 21, "wallfrictionvelocitybip": 21, "wallfrictionvelocitybip_": 21, "wallfunctionapproach": 21, "want": [21, 32, 38], "wave": [20, 25, 32], "wavelength": 32, "wavenumb": 20, "we": [8, 10, 13, 14, 20, 21, 22, 23, 30, 31, 32, 36, 37, 38, 41, 51], "weak": [24, 31, 32], "weakli": 20, "websit": [14, 17], "wedg": [34, 41, 51], "weigh": [30, 35], "weight": [25, 30, 31, 36], "well": [8, 12, 14, 20, 25, 28, 36, 38, 41, 43, 44], "were": [22, 27, 41, 51], "what": [20, 21, 27, 37, 38], "whatev": [14, 38], "when": [10, 13, 14, 18, 20, 21, 22, 23, 27, 28, 29, 30, 31, 32, 36, 37, 38, 43, 46, 51], "where": [14, 19, 20, 22, 23, 25, 27, 28, 31, 32, 33, 35, 36, 37, 43, 44, 45, 50, 51], "wherea": [20, 22], "wherebi": [18, 23, 30, 32], "whereby": 29, "whether": [14, 18, 20, 32], "which": [8, 12, 14, 18, 19, 20, 21, 22, 23, 26, 27, 28, 31, 32, 35, 36, 37, 38, 41, 42, 43, 51], "while": [14, 19, 20, 21, 25, 27, 28, 32, 35, 41, 51], "white": [20, 28], "who": 16, "whose": [23, 27, 32, 35], "wide": 51, "widehat": 36, "widetild": [32, 36], "width": [19, 36, 51], "wilcox": 32, "wilcox1998turbul": 32, "win": 22, "wind": [1, 8, 11, 12, 15, 17, 20, 22, 23, 26, 28, 29, 32, 35, 40, 41, 44, 51], "wing": [0, 41, 49], "wingtip": 41, "wise": [23, 51], "wish": [32, 37], "within": [18, 19, 20, 21, 23, 28, 31, 32, 36, 37, 43, 44, 51], "without": [31, 35, 36, 37, 41, 51], "word": [22, 35, 51], "work": [18, 23, 25, 27, 28, 31, 32, 36, 37, 38, 39, 40, 43, 45, 51], "workflow": [0, 11, 12, 38], "workset": 21, "would": [8, 14, 18, 21, 27, 32, 36, 50], "wrf": [32, 36], "wrftonalu": 36, "write": [0, 11, 22, 27, 28, 29], "written": [16, 17, 19, 20, 22, 23, 25, 27, 28, 29, 32, 33, 36], "www": 16, "x": [8, 19, 20, 23, 25, 31, 32, 35, 36, 37, 39, 40], "x86_64": 38, "x_": [19, 32], "x_1": 16, "x_2": 16, "x_i": [23, 25, 27, 29, 31, 32, 35], "x_j": [19, 20, 23, 25, 27, 29, 31, 32, 35, 36, 51], "x_k": [25, 27, 32, 35], "xf": 37, "xi": [16, 27], "xi_1": 27, "xi_2": 27, "xi_3": 27, "xi_k": 27, "xl": 20, "xml": [13, 14, 47], "xvf": 37, "xxx": 25, "xxxxxxi": 25, "y": [20, 23, 32, 36], "y_1": 16, "y_2": 16, "y_k": 32, "y_kj": 32, "y_p": 20, "yaml": [8, 14, 38, 43, 47, 48], "yaml_cpp_root_dir": 37, "yaml_install_dir": 14, "ye": [20, 23, 43], "yellow": 28, "yet": [10, 13, 18, 20, 26, 38], "yield": [19, 20, 28, 31, 32, 35, 51], "yoshizawa": 32, "you": [13, 14, 16, 37, 38, 48], "young": 32, "your": [8, 13, 17, 32, 37, 38, 48], "your_path": 37, "yourself": [37, 38], "z": [19, 20, 32, 36], "z_0": [20, 51], "z_direction_strong": 20, "z_o": 51, "z_sampl": 20, "zenith": 32, "zero": [19, 20, 25, 27, 31, 32, 35, 36, 51], "zeroeth": 25, "zlib": 14, "zlib_root_dir": 37, "zn": 32, "zone": 28, "zxvf": 37}, "titles": ["Nalu-Wind Documentation", "Actuator Sources", "Equation Systems", "Linear Solvers and Systems Interface", "CVFEM and FEM Interface", "Post-Processing Utilities", "Simulation \u2013 Nalu Top-level Interface", "Auxiliary Functions", "Building the Documentation", "Source Code Documentation", "Contributing to Nalu-Wind", "Developer Manual", "Development Infrastructure", "Nalu Style Guide", "Testing Nalu-Wind", "Developer Workflow", "Writing Developer Documentation", "Writing User Documentation", "17. Adaptivity", "4. Advection Stabilization", "9. Supported Boundary Conditions", "18. Code Abstractions", "12. Coupling Approach", "3. Discretization Approach", "Nalu-Wind - Theory Manual", "1. Low Mach Number Derivation", "14. Multi-Physics", "7. Nonlinear Stabilization Operator (NSO)", "10. Overset", "5. Pressure Stabilization", "11. Property Evaluations", "6. RTE Stabilization", "2. Supported Equation Set", "13. Time discretization", "16. Topological Support", "8. Turbulence Modeling", "15. Wind Energy Modeling", "Building Nalu-Wind Manually", "Building Nalu-Wind Semi-Automatically Using Spack", "Building Nalu-Wind", "User Manual", "Lessons Learned from Meshing the McAlister Case", "ABL Forcing", "Nalu-Wind Input File", "Exodus-II File Format", "Invoking Nalu-Wind - Command-line options", "Actuator Turbine Model", "Running Nalu-Wind", "Verifying that the installation of Nalu-Wind works", "Nalu-Wind - Verification Manual", "1. Introduction", "2. 2D Unsteady Uniform Property: Convecting Decaying Taylor Vortex", "References"], "titleterms": {"": 38, "0": 37, "1": [37, 38], "10": 37, "11": 37, "12": 37, "1x1x1": 51, "1x2x10": 51, "2": [4, 7, 37, 38], "2d": 51, "3": [4, 7, 37, 38], "3d": 51, "4": [37, 38], "5": 38, "6": [37, 38], "68": 37, "8": 37, "9": 37, "Of": 51, "One": [32, 35], "The": [29, 31], "With": 51, "abl": [7, 20, 32, 42, 43, 51], "abstract": 21, "access": 21, "accuraci": 51, "action": 12, "activ": 32, "actuat": [1, 36, 43, 46, 51], "ad": 14, "adapt": [18, 35, 37], "advect": 19, "algorithm": 36, "am": [20, 32], "applic": 51, "approach": [22, 23], "approxim": 36, "assembli": 28, "asymptot": 25, "atmospher": 20, "automat": 38, "auxiliari": 7, "averag": [32, 43], "base": [23, 27, 31, 51], "boost": 37, "boundari": [20, 36, 43, 51], "boussinesq": [32, 51], "bucket": 21, "build": [8, 37, 38, 39], "bulk": 21, "buoyanc": [32, 51], "capabl": 20, "case": [41, 48], "catalyst": 37, "cdash": 14, "cmake": [8, 37], "code": [9, 21], "coeffici": 27, "command": 45, "common": 43, "complement": 36, "compon": 51, "comput": 32, "condit": [20, 36, 43, 51], "conduct": [20, 32], "configur": [3, 8], "conform": [20, 43], "connect": 21, "conserv": 32, "contain": [12, 38], "continu": [12, 20], "contribut": 10, "control": 43, "convect": [7, 51], "corioli": 32, "coupl": [22, 36, 51], "cpp": 37, "cube": 51, "current": 41, "cvfem": [4, 23], "d": [4, 7], "daili": 12, "data": [14, 21, 43], "de": 32, "decai": 51, "definit": 31, "densiti": 30, "deriv": 25, "detach": 32, "detail": 20, "develop": [11, 12, 15, 16, 38], "diagnost": 32, "diffus": [23, 27], "discret": [23, 33, 36], "disk": 36, "displac": 7, "dissip": 20, "distanc": 32, "doc": 8, "docker": [12, 38], "document": [0, 8, 9, 16, 17], "dot": 29, "drop": 51, "dual": 23, "duct": 51, "due": 22, "dynam": 32, "eagl": 38, "earth": 32, "eddi": [32, 35], "edg": [23, 31], "element": 31, "energi": [20, 27, 32, 36], "enthalpi": 20, "equal": 51, "equat": [2, 32, 35, 36, 43], "equationsystem": 21, "error": [22, 51], "evalu": 30, "examin": 44, "exo": 41, "exodu": 44, "expans": 25, "expect": 48, "fem": 4, "field": 21, "file": [43, 44], "filter": 32, "find": 27, "finit": 31, "fix": 51, "flow": 7, "fluid": 43, "flux": 27, "forc": [32, 42, 43], "form": 31, "format": 44, "formul": 32, "fraction": [20, 32], "from": 41, "function": [7, 20, 31, 32], "gener": [27, 41], "geometri": 41, "github": 12, "govern": 36, "gradient": [20, 23, 51], "grid": 28, "grid07_conformal10": 41, "guid": 13, "hdf5": 37, "heat": [20, 30, 32], "high": [20, 21], "higher": 51, "homebrew": 37, "hybrid": [32, 35, 51], "hypr": 37, "ii": 44, "implement": 20, "inflow": [20, 43], "infrastructur": [12, 51], "initi": [36, 43], "inlet": 36, "input": 43, "insid": 38, "instal": [8, 48], "integr": [6, 12, 43], "intens": 20, "interact": 43, "interfac": [3, 4, 6, 51], "introduct": [41, 50], "invok": 45, "isotherm": 51, "k": [20, 35], "k_": 20, "kinet": [20, 27, 32], "kovasznai": 7, "lame": 30, "laplac": 51, "layer": [20, 43], "le": [20, 32, 35], "learn": 41, "length": 32, "lesson": 41, "level": [6, 21], "lewi": 32, "libxml2": 37, "limit": 32, "line": [45, 51], "linear": [3, 6, 43, 51], "linux": [37, 38], "local": [14, 27, 35], "low": [20, 25], "m": 29, "mac": 38, "mach": 25, "machin": [14, 38], "make": 8, "manual": [11, 24, 37, 40, 49], "mass": 32, "materi": 43, "mcalist": 41, "mesh": [7, 23, 32, 41, 43], "meta": 21, "method": 31, "mix": 32, "mixtur": [20, 32], "mm": [7, 51], "model": [20, 27, 32, 35, 36, 43, 46], "momentum": [20, 23, 32, 36, 51], "monin": 20, "motion": [7, 43], "move": 32, "multi": 26, "nalu": [0, 6, 10, 13, 14, 21, 24, 36, 37, 38, 39, 43, 45, 47, 48, 49], "nativ": 28, "netcdf": 37, "nodal": [23, 51], "non": [20, 43, 51], "nonconform": 51, "nonlinear": 27, "normal": [20, 51], "note": 41, "nrel": 38, "nso": 27, "number": [20, 25, 32], "numer": 36, "o": 38, "obukhov": 20, "omega": 20, "open": [20, 43, 51], "openfast": [36, 51], "oper": [27, 51], "opposit": 51, "option": [20, 43, 45], "order": 51, "osx": 37, "other": 44, "outflow": [20, 51], "outlet": 36, "output": 43, "overset": 28, "parabol": 51, "parallel": [21, 37], "paraview": 37, "part": 21, "period": [20, 43], "physic": [26, 43], "pointwis": 41, "post": [5, 43], "prandtl": 32, "precursor": 51, "prepar": 48, "pressur": [29, 51], "probe": 43, "problem": 51, "process": [5, 43], "profil": 51, "project": [23, 27, 51], "prolong": 18, "properti": [30, 43, 51], "pure": 31, "quadratur": 51, "radi": 32, "ran": [32, 35], "realm": [6, 21, 43], "refer": [14, 41, 52], "registr": 21, "regress": [12, 48], "residu": 27, "restart": 43, "restrict": 18, "result": [48, 51], "review": 32, "reynold": 20, "role": 29, "rte": 31, "rule": 21, "run": [8, 14, 47, 48], "scalar": 36, "scale": 32, "scheme": 36, "schmidt": 32, "schur": 36, "search": 28, "selector": 21, "semi": 38, "set": 32, "sg": [20, 35], "shear": 32, "sierra": 21, "simpl": 51, "simul": [6, 32, 43, 51], "smagorinski": 35, "solid": [20, 32], "solut": 43, "solver": [3, 6, 43], "sourc": [1, 9, 23, 32, 51], "spack": 38, "speci": [20, 32], "specif": [20, 30], "specifi": [20, 51], "split": [22, 32], "sst": [20, 32], "stabil": [19, 22, 27, 29, 31, 36], "standard": 35, "state": 21, "statist": [41, 43], "steadi": [7, 51], "step": [36, 38, 43], "stk": 28, "stratif": 51, "stratifi": 51, "stress": [20, 23, 32], "strong": 20, "structur": 43, "style": 13, "subgrid": 32, "subsequ": 51, "suit": 32, "superlu": 37, "supg": 31, "support": [20, 32, 34], "surfac": [20, 41], "symmetri": [20, 43], "system": [2, 3, 43], "tau": 31, "taylor": [7, 51], "temperatur": [20, 51], "tempor": 51, "term": [23, 32, 51], "terrain": 36, "test": [12, 14, 31, 48, 51], "theori": [20, 24], "thermal": [7, 20, 32, 51], "time": [6, 23, 33, 36, 43], "tioga": 28, "tip": 41, "tool": 8, "toolkit": 21, "top": [6, 20, 36], "topolog": 34, "topologi": 4, "transfer": [6, 43], "transform": 43, "transport": [32, 36], "trilino": 37, "turbin": [36, 43, 46], "turbul": [20, 27, 35, 36, 43], "underrelax": 36, "uniform": 51, "unit": [48, 51], "uniti": 32, "unsteadi": 51, "updat": 14, "upwind": 31, "us": [28, 38], "user": [17, 40], "util": [5, 7, 44], "v1": 37, "v2": 37, "v3": 37, "v4": 37, "veloc": 51, "verif": [49, 51], "verifi": 48, "via": 36, "viscos": [30, 35], "vortex": [7, 51], "wale": 35, "wall": [20, 32, 35, 36, 43], "weak": 20, "wind": [0, 10, 14, 21, 24, 36, 37, 38, 39, 43, 45, 47, 48, 49], "wing": 51, "work": 48, "workflow": 15, "write": [16, 17], "x": [38, 51], "y": 51, "yaml": 37, "your": 14, "z": 51, "zlib": 37}}) \ No newline at end of file +Search.setIndex({"alltitles": {"2-D Topologies": [[4, "id1"]], "2D Steady Laplace Operator": [[51, "d-steady-laplace-operator"]], "2D Unsteady Uniform Property: Convecting Decaying Taylor Vortex": [[51, null]], "3-D Topologies": [[4, "d-topologies"]], "3D Hybrid 1x1x1 Cube: Laplace": [[51, "d-hybrid-1x1x1-cube-laplace"]], "3D Hybrid 1x2x10 Duct: Specified Pressure Drop": [[51, "d-hybrid-1x2x10-duct-specified-pressure-drop"]], "3D Steady Laplace Operator with Nonconformal Interface": [[51, "d-steady-laplace-operator-with-nonconformal-interface"]], "3D Steady Non-isothermal with Buoyancy": [[51, "d-steady-non-isothermal-with-buoyancy"]], "3D Steady Non-uniform with Buoyancy": [[51, "d-steady-non-uniform-with-buoyancy"]], "ABL Forcing": [[42, null], [43, "abl-forcing"]], "ABL Forcing Source Terms": [[32, "abl-forcing-source-terms"]], "ABL Utilities": [[7, "abl-utilities"]], "ABL Wall Function": [[20, "abl-wall-function"]], "AMS of the Atmospheric Boundary Layer": [[20, "ams-of-the-atmospheric-boundary-layer"]], "AMS with SST Mixing Length Limiter": [[32, "ams-with-sst-mixing-length-limiter"]], "Active Model Split (AMS) Formulation": [[32, "active-model-split-ams-formulation"]], "Actuator Sources": [[1, null]], "Actuator Turbine Model": [[43, "actuator-turbine-model"], [46, null]], "Actuator line simulations coupled to OpenFAST": [[51, "actuator-line-simulations-coupled-to-openfast"]], "Adaptivity": [[18, null]], "Adding Testing Machines to CDash": [[14, "adding-testing-machines-to-cdash"]], "Adding Tests to Nalu-Wind": [[14, "adding-tests-to-nalu-wind"]], "Advection Stabilization": [[19, null]], "Application Verification Test; ABL Precursor/Subsequent": [[51, "application-verification-test-abl-precursor-subsequent"]], "Application Verification Test; Convecting Taylor Vortex": [[51, "application-verification-test-convecting-taylor-vortex"]], "Approximations for the Schur complement": [[36, "approximations-for-the-schur-complement"]], "Asymptotic Expansion": [[25, "asymptotic-expansion"]], "Atmospheric Boundary Layer Surface Conditions": [[20, "atmospheric-boundary-layer-surface-conditions"]], "Atmospheric Boundary Layer Top Conditions": [[20, "atmospheric-boundary-layer-top-conditions"]], "Auxiliary Functions": [[7, null]], "Averaging functions": [[32, "averaging-functions"]], "Boost v1.68.0": [[37, "boost-v1-68-0"]], "Boundary Conditions": [[43, "boundary-conditions"]], "Boundary Layer Statistics": [[43, "boundary-layer-statistics"]], "Boussinesq Buoyancy Model": [[32, "boussinesq-buoyancy-model"]], "Boussinesq Verification": [[51, "boussinesq-verification"]], "Buckets": [[21, "buckets"]], "Build": [[37, "build"], [37, "id1"]], "Build Nalu-Wind ParaView Catalyst Adapter": [[37, "build-nalu-wind-paraview-catalyst-adapter"]], "Building Nalu-Wind": [[39, null]], "Building Nalu-Wind Manually": [[37, null]], "Building Nalu-Wind Semi-Automatically Using Spack": [[38, null]], "Building inside Docker Container": [[38, "building-inside-docker-container"]], "Building the Documentation": [[8, null]], "CMake v3.12.4": [[37, "cmake-v3-12-4"]], "CVFEM Dual Mesh": [[23, "cvfem-dual-mesh"]], "CVFEM and FEM Interface": [[4, null]], "Code Abstractions": [[21, null]], "Common options": [[43, "common-options"]], "Connectivity": [[21, "connectivity"]], "Conservation of Energy": [[32, "conservation-of-energy"]], "Conservation of Mass": [[32, "conservation-of-mass"]], "Conservation of Momentum": [[32, "conservation-of-momentum"]], "Conservation of Species": [[32, "conservation-of-species"]], "Continuity": [[20, "continuity"], [20, "id1"], [20, "id16"]], "Continuity, Mixture Fraction, Enthalpy, Species, k_{sgs}, k and \\omega": [[20, "continuity-mixture-fraction-enthalpy-species-k-sgs-k-and-omega"]], "Continuous Integration": [[12, "continuous-integration"]], "Contributing to Nalu-Wind": [[10, null]], "Convecting Taylor Vortex": [[7, "convecting-taylor-vortex"]], "Coupling Approach": [[22, null]], "Daily Regression Tests": [[12, "daily-regression-tests"]], "Data probes": [[43, "data-probes"]], "Definition of the test function": [[31, "definition-of-the-test-function"]], "Density": [[30, "density"]], "Detached Eddy Simulation (DES) Formulation": [[32, "detached-eddy-simulation-des-formulation"]], "Developer Manual": [[11, null]], "Developer Workflow": [[15, null]], "Development Build of Nalu-Wind": [[38, "development-build-of-nalu-wind"]], "Development Infrastructure": [[12, null]], "Diffusion": [[23, "diffusion"]], "Discretization Approach": [[23, null]], "Docker Container": [[12, "docker-container"]], "Dynamic Hybrid Diagnostics": [[32, "dynamic-hybrid-diagnostics"]], "Earth Coriolis Force": [[32, "earth-coriolis-force"]], "Edge-Based Discretization": [[23, "edge-based-discretization"]], "Enthalpy": [[20, "enthalpy"]], "Equation Systems": [[2, null], [43, "equation-systems"]], "EquationSystem": [[21, "equationsystem"]], "Error in temperature": [[51, "id28"]], "Error in x-component of velocity": [[51, "id25"]], "Error in y-component of velocity": [[51, "id26"]], "Error in z-component of velocity": [[51, "id27"]], "Errors due to Splitting and Stabilization": [[22, "errors-due-to-splitting-and-stabilization"]], "Examining Exodus-II Files": [[44, "examining-exodus-ii-files"]], "Exodus-II File Format": [[44, null]], "Expected result": [[48, "expected-result"], [48, "id2"]], "Field Data Access": [[21, "field-data-access"]], "Field Data Registration": [[21, "field-data-registration"]], "Filtered Mixture Fraction": [[32, "filtered-mixture-fraction"]], "Finite Element SUPG Form": [[31, "finite-element-supg-form"]], "Fixed Wing Verification Problem": [[51, "fixed-wing-verification-problem"]], "Fluid-Structure Interaction": [[43, "fluid-structure-interaction"]], "Forcing Term": [[32, "forcing-term"]], "General Findings": [[27, "general-findings"]], "General Pointwise Tips": [[41, "general-pointwise-tips"]], "GitHub Actions": [[12, "github-actions"]], "Governing Equations": [[36, "governing-equations"]], "HDF5 v1.10.4": [[37, "hdf5-v1-10-4"]], "HYPRE": [[37, "hypre"]], "High Level Nalu-Wind Abstractions": [[21, "high-level-nalu-wind-abstractions"]], "Higher Order 2D Steady Uniform Property: Taylor Vortex": [[51, "higher-order-2d-steady-uniform-property-taylor-vortex"]], "Homebrew": [[37, "homebrew"]], "Hybrid RANS/LES Models": [[35, "hybrid-rans-les-models"]], "Implementation Details": [[20, "implementation-details"]], "Inflow Boundary Condition": [[20, "inflow-boundary-condition"], [43, "inflow-boundary-condition"]], "Inflow-Outflow Capability": [[20, "inflow-outflow-capability"]], "Infrastructure Unit Test": [[51, "infrastructure-unit-test"]], "Initial & Boundary Conditions": [[36, "initial-boundary-conditions"]], "Initial conditions": [[36, "initial-conditions"], [43, "initial-conditions"]], "Inlet conditions": [[36, "inlet-conditions"]], "Install the Tools": [[8, "install-the-tools"]], "Intensity": [[20, "intensity"]], "Introduction": [[41, "introduction"], [50, null]], "Invoking Nalu-Wind - Command-line options": [[45, null]], "Kovasznay 2-D Flow": [[7, "kovasznay-2-d-flow"]], "Lame Properties": [[30, "lame-properties"]], "Laminar-Turbulent Transition Model Formulation": [[32, "laminar-turbulent-transition-model-formulation"]], "Lessons Learned": [[41, "lessons-learned"]], "Lessons Learned from Meshing the McAlister Case": [[41, null]], "Libxml2 v2.9.8": [[37, "libxml2-v2-9-8"]], "Linear Solver Interface": [[6, "linear-solver-interface"]], "Linear Solvers": [[43, "linear-solvers"]], "Linear Solvers Interface": [[3, "linear-solvers-interface"]], "Linear Solvers and Systems Interface": [[3, null]], "Linear Systems": [[3, "linear-systems"]], "Linux and OSX": [[37, "linux-and-osx"]], "Local or Projected NSO Diffusive Flux Coefficient": [[27, "local-or-projected-nso-diffusive-flux-coefficient"]], "Low Mach Number Derivation": [[25, null]], "Mac OS X or Linux": [[38, "mac-os-x-or-linux"]], "Make the Docs": [[8, "make-the-docs"]], "Material Properties": [[43, "material-properties"]], "Mesh Motion": [[43, "mesh-motion"]], "Mesh Motion/Displacement Utilities": [[7, "mesh-motion-displacement-utilities"]], "Mesh Transformation": [[43, "mesh-transformation"]], "Meshes": [[41, "meshes"]], "Meta and Bulk Data": [[21, "meta-and-bulk-data"]], "Mixture Fraction": [[20, "mixture-fraction"]], "Mixture Fraction, Enthalpy, Species, k_{sgs}, k and \\omega": [[20, "mixture-fraction-enthalpy-species-k-sgs-k-and-omega"]], "Momentum": [[20, "momentum"], [20, "id17"], [20, "id18"]], "Momentum Stress": [[23, "momentum-stress"]], "Momentum and Pressure": [[51, "momentum-and-pressure"]], "Momentum, Mixture Fraction, Enthalpy, Species, k_{sgs}, k and \\omega": [[20, "momentum-mixture-fraction-enthalpy-species-k-sgs-k-and-omega"]], "Monin-Obukhov Theory": [[20, "monin-obukhov-theory"]], "Moving Mesh": [[32, "moving-mesh"]], "Multi-Physics": [[26, null]], "NREL\u2019s Eagle Machine": [[38, "nrel-s-eagle-machine"]], "NSO Based on Kinetic Energy Residual": [[27, "nso-based-on-kinetic-energy-residual"]], "NSO as a Turbulence Model": [[27, "nso-as-a-turbulence-model"]], "Nalu Style Guide": [[13, null]], "Nalu-Wind": [[37, "nalu-wind"]], "Nalu-Wind - Theory Manual": [[24, null]], "Nalu-Wind - Verification Manual": [[49, null]], "Nalu-Wind Documentation": [[0, null]], "Nalu-Wind Input File": [[43, null]], "Nalu-Wind \u2013 Actuator Disk Model via OpenFAST": [[36, "nalu-wind-actuator-disk-model-via-openfast"]], "Nalu-Wind \u2013 OpenFAST Coupling Algorithm": [[36, "nalu-wind-openfast-coupling-algorithm"]], "NetCDF v4.6.1": [[37, "netcdf-v4-6-1"]], "NetCDF v4.6.1 and Parallel NetCDF v1.8.0": [[37, "netcdf-v4-6-1-and-parallel-netcdf-v1-8-0"]], "Non-Conformal Boundary": [[43, "non-conformal-boundary"]], "Non-conformal Boundary Condition": [[20, "non-conformal-boundary-condition"]], "Nonlinear Stabilization Operator (NSO)": [[27, null]], "Notes on Geometry": [[41, "notes-on-geometry"]], "Numerical Discretization & Stabilization": [[36, "numerical-discretization-stabilization"]], "One Equation k^{sgs}": [[35, "one-equation-k-sgs"]], "Open Boundary Condition": [[20, "open-boundary-condition"], [43, "open-boundary-condition"]], "Open Boundary Condition With Outflow Thermal Stratification": [[51, "open-boundary-condition-with-outflow-thermal-stratification"]], "Other Exodus-II Utilities": [[44, "other-exodus-ii-utilities"]], "Outlet conditions": [[36, "outlet-conditions"]], "Output Options": [[43, "output-options"]], "Overset": [[28, null]], "Overset Grid Assembly using Native STK Search": [[28, "overset-grid-assembly-using-native-stk-search"]], "Overset Grid Assembly using TIOGA": [[28, "overset-grid-assembly-using-tioga"]], "ParaView Catalyst": [[37, "paraview-catalyst"]], "Parabolic Temperature Profile: Equal Specified Temperature Gradients": [[51, "parabolic-temperature-profile-equal-specified-temperature-gradients"]], "Parallel NetCDF v1.8.0": [[37, "parallel-netcdf-v1-8-0"]], "Parallel Rules": [[21, "parallel-rules"]], "Parts": [[21, "parts"]], "Periodic Boundary Condition": [[20, "periodic-boundary-condition"], [43, "periodic-boundary-condition"]], "Physics Realm Options": [[43, "physics-realm-options"]], "Post-Processing Utilities": [[5, null]], "Post-processing": [[43, "post-processing"]], "Precursor-based Simulations": [[51, "precursor-based-simulations"]], "Preparation": [[48, "preparation"]], "Pressure Stabilization": [[29, null]], "Projected Nodal Gradients": [[23, "projected-nodal-gradients"]], "Projected nodal gradients": [[51, "projected-nodal-gradients"]], "Prolongation and Restriction": [[18, "prolongation-and-restriction"]], "Property Evaluations": [[30, null]], "Pure Edge-based Upwind Method": [[31, "pure-edge-based-upwind-method"]], "RANS Model Suite": [[32, "rans-model-suite"]], "RANS Models": [[35, "rans-models"]], "RTE Stabilization": [[31, null]], "Radiative Transport Equation": [[32, "radiative-transport-equation"]], "Realm": [[21, "realm"]], "Realms": [[6, "realms"]], "References": [[41, "references"], [52, null]], "Regression Test Case": [[48, "regression-test-case"]], "Restart Options": [[43, "restart-options"]], "Review of Prandtl, Schmidt and Unity Lewis Number": [[32, "review-of-prandtl-schmidt-and-unity-lewis-number"]], "Run CMake Configure": [[8, "run-cmake-configure"]], "Running": [[48, "running"], [48, "id1"]], "Running Nalu-Wind": [[47, null]], "Running Tests Locally": [[14, "running-tests-locally"]], "SST Mixing Length Limiter": [[32, "sst-mixing-length-limiter"]], "SST of the Atmospheric Boundary Layer": [[20, "sst-of-the-atmospheric-boundary-layer"]], "Selectors": [[21, "selectors"]], "Shear Stress Transport (SST) Formulation": [[32, "shear-stress-transport-sst-formulation"]], "Sierra Toolkit Abstractions": [[21, "sierra-toolkit-abstractions"]], "Simple Linear Temperature Profile: Equal and Opposite Specified Temperature Gradients": [[51, "simple-linear-temperature-profile-equal-and-opposite-specified-temperature-gradients"]], "Simulation \u2013 Nalu Top-level Interface": [[6, null]], "Simulations": [[43, "simulations"]], "Solid Stress": [[20, "solid-stress"], [32, "solid-stress"]], "Solution Options": [[43, "solution-options"]], "Solver Configuration": [[3, "solver-configuration"]], "Source Code Documentation": [[9, null]], "Source Term Quadrature": [[51, "source-term-quadrature"]], "Species": [[20, "species"]], "Specific Heat": [[30, "specific-heat"]], "Specified Boundary-Normal Temperature Gradient Option": [[20, "specified-boundary-normal-temperature-gradient-option"]], "Specified Normal Temperature Gradient Boundary Condition": [[51, "specified-normal-temperature-gradient-boundary-condition"]], "Split subgrid model stress": [[32, "split-subgrid-model-stress"]], "Standard Smagorinsky LES Model": [[35, "standard-smagorinsky-les-model"]], "State": [[21, "state"]], "Statistics of Current Mesh (grid07_conformal10.exo)": [[41, "statistics-of-current-mesh-grid07-conformal10-exo"]], "Steady Taylor Vortex": [[7, "steady-taylor-vortex"]], "Steady Thermal MMS (2-D and 3-D)": [[7, "steady-thermal-mms-2-d-and-3-d"]], "Step 1": [[38, "step-1"], [38, "id1"]], "Step 2": [[38, "step-2"], [38, "id2"]], "Step 3": [[38, "step-3"], [38, "id3"]], "Step 4": [[38, "step-4"], [38, "id4"]], "Step 5": [[38, "step-5"], [38, "id5"]], "Step 6": [[38, "step-6"], [38, "id6"]], "Stratified MMS": [[51, "stratified-mms"]], "Strong Symmetry Boundary Condition": [[20, "strong-symmetry-boundary-condition"]], "Subgrid-Scale Kinetic Energy One-Equation LES Model": [[32, "subgrid-scale-kinetic-energy-one-equation-les-model"]], "SuperLU v4.3": [[37, "superlu-v4-3"]], "Supported Boundary Conditions": [[20, null]], "Supported Equation Set": [[32, null]], "Surface Mesh": [[41, "surface-mesh"]], "Symmetry Boundary Condition": [[43, "symmetry-boundary-condition"]], "Temperature Gradient Capability": [[20, "temperature-gradient-capability"]], "Temporal Order Of Accuracy Results": [[51, "temporal-order-of-accuracy-results"]], "Terrain (Wall) boundary condition": [[36, "terrain-wall-boundary-condition"]], "Testing Nalu-Wind": [[14, null]], "The Role of \\dot m": [[29, "the-role-of-dot-m"]], "The form of \\tau": [[31, "the-form-of-tau"]], "Thermal Heat Conduction": [[20, "thermal-heat-conduction"], [32, "thermal-heat-conduction"]], "Time Integration": [[6, "time-integration"]], "Time Integration Options": [[43, "time-integration-options"]], "Time and Source Terms": [[23, "time-and-source-terms"]], "Time discretization": [[33, null]], "Time stepping scheme": [[36, "time-stepping-scheme"]], "Time-step Control Options": [[43, "time-step-control-options"]], "Top boundary condition": [[36, "top-boundary-condition"]], "Topological Support": [[34, null]], "Transfers": [[6, "transfers"], [43, "transfers"]], "Trilinos": [[37, "trilinos"]], "Turbulence Modeling": [[35, null], [36, "turbulence-modeling"]], "Turbulence averaging": [[43, "turbulence-averaging"]], "Turbulent Kinetic Energy and Specific Dissipation SST High Reynolds Number Boundary conditions": [[20, "turbulent-kinetic-energy-and-specific-dissipation-sst-high-reynolds-number-boundary-conditions"]], "Turbulent Kinetic Energy and Specific Dissipation SST Low Reynolds Number Boundary conditions": [[20, "turbulent-kinetic-energy-and-specific-dissipation-sst-low-reynolds-number-boundary-conditions"]], "Turbulent Kinetic Energy, k_{sgs} LES model": [[20, "turbulent-kinetic-energy-k-sgs-les-model"]], "Underrelaxation for momentum and scalar transport": [[36, "underrelaxation-for-momentum-and-scalar-transport"]], "Unit Tests": [[48, "unit-tests"]], "Unit tests": [[51, "unit-tests"]], "Updating Reference Data for Your Machine": [[14, "updating-reference-data-for-your-machine"]], "User Manual": [[40, null]], "Verifying that the installation of Nalu-Wind works": [[48, null]], "Viscosity": [[30, "viscosity"]], "Wall Adapting Local Eddy-Viscosity, WALE": [[35, "wall-adapting-local-eddy-viscosity-wale"]], "Wall Boundary Condition": [[43, "wall-boundary-condition"]], "Wall Boundary Conditions": [[20, "wall-boundary-conditions"]], "Wall Distance Computation": [[32, "wall-distance-computation"]], "Wall Models": [[35, "wall-models"]], "Weak Symmetry Boundary Condition": [[20, "weak-symmetry-boundary-condition"]], "Wind Energy Modeling": [[36, null]], "Wind Turbine Modeling": [[36, "wind-turbine-modeling"]], "Writing Developer Documentation": [[16, null]], "Writing User Documentation": [[17, null]], "YAML-CPP 0.6.2": [[37, "yaml-cpp-0-6-2"]], "Zlib v1.2.11": [[37, "zlib-v1-2-11"]]}, "docnames": ["index", "source/developer/apidocs/actuatorsources", "source/developer/apidocs/eqsystems", "source/developer/apidocs/linsys", "source/developer/apidocs/masterelem", "source/developer/apidocs/postprocess", "source/developer/apidocs/realms", "source/developer/apidocs/userfunc", "source/developer/build_doc", "source/developer/code", "source/developer/contrib", "source/developer/index", "source/developer/infra", "source/developer/style", "source/developer/testing", "source/developer/workflow", "source/developer/write_developer_doc", "source/developer/write_user_doc", "source/theory/adaptivity", "source/theory/advectionStabilization", "source/theory/boundaryConditions", "source/theory/codeAbstractions", "source/theory/couplingApproach", "source/theory/discretizationApproach", "source/theory/index", "source/theory/lowMachNumberDerivation", "source/theory/multiPhysics", "source/theory/nso", "source/theory/overset", "source/theory/pressureStabilization", "source/theory/propertyEvaluation", "source/theory/rteStabilization", "source/theory/supportedEquationSet", "source/theory/timeDiscretization", "source/theory/topologicalSupport", "source/theory/turbulenceModeling", "source/theory/windEnergy", "source/user/build_manually", "source/user/build_spack", "source/user/building", "source/user/index", "source/user/nalu_run/McAlisterLessonsLearned", "source/user/nalu_run/abl_forcing", "source/user/nalu_run/nalu_inp", "source/user/nalu_run/nalu_mesh", "source/user/nalu_run/nalux", "source/user/nalu_run/turbine_modeling", "source/user/running", "source/user/verify_installation", "source/verification/index", "source/verification/introduction", "source/verification/verification", "zrefs"], "envversion": {"sphinx": 62, "sphinx.domains.c": 3, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 9, "sphinx.domains.index": 1, "sphinx.domains.javascript": 3, "sphinx.domains.math": 2, "sphinx.domains.python": 4, "sphinx.domains.rst": 2, "sphinx.domains.std": 2}, "filenames": ["index.rst", "source/developer/apidocs/actuatorsources.rst", "source/developer/apidocs/eqsystems.rst", "source/developer/apidocs/linsys.rst", "source/developer/apidocs/masterelem.rst", "source/developer/apidocs/postprocess.rst", "source/developer/apidocs/realms.rst", "source/developer/apidocs/userfunc.rst", "source/developer/build_doc.rst", "source/developer/code.rst", "source/developer/contrib.rst", "source/developer/index.rst", "source/developer/infra.rst", "source/developer/style.rst", "source/developer/testing.rst", "source/developer/workflow.rst", "source/developer/write_developer_doc.rst", "source/developer/write_user_doc.rst", "source/theory/adaptivity.rst", "source/theory/advectionStabilization.rst", "source/theory/boundaryConditions.rst", "source/theory/codeAbstractions.rst", "source/theory/couplingApproach.rst", "source/theory/discretizationApproach.rst", "source/theory/index.rst", "source/theory/lowMachNumberDerivation.rst", "source/theory/multiPhysics.rst", "source/theory/nso.rst", "source/theory/overset.rst", "source/theory/pressureStabilization.rst", "source/theory/propertyEvaluation.rst", "source/theory/rteStabilization.rst", "source/theory/supportedEquationSet.rst", "source/theory/timeDiscretization.rst", "source/theory/topologicalSupport.rst", "source/theory/turbulenceModeling.rst", "source/theory/windEnergy.rst", "source/user/build_manually.rst", "source/user/build_spack.rst", "source/user/building.rst", "source/user/index.rst", "source/user/nalu_run/McAlisterLessonsLearned.rst", "source/user/nalu_run/abl_forcing.rst", "source/user/nalu_run/nalu_inp.rst", "source/user/nalu_run/nalu_mesh.rst", "source/user/nalu_run/nalux.rst", "source/user/nalu_run/turbine_modeling.rst", "source/user/running.rst", "source/user/verify_installation.rst", "source/verification/index.rst", "source/verification/introduction.rst", "source/verification/verification.rst", "zrefs.rst"], "indexentries": {"--debug": [[45, "cmdoption-naluX-D", false]], "--help": [[45, "cmdoption-naluX-h", false]], "--input-deck": [[45, "cmdoption-naluX-i", false]], "--log-file": [[45, "cmdoption-naluX-o", false]], "--pprint": [[45, "cmdoption-naluX-p", false]], "--version": [[45, "cmdoption-naluX-v", false]], "-d": [[45, "cmdoption-naluX-D", false]], "-h": [[45, "cmdoption-naluX-h", false]], "-i": [[45, "cmdoption-naluX-i", false]], "-o": [[45, "cmdoption-naluX-o", false]], "-p": [[45, "cmdoption-naluX-p", false]], "-v": [[45, "cmdoption-naluX-v", false]], "nalux command line option": [[45, "cmdoption-naluX-D", false], [45, "cmdoption-naluX-h", false], [45, "cmdoption-naluX-i", false], [45, "cmdoption-naluX-o", false], [45, "cmdoption-naluX-p", false], [45, "cmdoption-naluX-v", false]]}, "objects": {"naluX": [[45, 0, 1, "cmdoption-naluX-D", "--debug"], [45, 0, 1, "cmdoption-naluX-h", "--help"], [45, 0, 1, "cmdoption-naluX-i", "--input-deck"], [45, 0, 1, "cmdoption-naluX-o", "--log-file"], [45, 0, 1, "cmdoption-naluX-p", "--pprint"], [45, 0, 1, "cmdoption-naluX-v", "--version"], [45, 0, 1, "cmdoption-naluX-D", "-D"], [45, 0, 1, "cmdoption-naluX-h", "-h"], [45, 0, 1, "cmdoption-naluX-i", "-i"], [45, 0, 1, "cmdoption-naluX-o", "-o"], [45, 0, 1, "cmdoption-naluX-p", "-p"], [45, 0, 1, "cmdoption-naluX-v", "-v"]]}, "objnames": {"0": ["std", "cmdoption", "program option"]}, "objtypes": {"0": "std:cmdoption"}, "terms": {"": [8, 14, 16, 20, 22, 27, 28, 30, 31, 32, 35, 36, 37, 39, 40, 43, 45, 51], "0": [14, 16, 19, 20, 21, 22, 25, 27, 28, 31, 32, 35, 36, 38, 41, 43, 44, 46, 48, 51], "00": [18, 51], "000": 51, "0000001": 14, "0001": 14, "00027": 32, "001": [20, 51], "00125": 51, "0015": 41, "0025": [41, 51], "0025m": 41, "003": [20, 41], "003m": 41, "005": 51, "00e": 51, "01": [19, 20, 32, 51], "01515": 41, "016": 51, "025": 51, "02e": 51, "03": 51, "035672821": 51, "0356751138": 51, "0356751139": 51, "03e": 51, "04": 51, "04e": 51, "05": 51, "05e": 51, "06": [32, 51], "06848e": 51, "06e": 51, "075": 32, "08": 32, "0828": 32, "0856": 32, "09": [32, 51], "09e": 51, "0e": 51, "0m": 51, "0x": 22, "1": [14, 16, 18, 19, 20, 22, 23, 25, 27, 28, 29, 31, 32, 33, 35, 36, 41, 43, 46, 51], "10": [14, 20, 27, 28, 31, 32, 36, 38, 41, 43, 51], "100": [32, 43, 46, 51], "1000": [41, 51], "10000": 32, "1000000": 20, "100x100": 51, "101": 28, "101325": 51, "10e": 51, "10m": 51, "11": [14, 20, 27, 38, 51], "11256e": 51, "12": [19, 31, 32, 36, 38, 41, 51], "121": 20, "125": 51, "128": 51, "12e": 51, "13": [12, 36, 38, 41, 51], "13225e": 51, "13e": 51, "14": 51, "15": [20, 31, 36, 51], "15065e": 51, "15668e": 51, "158m": 41, "16": [20, 37, 51], "17": [18, 20, 35, 51], "170": 41, "177": 41, "17804": 51, "17e": 51, "18": [20, 51], "180": 51, "188486": 51, "18e": 51, "19": [20, 41, 51], "192m": 41, "1978": 25, "1982": 25, "1984": 35, "1987": 23, "1991": [27, 41], "1996": 23, "1997": 32, "1998": [32, 35], "19e": 51, "1e": 43, "1m": [41, 51], "1x1": 51, "1x1x1": [0, 49], "1x2x10": [0, 49], "2": [9, 14, 16, 18, 19, 20, 22, 23, 25, 27, 28, 31, 32, 35, 36, 41, 43, 46, 51], "20": [20, 41, 43, 46, 51], "200": 19, "2000": 19, "2002": [36, 51], "2003": [24, 32, 49], "2005": [31, 32], "2006": [23, 29, 36], "2007": 32, "2008": 29, "200x200": 51, "2010": [20, 24, 49], "2011": 20, "2012": 36, "2013": 32, "2014": [23, 29, 51], "2015": [20, 27, 32], "2016": 36, "2017": 27, "2020": [32, 35], "2021": 32, "21": 20, "22": [32, 41], "225": [43, 46], "22e": 51, "23": 20, "23e": 51, "24": [20, 35], "25": [20, 43, 51], "250": [43, 46], "2500": 20, "250k": 51, "26": 20, "27": [20, 23], "27e": 51, "29": 20, "29277e": 51, "2_": [25, 35], "2b": 51, "2d": [0, 20, 23, 49], "2h": 51, "2re_": 32, "2x": 22, "3": [9, 14, 16, 18, 19, 20, 22, 23, 25, 27, 28, 31, 32, 35, 36, 41, 43, 51], "30": [20, 51], "300": [43, 51], "3000": 51, "30077e": 51, "300k": 51, "30m": 41, "310": 51, "31211e": 51, "3151": 41, "31e": 51, "32": 51, "325": 35, "33": 41, "33067e": 51, "34": 31, "346": 41, "35": 20, "350k": 51, "38": 51, "39": 20, "3b": 51, "3d": [0, 23, 49], "3mm": 41, "4": [14, 19, 20, 22, 27, 28, 29, 31, 32, 35, 36, 41, 51], "40": [43, 51], "400k": 51, "400x400": 51, "41": 20, "42": 20, "44": 32, "45000": 22, "4620": 51, "46e": 51, "47e": 51, "4b": 51, "4x": 22, "5": [19, 20, 22, 23, 28, 32, 35, 36, 41, 43, 46, 51], "50": [32, 43, 46, 51], "500": [28, 32], "50e": 51, "52": 41, "54e": 51, "56": 37, "58m": 41, "5m": [41, 51], "6": [14, 19, 20, 23, 28, 31, 32, 36, 51], "60785e": 51, "61": [20, 32], "63": 20, "63e": 51, "64": 51, "64e": 51, "65e": 51, "66": 14, "66m": 51, "68103e": 51, "68e": 51, "6x": 22, "7": [20, 27, 28, 32, 36, 37, 38, 41, 51], "70": 32, "70e": 51, "73": 41, "739208802178716": 51, "73e": 51, "74": 20, "75": 43, "768": 20, "77e": 51, "78": 32, "78e": 51, "7x": 22, "8": [14, 19, 20, 21, 23, 28, 32, 36, 41, 44, 51], "80": 51, "800": 51, "845": 32, "85": [20, 32], "856": 32, "86596e": 51, "866": 41, "89": 18, "8m": 51, "8n": 31, "9": [14, 20, 23, 28, 31, 32, 36, 38, 41, 51], "90": [20, 43, 46], "91e": 51, "92e": 51, "93": 18, "94": 18, "97517e": 51, "98249e": 51, "99e": 51, "A": [6, 16, 18, 19, 20, 21, 22, 23, 25, 26, 27, 28, 29, 31, 32, 33, 35, 36, 41, 43, 44, 51], "And": [16, 28], "As": [14, 18, 20, 21, 22, 23, 27, 28, 31, 32, 33, 35, 36, 43, 51], "At": [14, 21, 30, 31, 36, 48, 51], "By": [29, 32, 36, 43, 51], "For": [8, 12, 14, 19, 20, 21, 22, 23, 25, 26, 27, 28, 29, 30, 31, 32, 34, 35, 36, 37, 38, 41, 44, 45, 47, 50, 51], "If": [8, 10, 14, 20, 21, 22, 25, 32, 36, 37, 38, 45], "In": [8, 14, 18, 19, 20, 21, 22, 23, 25, 26, 27, 28, 29, 31, 32, 33, 34, 35, 36, 37, 38, 41, 43, 48, 50, 51], "It": [12, 16, 19, 20, 32, 35, 36, 38, 41, 48, 51], "Its": [12, 20], "No": [10, 13, 51], "Not": 20, "ON": [8, 14, 37], "Of": [44, 49], "On": [8, 23, 28, 37, 51], "One": [20, 23, 24, 36, 41, 43, 46], "Or": 14, "Such": [21, 51], "That": 38, "The": [1, 8, 9, 12, 14, 16, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 32, 33, 34, 35, 36, 37, 38, 41, 42, 43, 44, 45, 50, 51], "Then": [14, 48], "There": [10, 12, 14, 18, 20, 23, 38, 41, 42, 43, 51], "These": [14, 20, 21, 28, 29, 36, 37, 38], "To": [14, 20, 21, 32, 36, 37, 38, 48], "With": [0, 20, 21, 32, 49], "_": [20, 23, 25, 27, 31, 32, 36, 51], "_0": [20, 23, 25], "_1": [23, 25, 32], "_2": [25, 32], "_3": 32, "_c": [20, 36], "_extens": 8, "_i": [20, 25, 29, 31, 32, 36], "_j": [19, 20, 25, 32, 36], "_k": [19, 23, 25, 32], "_l": 23, "_n": 32, "_r": [23, 32], "_root_dir": 37, "_t": 32, "_user_data": 43, "_w": 20, "_x86_64": 37, "a2": 32, "a_": 36, "a_1": 32, "a_h": 51, "a_i": [20, 23, 32], "a_j": [19, 20, 23, 51], "a_k": [23, 51], "a_w": 20, "a_x": [23, 32], "a_z": [32, 51], "ab": 20, "abil": [8, 20, 21, 23, 32, 36, 51], "abl": [9, 14, 16, 24, 28, 36, 37, 38, 45, 46, 47, 49], "abl_": 20, "abl_forc": [20, 42, 43], "abl_mesh": [20, 44], "ablneutraledg": 48, "abltop": [20, 36], "abltop_boundary_condit": 20, "abltop_user_data": 20, "about": [18, 20, 21, 23, 32, 44], "abov": [14, 19, 20, 21, 22, 23, 27, 29, 31, 32, 36, 37, 41, 44, 51], "absenc": 20, "absolut": [20, 36], "absorb": 32, "absorpt": 32, "abstract": [0, 6, 24], "academ": [28, 32], "acceler": [20, 32], "accept": [35, 41, 43], "access": 38, "accommod": 32, "accomod": [19, 43, 46], "accomplish": 51, "accord": 38, "account": 32, "accoust": [25, 27], "accumul": [20, 51], "accur": [20, 23, 35, 36, 51], "accuraci": [23, 25, 31, 32, 35, 41, 49, 50], "achiev": [20, 23, 26, 32, 36], "acoust": [25, 30, 32], "acro": 44, "across": [20, 36, 37, 41, 43, 51], "act": [20, 25, 27, 32, 35, 43], "action": 44, "activ": [19, 20, 21, 23, 24, 27, 35, 36, 51], "actlinefast": [43, 46], "actlinesimpl": 51, "actlinesimplengp": 51, "actual": [20, 43], "actuat": [0, 9, 11, 47, 49], "actuatorlinefast": [1, 36], "ad": [10, 11, 12, 19, 20, 31, 32, 36, 38, 51], "adapt": [0, 24, 43], "adcock": 32, "add": [13, 14, 20, 31, 36, 37, 38], "add_test_r": 14, "addit": [20, 21, 27, 28, 31, 32, 36, 38, 41, 43, 47, 51], "addition": [12, 32, 35], "adequ": [28, 31, 51], "adequaci": [20, 32], "adher": 38, "adhoc": 32, "adiabat": [20, 28], "adjac": [18, 19, 41], "admit": [25, 32], "adv": 31, "adv_": 19, "advanc": [26, 32, 36], "advantag": [14, 23, 41], "advect": [0, 20, 22, 23, 24, 27, 29, 31, 32, 36, 41, 51], "adventag": 20, "advers": 35, "aero": [36, 51], "aerodyn": 51, "aerodynam": [24, 36, 49, 51], "affect": [23, 32, 50], "afford": 33, "aforement": 27, "after": [14, 28, 36, 38, 42, 43, 51], "aftosmi": 18, "again": [19, 20, 21, 23, 30, 31, 32, 35, 48, 51], "against": [14, 51], "agre": 51, "agreement": 51, "aid": 32, "air": [20, 51], "air_dens": [43, 46], "airfoil": [41, 51], "al": [32, 35], "alg": 22, "algebra": [29, 50, 51], "algorith": 22, "algorithm": [20, 21, 22, 23, 28, 32, 50, 51], "align": [20, 28, 32], "all": [8, 12, 14, 19, 20, 21, 23, 25, 27, 28, 29, 32, 35, 36, 37, 38, 43, 45, 48, 51], "allevi": 36, "alloc": 38, "allow": [12, 14, 16, 19, 20, 21, 23, 26, 29, 32, 36, 37, 38, 51], "almost": [14, 20], "alon": 51, "along": [14, 18, 20, 23, 24, 25, 28, 29, 32, 36, 43, 44, 47, 49, 51], "alpha": [19, 31, 32, 51], "alpha_": [19, 32, 51], "alpha_h": 20, "alpha_u": 32, "alreadi": [8, 21, 23, 26, 37, 38, 45], "also": [14, 17, 18, 20, 21, 22, 23, 26, 27, 28, 29, 32, 34, 35, 36, 37, 38, 41, 43, 44, 51], "altern": [19, 27, 29, 31, 32, 35, 36], "although": [20, 21, 22, 23, 32, 33, 35, 37, 51], "alwai": [10, 13, 20, 32, 36, 51], "am": [24, 35], "amb": 32, "ambient": 25, "amount": [14, 32], "amplifi": 20, "amsalgdriv": 32, "an": [6, 12, 14, 16, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 35, 36, 37, 41, 43, 44, 47, 49, 50, 51], "analog": 32, "analysi": 36, "analyt": [20, 22, 50, 51], "analyz": 47, "angl": [32, 41, 51], "angular": 32, "ani": [16, 20, 23, 28, 31, 32, 35, 36, 38, 43, 46, 51], "anisotrop": 32, "annot": 16, "anoth": [6, 16, 20, 28, 32, 41, 44], "anothermethod": 16, "ansatz": 31, "answer": [16, 22], "anticip": 22, "antisymmetr": 27, "anytim": 21, "anywher": 20, "aoa_tabl": 51, "appar": [23, 51], "appear": [20, 22, 23, 32, 42, 43, 51], "appl": 38, "appli": [20, 21, 27, 31, 32, 35, 36, 41, 43, 51], "applic": [8, 20, 23, 24, 26, 32, 35, 36, 37, 41, 49], "apporach": 31, "appraoch": [18, 23], "approach": [0, 18, 19, 20, 24, 27, 28, 29, 30, 31, 32, 33, 35, 36, 41, 51], "approaxim": 29, "appropri": [10, 20, 31, 32, 33, 36, 51], "approx": [20, 32, 41], "approxim": [20, 22, 29, 31, 32, 35, 37, 51], "apprpriat": 36, "apt": 8, "ar": [6, 8, 12, 14, 18, 19, 20, 21, 22, 23, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 41, 42, 43, 44, 50, 51], "arbitrari": [21, 23, 28, 51], "arc": 36, "archetyp": 14, "architectur": 43, "archiv": 38, "area": [20, 21, 23, 32, 36, 51], "aren": 8, "arg_": 32, "argon": 37, "aris": [18, 23, 25], "around": [36, 41], "arrai": [22, 35], "arriv": 21, "artif": 27, "artifici": 27, "asc": 22, "asid": 32, "ask": 10, "aspect": [20, 22, 23, 37, 41, 51], "assembl": [20, 21, 23, 28, 29, 33], "assembli": [18, 20, 23, 24, 49], "assess": [32, 50, 51], "assign": [28, 35, 51], "associ": [18, 20, 32, 36, 41], "assum": [20, 21, 25, 30, 31, 32, 36, 38, 51], "assumpt": [20, 30, 32, 36], "ast": 32, "asymptot": [19, 24, 35], "atmospher": [24, 28, 32, 36, 44, 51], "attack": 51, "attempt": [32, 45], "attribut": 32, "augment": [20, 29], "author": 41, "authorship": 20, "auto": [16, 44], "autom": 20, "automat": [16, 17, 20], "automatic_decomposition_typ": 43, "autonom": 21, "auxiliari": [9, 11, 32], "av": 21, "avail": [14, 16, 20, 36, 38, 43, 44, 45, 47], "averag": [20, 23, 35, 47, 51], "avoid": [13, 20, 25, 27, 31], "awai": [20, 32, 41], "ax": 28, "axi": [20, 51], "az": 32, "azimuth": [32, 36], "b": [16, 19, 20, 21, 36, 51], "b2": 37, "ba": 20, "back": [22, 28, 32, 38, 44, 51], "background": 28, "backslash": 20, "backward": [20, 32, 33, 36, 51], "balanc": [25, 32, 41, 51], "bamg_": 43, "band": 30, "bar": [20, 23, 25, 27, 29, 32, 35, 36, 51], "base": [0, 8, 12, 14, 18, 19, 20, 21, 24, 26, 28, 29, 30, 32, 34, 35, 36, 37, 43, 44, 45, 49], "baselin": [37, 51], "bash": [37, 38], "bashrc": 38, "basi": [23, 32, 36, 51], "basic": [28, 51], "batch": 38, "baum": 25, "bautista": 20, "bc": [20, 21, 31, 32, 36, 43], "bc_6": 43, "bc_inflow": 43, "bc_left": 43, "bc_lower": 20, "bc_open": 43, "bc_right": 43, "bc_terrain": 43, "bc_top": 43, "bc_upper": 20, "bdf2": [21, 32, 33, 36, 51], "bdylayervelocitysampl": 20, "becaus": [20, 32, 35, 36, 38, 41, 51], "becom": [25, 32, 36, 41], "been": [14, 18, 20, 21, 22, 23, 25, 27, 28, 31, 32, 35, 38, 51], "befor": [21, 28, 35, 36, 37], "began": [24, 49], "begin": [21, 22, 25, 28, 32, 35, 36, 51], "begin_nod": 21, "behav": [25, 28, 43], "behavior": [25, 35, 36, 45, 51], "being": [14, 20, 26, 28, 32, 35, 38, 48, 50], "belo": 43, "below": [16, 19, 20, 21, 22, 31, 32, 35, 36, 37, 41, 43, 51], "benchmark": 50, "bend": 36, "benefici": 41, "benefit": 38, "best": [0, 11, 27, 51], "beta": [20, 31, 32, 51], "beta_": 32, "beta_1": [20, 32], "beta_2": 32, "beta_h": 20, "beta_i": 32, "beta_m": 20, "better": [10, 13, 23, 32, 36, 41, 51], "between": [16, 18, 19, 20, 21, 23, 26, 27, 28, 29, 32, 35, 36, 41, 43, 50, 51], "beyond": [43, 46], "bf": [22, 31, 32, 36], "bibtex": 8, "bigint": 37, "billion": 37, "bin": 37, "binari": [32, 48], "bla": 14, "black": [32, 51], "blade": [28, 32, 36, 41, 43, 51], "blade0": 51, "blaslib": 37, "blend": [19, 20, 23, 27, 31, 32, 36, 51], "block": [20, 21, 22, 28, 32, 41, 44, 51], "block_1": [21, 43], "blockag": [36, 41], "blue": 28, "bmatrix": 32, "bodi": [28, 32, 36, 51], "boldsymbol": 35, "boltzmann": 32, "bool": [8, 14, 16, 37], "boolean": 20, "boomeramg": 43, "boost": [14, 20], "boost_1_68_0": 37, "boost_build_intal": 37, "boost_build_on": 37, "boost_root_dir": 37, "bootstrap": 37, "both": [19, 20, 22, 23, 28, 31, 32, 33, 36, 41, 43, 51], "bottom": [18, 20, 23, 51], "bottomwal": 44, "botzmann": 32, "bound": [20, 22, 28, 32, 35, 51], "boundari": [0, 18, 21, 22, 23, 24, 28, 31, 32, 34, 35, 41, 44, 47, 49], "boundary_condit": [20, 43], "boundary_layer_statist": 43, "boundreault": 20, "boussinesq": [0, 36, 49], "box": [20, 28, 35, 41, 51], "bracket": 32, "branch": [14, 23, 37], "break": 32, "breath": 8, "breviti": [37, 44], "brew": [8, 37], "brief": [16, 22, 28, 36, 43, 44, 51], "briefli": [36, 43, 51], "broken": [31, 36, 48], "brought": 32, "bruner": 41, "bucketvector": 21, "buffer": 20, "build": [0, 11, 12, 14, 40, 48, 51], "built": [17, 21, 22, 38], "bulkdata": 21, "bulkdata_": 21, "bullet": 21, "buoyanc": [0, 20, 36, 49], "buoyant": 32, "c": [9, 16, 20, 21, 32, 37, 38, 51], "c_": [19, 20, 25, 27, 32, 35], "c_0": 51, "c_compil": 37, "c_d": [36, 51], "c_f": 32, "c_i": 32, "c_l": 51, "c_p": [20, 32, 36, 51], "c_w": 35, "cach": [37, 38], "calcul": [14, 20, 25, 27, 32, 36, 43, 50, 51], "call": [13, 20, 23, 32, 35, 45], "camel": 13, "can": [6, 14, 16, 17, 19, 20, 21, 22, 23, 25, 27, 28, 29, 31, 32, 33, 35, 36, 37, 38, 41, 42, 43, 44, 45, 46, 48, 50, 51], "candid": 51, "cannot": [20, 25, 28, 32], "canon": [23, 41], "cap": [20, 36, 51], "capabl": [10, 14, 24, 28, 32, 36, 38, 49, 51], "capac": 32, "captur": [23, 27, 31, 32, 35, 41, 51], "care": [20, 23, 35], "carefulli": 35, "carri": [20, 27, 32], "cartesian": [18, 20, 25], "cartoon": 20, "cascad": 35, "case": [13, 14, 19, 20, 21, 23, 26, 28, 31, 32, 36, 37, 39, 40, 43, 47, 51], "cast": 22, "catalyst": 44, "catalyst_ioss_adapter_root_dir": 37, "cataylst": [44, 47], "categori": 14, "cauchi": 32, "caus": [20, 41, 48], "causal": 32, "cc": 37, "cd": [19, 37, 38, 48], "cd_": 32, "cd_tabl": 51, "cdash": [11, 12], "cdmremot": 37, "cdot": 32, "cell": [19, 20, 23, 32, 36, 41, 51], "cellar": 37, "center": [18, 23, 31, 32, 36, 51], "central": [19, 20, 28, 35, 51], "centroid": [23, 41], "certain": [32, 36, 43], "certainli": 27, "cfd": 21, "cfl": 22, "cflag": 37, "chang": [8, 18, 19, 20, 25, 32, 36, 38, 41, 43, 46, 48, 51], "channel": [20, 51], "channel_coarse_": 44, "char": 16, "character": [20, 51], "characterist": [20, 25, 35], "check": [12, 14, 21, 37, 38], "checkout": [8, 14, 37, 38], "checkpoint": 43, "chemic": 32, "chien": 32, "chien1982predict": 32, "child": [1, 18], "choic": [18, 19, 20, 21, 22, 23, 27, 32, 51], "choos": [14, 23, 35, 43, 46], "chord": [41, 51], "chord_tabl": 51, "chosen": [14, 31, 32, 51], "chri": 41, "cht": 26, "churchfield": 36, "ci": 12, "circ": [25, 32, 36, 51], "circul": 51, "circular": 28, "cite": [18, 20, 23, 24, 25, 27, 29, 31, 32, 35, 36, 49, 51], "civita": 32, "cl_tabl": 51, "clang": [12, 38], "class": [1, 13, 16, 20, 23, 28, 31, 36], "classic": [18, 19, 20, 22, 23, 27, 31, 32, 35, 51], "clean": [21, 37], "cleanli": 48, "cleanup": 37, "clear": [23, 51], "clip": 27, "clockwis": 51, "clone": [14, 37, 38, 51], "close": [25, 27, 32, 41], "closer": [27, 35, 51], "closest": 51, "closur": [27, 31, 32, 35, 36, 51], "cm": 51, "cmake": [11, 14, 38], "cmakecach": 37, "cmakefil": 37, "cmakelist": 14, "cmm": 51, "co": [20, 32, 51], "coars": [28, 51], "coarser": 51, "code": [0, 10, 11, 12, 16, 18, 20, 23, 24, 26, 27, 28, 31, 32, 35, 36, 38, 44, 48, 49, 50, 51], "codebas": 28, "coeffici": [20, 24, 25, 30, 32, 35, 36, 51], "coeffieci": 32, "coincid": 43, "collabor": 12, "collect": [12, 21, 23, 25, 28], "colloc": 32, "color": [28, 51], "column": [23, 28], "com": [14, 16, 21, 37, 38], "combin": [8, 18, 19, 20, 22, 23, 27, 29, 37, 44, 51], "combust": [24, 32, 49], "come": [8, 20, 21, 36, 38], "comfort": 38, "command": [8, 14, 20, 23, 32, 37, 40, 43, 44, 47, 48], "comment": 16, "commerci": [21, 44], "commit": [12, 14], "common": [20, 21, 23, 26, 32, 36, 47], "commonli": [20, 23, 32, 36], "commonplac": 23, "commun": [23, 41], "commut": 27, "compact": 31, "compar": [20, 27, 36, 41, 43, 50, 51], "comparis": 50, "comparison": [50, 51], "compars": 51, "compat": [20, 51], "compet": 20, "compil": [14, 37, 38, 44], "complet": [8, 14, 27, 28, 32, 35, 41, 43], "complex": [20, 28, 31, 35, 36, 47], "compon": [20, 23, 25, 32, 35, 43], "componnet": 23, "composit": [30, 32], "compress": [25, 27, 30, 32], "compris": 35, "compromis": [20, 51], "comput": [6, 14, 18, 19, 20, 24, 27, 31, 35, 36, 43, 44, 47, 51], "concept": [23, 26, 29, 36], "conclus": 22, "condit": [0, 18, 21, 23, 24, 31, 32, 35, 47, 49], "conduct": [21, 22, 24, 25, 28, 43, 51], "confid": 51, "config": [37, 38], "configur": [9, 11, 14, 18, 20, 28, 37, 38, 43, 47, 51], "confin": [14, 20, 32], "confirm": 51, "conform": [14, 24, 41, 47], "confus": 31, "conjug": [20, 26, 32], "connect": [20, 23, 28], "connected_nod": 21, "consequ": [25, 51], "conserv": [18, 20, 24, 26, 29, 36, 41], "consid": [20, 21, 22, 23, 25, 28, 32, 50, 51], "consider": 23, "consist": [14, 20, 21, 23, 27, 28, 32, 33, 41, 51], "consolid": 23, "const": [13, 16, 21], "const_iter": 21, "constant": [19, 20, 23, 25, 27, 30, 31, 32, 35, 36, 43, 51], "constrain": 18, "constraint": [18, 20, 28, 34, 38, 43], "construct": [18, 20, 23, 28, 36], "consult": [44, 51], "contain": [6, 11, 20, 21, 23, 25, 32, 35, 36, 39, 40, 43, 44, 48, 51], "content": [32, 44], "context": [22, 27, 32, 36, 43], "continu": [11, 18, 22, 23, 25, 27, 29, 32, 36], "continuosli": 38, "continuum": 50, "contour": 28, "contravari": 27, "contribut": [0, 11, 20, 23, 25, 31, 32, 33, 36], "control": [18, 23, 31, 32, 35, 36, 45, 47, 51], "convect": [0, 9, 20, 49], "convecting_taylor_vortex": 51, "conveni": 36, "convent": [20, 36], "converg": [20, 22, 23, 36, 41, 43, 51], "convergence_toler": 43, "convers": 51, "convert": [36, 51], "convolut": 35, "coordin": [20, 25, 32], "copi": [14, 16, 21, 37, 38], "cor": 32, "core": [22, 51], "corioli": 36, "corner": [31, 51], "correct": [14, 20, 23, 32, 36, 37, 38, 41, 51], "correctli": [37, 38, 50], "corrector": 22, "correl": 32, "correspond": [14, 22, 32, 38, 51], "cost": [20, 35], "couett": 20, "could": [8, 20, 28, 43, 48], "count": [21, 41], "counterpart": [28, 32], "coupl": [0, 1, 20, 21, 23, 24, 26, 32, 49], "courant": [36, 43, 51], "cours": 32, "covari": 27, "cover": [36, 41], "coverag": 51, "cp": 37, "cpp": [8, 12, 14, 38], "cpu": 37, "creat": [8, 14, 16, 18, 20, 21, 28, 37, 38, 48, 51], "creation": [21, 51], "criteria": 32, "critic": 32, "cross": [32, 51], "crossflow": 18, "ctest": [12, 14], "ctestlist": 14, "ctestnightlyscript": 14, "ctesttestfil": 14, "ctr": 20, "cube": [0, 32, 49], "cubit": 44, "current": [12, 14, 20, 23, 27, 28, 32, 34, 36, 37, 43, 45, 47, 51], "curv": [20, 51], "curvatur": 36, "custom": [21, 43], "cut": 28, "cvem": 51, "cvfem": [9, 11, 20, 24, 27, 29, 31, 32, 33, 34, 36, 51], "cxx": 37, "cxx_compil": 37, "cxxflag": 37, "cycl": 51, "cylind": 28, "d": [9, 16, 19, 20, 22, 23, 27, 29, 31, 32, 35, 36, 45, 51], "d_": [32, 35], "d_k": 32, "d_t": 32, "damp": 20, "dampen": 35, "dap": 37, "dash": 51, "dat": 20, "data": [6, 13, 20, 24, 28, 32, 44, 47, 49, 51], "data_prob": 43, "databas": [32, 44], "davidson": 32, "dboost_include_dir": 37, "dboost_library_dir": 37, "dboostlib_include_dir": 37, "dboostlib_library_dir": 37, "dcmake_build_typ": [8, 37, 38], "dcmake_cc_compil": 37, "dcmake_cxx_compil": 37, "dcmake_cxx_flag": 37, "dcmake_install_prefix": 37, "dco": [23, 27, 31], "de": 24, "deal": 18, "debat": 20, "debug": [43, 45, 46], "debug_output": 51, "decai": [0, 32, 49], "decent": 23, "decid": 41, "deck": [36, 45], "declar": 21, "declare_field": 21, "decomp": 44, "decompos": [31, 32, 35, 44], "decomposit": [28, 32], "decoupl": [25, 31, 32], "decreas": 20, "default": [14, 20, 32, 35, 36, 37, 38, 43], "defici": 32, "defin": [14, 16, 18, 19, 20, 21, 23, 26, 27, 29, 31, 32, 35, 38, 43, 50, 51], "definit": [12, 18, 20, 21, 22, 23, 24, 25, 32, 43], "deform": [32, 51], "degrad": 51, "degre": [20, 29, 31, 41, 51], "delai": 23, "delet": 48, "delin": 20, "delta": [19, 31, 32, 33, 35, 36, 51], "delta_": [20, 25, 27, 32, 35, 36], "demonstr": [20, 23, 51], "denable_document": [8, 37], "denable_hypr": 37, "denable_openfast": 37, "denable_paraview_catalyst": 37, "denable_test": [14, 37], "denable_tioga": 37, "denomin": 27, "denot": [19, 31, 32], "densiti": [20, 21, 22, 24, 25, 32, 33, 35, 36, 43, 49, 51], "density_": 21, "densityn_": 21, "densitynm1_": 21, "densitynp1": 21, "densitynp1_": 21, "depend": [14, 20, 32, 35, 37, 38, 43, 51], "depict": 28, "deplet": 32, "deploi": [18, 23], "deploy": 18, "deprec": 51, "dept": 41, "depth": 16, "deriv": [0, 20, 23, 24, 27, 29, 31, 32, 36, 51], "describ": [8, 12, 14, 15, 16, 18, 20, 21, 23, 28, 29, 32, 36, 37, 38, 41, 43, 45, 47, 51], "descript": [16, 20, 23, 28, 35, 36, 43, 44, 51], "design": [8, 13, 21, 23, 24, 26, 32, 36, 49, 51], "desir": [20, 21, 22, 23, 32, 35, 36, 43, 50, 51], "destruct": 32, "destructor": 16, "detach": 24, "detail": [16, 21, 22, 32, 35, 36, 43, 44, 51], "determin": [20, 21, 23, 25, 27, 28, 32, 36, 43, 44, 45, 50, 51], "develop": [0, 14, 20, 21, 27, 28, 32, 36, 37, 39, 40, 44, 51], "deviat": [14, 36, 38], "deviator": 32, "dextra_build_nam": 14, "dg": [20, 41, 51], "dhdf5_no_system_path": 37, "dhdf5_root": 37, "dhost_nam": 14, "dhypre_dir": 37, "diagon": [20, 29, 36], "dial": 19, "dictat": [14, 20], "dictionari": 43, "dif": 14, "diff": [31, 37], "differ": [12, 18, 19, 20, 22, 23, 25, 27, 28, 29, 32, 35, 37, 41, 43, 47, 50, 51], "differenc": 27, "differenti": [23, 31, 32], "difficult": [14, 19, 20], "diffuion": 51, "diffus": [20, 22, 24, 29, 30, 32, 36, 51], "diffusion": 29, "dilut": 36, "dimens": [20, 44], "dimension": [19, 20, 25, 28, 51], "dimensionless": [20, 25], "direct": [20, 23, 24, 31, 32, 36, 43, 45, 49, 51], "directli": [16, 20, 32, 35, 38], "directori": [8, 14, 37, 38, 43, 45, 48], "dirichlet": [20, 21, 31, 51], "disabl": 37, "disadvantag": 41, "discontinu": [20, 23, 27, 31, 41], "discret": [0, 20, 21, 22, 24, 29, 31, 32, 43, 50, 51], "discuss": [20, 32, 36, 37], "dispar": [20, 26], "dispers": 18, "displac": [9, 20, 32], "displai": [32, 51], "dissip": [19, 32, 35], "distanc": [16, 19, 20, 23, 24, 36, 51], "distinct": 50, "distinguish": 50, "distort": 51, "distribut": [20, 31, 36, 51], "disturb": 20, "diverg": [25, 31, 32, 36], "divid": [18, 25, 27, 36], "divis": 18, "dkokkos_enable_deprecated_cod": 37, "dmpi_cxx_compil": 37, "dmpi_use_compiler_wrapp": 37, "dmpiexec_preflag": 37, "dmuelu_enable_kokkos_refactor": 37, "dn": [32, 51], "dnetcdf_root": 37, "dnightly_dir": 14, "do": [13, 14, 18, 20, 35, 37, 38, 48, 51], "doc": 11, "docker": [11, 39, 40], "dockerhub": 12, "document": [10, 11, 12, 14, 15, 36, 41, 43, 44], "doe": [12, 14, 16, 20, 21, 23, 35, 36, 37, 38, 43], "doesn": 14, "dof": [20, 23, 28, 33, 51], "domain": [6, 14, 20, 31, 32, 36, 41, 43, 51], "domin": [20, 32, 36, 41], "domino": [20, 23, 27, 29, 36, 51], "don": 37, "done": [14, 20, 23, 27, 32, 38, 51], "donor": 28, "donoth": 16, "dopenfast_dir": 37, "dosometh": 16, "dot": [8, 19, 20, 24, 27, 32, 36], "doubl": [13, 21], "down": [22, 35, 38], "download": [16, 38, 48], "downstream": [20, 36, 41], "downward": 21, "downwash": 51, "doxygen": [8, 9, 16, 37], "doxylink": 8, "dp": 20, "dparaview_catalyst_install_path": 37, "dparaview_dir": 37, "dpnetcdf_include_dir": 37, "dpnetcdf_library_dir": 37, "dpnetcdf_root": 37, "drag": [36, 51], "drive": [32, 36, 43], "driven": [18, 35], "drop": [0, 20, 31, 32, 49], "dry_run": [43, 46], "dsuperlu_include_dir": 37, "dsuperlu_library_dir": 37, "dt": [16, 32], "dtdx": 51, "dtdy": 51, "dtdz": 51, "dtest_toler": 14, "dtioga_dir": 37, "dtpetra_inst_complex_doubl": 37, "dtpetra_inst_doubl": 37, "dtpetra_inst_seri": 37, "dtpl_enable_bla": 37, "dtpl_enable_boost": 37, "dtpl_enable_hdf5": 37, "dtpl_enable_mpi": 37, "dtpl_enable_netcdf": 37, "dtpl_enable_pnetcdf": 37, "dtpl_enable_superlu": 37, "dtpl_enable_zlib": 37, "dtpl_netcdf_parallel": 37, "dtrilinos_allow_no_packag": 37, "dtrilinos_assert_missing_packag": 37, "dtrilinos_dir": [8, 14, 37, 38], "dtrilinos_enable_all_optional_packag": 37, "dtrilinos_enable_ameso": 37, "dtrilinos_enable_amesos2": 37, "dtrilinos_enable_aztecoo": 37, "dtrilinos_enable_belo": 37, "dtrilinos_enable_cxx11": 37, "dtrilinos_enable_epetra": 37, "dtrilinos_enable_epetraext": 37, "dtrilinos_enable_explicit_instanti": 37, "dtrilinos_enable_gtest": 37, "dtrilinos_enable_ifpack": 37, "dtrilinos_enable_ifpack2": 37, "dtrilinos_enable_kokkoskernel": 37, "dtrilinos_enable_ml": 37, "dtrilinos_enable_muelu": 37, "dtrilinos_enable_seacasepu": 37, "dtrilinos_enable_seacasexodiff": 37, "dtrilinos_enable_seacasexodu": 37, "dtrilinos_enable_seacasioss": 37, "dtrilinos_enable_seacasnemslic": 37, "dtrilinos_enable_seacasnemspread": 37, "dtrilinos_enable_stk": 37, "dtrilinos_enable_test": 37, "dtrilinos_enable_tpetra": 37, "dtrilinos_enable_zoltan": 37, "dtrilinos_enable_zoltan2": 37, "dual": [20, 24, 30, 32, 33, 36, 51], "dual_nodal_volum": 43, "ducro": 35, "duct": [0, 49], "due": [14, 20, 23, 24, 31, 32, 35, 36, 37, 41, 50, 51], "durat": [43, 51], "dure": [28, 32, 36, 37, 43, 44, 45], "dv": [23, 29, 32, 33, 51], "dx": [20, 23], "dx_k": [23, 51], "dx_l": [23, 51], "dx_x": 23, "dx_y": 23, "dxpetra_enable_kokkos_refactor": 37, "dy": 23, "dyaml_dir": [8, 14, 37, 38], "dyer": 20, "dynam": [23, 25, 35], "dz": 20, "dzlib_include_dir": 37, "dzlib_library_dir": 37, "e": [8, 13, 19, 20, 21, 22, 23, 25, 27, 28, 31, 32, 36, 37, 38, 43, 44, 51], "e2": 32, "e4": 12, "each": [14, 19, 20, 21, 22, 23, 25, 26, 28, 29, 31, 32, 36, 37, 43, 50, 51], "eagl": [37, 39, 40], "earlier": [14, 37], "earth": 36, "eas": 41, "easi": 20, "easier": [36, 48], "easili": [20, 21, 51], "east": 32, "eb_nam": 44, "ebvc": [20, 23, 27, 29, 31, 51], "eclips": 13, "ecpe4": [12, 38], "ed": 21, "eddi": [24, 27, 51], "edg": [18, 19, 20, 21, 24, 29, 32, 34, 36, 41, 51], "edge_area_vector": 21, "edge_bucket": 21, "edge_rank": 21, "edgeareavec": 21, "edgeareavec_": 21, "edit": [37, 38], "editor": 13, "educ": 22, "edward": [24, 49], "eff": [20, 27, 51], "effect": [20, 32, 36, 41, 51], "effici": [23, 35, 51], "effort": [21, 24, 27, 41, 49], "ei": 20, "eigenvalu": [27, 32], "eight": 23, "einstein": 25, "either": [14, 19, 20, 23, 29, 30, 31, 32, 33, 35, 36, 41, 51], "el": 35, "elast": [32, 36, 51], "elem": 21, "elem_bucket": 21, "element": [18, 19, 20, 21, 23, 24, 27, 28, 29, 32, 34, 36, 41, 44, 51], "element_continuity_eq": 23, "element_rank": 21, "element_source_term": 43, "elev": 20, "elimin": [20, 31, 36, 41], "ellipt": [41, 51], "els": [21, 32], "elsewher": 36, "embed": [16, 28, 36], "emerg": 21, "emiss": 32, "emit": 32, "emphasi": [22, 31, 51], "empir": [20, 32], "emploi": 51, "enabl": [14, 37, 44, 45], "enclos": 28, "end": [16, 21, 22, 28, 32, 35, 36, 48, 51], "endif": 16, "energi": [0, 24, 25, 26, 35, 41, 44, 49, 51], "enforc": [20, 21, 25, 32, 36, 43, 51], "engin": 32, "enough": [20, 32, 43, 46], "ensur": [19, 28, 29, 32, 36, 41, 51], "enter": [20, 51], "enthalpi": [21, 23, 25, 26, 27, 30, 32, 36, 51], "entir": [20, 36, 37, 38], "entiti": [21, 28], "entrain": 20, "entrainment_method": 43, "entranc": 51, "entri": [8, 20, 28, 29, 36, 43], "env": 38, "environ": [32, 38], "environment": 32, "epetra": [24, 49], "epic": 16, "epsilon": [20, 22, 25, 32, 36, 43, 46, 51], "epsilon_": [32, 36], "epsilon_d": 36, "epu": 44, "eq": [23, 27, 29, 31, 36], "equal": [20, 22, 31, 32, 49], "equat": [0, 6, 9, 11, 18, 19, 20, 21, 23, 24, 25, 26, 27, 28, 29, 31, 41, 47, 50, 51], "equation_system": 43, "equationsystemvector": 21, "equationsystemvector_": 21, "equiangl": 41, "equilibrium": [20, 36], "equiv": [32, 35, 51], "equival": [35, 36], "equivolum": 41, "eras": 38, "error": [14, 18, 20, 21, 24, 27, 35, 36, 37, 43, 50], "especi": [20, 37], "essenti": [16, 35], "establish": 14, "estim": 50, "et": 32, "eta": [19, 20, 32], "etal": [32, 35], "etc": [13, 14, 19, 20, 21, 32, 37, 38, 43, 44, 51], "euler": [32, 33, 36, 51], "eulerian": 32, "evalu": [0, 19, 20, 21, 22, 23, 24, 26, 27, 29, 32, 33, 36, 50, 51], "even": [19, 30, 35, 38, 41, 51], "evenli": 36, "eventu": 41, "everi": [12, 14, 17, 28, 32, 43, 50], "everydai": 16, "everywher": 36, "evid": [32, 51], "evolut": 36, "evolv": [24, 49], "exact": [14, 19, 50, 51], "exactli": [43, 51], "examin": [40, 47], "exampl": [8, 14, 16, 20, 21, 23, 27, 28, 32, 36, 38, 41, 43, 44, 45, 50, 51], "example_h": 16, "exampleclass": 16, "exampleclass_h": 16, "exawind": [12, 37, 38], "exce": [32, 36], "excel": 23, "except": [10, 19, 23, 36, 37, 41], "exception": 16, "exec": 37, "execut": [13, 32, 36, 37, 43, 47], "exercis": 21, "exist": [6, 8, 14, 16, 18, 20, 21, 22, 23, 31, 36, 37, 38, 45, 50, 51], "exit": [45, 48, 51], "exo": 47, "exodu": [6, 20, 21, 40, 43, 47], "exp": 20, "expand": [25, 41], "expand_box_percentag": 43, "expans": [24, 32, 51], "expect": [20, 21, 26, 32, 35, 36, 37, 51], "expens": [35, 36], "experi": [23, 41], "experiment": [32, 51], "expert": 36, "explain": 32, "explic": 27, "explicit": [22, 51], "explicitli": [20, 32], "exploit": 23, "explor": [18, 25, 27], "exponenti": 20, "export": 38, "expos": [20, 21, 31, 34], "express": [14, 20, 23, 32, 51], "extend": [18, 20, 23, 28, 36, 51], "extens": [8, 12, 31, 37, 43, 45, 46, 51], "extent": [28, 32], "exterior": 28, "extern": [12, 28, 32, 38], "external_data": 51, "external_data_provid": 51, "external_field_provid": 51, "extra": [22, 37], "extra_arg": 37, "extract": [6, 9, 16, 21, 38, 43, 47], "extrapol": [19, 23], "extrud": 51, "extrus": 41, "f": [16, 20, 22, 32, 36, 37], "f_": [20, 32], "f_2": 32, "f_c": 32, "f_d": 36, "f_i": [20, 32, 36], "f_j": 20, "f_k": 20, "f_w": 20, "f_x": [20, 23], "f_y": [20, 23], "face": [18, 19, 20, 21, 23, 31, 34, 41, 43, 44], "face_bucket": 21, "facet": [20, 31], "facilit": 20, "fact": [20, 31, 51], "factor": [19, 20, 22, 32, 33, 36, 41, 48, 51], "fail": 14, "failur": [14, 48], "fairli": 41, "fall": 36, "fals": [43, 46, 51], "familiar": [28, 36, 41], "fanswer": 16, "far": [20, 22, 36, 41, 43], "farm": [36, 51], "fashion": 35, "fast": [20, 25], "fast_input_filenam": [43, 46], "faster": [23, 38], "fastest": 32, "favor": 20, "favr": [32, 35, 36], "fc": 37, "fcflag": 37, "featur": [10, 20, 36], "feel": 21, "fem": [9, 11, 20, 31, 51], "fem_diff": 43, "femhc": [14, 43], "few": 48, "fewer": 41, "fft": 20, "fickian": 32, "fidel": 51, "field": [13, 20, 23, 28, 32, 36, 43, 44, 51], "field_data": 21, "field_of_st": 21, "fieldoutputtyp": 21, "figur": [18, 19, 20, 23, 28, 32, 36, 51], "file": [9, 14, 16, 19, 20, 21, 23, 30, 32, 36, 37, 38, 40, 42, 45, 47, 48, 51], "filenam": 45, "filepath": 37, "filesystem": 37, "filter": [20, 23, 24, 27, 35, 36], "final": [14, 20, 21, 22, 23, 27, 28, 31, 32, 35, 36, 41, 51], "find": [24, 28, 32, 37, 38, 51], "fine": [27, 29, 31, 36, 51], "finer": 35, "finit": [18, 20, 23, 24, 27, 36, 51], "first": [8, 14, 20, 21, 23, 27, 31, 32, 36, 37, 41, 43, 48, 51], "fit": [20, 28, 36], "five": [22, 23, 51], "fix": [0, 20, 21, 32, 36, 43, 49], "flag": [20, 28, 37, 43, 44], "flame": 32, "flat": [20, 32, 36], "flexibl": 36, "float": 16, "flow": [9, 18, 20, 21, 22, 23, 24, 25, 27, 28, 29, 32, 35, 36, 41, 43, 44, 49, 51], "fluctuat": [20, 32, 35], "fluid": [20, 21, 25, 26, 32, 36, 47, 51], "fluidrealm": 20, "flux": [18, 20, 24, 30, 31, 32, 36, 51], "fold": 22, "folder": 48, "follow": [12, 13, 14, 19, 20, 21, 22, 23, 25, 27, 28, 31, 32, 34, 36, 37, 38, 42, 43, 44, 48, 51], "footnot": 20, "forc": [13, 20, 23, 24, 36, 47, 51], "forget": 37, "forgiv": 22, "form": [16, 18, 19, 20, 22, 23, 24, 25, 27, 28, 29, 30, 32, 35, 43, 51], "formal": [23, 27, 32], "format": [12, 13, 16, 17, 40, 41, 43, 47], "former": 27, "formul": [20, 24, 27, 31, 35, 51], "formula": [20, 51], "fortran": 37, "forum": 23, "forward": 32, "found": [8, 20, 25, 27, 37, 41], "foundat": 51, "four": [18, 23, 51], "fourier": 20, "fourth": [19, 20, 22, 23, 27, 29, 51], "fpic": 37, "fquestion": 16, "fr": 25, "frac": [16, 19, 20, 23, 25, 27, 29, 31, 32, 33, 35, 36, 51], "fraction": [23, 24, 27, 30, 51], "frame": [22, 51], "framework": [20, 31, 32], "free": [22, 32, 35, 36, 51], "freedom": [20, 29, 31], "freestream": [20, 32], "frequenc": [43, 51], "frequent": [23, 31], "friction": 20, "fring": 28, "from": [6, 9, 12, 13, 14, 18, 19, 20, 21, 22, 23, 25, 27, 28, 29, 32, 33, 35, 36, 37, 38, 40, 43, 44, 45, 46, 47, 50, 51], "front": 44, "froud": 25, "fsi": [26, 32, 36], "fsi_interfac": 32, "fst": [43, 46], "fsync": 37, "fuego": 36, "fuegotheorymanu": 36, "fuel": 32, "full": [10, 19, 20, 21, 22, 23, 25, 28, 29, 31, 32, 35, 36, 41, 43, 44, 51], "fulli": [10, 20, 22, 25, 28, 32, 34, 35, 41, 51], "functin": 51, "function": [9, 11, 14, 16, 18, 19, 21, 23, 24, 27, 30, 35, 36, 43, 51], "fund": 22, "fundament": 20, "further": [41, 51], "furthermor": [20, 36, 44, 51], "futur": [18, 20, 32, 36, 43, 46], "fy15": 22, "g": [8, 13, 20, 21, 22, 23, 27, 28, 31, 32, 35, 36, 37, 38, 43, 44], "g_": [27, 31], "g_0": 51, "g_h": 51, "g_i": [25, 29, 32, 36, 51], "g_j": [20, 23, 27, 29, 51], "g_l": [23, 51], "g_x": 23, "g_y": 23, "ga": [23, 24, 25, 30, 32, 36, 49, 51], "gain": 36, "galerkin": [19, 20, 27, 31, 41], "gamma": [16, 19, 20, 23, 25, 27, 31, 32, 51], "gamma_": [20, 23, 51], "gamma_1": [32, 33, 36], "gamma_2": [32, 33, 36], "gamma_3": [32, 33, 36], "gamma_h": 20, "gamma_i": [31, 32, 33, 36], "gamma_m": 20, "gather": [21, 35, 36], "gaurante": 51, "gauss": [20, 23, 27, 29, 51], "gaussian": 36, "gcc": [12, 14, 37, 38], "gcd": 19, "gcl": 32, "ge": 32, "gener": [1, 16, 17, 18, 19, 20, 21, 22, 23, 24, 26, 28, 31, 32, 33, 34, 35, 36, 37, 38, 40, 43, 44, 45, 47, 49, 51], "genericfieldtyp": 21, "genesi": 27, "geometr": [30, 32], "geometri": [28, 36, 47], "geophys": 32, "geostroph": [20, 32], "gerkema_et": 32, "german": [24, 49], "get": [8, 13, 20, 32, 36, 38], "get_bucket": 21, "get_field": 21, "get_inactive_selector": 21, "get_m": 13, "get_part": 21, "get_surface_master_el": 21, "gfem": 31, "ghost": 21, "git": [14, 37, 38, 48], "github": [17, 21, 23, 37, 38], "gitlab": 12, "give": [20, 41, 51], "given": [19, 20, 21, 22, 23, 27, 30, 31, 32, 35, 36, 41, 44, 51], "global": [20, 25, 32, 36, 51], "gmre": 43, "go": 20, "gold": 14, "good": [16, 20, 21, 41, 51], "googl": 16, "govern": [24, 32, 43, 50, 51], "gpu": 38, "gradient": [0, 19, 21, 24, 25, 27, 29, 31, 32, 34, 35, 36, 41, 49], "grain": 20, "graph": 20, "graphic": 20, "graphviz": 8, "graviti": [20, 25, 32, 43, 51], "gravity_vector_compon": 43, "great": [32, 36, 51], "greater": [22, 31, 51], "green": [23, 28, 32, 51], "grei": 20, "grid": [20, 24, 32, 35, 41, 50, 51], "grid07_conformal10": 47, "grid_dimens": 20, "gross": 41, "ground": 22, "group": [20, 25, 31], "growth": 41, "guarante": 20, "guard": 18, "guermond": 27, "guid": [0, 11], "gz": [37, 38], "h": [14, 16, 18, 19, 20, 25, 31, 32, 37, 44, 45, 51], "h_1": 32, "h_2": 32, "h_3": 32, "h_i": 32, "h_k": 32, "h_o": 51, "ha": [14, 18, 19, 20, 21, 22, 23, 24, 25, 27, 28, 31, 32, 35, 36, 37, 38, 41, 42, 43, 44, 49, 50, 51], "had": 51, "haer": [32, 35], "haeringaiaa": 32, "half": [20, 32], "halv": 20, "hand": [20, 21, 28, 31, 32, 37, 41], "handl": [23, 28, 35], "hang": 18, "happen": 28, "hat": [19, 20, 27, 29, 32, 36], "have": [14, 18, 20, 21, 22, 23, 28, 31, 32, 36, 37, 38, 41, 48, 50, 51], "hdf5": [14, 30], "hdf5_root_dir": 37, "header": [16, 38, 44], "health": 16, "heat": [21, 24, 25, 26, 28, 31, 36, 43, 51], "heat_flux": 43, "heatconduct": 43, "heavili": 32, "heavisid": 31, "height": [20, 32, 36, 42, 43, 51], "held": 36, "helio": 28, "helium": 51, "help": [16, 38, 45], "henc": [14, 25, 36, 51], "here": [10, 13, 14, 16, 17, 20, 22, 23, 28, 29, 32, 36, 37, 38, 41, 43, 44, 51], "hereiam_": 13, "heroux": [24, 49], "heterogen": 18, "heurist": 41, "hex": [23, 28, 34, 36, 41, 43, 46, 51], "hex8": 20, "hexahedr": [21, 23, 41, 51], "hexahedra": 41, "hierarchi": [18, 36], "high": [19, 23, 24, 28, 36, 41, 51], "higher": [0, 19, 23, 27, 29, 31, 44, 49], "highest": [27, 51], "highli": [23, 51], "histori": [36, 37], "hmmm": 13, "hoc": 31, "hold": [21, 51], "hole": 28, "homasterel": 51, "home": 38, "homebrew": [8, 38], "homegen": 21, "homepag": 0, "homogen": [21, 51], "hook": [32, 37], "hopefulli": [31, 36, 38], "horizont": [20, 36], "horizontal_bc": 20, "host": 14, "hour": 38, "how": [0, 8, 11, 14, 16, 20, 21, 28, 36, 38, 47], "howev": [13, 18, 20, 21, 23, 24, 26, 27, 31, 32, 34, 36, 37, 38, 41, 48, 49, 51], "hpcmp": 28, "html": [8, 17], "http": [12, 16, 17, 37, 38], "hub": [20, 28], "human": 16, "hwthread": 37, "hybrid": [0, 19, 23, 24, 28, 34, 36, 41, 49], "hydro": [36, 51], "hydrocarbon": 32, "hydrostat": [25, 36], "hyperbol": 19, "hypothesi": [25, 32], "hypr": [12, 43], "hypre_root_dir": 37, "i": [1, 6, 8, 9, 10, 12, 13, 14, 16, 17, 18, 19, 20, 21, 22, 23, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 41, 43, 44, 45, 46, 48, 50, 51], "i_": 20, "i_2": 16, "i_b": 32, "i_k": 31, "ib": 21, "iblank": 28, "ic_1": 43, "icm": 21, "id": 20, "idea": 13, "ideal": [19, 20, 23, 25, 30, 32, 36, 41, 48, 51], "ident": [19, 35], "identifi": [20, 32], "ifdef": 18, "ifndef": 16, "ignor": [23, 32, 36], "ii": [6, 21, 36, 40, 43, 47], "iii": 36, "ij": [20, 23, 25, 27, 31, 32, 35, 36], "ijk": [32, 36], "ik": [20, 32], "il": 20, "illustr": [23, 51], "imag": 36, "imax": 20, "immedi": [41, 51], "impact": [32, 36], "impart": 20, "implement": [14, 19, 21, 22, 23, 26, 27, 28, 31, 32, 34, 35, 36, 43, 51], "impli": [19, 29, 32, 48], "implic": 32, "implicit": [20, 22, 28, 32, 51], "implicitli": 20, "import": [20, 23, 32, 36, 41, 51], "impos": [36, 51], "imposit": 20, "improv": [27, 36], "inact": 28, "inc": 37, "incid": 32, "includ": [10, 14, 19, 20, 21, 23, 24, 25, 26, 27, 29, 31, 32, 37, 41, 49, 51], "inclus": [29, 32, 43, 51], "incom": [20, 31, 32, 36], "incomplet": 43, "incompress": [25, 36, 41], "inconsist": 32, "incorpor": 32, "increas": [20, 41, 51], "increment": [22, 29, 51], "independ": [20, 28, 35, 36, 51], "index": [8, 20, 23, 36], "indic": [16, 18, 19, 20, 25, 28, 51], "individu": 29, "induc": [32, 51], "inertia": [32, 36], "infer": 32, "infinit": 51, "infinitesim": [32, 51], "inflow": [21, 24, 32, 36, 47, 51], "inflow_boundary_condit": 43, "inflow_user_data": 43, "influenc": 36, "info": [12, 38], "inform": [16, 20, 21, 28, 35, 36, 43, 44, 48], "infrastructur": [0, 11, 14, 21, 49], "infrustructur": 51, "infti": [20, 25, 27, 32, 35, 36, 51], "inher": 23, "inherantli": 23, "init": [14, 43, 46, 48], "initi": [24, 28, 32, 41, 47, 51], "initial_condit": [36, 43], "initial_work": 32, "inlcud": 51, "inlet": [20, 43, 44, 51], "inlin": 16, "inner": 28, "inpfil": [36, 42, 43], "input": [6, 14, 19, 20, 21, 23, 30, 32, 36, 40, 42, 44, 45, 46, 47, 48, 51], "input_output": 51, "inputoutputrealm": 6, "insid": [28, 39, 40, 41, 51], "inspect": [27, 51], "instal": [11, 12, 14, 37, 38, 39, 40, 44], "install_nalu_eagl": 38, "install_nalu_gcc_mac": 38, "install_script": 38, "instanc": [6, 32, 43], "instantan": 32, "instead": [20, 32, 43], "instruct": [14, 17, 37, 38], "int": [16, 19, 20, 21, 23, 29, 31, 32, 33, 36, 51], "int_": [16, 20, 27, 31, 32, 35], "int_0": 36, "integ": [16, 28, 43], "integr": [9, 11, 19, 20, 23, 28, 29, 31, 32, 33, 35, 36, 40, 47, 51], "integrand": 32, "intel": [14, 38], "intend": [20, 37], "intens": [31, 32, 35], "intent": 51, "interact": [6, 32, 36, 47], "interest": [21, 23, 27, 36, 41, 44, 51], "interestingli": [21, 27, 51], "interfac": [0, 9, 11, 20, 21, 26, 36, 41, 49], "interior": [20, 28, 36, 41, 44], "intermedi": [28, 32], "intermitt": 32, "intern": [20, 21, 25, 28, 32, 36], "interpol": [18, 19, 20, 22, 23, 26, 27, 28, 29, 31, 32, 51], "interpret": [32, 36], "intersect": 20, "interv": 51, "intial": [14, 16], "introduc": [20, 32], "introduct": [0, 32, 40, 47, 49, 51], "intuit": 31, "invers": [20, 23, 25, 27, 30, 32, 36, 51], "investig": 41, "invoc": [43, 44, 45], "invok": [32, 40, 44, 47], "involv": [20, 21, 26, 32, 43, 50], "inward": 51, "io": [12, 17, 21, 51], "ioss": 37, "ip": [19, 23, 51], "irradi": [20, 32], "irrot": 20, "ish": 28, "isn": 41, "iso": 32, "isoparametr": 20, "isotherm": [0, 30, 32, 49], "isotrop": [27, 31, 32, 35, 41, 51], "isotropi": 41, "issu": [8, 27, 32, 50], "itarget": 21, "item": 16, "iter": [20, 21, 23, 29, 31, 32, 36, 50], "its": [16, 20, 28, 31, 32, 35, 36, 38, 41, 51], "itself": [14, 16, 23, 28, 32, 51], "iv": 36, "j": [20, 21, 23, 32, 36, 37, 51], "jacobian": 20, "jam": 37, "jasek": 23, "jbeder": 37, "jet": [18, 20, 22, 51], "ji": 35, "jk": 32, "jmax": 20, "jofr": 27, "just": [16, 20, 38, 44, 51], "k": [16, 18, 21, 23, 24, 25, 32, 36, 41, 51], "k1": 32, "k2": 32, "k_": [23, 24, 25, 32], "k_t": 20, "kallinderi": 18, "kappa": [20, 32], "kappa_": [20, 51], "karman": 20, "katzplotkin": 51, "kd": 44, "ke": 27, "keep": [14, 41, 51], "kei": [31, 43], "kept": 32, "kernal": 27, "kernel": [27, 32, 36, 51], "keyword": [20, 23], "kg": 51, "kinet": [24, 25, 35, 36, 44], "kirchoff": 32, "kj": 32, "kk": [32, 35], "km": 20, "kmax": 20, "know": 14, "knowledg": 20, "known": [20, 23, 32, 35, 51], "koblitz": 32, "kokko": 21, "kolmogorov": 32, "kovasznai": 9, "kspace": 43, "l": [14, 19, 20, 22, 23, 25, 32, 35, 36, 37, 51], "l0": 51, "l1": 51, "l2": [23, 29, 51], "l_": [19, 27, 32, 51], "l_1": [22, 36, 51], "l_2": [21, 22, 23, 27, 36, 51], "l_e": 32, "l_i": 22, "l_j": 19, "l_o": 51, "l_t": 32, "labatto": 20, "label": [12, 14, 28], "laboratori": [36, 41, 51], "lack": [20, 41], "lag": [23, 36, 51], "lambda": [19, 20, 32, 51], "lambda_": 20, "lambda_w": 20, "lame": [24, 32], "laminar": [20, 24, 35, 51], "langl": [20, 32], "lapack": 14, "laplac": [0, 20, 22, 49], "larg": [14, 20, 25, 32, 35, 36, 37, 41, 43, 46, 51], "larger": [20, 23, 35, 41, 51], "lario": 27, "last": [32, 51], "lastli": 51, "late": 22, "later": [14, 20, 27, 51], "latest": [14, 37, 38], "latitud": 32, "latter": 36, "launch": 13, "law": [20, 25, 32, 35, 51], "layer": [22, 24, 28, 32, 36, 41, 44, 47, 51], "layout": 21, "lbla": 37, "ld_library_path": 37, "ldflag": 37, "ldot": 25, "le": [19, 23, 24, 27, 36, 41, 51], "lead": [18, 20, 25, 31, 32, 36, 41], "learn": [21, 40, 47], "least": [23, 31, 41, 43], "leav": [20, 32], "leer": 19, "left": [16, 19, 20, 22, 23, 25, 29, 31, 32, 35, 36, 51], "legendr": 20, "lend": 23, "length": [20, 21, 25, 29, 35, 36, 41, 43, 51], "less": [20, 22, 23, 25, 31, 38, 51], "lesser": 32, "lesson": [40, 47], "let": 22, "level": [9, 11, 16, 18, 24, 28, 32, 38, 43, 51], "leverag": [21, 32, 51], "levi": 32, "lewi": [24, 30], "lh": 23, "li": [20, 28], "lib": 37, "lib64": 37, "librari": [12, 14, 28, 36, 37, 38, 43, 44, 51], "liekli": 21, "lift": 51, "light": 28, "like": [8, 14, 21, 27, 32, 38, 43, 51], "likewis": 21, "limit": [19, 21, 22, 23, 25, 27, 28, 41], "line": [0, 1, 14, 20, 23, 31, 32, 36, 38, 40, 43, 44, 47, 48, 49], "linear": [9, 11, 18, 19, 20, 23, 26, 27, 28, 29, 31, 32, 36, 37, 40, 47, 49], "linear_solv": 43, "linearli": [20, 51], "link": [16, 36, 37, 44], "linux": [8, 14, 39, 40], "list": [14, 16, 37, 38, 43, 51], "literatur": [20, 29], "littl": [20, 25], "live": [16, 21, 28], "ll": 25, "llnl": 37, "lmm": 51, "ln": 20, "load": [13, 21, 36, 38, 44, 45, 51], "local": [11, 17, 20, 21, 24, 25, 29, 32, 37, 51], "locally_owned_part": 21, "locat": [8, 14, 19, 20, 23, 28, 32, 35, 36, 37, 38, 41, 43, 51], "log": [14, 20, 38, 45, 48], "logarithm": 20, "logic": 13, "login": 38, "long": [35, 36, 41, 43, 46, 51], "longer": 16, "look": [8, 14, 16, 21, 27, 43], "loop": [21, 22, 23, 33], "loos": 21, "loss": 36, "lot": [16, 41], "low": [0, 19, 21, 22, 23, 24, 27, 32, 41, 43, 51], "lower": [14, 20, 21, 25, 32, 51], "lowmach": 21, "lowmacheo": 21, "lowmacheom": 23, "lowmachequationsystem": 21, "lr": 22, "lump": [23, 33, 51], "m": [19, 20, 24, 32, 36, 37, 41, 51], "m43": 32, "ma": 25, "mac": [8, 37, 39, 40], "mach": [0, 21, 22, 23, 24, 27, 32, 43, 51], "machin": [11, 12, 17, 37, 39, 40], "machine_on": [43, 46], "machine_zero": [43, 46], "machineri": 51, "maco": 38, "made": [22, 32, 50], "magenta": 28, "magnitud": [20, 25, 32, 50, 51], "mai": [14, 20, 21, 22, 23, 26, 27, 32, 37, 38, 41, 51], "main": [8, 14, 20, 32], "maintain": [18, 23, 28, 32, 36, 51], "major": [28, 32, 35], "make": [11, 14, 19, 20, 23, 28, 36, 37, 38, 48, 51], "make_inc": 37, "manag": [8, 12, 13, 20, 23, 28, 37, 38], "mandatori": 28, "mangl": 37, "mani": [14, 17, 21, 22, 23, 32, 37, 51], "manifest": 20, "manipul": 32, "manner": [18, 23, 31], "manual": [0, 16, 20, 23, 35, 36, 39, 43, 51], "manufactur": [23, 50, 51], "map": [20, 28, 31, 32, 36, 43, 44, 51], "mapvar": 44, "march": 37, "markdown": 16, "marker": 16, "martinez": [31, 36], "mask": 28, "mass": [18, 20, 21, 23, 24, 27, 29, 30, 33, 36, 51], "mass_flow_r": 21, "mass_flow_rate_sc": 21, "massflowr": 21, "massflowrate_": 21, "massiv": [24, 49], "master": [12, 14, 18, 20, 21, 37], "masterel": [21, 28, 51], "match": [14, 20, 32, 35, 37, 41, 51], "materi": [30, 32, 47], "material_properti": 43, "math": 20, "mathbb": 32, "mathbf": [27, 29, 32, 36, 51], "mathcal": [32, 35], "mathemat": [20, 32, 35, 41], "mathrm": [32, 35, 36, 51], "matrix": [20, 23, 24, 27, 28, 33, 49, 51], "mavripli": 18, "max": [19, 32, 41, 51], "max_": 32, "max_iter": 43, "maximum": [32, 41, 51], "mcal1991": 41, "mcalist": [40, 47], "mdot": 21, "mean": [14, 20, 25, 32, 36, 38, 50], "meant": [16, 20], "measur": [20, 32, 41], "mechan": [20, 21, 32], "media": [26, 31], "meet": 20, "member": 13, "menter": 32, "mention": 43, "mere": [14, 38], "mesc": 21, "mesh": [6, 9, 14, 18, 20, 21, 24, 26, 28, 29, 30, 34, 36, 40, 44, 47, 48, 51], "mesh_adapt": 44, "mesh_mot": [32, 43], "mesh_transform": 43, "mesh_veloc": 43, "mesoscal": [32, 36], "messag": 45, "metadata": [21, 44], "metadata_": 21, "method": [13, 16, 20, 21, 22, 23, 24, 26, 27, 29, 32, 35, 36, 43, 50, 51], "methodologi": [23, 28, 50, 51], "metric": [27, 28, 31, 32, 41], "mid": [23, 36, 51], "midpoint": [19, 20, 23, 29], "might": [20, 21, 28, 31, 32, 36, 47], "mimic": [32, 51], "min": 32, "minim": [23, 36], "minimum": [19, 20, 25, 32, 41], "misleadingli": 41, "miss": [20, 21], "mistak": 50, "mix": [20, 23, 28, 29, 35, 41, 51], "mixtur": [22, 23, 24, 27, 30, 51], "mixturefract": 21, "mkdir": 37, "mm": [9, 49], "mode": [14, 43], "model": [0, 18, 19, 24, 25, 28, 30, 37, 41, 47, 50, 51], "modif": [20, 32, 36], "modifi": [19, 20, 28, 31, 32, 37, 38], "modul": [18, 20, 26, 31, 36, 37, 38, 51], "modulu": 32, "moin": 35, "molecular": [20, 25, 32, 36], "momementum": 22, "moment": [14, 32, 48], "momentum": [22, 24, 25, 27, 29, 35, 42, 43, 49], "momentumequationsystem": 21, "momentumsstamsdiffedgekernel": 32, "momentumsstamsforcingnodekernel": 32, "monin": 43, "monolith": [21, 22], "monoton": [19, 23, 51], "more": [12, 16, 18, 20, 21, 23, 27, 31, 32, 35, 36, 38, 41, 43, 44, 47, 51], "moreov": [20, 26, 32, 51], "moser": 32, "most": [20, 23, 35, 36, 38, 41, 44, 48, 50, 51], "mostli": [23, 37, 38, 41], "motion": [9, 25, 28, 30, 32, 47, 51], "motiv": 51, "move": [20, 24, 25, 51], "mpi": [28, 37, 44, 45], "mpi_base_dir": 37, "mpi_root_dir": 37, "mpicc": 37, "mpich": 37, "mpicxx": 37, "mpiexec": 37, "mpif77": 37, "mpif90": 37, "mtune": 37, "mu": [20, 25, 27, 32, 51], "mu_": [23, 25, 31, 32], "mu_a": [31, 32], "mu_t": [32, 35], "much": [16, 35, 38, 51], "muelu": 47, "multi": [0, 20, 24], "multiphys": 26, "multipl": [6, 20, 26, 28, 36, 43], "multiscal": [29, 31], "multitud": 27, "muscl": 27, "must": [16, 18, 20, 21, 22, 25, 32, 35, 36, 37, 43, 51], "myhc": 43, "myoption": 43, "mytest": 14, "n": [19, 20, 21, 22, 23, 31, 32, 33, 36, 51], "n_": [32, 36], "n_b": 36, "n_every_checkpoint": [43, 46], "n_i": [20, 27, 29, 31, 32, 36, 51], "n_j": [20, 23, 31, 32, 36], "n_k": [20, 28, 32], "n_r": 36, "n_simpleblad": 51, "n_turbines_glob": [43, 46, 51], "n_x": 20, "n_y": 20, "na": 51, "nabla": [20, 32], "naca": 41, "naca0018": 41, "nacel": [28, 36], "nacelle_area": [43, 46], "nacelle_cd": [43, 46], "nalu": [1, 8, 9, 11, 12, 15, 17, 20, 22, 23, 26, 28, 29, 32, 35, 40, 41, 44, 51], "nalu_build_dir": 37, "nalu_output": 44, "nalu_root_dir": 37, "nalu_wind_dir": 14, "nalu_wind_testing_dir": 14, "naluwindutil": [36, 44], "nalux": [37, 43, 45, 48], "name": [13, 14, 19, 20, 21, 25, 37, 42, 43, 44, 45], "name_nod_var": 44, "nanosecond": 32, "nasa": [30, 32, 41], "nation": [36, 41, 51], "nativ": [24, 37], "natur": [14, 20, 23, 31, 35, 41], "navier": [36, 43], "ncdump": 44, "ndim": 21, "ne": [25, 32, 35], "nearest": [20, 36], "nearli": [36, 41, 51], "necessari": [28, 32, 36, 37, 38, 43, 51], "necessarili": [20, 36, 48], "need": [8, 13, 14, 20, 21, 23, 25, 28, 32, 36, 37, 38, 41], "neg": 31, "neglect": [20, 25, 32, 36, 51], "neglig": [20, 36], "neighbor": [18, 28], "neq": [20, 36], "nest": 16, "net": 20, "netcdf": [14, 44], "netcdf_root_dir": 37, "netlib": 14, "neutral": [20, 45], "new": [10, 14, 18, 21, 27, 28, 32, 37, 48], "newest": 38, "newli": 28, "newton": 36, "newtonian": 25, "next": [14, 36, 37, 38, 51], "ngp": [21, 51], "ni": 21, "nice": [37, 38], "nightli": [0, 14, 51], "nint": 32, "nm1": 21, "noc": 51, "nodal": [18, 19, 20, 21, 24, 27, 29, 31, 32, 44, 49], "node": [18, 19, 20, 21, 23, 27, 28, 31, 32, 33, 35, 36, 38, 41, 43, 44, 51], "node_bucket": 21, "node_rank": 21, "node_rel": 21, "nodeset": 21, "nomenclatur": [28, 36], "non": [0, 13, 18, 23, 24, 27, 30, 31, 32, 35, 36, 38, 41, 47, 49], "non_conformal_boundary_condit": 43, "non_conformal_user_data": 43, "nonconform": [0, 20, 49], "nondimension": 25, "nonetheless": 32, "nonlinear": [0, 22, 23, 24], "nor": 41, "norm": [14, 20, 51], "normal": [0, 19, 28, 31, 32, 35, 36, 49], "normal_temperature_gradi": [20, 36], "north": 32, "notabl": 51, "notat": [25, 32], "note": [14, 16, 19, 20, 21, 22, 23, 25, 27, 28, 29, 31, 32, 35, 36, 37, 38, 45, 47, 51], "noth": 48, "notic": 20, "notion": [29, 32], "novel": 16, "novelti": 41, "now": [23, 27, 31, 32, 37, 38, 42, 43, 48, 51], "np1": 21, "nrel": [12, 14, 36, 37, 39, 40, 51], "nso": [0, 24], "nu": [19, 20, 27, 32], "nu_": 32, "nu_t": 32, "nuanc": [18, 22], "null": 21, "nullptr": 21, "nullspac": 20, "num_force_pts_blad": [43, 46, 51], "num_force_pts_tow": [43, 46], "num_nod": 21, "num_swept_pt": 36, "number": [0, 19, 21, 22, 24, 27, 28, 29, 30, 31, 36, 41, 43, 44, 46, 51], "number_of_st": 21, "numer": [19, 20, 24, 32, 43, 51], "numip": 21, "numstat": 21, "o": [8, 20, 28, 36, 37, 39, 40, 45], "o2": 37, "o3": 37, "object": [32, 38, 50, 51], "observ": [20, 32, 51], "obstacl": 20, "obtain": [20, 21, 22, 23, 27, 29, 31, 32, 35, 36, 50, 51], "obukhov": 43, "obviou": 20, "occur": [18, 20, 21, 26, 28, 32, 51], "od": 32, "off": [20, 21, 32, 37, 51], "offici": [14, 38], "offset": 51, "often": [20, 32, 36, 50, 51], "oftentim": 20, "oga": 28, "ok": 41, "old": 37, "older": 37, "oliv": 32, "omega": [27, 32, 36, 51], "omega1": 32, "omega2": 32, "omega_": 32, "omega_ju_k": [32, 36], "omit": [20, 32], "onc": [14, 16, 21, 32], "one": [14, 18, 19, 20, 21, 23, 25, 28, 31, 32, 33, 35, 37, 38, 43, 44, 48, 51], "ongo": 32, "onli": [10, 14, 16, 20, 21, 23, 25, 27, 28, 29, 30, 32, 35, 36, 37, 42, 43, 44, 46, 51], "onset": 32, "onset1": 32, "onset2": 32, "onset3": 32, "onto": [32, 36], "oo": 27, "op": 20, "open": [0, 18, 21, 22, 24, 28, 29, 34, 36, 44, 47, 49], "open_boundary_condit": 43, "open_user_data": 43, "openfast": [0, 1, 12, 43, 46, 49], "openfast_root_dir": 37, "openfoam": 36, "openmp": 37, "openmpi": [14, 37, 38], "oper": [0, 18, 19, 20, 21, 22, 23, 24, 26, 31, 32, 34, 36, 49], "oppor": 21, "oppos": [20, 51], "opposit": [36, 49], "opt1": 43, "optim": [14, 23, 43], "option": [18, 19, 23, 27, 29, 32, 36, 37, 38, 40, 42, 44, 46, 47, 51], "orchestr": 43, "order": [0, 19, 20, 21, 22, 23, 25, 27, 29, 31, 32, 33, 36, 37, 41, 43, 44, 49, 50], "ordin": [31, 32], "orient": [20, 28], "origin": [14, 20, 23, 25, 28, 31, 32, 36, 41, 51], "orphan": 28, "orthogon": [20, 23, 51], "osx": [38, 39, 40], "other": [14, 17, 20, 21, 22, 23, 28, 31, 32, 33, 35, 36, 37, 40, 41, 43, 47, 50, 51], "otherwis": [16, 32, 35, 37, 50], "our": [14, 22, 23, 41, 51], "out": [14, 20, 28, 31, 32, 35, 37, 38, 41, 51], "outer": [22, 28, 36, 51], "outflow": [0, 36, 49], "outgo": 31, "outlet": [20, 43, 44], "outlfow": 20, "outlin": [19, 51], "output": [14, 16, 21, 32, 36, 44, 45, 47, 48, 51], "output_data_base_nam": 43, "output_format": 20, "output_frequ": 43, "output_level": 43, "output_node_set": 43, "output_vari": 43, "outsid": [31, 38], "outward": [20, 31, 32], "outwardli": 20, "over": [18, 20, 21, 23, 25, 28, 29, 32, 33, 35, 36, 43, 51], "overal": [20, 23, 25, 28, 35, 51], "overbar": 25, "overlap": 28, "overli": 51, "overlin": [20, 27, 32, 35], "overset": [0, 20, 24], "oversubscrib": 37, "oversubscribe_flag": 37, "overview": [20, 21, 32, 51], "overwrit": 14, "overwritten": 45, "own": [8, 14, 21, 26, 28, 37, 38, 51], "ownership": 21, "p": [20, 22, 23, 25, 27, 29, 32, 36, 45, 51], "p1": 51, "p1_zero_alpha_dir": 51, "p2": 51, "p_": [25, 32, 36], "p_0": 25, "p_1": [25, 51], "p_2": 51, "p_areavec": 21, "p_b": 32, "p_densiti": 21, "p_i": 32, "p_k": [20, 32], "p_o": 51, "pa": 51, "packag": [8, 14, 21, 28, 32, 37, 38, 51], "page": 37, "pair": [20, 43], "paolucci": 25, "paper": [22, 27, 29, 32, 41], "parabol": 49, "paralel": 44, "parallel": [14, 20, 24, 28, 44, 45, 49, 51], "parallel_netcdf_root_dir": 37, "param": 16, "paramet": [16, 19, 20, 25, 26, 27, 29, 31, 32, 43, 51], "paraview": [44, 47], "paraview_vers": 37, "paraviewcatalystiossadapt": 37, "parent": [18, 20], "part": [20, 23, 31, 32, 36, 43, 44], "parti": [12, 14, 38, 51], "partial": [19, 20, 23, 25, 27, 29, 31, 32, 33, 35, 36, 51], "partial_k": 32, "particip": [26, 28, 32, 43], "particl": 32, "particlar": 22, "particular": [14, 19, 20, 21, 26, 31, 32, 36, 43, 44, 51], "partit": 22, "partner": 32, "partvec_": 21, "pass": [14, 20, 32, 37, 41, 48], "past": [28, 51], "patch": [18, 21, 23, 51], "path": [8, 14, 37, 38, 41], "pathtompi": 37, "pathtonaluprojectdir": 37, "pde": [21, 27, 32, 35], "pe": 19, "peclet": [19, 27], "peer": 10, "peform": [10, 23], "penal": 20, "penalti": 20, "per": [14, 23, 28, 36, 51], "percept": [18, 44], "percis": 27, "perform": [20, 28, 32, 36, 41, 44, 51], "period": [21, 24, 32, 42, 47, 51], "periodic3d": 43, "periodic_user_data": 43, "permit": 34, "perpendicular": 20, "person": 16, "perspect": [36, 51], "perturb": [25, 27, 32, 36], "perus": 51, "phantom": 25, "phase": [24, 32, 37, 49], "phenomena": 32, "phi": [19, 20, 23, 27, 28, 32, 33, 35, 36, 51], "phi_": [19, 23, 51], "phi_0": 23, "phi_1": [23, 32], "phi_2": 32, "phi_h": 20, "phi_k": [19, 23, 28, 51], "phi_l": [23, 51], "phi_m": 20, "phi_r": [23, 51], "physic": [0, 13, 20, 21, 24, 29, 32, 35, 40, 41, 47, 51], "pi": [20, 31, 32, 36, 51], "pi_": 20, "picard": [22, 32, 36], "pick": 38, "piec": [23, 32], "piecewis": [20, 27, 31, 51], "piecwis": 51, "pimpl": 36, "pip": 8, "pip2": 8, "pipe": 51, "piv": 51, "pkg": 38, "place": [14, 18, 20, 28, 31, 37], "plan": 35, "plane": [20, 22, 32, 43, 44], "plant": 32, "plat": 37, "platform": 37, "pleas": [35, 37, 44], "plif": 51, "plot": [23, 51], "plu": 27, "plug": 21, "plume": 51, "pm": 32, "pmr": [20, 21, 26], "pnetcdf": 37, "png": 23, "point": [8, 19, 20, 21, 23, 26, 27, 28, 29, 31, 32, 33, 36, 38, 51], "pointer": 21, "pointwis": [21, 40, 44, 47], "poisson": [18, 20, 23, 32, 36, 37, 51], "polic": 13, "polymorph": 13, "polynomi": [23, 30], "poor": [23, 41, 51], "popul": 37, "porjectin": 22, "portion": [20, 32, 35, 41, 51], "pose": [20, 28], "posit": [20, 32, 36], "possibl": [13, 18, 20, 32, 38, 43, 46, 51], "possibli": [21, 37, 48], "post": [9, 11, 14, 20, 23, 28, 47, 51], "post_process": 43, "postul": 20, "potenti": [20, 36, 41], "potential_flow_bc": 20, "power": 50, "pprint": 45, "pr": [25, 32, 51], "practic": [0, 11, 20, 29, 50], "prandtl": [24, 25, 27, 51], "pre": [20, 21, 23, 32, 36, 38], "pre_iter_work": 32, "preceed": [20, 51], "precis": 21, "precondition": [37, 43, 47], "precurosr": 51, "precursor": [0, 32, 36, 49], "precusor": [36, 51], "predefin": 28, "predetermin": 32, "predict": [24, 31, 32, 35, 36, 49, 51], "predictor": [22, 36], "prefer": [20, 22, 25, 26, 27, 37, 38, 41], "prefix": [37, 42, 43], "preliminari": 44, "prepar": [37, 38], "prescrib": [20, 23, 32], "prescript": 20, "presenc": [20, 35, 36], "present": [20, 30, 32, 33, 35, 36, 43], "preserv": 41, "pressur": [0, 20, 21, 22, 23, 24, 25, 27, 32, 35, 36, 37, 41, 43, 49], "prevail": 32, "prevent": [20, 35, 41], "previou": [28, 32, 36, 51], "previous": [14, 32, 43, 51], "primari": [32, 36, 51], "primarili": 32, "prime": 20, "primer": 17, "primit": [23, 25, 29], "principl": 20, "print": [14, 44, 45, 48], "prior": 19, "priori": 51, "privat": [13, 16], "probabl": 32, "probe": 47, "problem": [0, 25, 27, 32, 35, 36, 37, 38, 41, 43, 49, 50], "problemat": 51, "proce": [28, 32], "procedur": [18, 20, 23, 28, 32, 35, 36], "proceed": 20, "process": [9, 11, 14, 16, 20, 23, 28, 32, 36, 37, 47, 50, 51], "procno": [43, 46], "produc": [32, 37, 41], "product": [10, 19, 20, 27, 29, 32, 37, 51], "profil": [20, 32, 36, 38, 43, 49], "program": [20, 28, 44], "program_opt": 37, "project": [0, 11, 12, 19, 20, 21, 22, 24, 29, 32, 36, 37, 44, 49], "prolong": 24, "promot": [23, 44], "prone": 27, "proof": 23, "propag": [14, 25, 32], "proper": [21, 32, 51], "properli": [35, 51], "properti": [0, 20, 24, 25, 31, 32, 35, 47, 49], "proport": [25, 30, 32, 35, 36], "propos": [27, 36, 50], "protect": 16, "prototyp": [18, 20, 24, 49], "prove": 51, "provid": [6, 14, 16, 19, 20, 21, 23, 27, 28, 29, 30, 31, 32, 35, 36, 37, 38, 43, 44, 45, 47, 50, 51], "provision": 29, "pseudo": 19, "psi": [16, 20], "psi_h": 20, "psi_m": 20, "psuedo": [19, 23], "public": [12, 16, 23, 32, 41], "pull": [10, 12], "pundit": 28, "pure": [19, 23, 24, 51], "purg": 38, "purpos": [21, 32, 36, 43], "push": [10, 12, 41], "put": 21, "put_field_on_mesh": 21, "pyramid": [34, 41, 51], "python": [8, 37, 38], "q": [20, 25, 32, 36], "q_": 20, "q_i": [25, 32], "q_j": [20, 25, 31, 32, 36], "q_n": 20, "qquad": 32, "quad": [18, 20, 23, 25, 32, 34, 35, 36, 41], "quadrat": [23, 51], "quadratur": [23, 31, 49], "quadrilater": 23, "qualiti": [19, 23, 41], "quantit": 50, "quantiti": [19, 20, 21, 23, 31, 32, 51], "queri": 51, "question": [16, 20, 44, 51], "quickli": 38, "quit": 50, "r": [14, 19, 23, 25, 27, 29, 31, 32, 36, 41, 51], "r0": 51, "r1": 51, "r2": 51, "r3": 51, "r4": 51, "r_": [19, 32], "r_j": [19, 36], "r_k": [27, 32], "r_t": 32, "radi": [20, 24, 31], "radial": 36, "radiat": [26, 31, 32], "radiatit": 32, "radii": 36, "radiu": 36, "ran": [19, 20, 24, 36], "rang": [22, 23, 33, 44, 51], "rangl": [20, 32], "rank": [21, 28, 44, 45], "rank_t": 21, "rans_abl_bc": 20, "rans_below_k": 20, "rare": [23, 32], "rate": [18, 20, 21, 27, 29, 32, 35, 36, 41, 51], "rather": [16, 18, 20, 27, 32, 35, 51], "ratio": [23, 25, 32, 36, 41, 51], "raw": 19, "rcb": 43, "re": [20, 25, 27, 32, 38], "re_": 32, "re_v": 32, "reaction": 32, "read": [16, 21, 36, 41, 51], "readabl": 16, "reader": [16, 27, 32, 35], "readili": 23, "readthedoc": 17, "real": 16, "realiz": [23, 31, 32, 51], "realli": [32, 38], "realm": [9, 13, 20, 23, 26, 32, 40, 47, 51], "realm_": 21, "realm_1": 43, "reason": [32, 41], "reat": 22, "rebuild": [12, 38], "recal": 32, "recent": [20, 22, 23, 32, 51], "recept": 28, "receptor": 28, "recev": 28, "recipi": 28, "recogn": 23, "recommend": [16, 23, 37, 38], "reconstruct": [18, 29], "recov": [20, 51], "recoveri": 21, "rectangular": 28, "recurs": 14, "recycl": 51, "recylc": 51, "red": 51, "redirect": 45, "reduc": [20, 23, 28, 31, 32, 51], "reduct": [23, 28, 32], "ref": [20, 32, 51], "refer": [0, 10, 17, 20, 21, 27, 28, 30, 32, 35, 36, 37, 40, 43, 47, 51], "referenc": 51, "reference_height": 20, "reference_temperatur": 43, "reference_veloc": 20, "refin": [18, 20, 28, 41, 44, 50, 51], "refinementerror": 51, "reflect": [14, 32], "reg_test": [14, 48], "regard": [14, 43], "regardless": 32, "regex": 37, "regim": [20, 51], "region": [20, 27, 28, 32, 35, 36, 41, 51], "regist": 21, "register_edge_field": 21, "register_nodal_field": 21, "register_wall_bc": 21, "registr": 13, "regress": [10, 14, 39, 40, 51], "regular": [14, 51], "rehm": 25, "rel": [20, 22, 23, 32, 41, 51], "relat": [14, 20, 21, 23, 25, 32, 35, 36, 43], "relationship": [20, 21, 31, 32], "relax": [22, 23, 27, 32, 36], "relaxation_factor": [20, 42, 43], "releas": [8, 37, 38], "relev": 44, "reli": 32, "remain": [25, 32, 50, 51], "remedi": [32, 34, 51], "remov": [13, 18, 20, 28, 37, 44], "render": 43, "renew": [36, 51], "repeat": [19, 25, 35], "replac": 32, "replic": 35, "repo": [8, 14, 17, 37, 38], "repo_url": 14, "report": 41, "repositori": [8, 14], "repres": [19, 20, 21, 22, 23, 24, 26, 27, 31, 32, 33, 35, 36, 41, 43, 49, 51], "represent": [20, 32, 36, 50], "reproduc": 36, "request": [10, 12, 43, 44], "requir": [14, 16, 18, 20, 21, 23, 25, 26, 27, 28, 29, 31, 32, 35, 36, 37, 38, 41, 43, 44, 47, 50, 51], "reres": 6, "rerun": 14, "research": [24, 28, 32, 49], "resembl": 27, "resid": 20, "residu": [20, 23, 24, 29, 31], "resolut": [20, 31, 32, 35, 41, 51], "resolv": [20, 21, 25, 31, 32, 35, 36, 41], "resourc": 32, "respect": [18, 20, 23, 32, 36, 51], "respons": [19, 26, 32], "restart": [44, 46, 47], "restart_filenam": [43, 46], "restartdriverinitfast": [43, 46], "restor": 36, "restrict": [20, 24, 36, 41, 51], "restructur": 17, "result": [0, 12, 14, 16, 19, 20, 22, 23, 25, 27, 28, 31, 32, 35, 36, 41, 43, 47, 49], "retain": [20, 32, 36, 51], "retent": 31, "return": [13, 16], "reus": 12, "reveal": 50, "revers": 44, "review": [10, 24, 36, 51], "revis": 14, "rex": 41, "reynold": [22, 23, 25, 32, 36, 51], "rf": 37, "rho": [19, 20, 23, 25, 27, 29, 32, 33, 35, 36, 51], "rho_": [20, 25, 32, 36], "rich": 32, "right": [16, 18, 19, 20, 22, 23, 25, 29, 31, 32, 35, 36, 51], "rigor": 50, "rm": [19, 20, 25, 31, 32, 36, 37, 51], "roach": 50, "robust": 23, "rodi": 32, "rogallo": 35, "role": 24, "roll": 38, "root": [20, 31], "rotat": [28, 32, 36], "rotor": [28, 36, 41], "rotorcraft": 41, "rough": [20, 36], "roughness_height": [20, 43], "round": [41, 51], "routin": [20, 21, 28], "row": [19, 20, 23, 28, 37], "rst": 17, "rte": [0, 20, 24, 26, 27, 32], "rule": [23, 51], "run": [0, 10, 11, 12, 13, 22, 23, 27, 35, 37, 38, 40, 43, 46, 51], "runtim": [37, 45], "runtime_error": 21, "rush": 10, "s_": [23, 27, 32, 35], "s_i": [20, 31, 32], "s_j": 31, "s_locally_owned_union": 21, "s_sourc": 20, "sai": 20, "sake": 22, "salmon": 28, "same": [14, 18, 20, 21, 22, 23, 25, 28, 32, 35, 37, 42, 43, 51], "sampl": [16, 20, 36, 43], "sand": 20, "sandia": 41, "satisfi": [18, 36], "satisifi": 14, "save": [21, 36, 51], "sc": [32, 51], "scalar": [20, 27, 31, 32, 44], "scalarfieldtyp": 21, "scale": [20, 22, 23, 24, 25, 27, 29, 31, 35, 36, 41, 43, 51], "scatter": [31, 32], "scenario": 43, "schemat": [36, 51], "scheme": [18, 19, 20, 21, 22, 23, 24, 27, 29, 31, 32, 33, 34, 43, 50, 51], "schmidt": [24, 27], "schneider": 23, "scienc": 37, "scope": 21, "script": [14, 37, 38], "seaca": [37, 44], "search": [20, 24, 36, 43, 51], "search_method": [43, 46, 51], "search_target_part": [43, 46, 51], "sec": [32, 36], "second": [19, 20, 22, 23, 27, 31, 32, 33, 36, 43, 51], "second_order_accuraci": 43, "secondari": [32, 51], "section": [10, 20, 21, 27, 28, 30, 31, 32, 35, 36, 41, 43, 44, 47, 51], "sector": [18, 24, 26, 49], "see": [12, 14, 19, 20, 21, 23, 27, 32, 35, 36, 38, 43, 44, 51], "seek": 32, "seem": [20, 22, 27], "seen": [14, 51], "segment": [23, 36], "segreg": 22, "select": [20, 21, 25, 28], "selectunion": 21, "senc": 23, "sens": [14, 16, 20], "sensit": [22, 23, 28, 32, 51], "sent": 36, "separ": [14, 20, 28, 35], "seri": [18, 25, 29, 41, 51], "serial": 37, "serv": [21, 41, 43, 44, 51], "servo": [36, 51], "set": [0, 6, 14, 16, 18, 19, 20, 21, 23, 24, 25, 26, 27, 28, 29, 31, 35, 36, 37, 38, 41, 43, 44, 46, 47, 51], "set_field_output_typ": 21, "setup": [13, 28, 36, 38, 43, 47], "seven": 23, "sever": [32, 35, 38, 43, 44, 45], "sf": 36, "sg": [18, 23, 24, 27, 32, 43], "sget": 32, "sgr": 32, "sh": [37, 38], "shade": 51, "shakib": 27, "shape": [18, 20, 23, 51], "share": [21, 26, 27, 37, 38], "shared_constraint": 38, "sharper": 27, "shear": [20, 25, 35], "shell": 38, "shen": 36, "shift": [19, 23, 29, 51], "short": 20, "shorten": 38, "shorter": [32, 51], "should": [8, 14, 16, 20, 21, 27, 28, 32, 35, 37, 38, 41, 42, 43, 48, 51], "show": [14, 16, 28, 32, 36, 37, 41, 43, 44, 51], "shown": [14, 16, 18, 19, 20, 23, 27, 28, 31, 32, 36, 37, 38, 43, 51], "side": [18, 20, 21, 32, 43, 44, 51], "side_rank": 21, "siderank": 21, "sideset": 21, "sierra": [1, 6, 24, 31, 38, 49, 51], "sigma": [20, 31, 32], "sigma_": 32, "sigma_k": 32, "sign": [20, 51], "signal": [25, 37], "signifi": 29, "signific": [36, 51], "significantli": [21, 32, 35, 51], "silli": 13, "sim": 20, "sim1": 43, "similar": [14, 18, 20, 22, 31, 35, 36, 37, 51], "similarli": 32, "simpl": [20, 21, 22, 23, 28, 30, 32, 33, 35, 36, 44, 49], "simplest": [20, 32, 44, 47], "simpli": [19, 20, 21, 23, 27, 28, 29, 31, 32, 33, 34, 35, 51], "simplic": 35, "simplif": 51, "simplifi": [20, 32, 35, 51], "simstart": [43, 46], "simul": [0, 1, 9, 11, 20, 22, 24, 25, 28, 35, 36, 40, 44, 46, 47, 49], "sin": [20, 32, 51], "sinc": [14, 20, 21, 25, 31, 32, 35, 50, 51], "singl": [14, 20, 21, 23, 30, 32, 36, 44, 51], "singular": 25, "site": 14, "situ": [37, 44, 47], "situat": [20, 32, 38, 51], "siumul": 51, "six": 44, "size": [20, 21, 32, 35, 36, 41, 51], "size_t": 21, "size_typ": 21, "sketch": 20, "skew": [19, 23, 41, 51], "skin": 28, "skip": [8, 37, 48], "slab": 20, "slave": 20, "slice": 32, "slide": 20, "slight": [20, 51], "slightli": [22, 41], "slip": [20, 36, 41, 51], "slope": 51, "slow": 22, "slowdown": 22, "smagorinski": [24, 32, 36], "small": [20, 21, 25, 32, 35, 41], "smaller": [32, 35, 51], "smallest": 35, "smooth": [20, 30, 32], "smoother": 20, "smoothli": 32, "snapshot": [12, 38], "snippet": [43, 44], "snl": 23, "so": [14, 16, 23, 25, 32, 35, 36, 37, 38, 43, 51], "soft": 32, "softwar": [14, 44], "sole": [6, 23], "solid": [23, 24, 28, 51], "solonoid": 23, "solut": [19, 20, 23, 28, 32, 35, 36, 44, 47, 50, 51], "solution_norm": 43, "solution_opt": [20, 43], "solutionnormpostprocess": 13, "solv": [6, 20, 21, 22, 23, 26, 28, 29, 31, 32, 35, 36, 37, 43, 47, 50, 51], "solve_scalar": 43, "solver": [9, 11, 20, 36, 37, 40, 47], "solver_system_specif": 43, "some": [8, 12, 13, 20, 21, 23, 26, 32, 36, 37, 38, 41, 44, 51], "someprotectedmethod": 16, "someth": [8, 16, 37, 38, 41], "sometim": 35, "soon": 51, "soot": 32, "sophist": 51, "sorensen": 36, "sort": 21, "sourc": [0, 11, 12, 16, 20, 24, 27, 28, 31, 36, 37, 38, 42, 43, 44, 49], "source_term": 20, "sowfa": 36, "space": [20, 25, 28, 32, 35, 36, 41, 50, 51], "spack": [8, 12, 14, 37, 39, 40], "spack_root": 38, "spalart": 32, "span": 51, "spanwis": 20, "spatial": [21, 23, 25, 32, 35, 51], "spatial_dimens": 21, "speak": 21, "spec": 20, "speci": [24, 30], "special": [6, 13, 16, 18, 20, 23, 43], "specif": [18, 19, 21, 22, 23, 24, 25, 27, 28, 31, 32, 37, 38, 43, 44, 46, 51], "specifi": [0, 19, 23, 32, 36, 38, 43, 49], "specific_heat": 43, "spectral": 23, "spectrum": 32, "speed": [22, 25, 32, 51], "sphere": 28, "sphinx": [8, 16, 17], "sphinx_rtd_them": 8, "sphinxcontrib": 8, "split": [18, 20, 21, 24, 25, 26, 31, 35, 36, 51], "spread": [36, 51], "sqrt": [16, 20, 25, 27, 32, 36, 51], "squar": [20, 25, 31, 35, 41], "src": 37, "ss_name": 44, "sst": 24, "sstamsaveragesalg": 32, "stabil": [0, 20, 23, 24, 32, 43, 51], "stabl": [20, 23, 51], "stabli": [20, 51], "stage": 38, "stai": 25, "standard": [19, 20, 21, 22, 23, 24, 27, 30, 31, 32, 36, 51], "standardtimeintegr": 43, "start": [19, 20, 31, 32, 37, 43, 46], "start_tim": 43, "state": [14, 19, 20, 23, 25, 28, 32, 33, 51], "statement": 31, "staten": 21, "statenm1": 21, "statenp1": 21, "static": [20, 26, 27, 32, 51], "static_cast": 21, "station": 51, "stationari": [36, 51], "statist": [35, 36, 47, 51], "statu": [21, 28], "std": [21, 37], "steadi": [0, 9, 22, 32, 49], "steady_2d_therm": 43, "steep": 41, "stencil": [19, 20, 23, 51], "step": [20, 22, 24, 28, 29, 32, 37, 47, 51], "stiff": 32, "still": [27, 32, 36, 51], "stk": [20, 21, 24, 26, 51], "stk_doc_test": 51, "stk_kdtree": [43, 46, 51], "stoke": [25, 36, 43], "stop": [43, 46], "storag": 29, "store": [20, 29, 32, 44], "straight": [32, 36], "straightforward": 35, "strain": [27, 32, 35], "strategi": 28, "stratif": [0, 20, 49], "stratifi": [20, 36, 49], "stream": [32, 36], "streamlin": 36, "streamwis": [20, 51], "strength": 20, "stress": [24, 25, 27, 36], "strickli": 23, "stricter": 41, "string": [21, 37, 45], "strong": [24, 32], "stronger": 20, "strongli": [20, 23, 36], "structu": 41, "structur": [20, 21, 23, 24, 31, 32, 35, 36, 41, 44, 47, 49, 51], "studi": [22, 51], "style": [0, 11, 12], "sub": [18, 19, 20, 23, 32, 36, 43], "subcontrol": [19, 23, 27, 29, 51], "subgrid": [24, 27, 35, 36], "sublay": 20, "submit": 14, "submodul": [14, 48], "subsect": [42, 43], "subsequ": [21, 36, 44, 49], "subset": [6, 14, 20, 25, 43, 51], "substantail": 23, "substitut": [20, 23, 31, 32], "subtl": 32, "subtract": [20, 25, 27, 32], "succe": 38, "success": [32, 48, 50, 51], "successfulli": [8, 38], "sucv": 31, "sudo": 8, "suffer": 51, "suffici": 28, "suggest": [15, 20, 25, 27], "suit": [10, 24, 51], "suitabl": [19, 27, 28, 31], "sum": [19, 23, 28, 29, 31, 32, 51], "sum_": [20, 27, 32, 36], "summari": [22, 48], "summat": [25, 36], "summer": 20, "superbuild": 37, "superior": 51, "superlu": 14, "superlu43": 37, "superlu_4": 37, "superlu_root_dir": 37, "superluroot": 37, "supg": 24, "supplement": 32, "suppli": [20, 32, 36], "support": [0, 10, 18, 19, 21, 23, 24, 26, 27, 28, 29, 30, 35, 36, 37, 38, 41, 44, 49, 51], "sure": 37, "surfac": [19, 21, 23, 24, 26, 27, 28, 29, 31, 32, 36, 47, 51], "surface_1": [21, 43], "surface_2": 43, "surface_6": 43, "surface_7": 43, "surface_77": 43, "sust": 32, "sutherland": 30, "sweep": 36, "swept": 36, "switch": 20, "symbol": 32, "symmetr": [19, 27, 31, 41], "symmetri": [21, 24, 34, 36, 47, 51], "symmetry_bc_penalty_factor": 20, "symmetry_boundary_condit": [20, 43], "symmetry_typ": 20, "symmetry_user_data": [20, 43], "syntax": [16, 20], "syrinx": 31, "system": [9, 11, 12, 18, 20, 21, 22, 23, 26, 28, 32, 33, 36, 37, 38, 41, 47, 50, 51], "t": [8, 14, 16, 20, 23, 25, 27, 29, 31, 32, 33, 35, 36, 37, 41, 43, 46, 51], "t_": [20, 25, 27, 32, 51], "t_0": 51, "t_end": [43, 46], "t_i": 20, "t_max": [43, 46], "t_start": [43, 46], "t_w": [20, 32], "t_x": 20, "tab": 13, "tabl": [19, 20, 30, 32, 43, 51], "tabul": 51, "tag": [20, 28], "tailor": 16, "takahashi": 41, "take": [18, 19, 20, 23, 27, 31, 32, 42, 43, 48, 51], "taken": [20, 32, 35], "tall": 51, "talor": 51, "tan": 20, "tangeant": 19, "tangenti": 20, "tanh": [19, 32], "tap": 37, "tar": [32, 37, 38], "target_nam": [20, 43], "target_part_format": [42, 43], "targetnam": 21, "targetpart": 21, "tau": [20, 22, 24, 25, 27, 29, 32, 36], "tau_": [20, 23, 25, 31, 32, 36], "tau_1": 36, "tau_2": [22, 36], "tau_3": [22, 36], "tau_i": 22, "tau_w": 20, "taylor": [0, 9, 32, 49], "team": 36, "technic": 41, "techniqu": [18, 23, 25, 32, 50, 51], "tee": 37, "temperatur": [0, 25, 28, 30, 32, 36, 42, 43, 49], "temperaur": 36, "templat": [13, 21, 38], "tempor": [32, 35, 49], "temporari": 14, "ten": 51, "tensor": [23, 25, 27, 31, 32, 35], "tensori": 32, "ter": 35, "term": [19, 20, 22, 24, 25, 27, 28, 29, 31, 35, 36, 41, 43, 49], "termin": 20, "termination_step_count": 43, "terrain": [20, 32, 43], "test": [0, 10, 11, 18, 20, 21, 23, 24, 27, 32, 37, 38, 39, 40, 41, 49], "test01": [43, 46], "test02": [43, 46], "test_fil": [14, 48], "testb": 21, "tet": [20, 28, 34, 41, 51], "tet4": 20, "tetrahedr": [18, 41, 51], "tetrahedra": 41, "text": [16, 17, 20, 32], "textrm": [36, 51], "tg": 32, "th": [20, 25, 27, 32], "than": [20, 22, 23, 28, 31, 32, 35, 41, 43, 51], "theeqsi": 43, "thei": [14, 18, 20, 22, 23, 25, 32, 35, 36, 37, 38, 50, 51], "them": [13, 18, 21, 22, 32, 37, 38, 47, 48], "themselv": 28, "theoret": [32, 36], "theori": [0, 23, 27, 32, 36, 51], "theory_abltop_bc": 20, "theprivatedata_": 13, "therebi": 31, "therefor": [8, 14, 19, 20, 21, 23, 27, 28, 29, 31, 35, 36, 38, 41, 44, 51], "therfor": 20, "thermal": [0, 9, 21, 24, 25, 26, 31, 49], "thermal_conduct": 43, "thermodynam": [25, 32], "thermophys": 25, "theta": [16, 20, 32, 36], "theta_": [20, 32], "theta_i": 36, "thetopo": 21, "thexahedr": 51, "thi": [8, 10, 12, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 29, 31, 32, 33, 35, 36, 37, 38, 41, 43, 45, 47, 48, 49, 51], "thick": [20, 32, 36], "thicker": 20, "thin": [20, 32, 51], "thing": [12, 16, 37], "third": [12, 14, 19, 23, 38, 51], "thorough": 36, "those": [20, 21, 25, 28, 36, 41], "thread": 37, "three": [20, 28, 30, 32, 33, 51], "threshold": 36, "through": [18, 20, 21, 23, 26, 31, 32, 36, 38, 41, 51], "throughout": [32, 51], "throw": [21, 37], "thu": [20, 22, 23, 32, 36, 50], "thurgood": 31, "ti_1": 43, "tieszen": 32, "tild": [19, 20, 31, 35], "time": [0, 9, 13, 14, 17, 20, 22, 24, 25, 27, 29, 32, 35, 38, 40, 41, 44, 46, 47, 50, 51], "time_integr": 43, "time_step": 43, "time_step_control": 43, "time_step_count": 43, "time_stepping_typ": 43, "timescal": 32, "timestep": [32, 36, 43, 51], "tioga": 24, "tioga_root_dir": 37, "tiom": 51, "tip": [40, 47, 51], "tipe": 41, "tke": [32, 36], "tmdot": 21, "togeth": [20, 25], "toler": [14, 35, 43], "too": 16, "tool": [11, 20, 24, 28, 32, 36, 38, 44, 49, 51], "toolkit": [24, 49, 51], "top": [9, 11, 14, 23, 24, 43, 51], "topolog": [0, 18, 24], "topologi": [9, 18, 20, 21, 23, 28, 33, 41, 51], "topwal": 44, "tossa": 36, "tossas2017": 36, "tot": 32, "total": [20, 25, 32, 36, 41, 44, 51], "total_pressur": 43, "touch": [21, 32], "tow": 20, "toward": 12, "tower": [36, 41, 43], "tpetra": [24, 43, 49], "tpl": [14, 20, 28, 37, 38], "tquad": 51, "tquad4": 51, "trac": 37, "traceless": 32, "track": 36, "tradeoff": 35, "tradit": [18, 24, 32, 41, 49], "trail": 41, "tran": 19, "transfer": [9, 20, 21, 26, 28, 32, 36, 40, 47, 51], "transform": [20, 27, 32, 47], "transient": [22, 32, 51], "transit": [18, 19, 24, 35, 36, 41], "transition": 22, "translat": 43, "transmiss": 32, "transport": [18, 19, 20, 24, 26, 27, 29, 30], "treat": [18, 20, 32], "treatment": [32, 36], "tri": [34, 38], "triangular": [41, 51], "trigger": 36, "trilino": [8, 14, 21, 24, 38, 44, 47, 49, 51], "trilinos_install_dir": 14, "trilinos_root_dir": 37, "tripl": 32, "tropic": 32, "troubl": 21, "true": [20, 32], "truerestart": [43, 46], "truli": 16, "truncat": 44, "try": [13, 38], "tucker2003": 32, "tune": 35, "tunnel": 41, "turb": 32, "turb_id": [43, 46], "turbin": [1, 20, 24, 28, 32, 47, 51], "turbine0": [43, 46], "turbine1": [43, 46], "turbine_base_po": [43, 46], "turbine_hub_po": [43, 46], "turbine_nam": [43, 46], "turbkineticenergi": 21, "turbul": [0, 21, 22, 23, 24, 44, 47, 49, 51], "turbulence_averag": 43, "turbulent_k": 44, "turn": [20, 37, 51], "twenti": 51, "twist": 51, "twist_tabl": 51, "two": [12, 18, 19, 20, 21, 23, 25, 28, 30, 31, 32, 36, 42, 43, 44, 51], "txt": [14, 37], "type": [6, 14, 19, 20, 21, 25, 30, 35, 36, 42, 43, 46, 51], "typic": [18, 21, 26, 32, 35, 36, 37, 41, 51], "u": [16, 20, 22, 25, 29, 32, 36, 51], "u_": [19, 20, 25, 32, 36, 51], "u_h": 20, "u_i": [19, 20, 23, 25, 27, 29, 32, 35, 36], "u_j": [19, 20, 23, 25, 27, 32, 35, 36], "u_k": [25, 27, 32, 35], "u_n": 32, "u_o": 51, "u_ot": 51, "u_t": 16, "u_u": 32, "u_x": 23, "ubuntu": 12, "ultim": 14, "un": [19, 27], "unam": 37, "unbeliev": 16, "unchang": 32, "uncomfort": 38, "under": [20, 32, 35, 36, 38, 43, 51], "underbrac": 36, "underli": [21, 23, 32, 51], "underscor": 13, "understand": [18, 36, 41, 44, 47], "understood": 32, "underwai": [27, 31], "unfortun": 51, "uniform": [0, 20, 22, 27, 30, 36, 49], "uniformli": [20, 36, 51], "uniqu": [20, 32], "unit": [10, 12, 14, 20, 21, 27, 32, 36, 39, 40, 49], "uniti": [19, 20, 22, 24, 28, 30, 31, 51], "unittestx": 48, "unknown": [32, 50], "unless": [13, 20, 51], "unlik": [20, 28, 35, 43], "unrefin": 18, "unresolv": 32, "unscal": 25, "unspecifi": [43, 46, 51], "unsplit": 25, "unstabl": 20, "unsteadi": [0, 35, 49], "unstructur": [18, 21, 23, 24, 41, 49, 51], "until": 51, "unus": 43, "unweight": 35, "uo": 12, "up": [21, 22, 23, 28, 32, 36, 38, 41, 44, 47], "updat": [17, 36, 48], "upper": [20, 23, 36, 51], "upstream": [20, 36, 41], "upw": [19, 27], "upward": 21, "upwind": [19, 20, 23, 24, 27], "urg": 36, "us": [8, 9, 12, 13, 14, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 27, 29, 30, 31, 32, 33, 35, 36, 37, 41, 43, 44, 45, 50, 51], "usag": [18, 19, 20, 23, 24, 26, 27, 31, 43, 49, 51], "use_abl_wall_funct": 43, "use_consolidated_solver_algorithm": 43, "use_edg": [23, 43], "useless": 41, "user": [0, 11, 16, 19, 20, 21, 22, 28, 32, 36, 37, 38, 43, 44, 45, 47, 51], "user_const": 20, "user_data": 36, "user_function_nam": 43, "usr": 37, "usual": [32, 35, 36, 38, 41], "util": [8, 9, 11, 14, 36, 38, 40, 47], "v": [16, 20, 28, 31, 32, 35, 36, 44, 45, 51], "v7": 37, "v_i": 32, "v_j": 32, "v_k": 32, "v_o": 51, "v_ot": 51, "valid": [20, 28, 32, 51], "valu": [16, 18, 19, 20, 23, 27, 28, 29, 30, 31, 32, 33, 35, 36, 43, 51], "van": 19, "varepsilon": [32, 51], "vari": [14, 19, 20, 25, 32, 35, 36, 43, 51], "variabl": [18, 19, 20, 22, 23, 24, 25, 32, 35, 37, 42, 43, 44, 49], "variabledensitymm": 51, "variat": [20, 25, 29, 31, 32, 35, 36], "varibal": 28, "varieti": [18, 21, 23, 24, 31, 49, 50, 51], "variou": [16, 20, 32, 43, 44, 45, 47, 48], "varphi": 20, "vast": 32, "ve": 38, "vec": [20, 36], "vector": [19, 20, 21, 23, 25, 32, 36, 43, 44, 51], "vector_3d": 21, "vectorfieldtyp": 21, "veloc": [20, 21, 22, 23, 25, 27, 28, 29, 32, 35, 36, 43, 44], "velocity_i": [20, 44], "velocity_x": [20, 44], "velocity_z": [20, 44], "velocityrtm": 21, "verbos": [14, 45], "veri": [20, 21, 22, 23, 27, 51], "verif": [0, 10, 23, 36, 50], "verifi": [39, 40, 51], "version": [12, 14, 17, 37, 38, 45, 51], "vertex": [18, 20, 23, 31, 36, 51], "vertic": [20, 32, 36], "veryusefulmethod": 16, "vi": 36, "via": [6, 19, 20, 27, 32, 43], "viabl": 27, "vicin": 41, "view": [23, 27, 29, 32, 41], "vii": 36, "viii": 36, "virtual": [20, 21], "viscos": [20, 24, 25, 27, 32, 43, 51], "viscou": [20, 23, 25, 32, 36, 41, 51], "visit": 44, "visual": [37, 44, 47], "visualizatt": 28, "vm": [27, 29, 31], "void": [16, 21], "volum": [18, 20, 21, 23, 26, 28, 30, 31, 32, 33, 35, 36, 41, 51], "volumetr": [23, 36], "von": 20, "vortex": [0, 9, 32, 41, 49], "vortic": [28, 32], "vv": 14, "w": [20, 23, 25, 27, 31, 32, 41, 51], "w_i": [23, 31, 51], "w_k": 31, "w_o": 51, "wa": [21, 22, 27, 28, 31, 32, 41, 45, 48, 51], "wai": [14, 20, 35, 38, 41, 51], "wait": 38, "wake": 36, "wale": [24, 32], "walk": 21, "wall": [21, 22, 24, 41, 47, 51], "wall_boundary_condit": [20, 43], "wall_friction_velocity_bip": 21, "wall_user_data": [20, 43], "wallbcdata": 21, "wallboundaryconditiondata": 21, "wallfrictionvelocitybip": 21, "wallfrictionvelocitybip_": 21, "wallfunctionapproach": 21, "want": [21, 32, 38], "wave": [20, 25, 32], "wavelength": 32, "wavenumb": 20, "we": [8, 10, 13, 14, 20, 21, 22, 23, 30, 31, 32, 36, 37, 38, 41, 51], "weak": [24, 31, 32], "weakli": 20, "websit": [14, 17], "wedg": [34, 41, 51], "weigh": [30, 35], "weight": [25, 30, 31, 36], "well": [8, 12, 14, 20, 25, 28, 36, 38, 41, 43, 44], "were": [22, 27, 41, 51], "what": [20, 21, 27, 37, 38], "whatev": [14, 38], "when": [10, 13, 14, 18, 20, 21, 22, 23, 27, 28, 29, 30, 31, 32, 36, 37, 38, 43, 46, 51], "where": [14, 19, 20, 22, 23, 25, 27, 28, 31, 32, 33, 35, 36, 37, 43, 44, 45, 50, 51], "wherea": [20, 22], "wherebi": [18, 23, 30, 32], "whereby": 29, "whether": [14, 18, 20, 32], "which": [8, 12, 14, 18, 19, 20, 21, 22, 23, 26, 27, 28, 31, 32, 35, 36, 37, 38, 41, 42, 43, 51], "while": [14, 19, 20, 21, 25, 27, 28, 32, 35, 41, 51], "white": [20, 28], "who": 16, "whose": [23, 27, 32, 35], "wide": 51, "widehat": 36, "widetild": [32, 36], "width": [19, 36, 51], "wilcox": 32, "wilcox1998turbul": 32, "win": 22, "wind": [1, 8, 11, 12, 15, 17, 20, 22, 23, 26, 28, 29, 32, 35, 40, 41, 44, 51], "wing": [0, 41, 49], "wingtip": 41, "wise": [23, 51], "wish": [32, 37], "within": [18, 19, 20, 21, 23, 28, 31, 32, 36, 37, 43, 44, 51], "without": [31, 35, 36, 37, 41, 51], "word": [22, 35, 51], "work": [18, 23, 25, 27, 28, 31, 32, 36, 37, 38, 39, 40, 43, 45, 51], "workflow": [0, 11, 12, 38], "workset": 21, "would": [8, 14, 18, 21, 27, 32, 36, 50], "wrf": [32, 36], "wrftonalu": 36, "write": [0, 11, 22, 27, 28, 29], "written": [16, 17, 19, 20, 22, 23, 25, 27, 28, 29, 32, 33, 36], "www": 16, "x": [8, 19, 20, 23, 25, 31, 32, 35, 36, 37, 39, 40], "x86_64": 38, "x_": [19, 32], "x_1": 16, "x_2": 16, "x_i": [23, 25, 27, 29, 31, 32, 35], "x_j": [19, 20, 23, 25, 27, 29, 31, 32, 35, 36, 51], "x_k": [25, 27, 32, 35], "xf": 37, "xi": [16, 27], "xi_1": 27, "xi_2": 27, "xi_3": 27, "xi_k": 27, "xl": 20, "xml": [13, 14, 47], "xvf": 37, "xxx": 25, "xxxxxxi": 25, "y": [20, 23, 32, 36], "y_1": 16, "y_2": 16, "y_k": 32, "y_kj": 32, "y_p": 20, "yaml": [8, 14, 38, 43, 47, 48], "yaml_cpp_root_dir": 37, "yaml_install_dir": 14, "ye": [20, 23, 43], "yellow": 28, "yet": [10, 13, 18, 20, 26, 38], "yield": [19, 20, 28, 31, 32, 35, 51], "yoshizawa": 32, "you": [13, 14, 16, 37, 38, 48], "young": 32, "your": [8, 13, 17, 32, 37, 38, 48], "your_path": 37, "yourself": [37, 38], "z": [19, 20, 32, 36], "z_0": [20, 51], "z_direction_strong": 20, "z_o": 51, "z_sampl": 20, "zenith": 32, "zero": [19, 20, 25, 27, 31, 32, 35, 36, 51], "zeroeth": 25, "zlib": 14, "zlib_root_dir": 37, "zn": 32, "zone": 28, "zxvf": 37}, "titles": ["Nalu-Wind Documentation", "Actuator Sources", "Equation Systems", "Linear Solvers and Systems Interface", "CVFEM and FEM Interface", "Post-Processing Utilities", "Simulation \u2013 Nalu Top-level Interface", "Auxiliary Functions", "Building the Documentation", "Source Code Documentation", "Contributing to Nalu-Wind", "Developer Manual", "Development Infrastructure", "Nalu Style Guide", "Testing Nalu-Wind", "Developer Workflow", "Writing Developer Documentation", "Writing User Documentation", "17. Adaptivity", "4. Advection Stabilization", "9. Supported Boundary Conditions", "18. Code Abstractions", "12. Coupling Approach", "3. Discretization Approach", "Nalu-Wind - Theory Manual", "1. Low Mach Number Derivation", "14. Multi-Physics", "7. Nonlinear Stabilization Operator (NSO)", "10. Overset", "5. Pressure Stabilization", "11. Property Evaluations", "6. RTE Stabilization", "2. Supported Equation Set", "13. Time discretization", "16. Topological Support", "8. Turbulence Modeling", "15. Wind Energy Modeling", "Building Nalu-Wind Manually", "Building Nalu-Wind Semi-Automatically Using Spack", "Building Nalu-Wind", "User Manual", "Lessons Learned from Meshing the McAlister Case", "ABL Forcing", "Nalu-Wind Input File", "Exodus-II File Format", "Invoking Nalu-Wind - Command-line options", "Actuator Turbine Model", "Running Nalu-Wind", "Verifying that the installation of Nalu-Wind works", "Nalu-Wind - Verification Manual", "1. Introduction", "2. 2D Unsteady Uniform Property: Convecting Decaying Taylor Vortex", "References"], "titleterms": {"": 38, "0": 37, "1": [37, 38], "10": 37, "11": 37, "12": 37, "1x1x1": 51, "1x2x10": 51, "2": [4, 7, 37, 38], "2d": 51, "3": [4, 7, 37, 38], "3d": 51, "4": [37, 38], "5": 38, "6": [37, 38], "68": 37, "8": 37, "9": 37, "Of": 51, "One": [32, 35], "The": [29, 31], "With": 51, "abl": [7, 20, 32, 42, 43, 51], "abstract": 21, "access": 21, "accuraci": 51, "action": 12, "activ": 32, "actuat": [1, 36, 43, 46, 51], "ad": 14, "adapt": [18, 35, 37], "advect": 19, "algorithm": 36, "am": [20, 32], "applic": 51, "approach": [22, 23], "approxim": 36, "assembli": 28, "asymptot": 25, "atmospher": 20, "automat": 38, "auxiliari": 7, "averag": [32, 43], "base": [23, 27, 31, 51], "boost": 37, "boundari": [20, 36, 43, 51], "boussinesq": [32, 51], "bucket": 21, "build": [8, 37, 38, 39], "bulk": 21, "buoyanc": [32, 51], "capabl": 20, "case": [41, 48], "catalyst": 37, "cdash": 14, "cmake": [8, 37], "code": [9, 21], "coeffici": 27, "command": 45, "common": 43, "complement": 36, "compon": 51, "comput": 32, "condit": [20, 36, 43, 51], "conduct": [20, 32], "configur": [3, 8], "conform": [20, 43], "connect": 21, "conserv": 32, "contain": [12, 38], "continu": [12, 20], "contribut": 10, "control": 43, "convect": [7, 51], "corioli": 32, "coupl": [22, 36, 51], "cpp": 37, "cube": 51, "current": 41, "cvfem": [4, 23], "d": [4, 7], "daili": 12, "data": [14, 21, 43], "de": 32, "decai": 51, "definit": 31, "densiti": 30, "deriv": 25, "detach": 32, "detail": 20, "develop": [11, 12, 15, 16, 38], "diagnost": 32, "diffus": [23, 27], "discret": [23, 33, 36], "disk": 36, "displac": 7, "dissip": 20, "distanc": 32, "doc": 8, "docker": [12, 38], "document": [0, 8, 9, 16, 17], "dot": 29, "drop": 51, "dual": 23, "duct": 51, "due": 22, "dynam": 32, "eagl": 38, "earth": 32, "eddi": [32, 35], "edg": [23, 31], "element": 31, "energi": [20, 27, 32, 36], "enthalpi": 20, "equal": 51, "equat": [2, 32, 35, 36, 43], "equationsystem": 21, "error": [22, 51], "evalu": 30, "examin": 44, "exo": 41, "exodu": 44, "expans": 25, "expect": 48, "fem": 4, "field": 21, "file": [43, 44], "filter": 32, "find": 27, "finit": 31, "fix": 51, "flow": 7, "fluid": 43, "flux": 27, "forc": [32, 42, 43], "form": 31, "format": 44, "formul": 32, "fraction": [20, 32], "from": 41, "function": [7, 20, 31, 32], "gener": [27, 41], "geometri": 41, "github": 12, "govern": 36, "gradient": [20, 23, 51], "grid": 28, "grid07_conformal10": 41, "guid": 13, "hdf5": 37, "heat": [20, 30, 32], "high": [20, 21], "higher": 51, "homebrew": 37, "hybrid": [32, 35, 51], "hypr": 37, "ii": 44, "implement": 20, "inflow": [20, 43], "infrastructur": [12, 51], "initi": [36, 43], "inlet": 36, "input": 43, "insid": 38, "instal": [8, 48], "integr": [6, 12, 43], "intens": 20, "interact": 43, "interfac": [3, 4, 6, 51], "introduct": [41, 50], "invok": 45, "isotherm": 51, "k": [20, 35], "k_": 20, "kinet": [20, 27, 32], "kovasznai": 7, "lame": 30, "laminar": 32, "laplac": 51, "layer": [20, 43], "le": [20, 32, 35], "learn": 41, "length": 32, "lesson": 41, "level": [6, 21], "lewi": 32, "libxml2": 37, "limit": 32, "line": [45, 51], "linear": [3, 6, 43, 51], "linux": [37, 38], "local": [14, 27, 35], "low": [20, 25], "m": 29, "mac": 38, "mach": 25, "machin": [14, 38], "make": 8, "manual": [11, 24, 37, 40, 49], "mass": 32, "materi": 43, "mcalist": 41, "mesh": [7, 23, 32, 41, 43], "meta": 21, "method": 31, "mix": 32, "mixtur": [20, 32], "mm": [7, 51], "model": [20, 27, 32, 35, 36, 43, 46], "momentum": [20, 23, 32, 36, 51], "monin": 20, "motion": [7, 43], "move": 32, "multi": 26, "nalu": [0, 6, 10, 13, 14, 21, 24, 36, 37, 38, 39, 43, 45, 47, 48, 49], "nativ": 28, "netcdf": 37, "nodal": [23, 51], "non": [20, 43, 51], "nonconform": 51, "nonlinear": 27, "normal": [20, 51], "note": 41, "nrel": 38, "nso": 27, "number": [20, 25, 32], "numer": 36, "o": 38, "obukhov": 20, "omega": 20, "open": [20, 43, 51], "openfast": [36, 51], "oper": [27, 51], "opposit": 51, "option": [20, 43, 45], "order": 51, "osx": 37, "other": 44, "outflow": [20, 51], "outlet": 36, "output": 43, "overset": 28, "parabol": 51, "parallel": [21, 37], "paraview": 37, "part": 21, "period": [20, 43], "physic": [26, 43], "pointwis": 41, "post": [5, 43], "prandtl": 32, "precursor": 51, "prepar": 48, "pressur": [29, 51], "probe": 43, "problem": 51, "process": [5, 43], "profil": 51, "project": [23, 27, 51], "prolong": 18, "properti": [30, 43, 51], "pure": 31, "quadratur": 51, "radi": 32, "ran": [32, 35], "realm": [6, 21, 43], "refer": [14, 41, 52], "registr": 21, "regress": [12, 48], "residu": 27, "restart": 43, "restrict": 18, "result": [48, 51], "review": 32, "reynold": 20, "role": 29, "rte": 31, "rule": 21, "run": [8, 14, 47, 48], "scalar": 36, "scale": 32, "scheme": 36, "schmidt": 32, "schur": 36, "search": 28, "selector": 21, "semi": 38, "set": 32, "sg": [20, 35], "shear": 32, "sierra": 21, "simpl": 51, "simul": [6, 32, 43, 51], "smagorinski": 35, "solid": [20, 32], "solut": 43, "solver": [3, 6, 43], "sourc": [1, 9, 23, 32, 51], "spack": 38, "speci": [20, 32], "specif": [20, 30], "specifi": [20, 51], "split": [22, 32], "sst": [20, 32], "stabil": [19, 22, 27, 29, 31, 36], "standard": 35, "state": 21, "statist": [41, 43], "steadi": [7, 51], "step": [36, 38, 43], "stk": 28, "stratif": 51, "stratifi": 51, "stress": [20, 23, 32], "strong": 20, "structur": 43, "style": 13, "subgrid": 32, "subsequ": 51, "suit": 32, "superlu": 37, "supg": 31, "support": [20, 32, 34], "surfac": [20, 41], "symmetri": [20, 43], "system": [2, 3, 43], "tau": 31, "taylor": [7, 51], "temperatur": [20, 51], "tempor": 51, "term": [23, 32, 51], "terrain": 36, "test": [12, 14, 31, 48, 51], "theori": [20, 24], "thermal": [7, 20, 32, 51], "time": [6, 23, 33, 36, 43], "tioga": 28, "tip": 41, "tool": 8, "toolkit": 21, "top": [6, 20, 36], "topolog": 34, "topologi": 4, "transfer": [6, 43], "transform": 43, "transit": 32, "transport": [32, 36], "trilino": 37, "turbin": [36, 43, 46], "turbul": [20, 27, 32, 35, 36, 43], "underrelax": 36, "uniform": 51, "unit": [48, 51], "uniti": 32, "unsteadi": 51, "updat": 14, "upwind": 31, "us": [28, 38], "user": [17, 40], "util": [5, 7, 44], "v1": 37, "v2": 37, "v3": 37, "v4": 37, "veloc": 51, "verif": [49, 51], "verifi": 48, "via": 36, "viscos": [30, 35], "vortex": [7, 51], "wale": 35, "wall": [20, 32, 35, 36, 43], "weak": 20, "wind": [0, 10, 14, 21, 24, 36, 37, 38, 39, 43, 45, 47, 48, 49], "wing": 51, "work": 48, "workflow": 15, "write": [16, 17], "x": [38, 51], "y": 51, "yaml": 37, "your": 14, "z": 51, "zlib": 37}}) \ No newline at end of file diff --git a/source/theory/index.html b/source/theory/index.html index dbcb1bfec..78dafdfea 100644 --- a/source/theory/index.html +++ b/source/theory/index.html @@ -122,12 +122,13 @@

Nalu-Wind - Theory Manual2.8. Conservation of Species
  • 2.9. Subgrid-Scale Kinetic Energy One-Equation LES Model
  • 2.10. RANS Model Suite
  • -
  • 2.11. Detached Eddy Simulation (DES) Formulation
  • -
  • 2.12. Active Model Split (AMS) Formulation
  • -
  • 2.13. Solid Stress
  • -
  • 2.14. Moving Mesh
  • -
  • 2.15. Radiative Transport Equation
  • -
  • 2.16. Wall Distance Computation
  • +
  • 2.11. Laminar-Turbulent Transition Model Formulation
  • +
  • 2.12. Detached Eddy Simulation (DES) Formulation
  • +
  • 2.13. Active Model Split (AMS) Formulation
  • +
  • 2.14. Solid Stress
  • +
  • 2.15. Moving Mesh
  • +
  • 2.16. Radiative Transport Equation
  • +
  • 2.17. Wall Distance Computation
  • 3. Discretization Approach
  • -
  • 2.11. Detached Eddy Simulation (DES) Formulation
  • -
  • 2.12. Active Model Split (AMS) Formulation
  • 3. Discretization Approach
  • @@ -720,13 +721,37 @@

    2.10.1. Shear Stress Transport (SST) For

    where \(\Omega\) is the earth’s angular velocity and \(\lambda\) is the latitude.

    +
    +

    2.11. Laminar-Turbulent Transition Model Formulation

    +

    To account for the effects of the laminar-turbulent boundary layer transition, +Menter’s one-equation \(\gamma\) transition model :cite:`Menter:2015` is coupled with the SST model. +The model consists of single transport equation for intermittency

    +
    +\[\frac{D(\rho \gamma)}{Dt}=P_{\gamma}-D_{\gamma}+\frac{\partial }{\partial x_j}\left[ (\mu + \frac{\mu_t}{\sigma_{\gamma}} )\frac{\partial \gamma}{\partial x_j} \right]\]
    +

    The production term, \(P_{\gamma}\), and destruction term, \(D_{\gamma}\), are as:

    +
    +\[P_{\gamma}=F_{length} \rho S \gamma (1-\gamma) F_{onset}, \quad D_{\gamma}=C_{a2} \rho \Omega \gamma F_{turb} (C_{e2}\gamma-1)\]
    +

    The model constants are:

    +
    +\[F_{length}=100, \quad c_{e2}=50, \quad c_{a2}=0.06, \quad \sigma_{\gamma}=1.0\]
    +

    The transition onset criteria of the model are defined as:

    +
    +\[F_{onset1}=\frac{Re_{v}}{2.2Re_{\theta c}}, \quad F_{onset2}=(F_{onset1},2.0 )\]
    +
    +\[F_{onset3}=\max \left(1- \left (\frac{R_{T}}{3.5}\right)^3,0 \right ), \quad F_{onset}=\max(F_{onset2}-F_{onset3},0)\]
    +
    +\[F_{turb}=e^{-\left ( \frac{R_{T}}{2} \right )^{4}}, \quad R_T=\frac{\rho k}{\mu \omega}, \quad Re_v=\frac{\rho d_{w}^2S}{\mu}\]
    +

    The transition onset occurs once the scaled vorticity Reynolds number, \(Re_{v}/2.2\), exceeds the critical momentum thickness Reynolds number, \(Re_{\theta c}\), from the empirical correlations.

    +

    The output intermittency from the transition model is applied to both the production and destruction terms of the turbulent kinetic energy +transport equation.

    +
    -

    2.11. Detached Eddy Simulation (DES) Formulation

    +

    2.12. Detached Eddy Simulation (DES) Formulation

    The DES technique is also supported in the code base when the SST model is activated. This model seeks to formally relax the RANS-based approach and allows for a theoretical basis to allow for transient flows. The method follows the method of Temporally Filtered NS formulation as -described by Tieszen, :cite:`Tieszen:2005`.

    +described by Tieszen, :cite:`Tieszen:2005`.

    The SST DES model simply changes the turbulent kinetic energy equation to include a new minimum scale that manipulates the dissipation term.

    @@ -739,9 +764,9 @@

    2.10.1. Shear Stress Transport (SST) For node.

    -

    2.12. Active Model Split (AMS) Formulation

    +

    2.13. Active Model Split (AMS) Formulation

    The AMS approach is a recently developed hybrid RANS/LES framework by Haering, -Oliver and Moser :cite:`Haering-etal:2020`. In this approach a triple +Oliver and Moser :cite:`Haering-etal:2020`. In this approach a triple decomposition is used, breaking the instantaneous velocity field into an average component \(<u_i>\), a resolved fluctuation \(u_i^>\) and an unresolved fluctuation \(u_i^<\). The subgrid stress is @@ -766,13 +791,13 @@

    2.12. Active Model Split (AMS) Formulati + \int \left( \mu_{ik}^t \widetilde{u}_j + \mu_{jk}^t \widetilde{u}_i \right) n_k {\rm d}S + \int f_i {\rm d}V.\end{split}\]
    -

    2.12.1. Split subgrid model stress

    +

    2.13.1. Split subgrid model stress

    In a typical Hybrid RANS/LES approach, the observation that the LES and RANS equations take on the same mathematical form is leveraged, relying simply on a modified turbulent viscosity coefficient that takes into account the ability to resolve some turbulent content. Due to deficiencies in this approach as discussed in Haering et -al. :cite:`Haering-etal:2020`, an alternative approach where the modeled term +al. :cite:`Haering-etal:2020`, an alternative approach where the modeled term is split into two contributions, one representing the impact on the mean flow and one the impact on the resolved fluctuations, from the unresolved content, is used in the Active Model Split (AMS) @@ -812,7 +837,7 @@

    2.12.1. Split subgrid model stress\(k_{res} = 0.5 \langle u_i^> u_i^> \rangle\), a measure of the average resolved turbulent kinetic energy.

    \(\tau_{ij}^{SGET}\) is modeled using the M43 SGS model discussed -in Haering et al. :cite:`HaeringAIAA`. This uses an anisotropic +in Haering et al. :cite:`HaeringAIAA`. This uses an anisotropic representation, \(\tau_{ij} = \nu_{jk} \partial_k u_i + \nu_{ik} \partial_k u_j\), of the stress tensor and a tensorial eddy viscosity, \(\nu_{ij} = C(\mathcal{M}) \langle \epsilon \rangle^{1/3} @@ -832,7 +857,7 @@

    2.12.1. Split subgrid model stress

    -

    2.12.2. Averaging functions

    +

    2.13.2. Averaging functions

    The averaging algorithms are invoked as part of the AMSAlgDriver and are called from the pre_iter_work function so that they are executed at the beginning of each Picard @@ -869,7 +894,7 @@

    2.12.2. Averaging functions -

    2.12.3. Dynamic Hybrid Diagnostics

    +

    2.13.3. Dynamic Hybrid Diagnostics

    Typically in a hybrid model, it is necessary to have diagnostics that assess the ability of the grid to resolve turbulent content and to aid in its introduction. In AMS, there are two main diagnostic @@ -901,11 +926,11 @@

    2.12.3. Dynamic Hybrid Diagnostics.

    -

    2.12.4. Forcing Term

    +

    2.13.4. Forcing Term

    When the grid is capable of resolving some turbulent content, the model will want to reduce the modeled stress and allow for resolved turbulence to contribute the remaining piece of the total stress. As -discussed in Haering et al. :cite:`Haering-etal:2020` and the observation of +discussed in Haering et al. :cite:`Haering-etal:2020` and the observation of “modeled-stress depletion” in other hybrid approaches, such as DES, a mechanism for inducing resolved turbulent fluctuations at proper energy levels and timescales to match your reduction of the modeled @@ -969,14 +994,14 @@

    2.12.3. Dynamic Hybrid DiagnosticsMomentumSSTAMSForcingNodeKernel.

    -

    2.12.5. AMS with SST Mixing Length Limiter

    +

    2.13.5. AMS with SST Mixing Length Limiter

    When using AMS with SST as the mean (RANS) contribution to model the Atmospheric Boundary Layer with the Coriolis effect, SST should include a mixing length limiter. The mixing length limiter is described in SST Mixing Length Limiter. For consistency, when using the limiter the RANS time scale, \(T_{RANS}^*\), should depend on the mixing length rather than \(\omega\) to account for the effect of the limiter. The time scale becomes

    \[T_{RANS}^* = \frac{l_t}{\sqrt{k}}.\]

    -

    2.13. Solid Stress

    +

    2.14. Solid Stress

    A fully implicit CVFEM (only) linear elastic equation is supported in the code base. This equation is either used for true solid stress prediction or for smoothing the mesh due to boundary mesh motion (either @@ -1017,7 +1042,7 @@

    2.13. Solid Stress(2.33)\[v_i = \frac{\gamma_1 u^{n+1}_i + \gamma_2 u^n_i + \gamma_3 u^{n-1}_i}{\Delta t}\]

    -

    2.14. Moving Mesh

    +

    2.15. Moving Mesh

    The code base supports three notions of moving mesh: 1) linear elastic equation system that computes the stress of a solid 2) solid body rotation mesh motion and 3) mesh deformation via an external @@ -1062,7 +1087,7 @@

    2.14. Moving Mesh

    -

    2.15. Radiative Transport Equation

    +

    2.16. Radiative Transport Equation

    The spatial variation of the radiative intensity corresponding to a given direction and at a given wavelength within a radiatively participating material, \(I(s)\), is governed by the Boltzmann @@ -1118,11 +1143,11 @@

    2.15. Radiative Transport Equation

    where \(\theta_{zn}\) and \(\theta_{az}\) are the zenith and azimuthal angles respectively as shown in Figure 2.1.

    -
    +
    Ordinate Direction Definition

    2.1 Ordinate Direction Definition, -\({\bf s} = \sin \theta_{zn} \sin \theta_{az} {\bf i} + \cos \theta_{zn} {\bf j} + \sin \theta_{zn} \cos \theta_{az} {\bf k}\).

    +\({\bf s} = \sin \theta_{zn} \sin \theta_{az} {\bf i} + \cos \theta_{zn} {\bf j} + \sin \theta_{zn} \cos \theta_{az} {\bf k}\).

    The radiation intensity must be defined at all portions of the boundary @@ -1148,7 +1173,7 @@

    2.15. Radiative Transport Equationwhere it is implied that \(\alpha = \epsilon\).

    -

    2.16. Wall Distance Computation

    +

    2.17. Wall Distance Computation

    RANS and DES simulations using \(k-\omega\) SST or SST-DES equations requires the specification of a wall distance for computing various turbulence parameters. For static mesh @@ -1156,7 +1181,7 @@

    2.16. Wall Distance Computation:cite:`Tucker2003`) to determine the wall distance \(d\) using the +(:cite:`Tucker2003`) to determine the wall distance \(d\) using the gradients of a field \(\phi\).

    \[\begin{split}\nabla^2 \phi &= 1 \\