Navier Stokes System Design Description
This template follows INL template TEM-140, "IT System Design Description."
This document serves as an addendum to Framework System Design Description and captures information for SDD specific to the Navier Stokes application.
Introduction
Frameworks are a software development construct aiming to simplify the creation of specific classes of applications through abstraction of low-level details. The main object of creating a framework is to provide an interface to application developers that saves time and provides advanced capabilities not attainable otherwise. The MOOSE, mission is just that: provide a framework for engineers and scientists to build state-of-the-art, computationally scalable finite element based simulation tools.
MOOSE was conceived with one major objective: to be as easy and straightforward to use by scientists and engineers as possible. MOOSE is meant to be approachable by non-computational scientists who have systems of PDEs they need to solve. Every single aspect of MOOSE was driven by this singular principle from the build system to the API to the software development cycle. At every turn, decisions were made to enable this class of users to be successful with the framework. The pursuit of this goal has led to many of the unique features of MOOSE:
A streamlined build system
An API aimed at extensible
Straightforward APIs providing sensible default information
Integrated, automatic, and rigorous testing
Rapid, continuous integration development cycle
Codified, rigorous path for contributing
Applications are modular and composable
Each of these characteristics is meant to build trust in the framework by those attempting to use it. For instance, the build system is the first thing potential framework users come into contact with when they download a new software framework. Onerous dependency issues, complicated, hard to follow instructions or build failure can all result in a user passing on the platform. Ultimately, the decision to utilize a framework comes down to whether or not you trust the code in the framework and those developing it to be able to support your desired use-case. No matter the technical capabilities of a framework, without trust users will look elsewhere. This is especially true of those not trained in software development or computational science.
Developing trust in a framework goes beyond utilizing "best practices" for the code developed, it is equally important that the framework itself is built upon tools that are trusted. For this reason, MOOSE relies on a well-established code base of libMesh and PETSc. The libMesh library provides foundational capability for the finite element method and provides interfaces to leading-edge numerical solution packages such as PETSc.
With these principles in mind, an open source, massively parallel, finite element, multiphysics framework has been conceived. MOOSE is an on-going project started in 2008 aimed toward a common platform for creation of new multiphysics tools. This document provides design details pertinent to application developers as well as framework developers.
Use Cases
The MOOSE Framework is targeted at two main groups of actors: Developers and Users. Developers are the main use case. These are typically students and professionals trained in science and engineering fields with some level of experience with coding but typically very little formal software development training. The other user group is Users. Those who intend to use an application built upon the framework without writing any computer code themselves. Instead they may modify or create input files for driving a simulation, run the application, and analyze the results. All interactions through MOOSE are primarily through the command-line interface and through a customizable block-based input file.
System Purpose
The Software Design Description provided here is description of each object in the system. The pluggable architecture of the framework makes MOOSE and MOOSE-based applications straightforward to develop as each piece of end-user (developer) code that goes into the system follows a well-defined interface for the underlying systems that those object plug into. These descriptions are provided through developer-supplied "markdown" files that are required for all new objects that are developed as part of the framework, modules and derivative applications. More information about the design documentation can be found in Documenting MOOSE.
System Scope
The purpose of this software is to provide several libraries that can be used to build an application based upon the framework. Additionally, several utilities are provided for assisting developers and users in end-to-end FEM analysis. A brief overview of the major components are listed here:
Component | Description |
---|---|
framework library | The base system from which all MOOSE-based applications are created |
module libraries | Optional "physics" libraries that may be used in an application to provide capability |
build system | The system responsible for creating applications for a series of libraries and applications |
test harness | The extendable testing system for finding, scheduling, running, and reporting regression tests |
"peacock" | The GUI for building input files, executing applications, and displaying results |
MooseDocs | The extendable markdown system for MOOSE providing common documentation and requirements enforcement |
"stork" | The script and templates for generating a new MOOSE-based application ready for building and testing |
examples | A set of complete applications demonstrating the use of MOOSE's pluggable systems |
tutorials | Step by step guides to building up an application using MOOSE's pluggable systems |
unit | An application for unit testing individual classes or methods of C++ code |
Dependencies and Limitations
The MOOSE platform has several dependencies on other software packages and has scope that is constantly evolving based upon funding, resources, priorities, and lab direction. However, the software is open-source and many features and even bugs can be offloaded to developers with appropriate levels of knowledge and direction from the main design team. The primary list of software dependencies is listed below. This list is not meant to be exhaustive. Individual operating systems may require specific packages to be installed prior to using MOOSE, which can be found on the Install MOOSE pages.
Software Dependency | Description |
---|---|
libMesh | Finite Element Library and I/O routines |
PETSc | Solver Package |
hypre | Multigrid Preconditioner |
MPI | A distributed parallel processing library (MPICH) |

Figure 1: A diagram of the MOOSE code platform.
References
Definitions and Acronyms
This section defines, or provides the definition of, all terms and acronyms required to properly understand this specification.
Definitions
- Pull (Merge) Request: A proposed change to the software (e.g. usually a code change, but may also include documentation, requirements, design, and/or testing). - Baseline: A specification or product (e.g., project plan, maintenance and operations (M&O) plan, requirements, or design) that has been formally reviewed and agreed upon, that thereafter serves as the basis for use and further development, and that can be changed only by using an approved change control process (NQA-1, 2009). - Validation: Confirmation, through the provision of objective evidence (e.g., acceptance test), that the requirements for a specific intended use or application have been fulfilled (24765:2010(E), 2010). - Verification: (1) The process of: evaluating a system or component to determine whether the products of a given development phase satisfy the conditions imposed at the start of that phase. (2) Formal proof of program correctness (e.g., requirements, design, implementation reviews, system tests) (24765:2010(E), 2010).
Acronyms
Acronym | Description |
---|---|
API | Application Programming Interface |
DOE-NE | Department of Energy, Nuclear Energy |
FE | finite element |
FEM | Finite Element Method |
GUI | graphical user interface |
HIT | Hierarchical Input Text |
HPC | High Performance Computing |
I/O | Input/Output |
INL | Idaho National Laboratory |
MOOSE | Multiphysics Object Oriented Simulation Environment |
MPI | Message Passing Interface |
PDEs | partial differential equations |
SDD | Software Design Description |
Design Stakeholders and Concerns
Design Stakeholders
Stakeholders for MOOSE include several of the funding sources including DOE-NE and the INL. However, Since MOOSE is an open-source project, several universities, companies, and foreign governments have an interest in the development and maintenance of the MOOSE project.
Stakeholder Design Concerns
Concerns from many of the stakeholders are similar. These concerns include correctness, stability, and performance. The mitigation plan for each of these can be addressed. For correctness, MOOSE development requires either regression or unit testing for all new code added to the repository. The project contains several comparisons against analytical solutions where possible and also other verification methods such as MMS. For stability, MOOSE maintains multiple branches to incorporate several layers of testing both internally and for dependent applications. Finally, performance tests are also performed as part of the the normal testing suite to monitor code change impacts to performance.
System Design
The MOOSE framework itself is composed of a wide range of pluggable systems. Each system is generally composed of a single or small set of C++ objects intended to be specialized by a Developer to solve a specific problem. To accomplish this design goal, MOOSE uses several modern object-oriented design patterns. The primary overarching pattern is the "Factory Pattern". Users needing to extend MOOSE may inherit from one of MOOSE's systems to providing an implementation meeting his or her needs. The design of each of these systems is documented on the mooseframework.org wiki in the Tutorial section. Additionally, up-to-date documentation extracted from the source is maintained on the the mooseframework.org documentation site after every successful merge to MOOSE's stable branch. After these objects are created, the can be registered with the framework and used immediately in a MOOSE input file.
System Structure
The MOOSE framework architecture consists of a core and several pluggable systems. The core of MOOSE consists of a number of key objects responsible for setting up and managing the user-defined objects of a finite element simulation. This core set of objects has limited extendability and exist for every simulation configuration that the framework is capable of running.
Adaptivity
Adaptivity/Indicators
Adaptivity/Markers
AuxKernels
AuxKernels/MatVecRealGradAuxKernel
AuxKernels/MaterialVectorAuxKernel
AuxKernels/MaterialVectorGradAuxKernel
AuxScalarKernels
AuxVariables
AuxVariables/MultiAuxVariables
BCs
BCs/CavityPressure
BCs/CoupledPressure
BCs/InclinedNoDisplacementBC
BCs/Periodic
BCs/Pressure
Bounds
Closures
Components
Constraints
Contact
ControlLogic
Controls
CoupledHeatTransfers
Covariance
DGKernels
Dampers
Debug
Debug/MaterialDerivativeTest
DeprecatedBlock
DiracKernels
Distributions
DomainIntegral
Executioner
Executioner/Adaptivity
Executioner/Predictor
Executioner/Quadrature
Executioner/TimeIntegrator
Executioner/TimeStepper
Executors
FVBCs
FVInterfaceKernels
FVKernels
FluidPropertiesInterrogator
Functions
GeochemicalModelInterrogator
GlobalParams
GrayDiffuseRadiation
HeatStructureMaterials
ICs
ICs/PolycrystalICs
ICs/PolycrystalICs/BicrystalBoundingBoxIC
ICs/PolycrystalICs/BicrystalCircleGrainIC
ICs/PolycrystalICs/PolycrystalColoringIC
ICs/PolycrystalICs/PolycrystalRandomIC
ICs/PolycrystalICs/PolycrystalVoronoiVoidIC
ICs/PolycrystalICs/Tricrystal2CircleGrainsIC
InterfaceKernels
Kernels
Kernels/CHPFCRFFSplitKernel
Kernels/DynamicTensorMechanics
Kernels/HHPFCRFFSplitKernel
Kernels/PFCRFFKernel
Kernels/PolycrystalElasticDrivingForce
Kernels/PolycrystalKernel
Kernels/PolycrystalStoredEnergy
Kernels/PoroMechanics
Kernels/RigidBodyMultiKernel
Kernels/TensorMechanics
Materials
Mesh
Mesh/Partitioner
Modules
Modules/CompressibleNavierStokes
Modules/FluidProperties
Modules/HeatConduction
Modules/HeatConduction/ThermalContact
Modules/HeatConduction/ThermalContact/BC
Modules/IncompressibleNavierStokes
Modules/NavierStokesFV
Modules/Peridynamics
Modules/Peridynamics/Mechanics
Modules/Peridynamics/Mechanics/GeneralizedPlaneStrain
Modules/Peridynamics/Mechanics/Master
Modules/PhaseField
Modules/PhaseField/Conserved
Modules/PhaseField/DisplacementGradients
Modules/PhaseField/EulerAngles2RGB
Modules/PhaseField/GrainGrowth
Modules/PhaseField/GrandPotential
Modules/PhaseField/Nonconserved
Modules/PorousFlow
Modules/PorousFlow/BCs
Modules/TensorMechanics
Modules/TensorMechanics/CohesiveZoneMaster
Modules/TensorMechanics/DynamicMaster
Modules/TensorMechanics/GeneralizedPlaneStrain
Modules/TensorMechanics/GlobalStrain
Modules/TensorMechanics/LineElementMaster
Modules/TensorMechanics/Master
Modules/TensorMechanics/MaterialVectorBodyForce
MortarGapHeatTransfer
MultiApps
NodalKernels
NodalNormals
Outputs
PorousFlowBasicTHM
PorousFlowFullySaturated
PorousFlowUnsaturated
Postprocessors
Preconditioning
Problem
RayBCs
RayKernels
ReactionNetwork
ReactionNetwork/AqueousEquilibriumReactions
ReactionNetwork/SolidKineticReactions
Reporters
Samplers
ScalarKernels
SpatialReactionSolver
StochasticTools
Surrogates
ThermalContact
TimeDependentReactionSolver
TimeIndependentReactionSolver
Trainers
Transfers
UserObjects
Variables
Variables/CHPFCRFFSplitVariables
Variables/HHPFCRFFSplitVariables
Variables/PFCRFFVariables
Variables/PolycrystalVariables
VectorPostprocessors
XFEM
The MooseApp is the top-level object used to hold all of the other objects in a simulation. In a normal simulation a single MooseApp object is created and "run()". This object uses it's Factory objects to build user defined objects which are stored in a series of Warehouse objects and executed. The Finite Element data is stored in the Systems and Assembly object while the domain information (the Mesh) is stored in the Mesh object. A series of threaded loops are used to run parallel calculations on the objects created and stored within the warehouses.
MOOSE's pluggable systems are documented on the mooseframework.org wiki. Each of these systems has set of defined polymorphic interfaces and are designed to accomplish a specific task within the simulation. The design of these systems is fluid and is managed through agile methods and ticket request system on the Github.org website.
Data Design and Control
At a high level, the system is designed to process HIT input files to construct several objects that will constitute an FE simulation. Some of the objects in the simulation may in turn load other file-based resources to complete the simulation. Examples include meshes or data files. The system will then assemble systems of equations and solve them using the libraries of the Code Platform. The system can then output the solution in one or more supported output formats commonly used for visualization.
Human-Machine Interface Design
MOOSE is a command-line driven program. All interaction with MOOSE and MOOSE-based codes is ultimately done through the command line. This is typical for HPC applications that use the MPI interface for running on super computing clusters. Optional GUIs may be used to assist in creating input files and launching executables on the command line.
System Design Interface
All external system interaction is performed either through file I/O or through local API calls. Neither the framework, nor the modules are designed to interact with any external system directly through remote procedure calls. Any code to code coupling performed using the framework are done directly through API calls either in a static binary or after loading shared libraries.
Security Structure
The framework does not require any elevated privileges to operate and does not run any stateful services, daemons or other network programs. Distributed runs rely on the MPI library.
Requirements Cross-Reference
- navier_stokes: PecletNumberFunctorAux
- 10.1.1The system shall be able to compute element thermal Peclet numbers for:
- finite volume discretizations
- finite element discretizations
Specification(s): peclet/fv, peclet/fe
Design: PecletNumberFunctorAuxThermalDiffusivityFunctorMaterial
Issue(s): #20476
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: ThermalDiffusivityFunctorMaterial
- 10.1.1The system shall be able to compute element thermal Peclet numbers for:
- finite volume discretizations
- finite element discretizations
Specification(s): peclet/fv, peclet/fe
Design: PecletNumberFunctorAuxThermalDiffusivityFunctorMaterial
Issue(s): #20476
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: ReynoldsNumberFunctorAux
- 10.1.2The system shall be able to compute element Reynolds numbers for:
- finite volume discretizations
- finite element discretizations
Specification(s): reynolds/fv, reynolds/fe
Design: ReynoldsNumberFunctorAux
Issue(s): #20359
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: Continuous Galerkin Finite Element Navier Stokes
- 10.2.1The system shall be able to solve the Euler equations for subsonic flow with a bump in the channel.
Specification(s): bump
Design: Continuous Galerkin Finite Element Navier Stokes
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.61The system shall be able to model the effect of gravity on incompressible flow using a finite element discretization.
Specification(s): gravity
Design: Continuous Galerkin Finite Element Navier StokesINSMomentumLaplaceForm
Issue(s): #9528
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.65The system shall be able to solve Jeffery-Hamel flow in a 2D wedge and compare to the analytical solution
- with pressure Dirichlet boundary conditions
- and with natural advection boundary conditions.
Specification(s): jeffery/wedge_dirichlet, jeffery/wedge_natural
Design: Continuous Galerkin Finite Element Navier Stokes
Issue(s): #7904
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.95The system shall be able to solve for incompressible fluid flowing through a 2D channel driven by pressure inlet and outlet boundary conditions
- using the kernel formulation,
- using the action formulation
- and using a field split preconditioning.
Specification(s): open_bc_pressure_BC/kernels, open_bc_pressure_BC/action, open_bc_pressure_BC/fieldSplit
Design: Continuous Galerkin Finite Element Navier Stokes
Issue(s): #6585
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.97The system shall be able to solve for an incompressible fluid flowing through a 1D channel with Streamline Upwind Petrov Galerkin stabilization.
- using the optimal tau stabilization,
- using the modified tau stabilization,
- and still satisfy MMS testing in 1D
- and in 2D.
Specification(s): supg/tauOpt, supg/tauMod, supg/1d_error_test_supg, supg/2d_error_test_supg
Design: Continuous Galerkin Finite Element Navier Stokes
Issue(s): #9643
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.98The system shall be able to solve for incompressible fluid evolving in a corner cavity with Dirichlet boundary conditions on velocity.
- in 2D
- and in 2D RZ axisymmetric simulations.
Specification(s): stagnation/2D, stagnation/axisymmetric
Design: Continuous Galerkin Finite Element Navier Stokes
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.99The system shall be able to solve for incompressible fluid flowing through a 2D channel with only inlet velocity boundary conditions
- with the regular volumetric integration of the momentum pressure term
- and with the momentum pressure term integrated by parts.
Specification(s): velocity_inletBC/no_parts, velocity_inletBC/by_parts
Design: Continuous Galerkin Finite Element Navier Stokes
Issue(s): #3036
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: Navier-Stokes Module
- 10.2.2The system shall be able to solve the incompressible Navier-Stokes equations in an RZ coordinate system while not integrating the pressure term by parts.
Specification(s): RZ_cone_no_parts
Design: Navier-Stokes Module
Issue(s): #7651
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.3The system shall be able to solve the incompressible Navier-Stokes equations in an RZ coordinate system while integrating the pressure term by parts.
Specification(s): RZ_cone_by_parts
Design: Navier-Stokes Module
Issue(s): #7651
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.4The system shall be able to solve the incompressible Navier-Stokes equations for a high Reynolds number in an RZ coordinate system.
Specification(s): high_re
Design: Navier-Stokes Module
Issue(s): #7651
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.5The system shall be able to compute an accurate Jacobian for the incompressible Navier-Stokes equations in an RZ coordinate system.
Specification(s): jac
Design: Navier-Stokes Module
Issue(s): #7651
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.6The system shall be able to solve the transient incompressible Navier-Stokes equations using an automatic differentiation, vector variable implementation in an RZ coordinate system while integrating the pressure term by parts and reproduce the results of a hand-coded Jacobian implementation.
Specification(s): ad_rz_cone_by_parts
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.7The system shall be able to solve the transient incompressible Navier-Stokes equations using an automatic differentiation, vector variable implementation in an RZ coordinate system while not integrating the pressure term by parts, using a traction form for the viscous term, and using a no-bc boundary condition, and reproduce the results of a hand-coded Jacobian implementation.
Specification(s): ad_rz_cone_no_parts
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.8The system shall be able to solve the steady incompressible Navier-Stokes equations using an automatic differentiation, vector variable implementation in an RZ coordinate system while not integrating the pressure term by parts and applying a natural outflow boundary condition.
Specification(s): ad_rz_cone_no_parts_steady
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.9The system shall be able to solve the steady incompressible Navier-Stokes equations using an automatic differentiation, vector variable implementation in an RZ coordinate system while integrating the pressure term by parts and applying a natural outflow boundary condition
Specification(s): ad_rz_cone_by_parts_steady
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.10The system shall be able to solve the steady incompressible Navier-Stokes equations using an automatic differentiation, vector variable implementation in an RZ coordinate system while not integrating the pressure term by parts and applying a NoBC outflow boundary condition.
Specification(s): ad_rz_cone_no_parts_steady_nobcbc
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.11The system shall be able to solve the steady incompressible Navier-Stokes equations using an automatic differentiation, vector variable implementation in an RZ coordinate system while integrating the pressure term by parts and applying a NoBC outflow boundary condition
Specification(s): ad_rz_cone_by_parts_steady_nobcbc
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.12The system shall be able to solve the steady incompressible Navier-Stokes equations using a hand-coded Jacobian, standard variable implementation in an RZ coordinate system while not integrating the pressure term by parts and applying a natural outflow boundary condition and reproduce the results of the AD, vector variable implementation.
Specification(s): rz_cone_no_parts_steady
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.13The system shall be able to solve the steady incompressible Navier-Stokes equations using a hand-coded Jacobian, standard variable implementation in an RZ coordinate system while integrating the pressure term by parts and applying a natural outflow boundary condition and reproduce the results of the AD, vector variable implementation.
Specification(s): rz_cone_by_parts_steady
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.14The system shall be able to solve the steady incompressible Navier-Stokes equations using a hand-coded Jacobian, standard variable implementation in an RZ coordinate system while not integrating the pressure term by parts and applying a NoBC outflow boundary condition and reproduce the results of the AD, vector variable implementation.
Specification(s): rz_cone_no_parts_steady_nobcbc
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.15The system shall be able to solve the steady incompressible Navier-Stokes equations using a hand-coded Jacobian, standard variable implementation in an RZ coordinate system while integrating the pressure term by parts and applying a NoBC outflow boundary condition and reproduce the results of the AD, vector variable implementation.
Specification(s): rz_cone_by_parts_steady_nobcbc
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.16The system shall be able to solve the steady incompressible Navier-Stokes equations with SUPG and PSPG stabilization and a first order velocity basis using an automatic differentiation, vector variable implementation in an RZ coordinate system while not integrating the pressure term by parts and applying a natural outflow boundary condition.
Specification(s): ad_rz_cone_no_parts_steady_supg_pspg
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.17The system shall be able to solve the steady incompressible Navier-Stokes equations with SUPG and PSPG stabilization and a first order velocity basis using a hand-coded Jacobian, standard variable implementation in an RZ coordinate system while not integrating the pressure term by parts and applying a natural outflow boundary condition and reproduce the results of the AD, vector variable implementation.
Specification(s): rz_cone_no_parts_steady_supg_pspg
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.18The system shall be able to solve the steady incompressible Navier-Stokes equations with SUPG and PSPG stabilization and a first order velocity basis using an automatic differentiation, vector variable implementation in an RZ coordinate system while integrating the pressure term by parts and applying a natural outflow boundary condition.
Specification(s): ad_rz_cone_by_parts_steady_supg_pspg
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.19The system shall be able to solve the steady incompressible Navier-Stokes equations with SUPG and PSPG stabilization and a first order velocity basis using a hand-coded Jacobian, standard variable implementation in an RZ coordinate system while integrating the pressure term by parts and applying a natural outflow boundary condition and reproduce the results of the AD, vector variable implementation.
Specification(s): rz_cone_by_parts_steady_supg_pspg
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.20The system shall be able to solve the steady incompressible Navier-Stokes equations with SUPG and PSPG stabilization and a second order velocity basis using an automatic differentiation, vector variable implementation in an RZ coordinate system while not integrating the pressure term by parts and applying a natural outflow boundary condition.
Specification(s): ad_rz_cone_no_parts_steady_supg_pspg_second_order
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.21The system shall be able to solve the steady incompressible Navier-Stokes equations with SUPG and PSPG stabilization and a second order velocity basis using a hand-coded Jacobian, standard variable implementation in an RZ coordinate system while not integrating the pressure term by parts and applying a natural outflow boundary condition.
Specification(s): rz_cone_no_parts_steady_supg_pspg_second_order
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.22The system shall be able to solve the steady incompressible Navier-Stokes equations with SUPG and PSPG stabilization and a second order velocity basis using an automatic differentiation, vector variable implementation in an RZ coordinate system while integrating the pressure term by parts and applying a natural outflow boundary condition.
Specification(s): ad_rz_cone_by_parts_steady_supg_pspg_second_order
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.23The system shall be able to solve the steady incompressible Navier-Stokes equations with SUPG and PSPG stabilization and a second order velocity basis using a hand-coded Jacobian, standard variable implementation in an RZ coordinate system while integrating the pressure term by parts and applying a natural outflow boundary condition.
Specification(s): rz_cone_by_parts_steady_supg_pspg_second_order
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.24The system shall compute an accurate Jacobian using automatic differentiation when solving the incompressible Navier Stokes equations in an axisymmetric coordinate system with SUPG and PSPG stabilization
Specification(s): ad_jac
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.25The system shall be able to solve the steady incompressible Navier-Stokes equations with SUPG and PSPG stabilization and a first order velocity basis using an automatic differentiation, vector variable implementation in an RZ coordinate system while integrating the pressure term by parts, using a traction form for the viscous term, and applying a natural outflow boundary condition.
Specification(s): ad_rz_cone_by_parts_traction_steady_supg_pspg
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.26The system shall be able to solve the steady incompressible Navier-Stokes equations with SUPG and PSPG stabilization and a first order velocity basis using a hand-coded Jacobian, standard variable implementation in an RZ coordinate system while integrating the pressure term by parts, using a traction form for the viscous term, and applying a natural outflow boundary condition and reproduce the results of the AD, vector variable implementation.
Specification(s): rz_cone_by_parts_traction_steady_supg_pspg
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.27The system shall be able to solve the steady incompressible Navier-Stokes equations with SUPG and PSPG stabilization and a first order velocity basis using an automatic differentiation, vector variable implementation in an RZ coordinate system while integrating the pressure term by parts, using a traction form for the viscous term, and applying a natural outflow boundary condition and obtain a perfect Jacobian.
Specification(s): ad_rz_cone_by_parts_traction_steady_supg_pspg_jac
Design: Navier-Stokes Module
Issue(s): #14901
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.28The system shall be able to solve the steady incompressible Navier-Stokes equations in an axisymmetric coordinate system, using a Jacobian computed via automatic differentiation, on a displaced mesh, with the viscous term in
- traction form
- laplace form
Specification(s): ad_rz_displacements/traction, ad_rz_displacements/laplace
Design: Navier-Stokes Module
Issue(s): #21102
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.33The system shall be able to solve two different kernel sets with two different material domains.
Specification(s): two-mats-two-eqn-sets
Design: Navier-Stokes Module
Issue(s): #15884
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.34The system shall be able to solve two different kernel sets within one material domain.
Specification(s): one-mat-two-eqn-sets
Design: Navier-Stokes Module
Issue(s): #15884
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.35The system shall be able to solve one kernel set with two different material domains.
Specification(s): two-mats-one-eqn-set
Design: Navier-Stokes Module
Issue(s): #15884
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.62The system shall compute accurate Jacobians for the incompressible Navier-Stokes equation.
Specification(s): jacobian_test
Design: Navier-Stokes Module
Issue(s): #13025
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 10.2.63The system shall compute accurate Jacobians for the incompressible Navier-Stokes equation with stabilization.
Specification(s): jacobian_stabilized_test
Design: Navier-Stokes Module
Issue(s): #13025
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 10.2.64The system shall compute accurate Jacobians for the incompressible Navier-Stokes equation with stabilization with a traction boundary condition.
Specification(s): jacobian_traction_stabilized_test
Design: Navier-Stokes Module
Issue(s): #13025
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 10.2.66The system shall support solving a steady energy equation and transient momentum equations and apply the correct stabilization.
Specification(s): mixed
Design: Navier-Stokes Module
Issue(s): #16014
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.67The system shall support solving a steady energy equation and transient momentum equations with correct stabilization and compute a perfect Jacobian.
Specification(s): jac
Design: Navier-Stokes Module
Issue(s): #16014
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.68We shall be able to solve a canonical lid-driven problem without stabilization, using mixed order finite elements for velocity and pressure.
Specification(s): lid_driven
Design: Navier-Stokes Module
Issue(s): #000
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.69We shall be able to reproduce the results from the hand-coded lid-driven simulation using automatic differentiation objects.
Specification(s): ad_lid_driven
Design: Navier-Stokes Module
Issue(s): #13025
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.70We shall be able to run lid-dirven simulation using a global mean-zero pressure constraint approach.
Specification(s): ad_lid_driven_mean_zero_pressure
Design: Navier-Stokes Module
Issue(s): #15549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.71The Jacobian for the mixed-order INS problem shall be perfect when provided through automatic differentiation.
Specification(s): ad_lid_driven_jacobian
Design: Navier-Stokes Module
Issue(s): #13025
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.72We shall be able to solve the lid-driven problem using equal order shape functions with pressure-stabilized petrov-galerkin stabilization. We shall also demonstrate SUPG stabilization.
Specification(s): lid_driven_stabilized
Design: Navier-Stokes Module
Issue(s): #9687
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.73We shall be able to reproduce the hand-coded stabilized results with automatic differentiation objects.
Specification(s): ad_lid_driven_stabilized
Design: Navier-Stokes Module
Issue(s): #13025
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.74The Jacobian for the automatic differentiation stabilized lid-driven problem shall be perfect.
Specification(s): ad_lid_driven_stabilized_jacobian
Design: Navier-Stokes Module
Issue(s): #13025
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.75Simulation with equal-order shape functions without pressure stabilization shall be unstable.
Specification(s): still_unstable
Design: Navier-Stokes Module
Issue(s): #9687
Collection(s): FUNCTIONAL
Type(s): RunApp
- 10.2.76We shall be able to solve the INS equations using the classical Chorin splitting algorithm.
Specification(s): lid_driven_chorin
Design: Navier-Stokes Module
Issue(s): #000
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.77The system shall be able to reproduce unstabilized incompressible Navier-Stokes results with hand-coded Jacobian using a customized and condensed action syntax.
Specification(s): lid_driven_action
Design: Navier-Stokes Module
Issue(s): #15159
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.78The system shall be able to reproduce stabilized incompressible Navier-Stokes results with hand-coded Jacobian using a customized and condensed action syntax.
Specification(s): lid_driven_stabilized_action
Design: Navier-Stokes Module
Issue(s): #15159
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.79The system shall be able to reproduce unstabilized incompressible Navier-Stokes results with auto-differentiation using a customized and condensed action syntax.
Specification(s): ad_lid_driven_action
Design: Navier-Stokes Module
Issue(s): #15159
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.80The system shall be able to reproduce stabilized incompressible Navier-Stokes results with auto-differentiation using a customized and condensed action syntax.
Specification(s): ad_lid_driven_stabilized_action
Design: Navier-Stokes Module
Issue(s): #15159
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.81The system shall be able to solve a steady stabilized mass/momentum/energy incompressible Navier-Stokes formulation.
Specification(s): ad_stabilized_energy_steady
Design: Navier-Stokes Module
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.82The system shall be able to solve a transient stabilized mass/momentum/energy incompressible Navier-Stokes formulation.
Specification(s): ad_stabilized_energy_transient
Design: Navier-Stokes Module
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.83The system shall be able to solve a steady stabilized mass/momentum/energy incompressible Navier-Stokes formulation with action syntax.
Specification(s): ad_stabilized_energy_steady_action
Design: Navier-Stokes Module
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.84The system shall be able to solve a transient stabilized mass/momentum/energy incompressible Navier-Stokes formulation with action syntax.
Specification(s): ad_stabilized_energy_transient_action
Design: Navier-Stokes Module
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.85The system shall be able to solve a transient incompressible Navier-Stokes with nonlinear Smagorinsky eddy viscosity.
Specification(s): ad_stabilized_transient_les
Design: Navier-Stokes Module
Issue(s): #15757
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.110The system shall be able to solve the incompressible Navier-Stokes equations in a lid-driven cavity using the finite volume method.
Specification(s): exo
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.111The system shall be able to solve the incompressible Navier-Stokes equations in a lid-driven cavity using the finite volume Navier-Stokes action.
Specification(s): exo-action
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.112The system shall be able to solve the incompressible Navier-Stokes equations in a lid-driven cavity by fixing the point value of the pressure at a certain coordinate.
Specification(s): point-pressure
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.113The system shall be able to solve the incompressible Navier-Stokes equations in a lid-driven cavity by fixing the point value of the pressure at a certain coordinate using the NSFV action syntax.
Specification(s): point-pressure-action
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.114The system shall be able to solve an incompressible Navier-Stokes problem with dirichlet boundary conditions for all the normal components of velocity, using the finite volume method, and have a nonsingular system matrix.
Specification(s): nonsingular
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): RunApp
- 10.3.115The system shall be able to compute a perfect Jacobian when solving a lid-driven incompressible Navier-Stokes problem with the finite volume method.
Specification(s): jacobian
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.3.116The system shall be able to transport scalar quantities using the simultaneously calculated velocity field from the incompressible Navier Stokes equations.
Specification(s): with-temp
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.117The system shall be able to get the same result as the enthalpy transport example using the NSFVAction to set up the run.
Specification(s): with-temp-action
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.118The system shall be able to transport scalar quantities using the simultaneously calculated velocity field from the transient incompressible Navier Stokes equations.
Specification(s): transient-with-temp
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.119The system shall yield a quiescent fluid in an axisymmetric coordinate system with a gravitational force applied and Rhie-Chow interpolation used for the velocity field.
Specification(s): quiescent
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.120The system shall compute an accurate Jacobian when a scaling factor is applied to a scalar variable.
Specification(s): quiescent_jac
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- navier_stokes: AdvectionBC
- 10.2.29The system shall compute inflow and outflow boundary conditions for advected variables
Specification(s): advection_bc
Design: AdvectionBC
Issue(s): #13283
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.30We shall error if the user provides less velocity components than the mesh dimension
Specification(s): check_too_few_components
Design: AdvectionBC
Issue(s): #13283
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.2.31We shall error if the user provides more than 3 velocity components
Specification(s): check_too_many_components
Design: AdvectionBC
Issue(s): #13283
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.2.32We shall allow the user to supply more velocity components than the mesh dimension (up to 3 components)
Specification(s): check_more_components_than_mesh_dim
Design: AdvectionBC
Issue(s): #13283
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSADBoussinesqBodyForce
- 10.2.36The system shall be able to reproduce benchmark results for a Rayleigh number of 1e3.
Specification(s): 1e3
Design: INSADBoussinesqBodyForce
Issue(s): #15099
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.37The system shall be able to reproduce benchmark results for a Rayleigh number of 1e4.
Specification(s): 1e4
Design: INSADBoussinesqBodyForce
Issue(s): #15099
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.38The system shall be able to reproduce benchmark results for a Rayleigh number of 1e5.
Specification(s): 1e5
Design: INSADBoussinesqBodyForce
Issue(s): #15099
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.39The system shall be able to reproduce benchmark results for a Rayleigh number of 1e6.
Specification(s): 1e6
Design: INSADBoussinesqBodyForce
Issue(s): #15099
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.40The system shall be able to simulate natural convection by adding the Boussinesq approximation to the incompressible Navier-Stokes equations.
Specification(s): exo
Design: INSADBoussinesqBodyForce
Issue(s): #15099
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.41The system shall be able to solve mass, momentum, and energy incompressible Navier-Stokes equations with multiple threads.
Specification(s): threaded_exo
Design: INSADBoussinesqBodyForce
Issue(s): #15713
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.42The system shall have an accurate Jacobian provided by automatic differentiation when computing the Boussinesq approximation.
Specification(s): jac
Design: INSADBoussinesqBodyForce
Issue(s): #15099
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.43The system shall be able to support SUPG and PSPG stabilization of the incompressible Navier Stokes equations including the Boussinesq approximation.
Specification(s): exo_stab
Design: INSADBoussinesqBodyForce
Issue(s): #15099
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.44The system shall be able to solve stablized mass, momentum, and energy incompressible Navier-Stokes equations with multiple threads.
Specification(s): threaded_exo_stab
Design: INSADBoussinesqBodyForce
Issue(s): #15713
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.45The system shall have an accurate Jacobian provided by automatic differentiation when computing the Boussinesq approximation with SUPG and PSPG stabilization.
Specification(s): jac_stab
Design: INSADBoussinesqBodyForce
Issue(s): #15099
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.46The system shall be able to reproduce results of incompressible Navier-Stokes with Boussinesq approximation using a customized and condensed action syntax.
Specification(s): exo_stab_action
Design: INSADBoussinesqBodyForce
Issue(s): #15159
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.47The system shall be able to solve mass, momentum, and energy incompressible Navier-Stokes equations with a custom action syntax using multiple threads.
Specification(s): threaded_exo_stab_action
Design: INSADBoussinesqBodyForce
Issue(s): #15713
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSADMomentumCoupledForce
- 10.2.48The system shall be able to apply an external force to the incompressible Navier-Stokes momentum equation through a coupled variable.
Specification(s): steady
Design: INSADMomentumCoupledForce
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.49The system shall be able to compute an accurate Jacobian when applying an external force to the incompressible Navier-Stokes momentum equation through a coupled variable.
Specification(s): steady-jac
Design: INSADMomentumCoupledForce
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.50The system shall be able to apply an external force to the incompressible Navier-Stokes momentum equation through a vector function.
Specification(s): steady-function
Design: INSADMomentumCoupledForce
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.51The system shall be able to compute an accurate Jacobian when applying an external force to the incompressible Navier-Stokes momentum equation through a vector function.
Specification(s): steady-function-jac
Design: INSADMomentumCoupledForce
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.52The system shall be able to apply an external force to the incompressible Navier-Stokes momentum equation through a coupled variable, with the problem setup through automatic action syntax.
Specification(s): steady-action
Design: INSADMomentumCoupledForce
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.53The system shall be able to compute an accurate Jacobian when applying an external force to the incompressible Navier-Stokes momentum equation through a coupled variable, with the problem setup through automatic action syntax.
Specification(s): steady-action-jac
Design: INSADMomentumCoupledForce
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.54The system shall be able to apply an external force to the incompressible Navier-Stokes momentum equation through a vector function, with the problem setup through automatic action syntax.
Specification(s): steady-action-function
Design: INSADMomentumCoupledForce
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.55The system shall be able to compute an accurate Jacobian when applying an external force to the incompressible Navier-Stokes momentum equation through a vector function, with the problem setup through automatic action syntax.
Specification(s): steady-action-function-jac
Design: INSADMomentumCoupledForce
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.2.56The system shall be able to solve the Navier-Stokes equations with a coupled variable force and a gravity force
- provided through a dedicated object,
- or through a generic object that can simultaneously add multiple forces through both a coupled variable and a function.
- The generic object shall also be able to compute the forces solely through multiple coupled variables,
- or solely through multiple vector functions.
- The system shall be able to add the generic object through an automatic action syntax and provide two forces either through a coupled variable and a function,
- two coupled variables,
- or two functions.
Specification(s): gravity/gravity-object, gravity/var-and-func, gravity/two-vars, gravity/two-funcs, gravity/var-and-func-action, gravity/two-vars-action, gravity/two-funcs-action
Design: INSADMomentumCoupledForce
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSADEnergySource
- 10.2.57The system shall be able to model a volumetric heat source and included it in stabilization terms.
Specification(s): steady
Design: INSADEnergySource
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.58The system shall be able to build a volumetric heat source model using an automatic action syntax.
Specification(s): steady-action
Design: INSADEnergySource
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.59The system shall be able to model a volumetric heat source with a coupled variable and included it in stabilization terms.
Specification(s): steady-var
Design: INSADEnergySource
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.60The system shall be able to build a volumetric heat source model, provided through a coupled variable, using an automatic action syntax.
Specification(s): steady-var-action
Design: INSADEnergySource
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSMomentumLaplaceForm
- 10.2.61The system shall be able to model the effect of gravity on incompressible flow using a finite element discretization.
Specification(s): gravity
Design: Continuous Galerkin Finite Element Navier StokesINSMomentumLaplaceForm
Issue(s): #9528
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.86The system shall be able to apply pressure stabilization using an alpha parameter of 1e-6 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e-6/4x4, alpha_1e-6/8x8, alpha_1e-6/16x16, alpha_1e-6/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.87The system shall be able to apply pressure stabilization using an alpha parameter of 1e-3 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e-3/4x4, alpha_1e-3/8x8, alpha_1e-3/16x16, alpha_1e-3/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.88The system shall be able to apply pressure stabilization using an alpha parameter of 1e0 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e0/4x4, alpha_1e0/8x8, alpha_1e0/16x16, alpha_1e0/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.89The system shall be able to apply streamline-upwind stabilization using an alpha parameter of 1e-6 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e-6/4x4, alpha_1e-6/8x8, alpha_1e-6/16x16, alpha_1e-6/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.90The system shall be able to apply streamline-upwind stabilization using an alpha parameter of 1e-3 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e-3/4x4, alpha_1e-3/8x8, alpha_1e-3/16x16, alpha_1e-3/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.91The system shall be able to apply streamline-upwind stabilization using an alpha parameter of 1e0 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e0/4x4, alpha_1e0/8x8, alpha_1e0/16x16, alpha_1e0/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.92The system shall be able to solve high Reynolds number incompressible flow problems through use of streamline upwind Petrov-Galerkin stabilization and with a Q2Q1 discretization
Specification(s): adv_dominated_supg_stabilized
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.93The system shall be able to solve high Reynolds number incompressible flow problems through use of streamline upwind and pressure stabilized Petrov-Galerkin and with a Q1Q1 discretization
Specification(s): adv_dominated_supg_pspg_stabilized
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSMass
- 10.2.86The system shall be able to apply pressure stabilization using an alpha parameter of 1e-6 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e-6/4x4, alpha_1e-6/8x8, alpha_1e-6/16x16, alpha_1e-6/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.87The system shall be able to apply pressure stabilization using an alpha parameter of 1e-3 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e-3/4x4, alpha_1e-3/8x8, alpha_1e-3/16x16, alpha_1e-3/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.88The system shall be able to apply pressure stabilization using an alpha parameter of 1e0 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e0/4x4, alpha_1e0/8x8, alpha_1e0/16x16, alpha_1e0/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.89The system shall be able to apply streamline-upwind stabilization using an alpha parameter of 1e-6 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e-6/4x4, alpha_1e-6/8x8, alpha_1e-6/16x16, alpha_1e-6/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.90The system shall be able to apply streamline-upwind stabilization using an alpha parameter of 1e-3 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e-3/4x4, alpha_1e-3/8x8, alpha_1e-3/16x16, alpha_1e-3/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.91The system shall be able to apply streamline-upwind stabilization using an alpha parameter of 1e0 on a
- 4x4,
- 8x8,
- 16x16,
- and 32x32 mesh.
Specification(s): alpha_1e0/4x4, alpha_1e0/8x8, alpha_1e0/16x16, alpha_1e0/32x32
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.92The system shall be able to solve high Reynolds number incompressible flow problems through use of streamline upwind Petrov-Galerkin stabilization and with a Q2Q1 discretization
Specification(s): adv_dominated_supg_stabilized
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.93The system shall be able to solve high Reynolds number incompressible flow problems through use of streamline upwind and pressure stabilized Petrov-Galerkin and with a Q1Q1 discretization
Specification(s): adv_dominated_supg_pspg_stabilized
Design: INSMassINSMomentumLaplaceForm
Issue(s): #9960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: MooseApp
- 10.2.94The system shall allow MOOSE applications to specify nonzero malloc behavior; for the Navier-Stokes application, new nonzero allocations shall be errors.
Specification(s): malloc
Design: MooseApp
Issue(s): #7901
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- navier_stokes: Incompressible Finite Volume Navier Stokes
- 10.2.96The system shall be able to solve an axisymmetric pipe flow problem using a finite element discretization in which the axis of symmetry is the x-axis.
Specification(s): exo
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #21102
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.75The system shall be able to solve incompressible Navier-Stokes channel flow with no-slip boundary conditions on the wall in an axisymmetric coordinate system using an average interpolation scheme for the velocity.
Specification(s): average-no-slip
Design: Incompressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.76The system shall be able to solve incompressible Navier-Stokes channel flow with no-slip boundary conditions on the wall in an axisymmetric coordinate system using a Rhie-Chow interpolation scheme for the velocity.
Specification(s): rc-rz-no-slip-mass-conservation
Design: Incompressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 10.3.77The system shall be able to solve incompressible Navier-Stokes channel flow with free-slip boundary conditions on the wall in an axisymmetric coordinate system using a Rhie-Chow interpolation scheme for the velocity.
Specification(s): rc-free-slip
Design: Incompressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 10.3.78The system shall be able to solve a diverging channel problem in cylindrical coordinates with no slip boundary conditions.
Specification(s): rz-diverging-no-slip
Design: Incompressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 10.3.79The system shall be able to solve a straight channel problem in cylindrical coordinates using triangular elements with no slip boundary conditions.
Specification(s): rz-no-slip-tris
Design: Incompressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.80The system shall be able to solve a straight channel problem in cylindrical coordinates using triangular elements with no slip boundary conditions and the NSFV action syntax.
Specification(s): rz-no-slip-tris-action
Design: Incompressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.81The system shall be able to solve a diverging channel problem in cylindrical coordinates with free slip boundary conditions.
Specification(s): rz-diverging-free-slip
Design: Incompressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.82The system shall conserve mass when solving a Cartesian channel flow problem with one symmetry boundary condition and one no-slip wall boundary condition.
Specification(s): rc-xyz-no-slip-mass-conservation
Design: Incompressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.83The system shall be able to model free-slip conditions in a 1D channel; specifically the tangential velocity shall have a uniform value of unity and the pressure shall not change.
Specification(s): 1d-rc
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.84The system shall be able to model free-slip conditions in a channel; specifically the tangential velocity shall have a uniform value of unity, the normal velocity shall have a uniform value of zero, and the pressure shall not change.
Specification(s): free-slip
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.85The system shall be able to model free-slip conditions in a channel using the NSFV action.
Specification(s): free-slip-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.86The system shall be able to model no-slip conditions in a channel; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): no-slip
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.87The system shall be able to model no-slip conditions in a channel using incompressible Navier Stokes action.
Specification(s): no-slip-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.94The system shall be able to model the effect of Reynolds-averaged parameters on the momentum and passive scalar advection equations using a mixing length model and the NSFVAction syntax
Specification(s): mixing-length-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.98The system shall be able to model linear volumetric friction in a channel using NSFVAction syntax.
Specification(s): linear-friction-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.99The system shall be able to model quadratic volumetric friction in a channel using NSFVAction syntax.
Specification(s): quadratic-friction-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.103The system shall be able to model free-slip conditions in a 3D square channel; specifically the tangential velocity shall have a uniform value of unity and the pressure shall not change.
Specification(s): 3d-rc
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.104The system shall be able to compute gradients, when extrapolated boundary face values make the gradient computation singular, by catching the singularity error and re-running without doing boundary face value extrapolation.
Specification(s): singular_two_term_expansion
Design: Incompressible Finite Volume Navier StokesNSFVAction
Issue(s): #16822
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.106The system shall be able to simulate a transient flow in a channel with enthalpy as an advected quantity.
Specification(s): transient
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.107The system shall be able to simulate a transient flow in a channel with enthalpy as an advected quantity using the NSFV action syntax.
Specification(s): transient-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.123The system shall exhibit second order convergence for all variables in a Cartesian, no-slip, channel-flow problem using a Rhie-Chow interpolation, including body forces, and two term boundary expansion for gradient and extrapolated boundary face value computation.
Specification(s): two_term
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.124The system shall exhibit second order convergence for all variables in a Cartesian, no-slip, channel-flow problem with a symmetry axis using a Rhie-Chow interpolation, including body forces, and two term boundary expansion for gradient and extrapolated boundary face value computation.
Specification(s): two_term_symmetry
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.125The system shall exhibit second order convergence for all variables in an axisymmetric, no-slip, channel-flow problem using a Rhie-Chow interpolation, including body forces, and two term boundary expansion for gradient and extrapolated boundary face value computation.
Specification(s): two_term_symmetry_rz
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.126The system shall be able to solve a problem with channel-flow like boundary conditions in the coordinate system with an average interpolation for the velocity and demonstrate second order convergence in the velocity variables and first order convergence in the pressure variable.
Specification(s): average
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.127The system shall be able to solve a problem with channel-flow like boundary conditions in the coordinate system with a Rhie-Chow interpolation for the velocity and demonstrate second order convergence in the velocity and pressure variables.
Specification(s): rc
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.128The system shall be able to solve the incompressible Navier-Stokes equations in an RZ coordinate system, including energy, using an average interpolation for the velocity, with a mix of Dirichlet and zero-gradient boundary conditions for each variable, and demonstrate second order convergence for each variable other than the pressure which shall demonstrate first order convergence.
Specification(s): average-with-temp
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.129The system shall be able to solve the incompressible Navier-Stokes equations in an RZ coordinate system, including energy, using a RC interpolation for the velocity, with a mix of Dirichlet and zero-gradient boundary conditions for each variable, and demonstrate second order convergence for each variable.
Specification(s): rc-with-temp
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.130The system shall demonstrate global second order convergence for all variables on a rotated mesh when using an average interpolation for the velocity and a two term Taylor series expansion for face values on non-Dirichlet boundaries.
Specification(s): plane-poiseuille-average
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.131The system shall demonstrate global second order convergence for all variables on a rotated mesh when using an RC interpolation for the velocity and a two term Taylor series expansion for face values on non-Dirichlet boundaries.
Specification(s): plane-poiseuille-rc
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.132The system shall demonstrate global second order convergence for velocity variables and first order convergence for the pressure variable on a rotated mesh when using an average interpolation for the velocity and a one term Taylor series expansion for face values on non-Dirichlet boundaries.
Specification(s): plane-poiseuille-average-first
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.133The system shall demonstrate global second order convergence for all variables on a rotated mesh when using an RC interpolation for the velocity and a one term Taylor series expansion for face values on non-Dirichlet boundaries.
Specification(s): plane-poiseuille-rc-first
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.134The system shall be able to solve the incompressible Navier-Stokes equations in one dimension with prescribed inlet velocity and outlet pressure and implicit zero gradient boundary conditions elsewhere, and demonstrate second order convergence in both velocity and pressure when using an average interpolation scheme for the velocity.
Specification(s): 1d-average
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.135The system shall be able to solve the incompressible Navier-Stokes equations in two dimensions with prescribed inlet velocity and outlet pressure, free slip along the walls, and implicit zero gradient boundary conditions elsewhere, and demonstrate second order convergence in both velocity and pressure when using an average interpolation scheme for the velocity.
Specification(s): 2d-average
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.136The system shall be able to solve the incompressible Navier-Stokes equations in two dimensions with prescribed inlet velocity and outlet pressure, free slip along the walls, and implicit zero gradient boundary conditions elsewhere, and demonstrate second order convergence in both velocity and pressure when using a Rhie-Chow interpolation scheme for the velocity.
Specification(s): 2d-rc
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.137The system shall demonstrate global second order convergence for all variables when using an average interpolation for the velocity and a two term Taylor series expansion for face values on non-Dirichlet boundaries.
Specification(s): plane-poiseuille-average
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.138The system shall demonstrate global second order convergence for all variables when using an RC interpolation for the velocity and a two term Taylor series expansion for face values on non-Dirichlet boundaries.
Specification(s): plane-poiseuille-rc
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.139The system shall demonstrate global second order convergence for all variables when using an average interpolation for the velocity and a one term Taylor series expansion for face values on non-Dirichlet boundaries.
Specification(s): plane-poiseuille-average-first
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.140The system shall demonstrate global second order convergence for all variables when using an RC interpolation for the velocity and a one term Taylor series expansion for face values on non-Dirichlet boundaries.
Specification(s): plane-poiseuille-rc-first
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.141The system shall be able to solve the incompressible Navier-Stokes equations, including energy, using an average interpolation for the velocity, with a mix of Dirichlet and zero-gradient boundary conditions for each variable, and demonstrate second order convergence for each variable.
Specification(s): 2d-average-with-temp
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.142The system shall be able to solve the incompressible Navier-Stokes equations, including energy, using a Rhie-Chow interpolation for the velocity, with a mix of Dirichlet and zero-gradient boundary conditions for each variable, and demonstrate second order convergence for each variable.
Specification(s): 2d-rc-with-temp
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.143The system shall be able to solve the incompressible Navier-Stokes equations in 2D cylindrical coordinates, using a Rhie-Chow scheme, dirichlet boundary conditions for both variables, and demonstrate second order convergence for the velocity and pressure.
Specification(s): 2d-rc-diri
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.144The system shall be able to solve the incompressible Navier-Stokes equations on triangular meshes, using a Rhie-Chow scheme and skewness-correction, Dirichlet boundary conditions for the velocity, and demonstrate second order convergence for the velocity and first order convergence for pressure.
Specification(s): vortex-skewness-corrected
Design: Incompressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.145The system shall be able to solve the incompressible Navier-Stokes equations on triangular meshes using skewness-correction and the NSFV action syntax.
Specification(s): vortex-skewness-corrected-action
Design: Incompressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.146The system shall be able to automatically expand its ghosting pattern when skew-corrected face gradients are involved in the simulation.
Specification(s): run
Design: Incompressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): RunApp
- 10.3.147The system shall be able to solve the incompressible Navier-Stokes equations using a Rhie-Chow interpolation scheme and produce second order convergence for all variables.
Specification(s): rc
Design: Incompressible Finite Volume Navier Stokes
Issue(s): #15640
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- navier_stokes: INSADEnergyAmbientConvection
- 10.2.100The system shall be able to model heat transfer from ambient surroundings using a volumetric approximation.
Specification(s): steady
Design: INSADEnergyAmbientConvection
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.2.101The system shall be able to build a simulation, modeling heat transfer from ambient surroundings, using an automated action syntax.
Specification(s): steady-action
Design: INSADEnergyAmbientConvection
Issue(s): #15500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSAction
- 10.2.102The system shall be able to add a incompressible Navier-Stokes energy/temperature equation using an action, but use a temperature variable already added in the input file.
Specification(s): steady-action-no-temp-var
Design: INSAction
Issue(s): #15607
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: CNSFVHLLCBase
- 10.3.1The system shall be able to solve the 1D Sod shock-tube benchmark problem using an HLLC scheme to compute convective fluxes.
Specification(s): hllc_sod_shocktube_1D_benchmark
Design: CNSFVHLLCBase
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.4The system shall exhibit first order convergence for all variables for the free-flow Euler equations using a HLLC discretization scheme for the advection flux and with specified temperature and momentum at one boundary and specified pressure at another boundary.
Specification(s): 1d-free-flow-hllc
Design: CNSFVHLLCBase
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.11The system displays issues when trying to solve hyperbolic equations with sources when using a Godunov method with HLLC approximate Riemann solver on an irregular grid
- when the source has a cell-centered volumetric discretization
Specification(s): sources_give_hllc_problems_irregular/hllc_with_volume_source
Design: CNSFVHLLCBase
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.12On a regular grid, using a HLLC scheme to calculate inter-cell fluxes, the system shall show, via the momentum variable
- conservation of mass when no sources are present
- violation of conservation of mass when sources are present
- lesser violation of conservation of mass when sources are present and the mesh is refined
Specification(s): sources_give_hllc_problems_regular/conserved, sources_give_hllc_problems_regular/non_conserved, sources_give_hllc_problems_regular/non_conserved_finer
Design: CNSFVHLLCBase
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.14The system shall be able to solve compressible fluid flow kernels for mass, momentum, and energy with the addition of diffusion and display first order convergence for all variables when using a HLLC scheme for the convection terms.
Specification(s): 1d-hllc
Design: CNSFVHLLCBase
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.15The system shall be able to model subsonic nozzle flow using an HLLC discretization with a specified outlet pressure.
Specification(s): fv_specified_pressure_out
Design: CNSFVHLLCBase
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.17The system shall be able to run a two-dimensional version of Sod's shocktube problem.
Specification(s): hllc_sod_shocktube_2D
Design: CNSFVHLLCBase
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): RunApp
- 10.3.23The system shall be able to run a two-dimensional symmetric flow problem with an HLLC discretization for advection.
Specification(s): 2D_symmetry_hllc
Design: CNSFVHLLCBase
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): RunApp
- navier_stokes: PCNSFVKT
- 10.3.2The system shall be able to solve the steady Euler equations in a heated channel using Kurganov-Tadmor with linearly reconstructed data with Van-Leer limiting for the convection term and a primitive variable set and show a flat momentum profile
Specification(s): kt-van-leer-primitive
Design: PCNSFVKT
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.6The system shall be able to use a primitive variable set and compute intercell fluxes using a Kurganov-Tadmor scheme
- when using central differencing to interpolate cell center values to faces and display second order convergence
- when using directional upwinding to interpolate cell center values to faces and display first order convergence
- when using linear interpolation of cell center values to faces with Van-Leer limiting and display at least second order convergence
Specification(s): primitive_basic_kurganov_tadmor/central_difference, primitive_basic_kurganov_tadmor/upwind, primitive_basic_kurganov_tadmor/vanLeer
Design: PCNSFVKT
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.7The system shall be able to use a conserved variable set and compute intercell fluxes using a Kurganov-Tadmor scheme
- when using central differencing to interpolate cell center values to faces and display second order convergence
- when using directional upwinding to interpolate cell center values to faces and display first order convergence
- when using linear interpolation of cell center values to faces with Van-Leer limiting and display at least second order convergence
Specification(s): conserved_basic_kurganov_tadmor/central_difference, conserved_basic_kurganov_tadmor/upwind, conserved_basic_kurganov_tadmor/vanLeer
Design: PCNSFVKT
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.8The system shall be able to solve a problem with continuously varying porosity provided through a function object, using a primitive variable set, and compute intercell fluxes using a Kurganov-Tadmor (KT) scheme with the KT Method for computing omega
- when using central differencing to interpolate cell center values to faces and display second order convergence
- when using directional upwinding to interpolate cell center values to faces and display first order convergence
- when using linear interpolation of cell center values to faces with Van-Leer limiting and display at least second order convergence
Specification(s): primitive_basic_kurganov_tadmor_varying_porosity_function/central_difference, primitive_basic_kurganov_tadmor_varying_porosity_function/upwind, primitive_basic_kurganov_tadmor_varying_porosity_function/vanLeer
Design: PCNSFVKT
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.9The system shall be able to solve a problem with continuously varying porosity provided through a function object, using a primitive variable set, and compute intercell fluxes using a Kurganov-Tadmor scheme with the Kurganov-Noelle-Petrova method for computing omega
- when using central differencing to interpolate cell center values to faces and display second order convergence
- when using directional upwinding to interpolate cell center values to faces and display first order convergence
- when using linear interpolation of cell center values to faces with Van-Leer limiting and display at least second order convergence
Specification(s): primitive_basic_knp_varying_porosity_function/central_difference, primitive_basic_knp_varying_porosity_function/upwind, primitive_basic_knp_varying_porosity_function/vanLeer
Design: PCNSFVKT
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.10The system shall be able to solve a problem with continuously varying porosity provided through a function object, using a mixed variable set, and compute intercell fluxes using a Kurganov-Tadmor scheme
- when using central differencing to interpolate cell center values to faces and display second order convergence
- when using directional upwinding to interpolate cell center values to faces and display first order convergence
Specification(s): mixed_basic_kurganov_tadmor_varying_porosity_function/central_difference, mixed_basic_kurganov_tadmor_varying_porosity_function/upwind
Design: PCNSFVKT
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.16The system shall be able to advect a scalar using density and velocity computed through solution of the Euler equations.
Specification(s): scalar_advection
Design: PCNSFVKT
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.19The system shall be able to solve a series of stages of continuous porosity changes with different schemes for computing the convective fluxes assuming piecewise constant data including
- the Kurganov-Tadmor scheme
- the HLLC scheme
Specification(s): continuous_eps/continuous_eps_kt, continuous_eps/continuous_eps_hllc
Design: PCNSFVHLLCPCNSFVKTPNSFVPGradEpsilonPorousPrimitiveVarMaterial
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.20The system shall be able to solve a two-dimensional y-channel problem with frictional drag and a series of porosity jumps smoothed into a continuous porosity function, using the Kurganov-Tadmor scheme for computing intercell convective fluxes with upwind limiting interpolation (e.g. the + cell centroid value is used as the + side value at the face).
Specification(s): twod_y_channel_upwind_frictional_porosity_function
Design: PCNSFVKTPNSFVPGradEpsilonPorousPrimitiveVarMaterialPCNSFVMomentumFriction
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.21The system shall be able to solve a two-dimensional y-channel problem using a mixed variable set with frictional drag and a series of porosity jumps smoothed into a continuous porosity function, using the Kurganov-Tadmor scheme for computing intercell convective fluxes with upwind limiting interpolation (e.g. the + cell centroid value is used as the + side value at the face).
Specification(s): twod_y_channel_upwind_frictional_porosity_function_mixed
Design: PCNSFVKTPNSFVPGradEpsilonPorousMixedVarMaterialPCNSFVMomentumFriction
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: CNSFVHLLCMassImplicitBC
- 10.3.3The system shall be able to impose boundary advective fluxes for HLLC discretizations that use implicit/interior cell information.
Specification(s): fv_implicit_bcs
Design: CNSFVHLLCMassImplicitBCCNSFVHLLCMomentumImplicitBCCNSFVHLLCFluidEnergyImplicitBC
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: CNSFVHLLCMomentumImplicitBC
- 10.3.3The system shall be able to impose boundary advective fluxes for HLLC discretizations that use implicit/interior cell information.
Specification(s): fv_implicit_bcs
Design: CNSFVHLLCMassImplicitBCCNSFVHLLCMomentumImplicitBCCNSFVHLLCFluidEnergyImplicitBC
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: CNSFVHLLCFluidEnergyImplicitBC
- 10.3.3The system shall be able to impose boundary advective fluxes for HLLC discretizations that use implicit/interior cell information.
Specification(s): fv_implicit_bcs
Design: CNSFVHLLCMassImplicitBCCNSFVHLLCMomentumImplicitBCCNSFVHLLCFluidEnergyImplicitBC
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PCNSFVHLLC
- 10.3.5The system shall exhibit first order convergence for all variables for the porous Euler equations using a HLLC discretization scheme for the advection flux and with specified temperature and momentum/velocity at one boundary and specified pressure at another boundary with
- constant porosity
- varying porosity
Specification(s): 1d-porous-hllc/constant, 1d-porous-hllc/varying
Design: PCNSFVHLLC
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.19The system shall be able to solve a series of stages of continuous porosity changes with different schemes for computing the convective fluxes assuming piecewise constant data including
- the Kurganov-Tadmor scheme
- the HLLC scheme
Specification(s): continuous_eps/continuous_eps_kt, continuous_eps/continuous_eps_hllc
Design: PCNSFVHLLCPCNSFVKTPNSFVPGradEpsilonPorousPrimitiveVarMaterial
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PINSFVMomentumAdvection
- 10.3.13The system shall demonstrate first order convergence rates for pressure and superficial velocity when using an upwind interpolation for advected quantities in a weakly compressible formulation of the mass and momentum Euler equations.
Specification(s): pwcnsfv
Design: PINSFVMomentumAdvection
Issue(s): #18215
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- navier_stokes: CNSFVHLLCStagnationInletBC
- 10.3.18The system shall be able to model supersonic nozzle flow using an HLLC advective flux discretization and with inlet boundary conditions based on stagnation temperature and stagnation pressure.
Specification(s): supersonic_nozzle_hllc
Design: CNSFVHLLCStagnationInletBC
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PNSFVPGradEpsilon
- 10.3.19The system shall be able to solve a series of stages of continuous porosity changes with different schemes for computing the convective fluxes assuming piecewise constant data including
- the Kurganov-Tadmor scheme
- the HLLC scheme
Specification(s): continuous_eps/continuous_eps_kt, continuous_eps/continuous_eps_hllc
Design: PCNSFVHLLCPCNSFVKTPNSFVPGradEpsilonPorousPrimitiveVarMaterial
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.20The system shall be able to solve a two-dimensional y-channel problem with frictional drag and a series of porosity jumps smoothed into a continuous porosity function, using the Kurganov-Tadmor scheme for computing intercell convective fluxes with upwind limiting interpolation (e.g. the + cell centroid value is used as the + side value at the face).
Specification(s): twod_y_channel_upwind_frictional_porosity_function
Design: PCNSFVKTPNSFVPGradEpsilonPorousPrimitiveVarMaterialPCNSFVMomentumFriction
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.21The system shall be able to solve a two-dimensional y-channel problem using a mixed variable set with frictional drag and a series of porosity jumps smoothed into a continuous porosity function, using the Kurganov-Tadmor scheme for computing intercell convective fluxes with upwind limiting interpolation (e.g. the + cell centroid value is used as the + side value at the face).
Specification(s): twod_y_channel_upwind_frictional_porosity_function_mixed
Design: PCNSFVKTPNSFVPGradEpsilonPorousMixedVarMaterialPCNSFVMomentumFriction
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PorousPrimitiveVarMaterial
- 10.3.19The system shall be able to solve a series of stages of continuous porosity changes with different schemes for computing the convective fluxes assuming piecewise constant data including
- the Kurganov-Tadmor scheme
- the HLLC scheme
Specification(s): continuous_eps/continuous_eps_kt, continuous_eps/continuous_eps_hllc
Design: PCNSFVHLLCPCNSFVKTPNSFVPGradEpsilonPorousPrimitiveVarMaterial
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.20The system shall be able to solve a two-dimensional y-channel problem with frictional drag and a series of porosity jumps smoothed into a continuous porosity function, using the Kurganov-Tadmor scheme for computing intercell convective fluxes with upwind limiting interpolation (e.g. the + cell centroid value is used as the + side value at the face).
Specification(s): twod_y_channel_upwind_frictional_porosity_function
Design: PCNSFVKTPNSFVPGradEpsilonPorousPrimitiveVarMaterialPCNSFVMomentumFriction
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PCNSFVMomentumFriction
- 10.3.20The system shall be able to solve a two-dimensional y-channel problem with frictional drag and a series of porosity jumps smoothed into a continuous porosity function, using the Kurganov-Tadmor scheme for computing intercell convective fluxes with upwind limiting interpolation (e.g. the + cell centroid value is used as the + side value at the face).
Specification(s): twod_y_channel_upwind_frictional_porosity_function
Design: PCNSFVKTPNSFVPGradEpsilonPorousPrimitiveVarMaterialPCNSFVMomentumFriction
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.21The system shall be able to solve a two-dimensional y-channel problem using a mixed variable set with frictional drag and a series of porosity jumps smoothed into a continuous porosity function, using the Kurganov-Tadmor scheme for computing intercell convective fluxes with upwind limiting interpolation (e.g. the + cell centroid value is used as the + side value at the face).
Specification(s): twod_y_channel_upwind_frictional_porosity_function_mixed
Design: PCNSFVKTPNSFVPGradEpsilonPorousMixedVarMaterialPCNSFVMomentumFriction
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PorousMixedVarMaterial
- 10.3.21The system shall be able to solve a two-dimensional y-channel problem using a mixed variable set with frictional drag and a series of porosity jumps smoothed into a continuous porosity function, using the Kurganov-Tadmor scheme for computing intercell convective fluxes with upwind limiting interpolation (e.g. the + cell centroid value is used as the + side value at the face).
Specification(s): twod_y_channel_upwind_frictional_porosity_function_mixed
Design: PCNSFVKTPNSFVPGradEpsilonPorousMixedVarMaterialPCNSFVMomentumFriction
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PCNSFVKTDC
- 10.3.22The system shall support the deferred correction algorithm for transitioning from low-order to high-order representations of the convective flux during a transient simulation.
Specification(s): deferred_correction
Design: PCNSFVKTDC
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: HLLCUserObject
- 10.3.24The system shall be able to compute wave speeds for HLLC Riemann solvers.
Specification(s): HLLC_wave_speeds_1D
Design: HLLCUserObjectWaveSpeedVPP
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 10.3.25The system shall be able to compute wave speeds for HLLC Riemann solvers in multiple dimensions.
Specification(s): HLLC_wave_speeds_2D
Design: HLLCUserObjectWaveSpeedVPP
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- navier_stokes: WaveSpeedVPP
- 10.3.24The system shall be able to compute wave speeds for HLLC Riemann solvers.
Specification(s): HLLC_wave_speeds_1D
Design: HLLCUserObjectWaveSpeedVPP
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 10.3.25The system shall be able to compute wave speeds for HLLC Riemann solvers in multiple dimensions.
Specification(s): HLLC_wave_speeds_2D
Design: HLLCUserObjectWaveSpeedVPP
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- navier_stokes: NSFVFunctorHeatFluxBC
- 10.3.26The system shall provide a boundary condition to split a constant heat flux according to local values of porosity, using functor material properties.
Specification(s): local_porosity
Design: NSFVFunctorHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.27The system shall provide a boundary condition to split a constant heat flux according to domain-averaged values of porosity, using functor material properties.
Specification(s): global_porosity
Design: NSFVFunctorHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.28The system shall provide a boundary condition to split a constant heat flux according to local values of thermal conductivity, using functor material properties.
Specification(s): local_k
Design: NSFVFunctorHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.29The system shall provide a boundary condition to split a constant heat flux according to domain-averaged values of thermal conductivity, using functor material properties.
Specification(s): global_k
Design: NSFVFunctorHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.30The system shall provide a boundary condition to split a constant heat flux according to local values of effective thermal conductivity, using functor material properties.
Specification(s): local_kappa
Design: NSFVFunctorHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.31The system shall provide a boundary condition to split a constant heat flux according to domain-averaged values of effective thermal conductivity, using functor material properties.
Specification(s): global_kappa
Design: NSFVFunctorHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: NSFVHeatFluxBC
- 10.3.32The system shall provide a boundary condition to split a constant heat flux according to local values of porosity.
Specification(s): local_porosity
Design: NSFVHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.33The system shall provide a boundary condition to split a constant heat flux according to domain-averaged values of porosity.
Specification(s): global_porosity
Design: NSFVHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.34The system shall provide a boundary condition to split a constant heat flux according to local values of thermal conductivity.
Specification(s): local_k
Design: NSFVHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.35The system shall provide a boundary condition to split a constant heat flux according to domain-averaged values of thermal conductivity.
Specification(s): global_k
Design: NSFVHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.36The system shall provide a boundary condition to split a constant heat flux according to local values of effective thermal conductivity.
Specification(s): local_kappa
Design: NSFVHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.37The system shall provide a boundary condition to split a constant heat flux according to domain-averaged values of effective thermal conductivity.
Specification(s): global_kappa
Design: NSFVHeatFluxBC
Issue(s): #18434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: Turbulence modeling
- 10.3.38The system shall be able to impose a wall shear stress at the wall according to the algebraic wall function.
Specification(s): wall-function-bc
Design: Turbulence modelingINSFVWallFunctionBC
Issue(s): #18273
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.93The system shall be able to model the effect of Reynolds-averaged parameters on the momentum and passive scalar advection equations using a mixing length model
Specification(s): mixing-length
Design: Turbulence modeling
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.95The system shall be able to model the effect of Reynolds-averaged parameters on the momentum and passive scalar advection equations using a mixing length model and show a perfect Jacobian
Specification(s): mixing-length-jac
Design: Turbulence modeling
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.3.121The system shall be able to compute the turbulent viscosity based on the capped mixing length model and store it in a variable when performing
- transient simulations
- steady simulations
Specification(s): capped_mixing_length/transient, capped_mixing_length/steady
Design: Turbulence modelingINSFVMixingLengthTurbulentViscosityAux
Issue(s): #18666
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.122The system shall be able to calculate the material property comprising the total turbulent viscosity, based on the capped mixing length model when performing
- transient simulations
- steady simulations
- steady simulations with action syntax
Specification(s): capped_mixing_length/transient, capped_mixing_length/steady, capped_mixing_length/steady_action
Design: Turbulence modelingMixingLengthTurbulentViscosityMaterialNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.156The system shall be able to compute the turbulent viscosity based on the capped mixing length model.
Specification(s): capped_mixing_length
Design: Turbulence modelingWallDistanceMixingLengthAux
Issue(s): #18666
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSFVWallFunctionBC
- 10.3.38The system shall be able to impose a wall shear stress at the wall according to the algebraic wall function.
Specification(s): wall-function-bc
Design: Turbulence modelingINSFVWallFunctionBC
Issue(s): #18273
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: FVConvectionCorrelationInterface
- 10.3.39The system shall be able to solve for wall-convection with a user-specified heat transfer coefficient
- for a cavity problem
- and for a channel problem.
Specification(s): convection_correlation/cavity, convection_correlation/channel
Design: FVConvectionCorrelationInterface
Issue(s): #17638
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSFVFrictionFlowDiode
- 10.3.40The system shall be able to model a simple friction-based volumetric flow diode
Specification(s): friction_flow_diode
Design: INSFVFrictionFlowDiode
Issue(s): #20695
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: NSFVAction
- 10.3.41The system shall throw an error if the number of momentum inlet types does not match the number of inlet boundaries.
Specification(s): momentum-inlet-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.42The system shall throw an error if the number of momentum inlet functions does not match the number of inlet boundaries times the dimension of the mesh.
Specification(s): momentum-inlet-function-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.43The system shall throw an error if the number of momentum outlet types does not match the number of outlet boundaries.
Specification(s): momentum-outlet-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.44The system shall throw an error if the number of pressure outlet functions is not the same the pressure outlet boundaries.
Specification(s): pressure-outlet-function-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.45The system shall throw an error if the number of momentum wall types does not match the number of wall boundaries.
Specification(s): momentum-wall-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.46The system shall throw an error if the number of energy inlet types does not match the number of inlet boundaries.
Specification(s): energy-inlet-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.47The system shall throw an error if the number of passive scalar inlet types does not match the number of inlet boundaries.
Specification(s): passive-scalar-inlet-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.48The system shall throw an error if the number of passive scalar inlet functions does not match the number of inlet boundaries.
Specification(s): passive-scalar-inlet-function-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.49The system shall throw an error if the number of energy wall types does not match the number of wall boundaries.
Specification(s): energy-wall-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.50The system shall throw an error if the number of energy wall functions does not match the number of energy wall types.
Specification(s): energy-wall-function-action-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.51The system shall throw an error if the number of defined initial conditions is different than the number of created scalar variables.
Specification(s): scalar-ic-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.52The system shall throw an error if the number of components for the initial velocity is not 3.
Specification(s): velocity-ic-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.53The system shall throw an error if friction correction is requested with no porous medium treatment.
Specification(s): porosity-correction-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.54The system shall throw an error if consistent scaling is defined without using friction correction
Specification(s): porosity-scaling-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.55The system shall throw an error if porosity smoothing is requested without porous medium treatment.
Specification(s): porosity-smoothing-layer-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.56The system shall throw an error if the user defines an inappropriate number of passive scalar diffusivities
Specification(s): passive-scalar-diffusivity-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.57The system shall throw an error if the user defines an inappropriate number of passive scalar source functions
Specification(s): passive-scalar-source-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.58The system shall throw an error if the user defines an inappropriate number of passive scalar coupled source functions
Specification(s): passive-scalar-coupled-source-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.59The system shall throw an error if the user defines an inappropriate number of passive scalar coupled source coefficients
Specification(s): passive-scalar-coupled-source-coeff-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.60The system shall throw an error if the user defines an inappropriate number of passive scalar Schmidt numbers
Specification(s): passive-scalar-schmidt-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.61The system shall throw an error if the user supplies a velocity variable which does not exist
Specification(s): velocity-variable-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.62The system shall throw an error if the user supplies an inappropriate number of externally created velocity components
Specification(s): velocity-component-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.63The system shall throw an error if the user supplies a pressure variable which does not exist
Specification(s): pressure-variable-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.64The system shall throw an error if the user supplies a fluid temperature variable which does not exist
Specification(s): fluid-temperature-variable-error
Design: NSFVAction
Issue(s): #19472
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.83The system shall be able to model free-slip conditions in a 1D channel; specifically the tangential velocity shall have a uniform value of unity and the pressure shall not change.
Specification(s): 1d-rc
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.84The system shall be able to model free-slip conditions in a channel; specifically the tangential velocity shall have a uniform value of unity, the normal velocity shall have a uniform value of zero, and the pressure shall not change.
Specification(s): free-slip
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.85The system shall be able to model free-slip conditions in a channel using the NSFV action.
Specification(s): free-slip-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.86The system shall be able to model no-slip conditions in a channel; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): no-slip
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.87The system shall be able to model no-slip conditions in a channel using incompressible Navier Stokes action.
Specification(s): no-slip-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.89The system shall be able to create and transport scalar field variables in a fluid flow field using the NSFVAction syntax.
Specification(s): scalar-transport-action
Design: NSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.90The system shall be able to transport an externally-generated scalar field variables in a fluid flow field using the NSFVAction syntax.
Specification(s): external-scalar-transport-action
Design: NSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.94The system shall be able to model the effect of Reynolds-averaged parameters on the momentum and passive scalar advection equations using a mixing length model and the NSFVAction syntax
Specification(s): mixing-length-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.98The system shall be able to model linear volumetric friction in a channel using NSFVAction syntax.
Specification(s): linear-friction-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.99The system shall be able to model quadratic volumetric friction in a channel using NSFVAction syntax.
Specification(s): quadratic-friction-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.103The system shall be able to model free-slip conditions in a 3D square channel; specifically the tangential velocity shall have a uniform value of unity and the pressure shall not change.
Specification(s): 3d-rc
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.104The system shall be able to compute gradients, when extrapolated boundary face values make the gradient computation singular, by catching the singularity error and re-running without doing boundary face value extrapolation.
Specification(s): singular_two_term_expansion
Design: Incompressible Finite Volume Navier StokesNSFVAction
Issue(s): #16822
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.106The system shall be able to simulate a transient flow in a channel with enthalpy as an advected quantity.
Specification(s): transient
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.107The system shall be able to simulate a transient flow in a channel with enthalpy as an advected quantity using the NSFV action syntax.
Specification(s): transient-action
Design: Incompressible Finite Volume Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.110The system shall be able to solve the incompressible Navier-Stokes equations in a lid-driven cavity using the finite volume method.
Specification(s): exo
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.111The system shall be able to solve the incompressible Navier-Stokes equations in a lid-driven cavity using the finite volume Navier-Stokes action.
Specification(s): exo-action
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.112The system shall be able to solve the incompressible Navier-Stokes equations in a lid-driven cavity by fixing the point value of the pressure at a certain coordinate.
Specification(s): point-pressure
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.113The system shall be able to solve the incompressible Navier-Stokes equations in a lid-driven cavity by fixing the point value of the pressure at a certain coordinate using the NSFV action syntax.
Specification(s): point-pressure-action
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.114The system shall be able to solve an incompressible Navier-Stokes problem with dirichlet boundary conditions for all the normal components of velocity, using the finite volume method, and have a nonsingular system matrix.
Specification(s): nonsingular
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): RunApp
- 10.3.115The system shall be able to compute a perfect Jacobian when solving a lid-driven incompressible Navier-Stokes problem with the finite volume method.
Specification(s): jacobian
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.3.116The system shall be able to transport scalar quantities using the simultaneously calculated velocity field from the incompressible Navier Stokes equations.
Specification(s): with-temp
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.117The system shall be able to get the same result as the enthalpy transport example using the NSFVAction to set up the run.
Specification(s): with-temp-action
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.118The system shall be able to transport scalar quantities using the simultaneously calculated velocity field from the transient incompressible Navier Stokes equations.
Specification(s): transient-with-temp
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.119The system shall yield a quiescent fluid in an axisymmetric coordinate system with a gravitational force applied and Rhie-Chow interpolation used for the velocity field.
Specification(s): quiescent
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.120The system shall compute an accurate Jacobian when a scaling factor is applied to a scalar variable.
Specification(s): quiescent_jac
Design: Navier-Stokes ModuleNSFVAction
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.3.122The system shall be able to calculate the material property comprising the total turbulent viscosity, based on the capped mixing length model when performing
- transient simulations
- steady simulations
- steady simulations with action syntax
Specification(s): capped_mixing_length/transient, capped_mixing_length/steady, capped_mixing_length/steady_action
Design: Turbulence modelingMixingLengthTurbulentViscosityMaterialNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.159The system shall be able to solve for fluid energy diffusion, advection and convection with the solid phase in a 2D channel using the NSFV action syntax.
Specification(s): solid-fluid-action
Design: NSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.161The system shall be able to solve for fluid energy diffusion, advection and block-restricted convection with the solid phase in a 2D channel using the NSFV action syntax.
Specification(s): solid-fluid-block-action
Design: NSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.163The system shall be able to run transient simulations with fluid energy diffusion, advection and convection with the solid phase in a 2D channel, modeling both fluid and solid temperature using the NSFV action syntax.
Specification(s): transient-action
Design: NSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.165The system shall be able to solve for fluid energy diffusion, advection and convection with the solid phase in a 2D channel with a Boussinesq approximation using the NSFV action syntax.
Specification(s): boussinesq-action
Design: NSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.174The system shall be able to model free-slip conditions in a porous media channel; specifically the tangential velocity shall have a uniform value of unity, the normal velocity shall have a uniform value of zero, and the pressure shall not change.
Specification(s): free-slip
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.175The system should be able to run a porous medium channel computation using the NSFV action.
Specification(s): free-slip-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.176The system shall be able to model free-slip conditions in a porous media cylindrical channel; specifically the tangential velocity shall have a uniform value of unity, the normal velocity shall have a uniform value of zero, and the pressure shall not change.
Specification(s): free-slip-rz
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.177The system shall be able to model no-slip conditions in a porous media channel; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): no-slip
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.178The system shall be able to model no-slip conditions in a porous media channel with flow driven by a pressure differential; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): no-slip-pressure-driven
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.179The system shall be able to model no-slip conditions in a porous media channel with flow driven by a pressure differential using the NSFVAction syntax.
Specification(s): no-slip-pressure-driven-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.180The system shall be able to model no-slip conditions in a porous media channel with a set mean pressure; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): no-slip-pressure-average
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.181The system shall be able to model no-slip conditions in a porous media channel using the NSFV action and a set mean pressure.
Specification(s): no-slip-pressure-average-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.182The system shall be able to model no-slip conditions in a porous media channel using an average interpolation for velocity; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): no-slip-average
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.183The system shall be able to model no-slip conditions in a porous media channel with a porosity of 1; specifically, it should match a regular INSFV simulation results.
Specification(s): no-slip-match
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.184The system shall be able to model no-slip conditions in a porous media channel with reflective boundary conditions on one side; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): symmetry
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.185The system shall be able to model no-slip conditions in a symmetric porous media channel using the NSFV action.
Specification(s): symmetry-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.186The system shall be able to model no-slip conditions in a cylindrical porous media channel with reflective boundary conditions on one side; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): symmetry-rz
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.187The system shall be able to model porous flow with volumetric friction, using the Darcy and Forchheimer friction models with no slip boundary conditions on the channel walls.
Specification(s): friction
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.188The system shall be able to model porous flow with volumetric friction, using the Darcy and Forchheimer friction models and the NSFV action input syntax.
Specification(s): friction-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.189The system shall be able to model porous flow with volumetric friction, using the Darcy and Forchheimer friction models with free slip boundary conditions on the channel walls.
Specification(s): friction-free-slip
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #16765
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.190The system shall be able to model porous flow with volumetric friction, using the Darcy and Forchheimer friction models with free slip boundary conditions using the NSFV action.
Specification(s): friction-free-slip-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.191The system shall be able to model porous flow with block-restricted volumetric friction.
Specification(s): friction-block
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #16765
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.192The system shall be able to model porous flow with block-restricted volumetric friction using the NSFV action.
Specification(s): friction-block-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.193The system shall be able to solve the porous flow equations in RZ geometry using an integration by parts of the pressure term.
Specification(s): rz-by-parts
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #18478
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.194The system shall be able to compute the speed, eg the norm of the interstitial velocity, in a porous media incompressible flow problem.
Specification(s): check_material
Design: PINSFVSpeedFunctorMaterialNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.195The system shall be able to compute the speed in a porous media incompressible flow problem from within the NSFVAction.
Specification(s): check_material-action
Design: PINSFVSpeedFunctorMaterialNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.196The system shall be able to solve the incompressible porous flow Navier-Stokes equations using a Rhie-Chow interpolation scheme in a 1D channel with a continuously varying porosity and produce second order convergence for all variables.
Specification(s): 1D_continuous_porosity
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.197The system shall be able to solve the incompressible porous flow Navier-Stokes equations using a Rhie-Chow interpolation scheme in a 2D channel with a continuously varying porosity and produce second order convergence for all variables.
Specification(s): 2D_continuous_porosity
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.198The system shall show second order convergence for all variables when the porosity is interpolated and reconstructed multiple times and when a correction is applied to the pressure interpolation.
Specification(s): pressure-corrected
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.199The system shall show second order convergence for all variables when using porosity reconstructions and friction corrections together with NSFV action syntax.
Specification(s): pressure-corrected-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.200The system shall show a perfect Jacobian when the porosity is interpolated and reconstructed multiple times and when a correction is applied to the pressure interpolation.
Specification(s): pressure-corrected-jac
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.3.209The system shall be able to use flux boundary conditions for specifying inlet conditions in a weakly compressible fluid flow simulation
- specifying the flux values directly though the flow rates
- using the inlet velocity to compute the fluxes
- using the inlet velocity to compute the fluxes with the NSFV action syntax
- using the inlet mass flow rate to compute the fluxes
- using the inlet mass flow rate to compute the fluxes with NSFVAction syntax
Specification(s): flux/direct, flux/from_velocity, flux/from_velocity_action, flux/from_mdot, flux/from_mdot_action
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBCNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSFVMomentumAdvection
- 10.3.65The system shall be able to perform a variety of limiting schemes when solving fluid flow equations. These schemes include
- second-order upwind
- van Leer
- min-mod
- QUICK
Specification(s): limiting_schemes/sou, limiting_schemes/vanLeer, limiting_schemes/min_mod, limiting_schemes/quick
Design: INSFVMomentumAdvection
Issue(s): #20493
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.66The system shall be able to block-restrict all variables in a heated channel simulation with passive scalar advection.
Specification(s): block_restricted_variables
Design: INSFVMomentumAdvectionINSFVVelocityVariable
Issue(s): #16972
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSFVVelocityVariable
- 10.3.66The system shall be able to block-restrict all variables in a heated channel simulation with passive scalar advection.
Specification(s): block_restricted_variables
Design: INSFVMomentumAdvectionINSFVVelocityVariable
Issue(s): #16972
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSFVMomentumBoussinesq
- 10.3.67The system shall be able to reproduce benchmark results for a Rayleigh number of 1e3 using a finite volume discretization.
Specification(s): 1e3
Design: INSFVMomentumBoussinesq
Issue(s): #16755
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.68The system shall be able to reproduce benchmark results for a Rayleigh number of 1e4 using a finite volume discretization.
Specification(s): 1e4
Design: INSFVMomentumBoussinesq
Issue(s): #16755
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.69The system shall be able to reproduce benchmark results for a Rayleigh number of 1e5 using a finite volume discretization.
Specification(s): 1e5
Design: INSFVMomentumBoussinesq
Issue(s): #16755
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.70The system shall be able to reproduce benchmark results for a Rayleigh number of 1e6 using a finite volume discretization.
Specification(s): 1e6
Design: INSFVMomentumBoussinesq
Issue(s): #16755
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.71The system shall be able to reproduce benchmark results for a Rayleigh number of 1e6 using the INSFV actions.
Specification(s): 1e6-action
Design: INSFVMomentumBoussinesq
Issue(s): #19742
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.72The system should throw an error if the density is not a constant functor in case of Boussinesq treatment.
Specification(s): rho-error
Design: INSFVMomentumBoussinesq
Issue(s): #19742
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.73The system shall be able to model natural convection using a weakly compressible implementation.
Specification(s): wcnsfv
Design: INSFVMomentumBoussinesq
Issue(s): #16755
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.74The system shall be able to model transient natural convection with a low Rayleigh number using a weakly compressible implementation.
Specification(s): transient_wcnsfv
Design: INSFVMomentumBoussinesq
Issue(s): #16755
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSFVScalarFieldAdvection
- 10.3.88The system shall be able to transport arbitrary scalar field variables in a fluid flow field.
Specification(s): scalar-transport
Design: INSFVScalarFieldAdvection
Issue(s): #16732
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.148The system shall be able to transport passive scalar quantities in an application different from the fluid flow.
Specification(s): multiapp
Design: INSFVScalarFieldAdvectionINSFVRhieChowInterpolator
Issue(s): #16585
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.149The system shall error out if both average and Rhie Chow velocity interpolation parameters are provided.
Specification(s): average_yet_a_provided
Design: INSFVScalarFieldAdvectionINSFVRhieChowInterpolator
Issue(s): #20294
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.150The system shall error out if Rhie Chow velocity interpolation is requested but the a coefficients are not provided and cannot be computed from the momemtum equation.
Specification(s): RC_yet_a_not_provided
Design: INSFVScalarFieldAdvectionINSFVRhieChowInterpolator
Issue(s): #20294
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.151The system shall error out if the Rhie Chow a coefficients are provided in a manner inconsistent with the dimension of the problem g
- for example with the Y coefficient but not the X one
- for example with the Z coefficient but not the X one
Specification(s): bad_a_components/vu, bad_a_components/bad_a_components_wu
Design: INSFVScalarFieldAdvectionINSFVRhieChowInterpolator
Issue(s): #20294
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- navier_stokes: INSFVMomentumAdvectionOutflowBC
- 10.3.91The system shall be able to use flux boundary conditions for the momentum and match results produced by using flux kernels.
Specification(s): momentum-outflow-bcs
Design: INSFVMomentumAdvectionOutflowBC
Issue(s): #16854
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSFVMassAdvectionOutflowBC
- 10.3.92The system shall be able to extrapolate a pressure value at a fully developed outflow boundary and use a mean pressure approach to eliminate the nullspace for the pressure.
Specification(s): extrapolated-outlet-pressure
Design: INSFVMassAdvectionOutflowBC
Issue(s): #16854
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSFVMomentumFriction
- 10.3.96The system shall be able to model linear volumetric friction in a channel.
Specification(s): linear-friction
Design: INSFVMomentumFriction
Issue(s): #16872
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.97The system shall be able to model quadratic volumetric friction in a channel.
Specification(s): quadratic-friction
Design: INSFVMomentumFriction
Issue(s): #16872
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: NSFVEnergyAmbientConvection
- 10.3.100The system shall be able to model ambient volumetric convection in a channel.
Specification(s): ambient-convection
Design: NSFVEnergyAmbientConvection
Issue(s): #16948
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 10.3.101The system shall be able to model ambient volumetric convection in a channel using the Navier-Stokes action.
Specification(s): ambient-convection-action
Design: NSFVEnergyAmbientConvection
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- navier_stokes: MooseVariableFVReal
- 10.3.102The system shall be able to run incompressible Navier-Stokes channel-flow simulations with
- two-dimensional triangular elements
- three-dimensional tetrahedral elements
Specification(s): triangles/tris, triangles/tets
Design: MooseVariableFVReal
Issue(s): #16822
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.152The system shall be able to solve for flow in a 3D channel while not caching face variable values.
Specification(s): 3d-no-face-caching
Design: MooseVariableFVReal
Issue(s): #18009
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.153The system shall be able to solve for flow in a 3D channel while not caching face variable gradients.
Specification(s): 3d-no-gradient-caching
Design: MooseVariableFVReal
Issue(s): #18009
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.154The system shall be able to solve for flow in a 3D channel while only caching face pressure gradients.
Specification(s): 3d-pressure-gradient-caching
Design: MooseVariableFVReal
Issue(s): #18009
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.155The system shall be able to solve for flow in a 3D channel while caching all variable face values and gradients.
Specification(s): 3d-all-caching
Design: MooseVariableFVReal
Issue(s): #18009
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: INSFVRhieChowInterpolator
- 10.3.105The system shall show a monotone pressure profile in the presence of discontinuous body forces, in this case a transient from free flow to linear drag.
Specification(s): discontinuous
Design: INSFVRhieChowInterpolator
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.108The system shall error if a user specifies a residual object for the momentum equation that is not a incompressible Navier-Stokes finite volume momentum residual object.
Specification(s): bad_ro
Design: INSFVRhieChowInterpolator
Issue(s): #18215
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.109The system shall error if the interpolation object has block restriction different from the nonlinear flow variables.
Specification(s): bad_restriction
Design: INSFVRhieChowInterpolator
Issue(s): #18215
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.148The system shall be able to transport passive scalar quantities in an application different from the fluid flow.
Specification(s): multiapp
Design: INSFVScalarFieldAdvectionINSFVRhieChowInterpolator
Issue(s): #16585
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.149The system shall error out if both average and Rhie Chow velocity interpolation parameters are provided.
Specification(s): average_yet_a_provided
Design: INSFVScalarFieldAdvectionINSFVRhieChowInterpolator
Issue(s): #20294
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.150The system shall error out if Rhie Chow velocity interpolation is requested but the a coefficients are not provided and cannot be computed from the momemtum equation.
Specification(s): RC_yet_a_not_provided
Design: INSFVScalarFieldAdvectionINSFVRhieChowInterpolator
Issue(s): #20294
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.151The system shall error out if the Rhie Chow a coefficients are provided in a manner inconsistent with the dimension of the problem g
- for example with the Y coefficient but not the X one
- for example with the Z coefficient but not the X one
Specification(s): bad_a_components/vu, bad_a_components/bad_a_components_wu
Design: INSFVScalarFieldAdvectionINSFVRhieChowInterpolator
Issue(s): #20294
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- navier_stokes: INSFVMixingLengthTurbulentViscosityAux
- 10.3.121The system shall be able to compute the turbulent viscosity based on the capped mixing length model and store it in a variable when performing
- transient simulations
- steady simulations
Specification(s): capped_mixing_length/transient, capped_mixing_length/steady
Design: Turbulence modelingINSFVMixingLengthTurbulentViscosityAux
Issue(s): #18666
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: MixingLengthTurbulentViscosityMaterial
- 10.3.122The system shall be able to calculate the material property comprising the total turbulent viscosity, based on the capped mixing length model when performing
- transient simulations
- steady simulations
- steady simulations with action syntax
Specification(s): capped_mixing_length/transient, capped_mixing_length/steady, capped_mixing_length/steady_action
Design: Turbulence modelingMixingLengthTurbulentViscosityMaterialNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: WallDistanceMixingLengthAux
- 10.3.156The system shall be able to compute the turbulent viscosity based on the capped mixing length model.
Specification(s): capped_mixing_length
Design: Turbulence modelingWallDistanceMixingLengthAux
Issue(s): #18666
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PINSFVEnergyAdvection
- 10.3.157The system shall be able to solve for fluid energy diffusion, advection and convection with the solid phase in a 2D channel
- with a Cartesian geometry, only modeling the fluid phase,
- in rz geometry,
- with an effective diffusion coefficient,
Specification(s): heated/fluid_only, heated/rz, heated/kappa
Design: PINSFVEnergyAdvection
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PINSFVEnergyAmbientConvection
- 10.3.158The system shall be able to solve for fluid energy diffusion, advection and convection with the solid phase in a 2D channel, modeling both fluid and solid temperature.
Specification(s): solid-fluid
Design: PINSFVEnergyAmbientConvection
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.160The system shall be able to solve for fluid energy diffusion, advection and block-restricted convection.
Specification(s): solid-fluid-block
Design: PINSFVEnergyAmbientConvection
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PINSFVEnergyTimeDerivative
- 10.3.162The system shall be able to solve transient relaxations with fluid energy diffusion, advection and convection with the solid phase in a 2D channel, modeling both fluid and solid temperature.
Specification(s): transient
Design: PINSFVEnergyTimeDerivativeINSFVMomentumTimeDerivative
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.205The system shall be able to solve transient relaxations within the weakly compressible approximation, with fluid energy diffusion, advection and convection with the solid phase in a 2D channel, modeling both fluid and solid temperature.
Specification(s): transient
Design: PINSFVEnergyTimeDerivative
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.206The system shall be able to solve weakly compressible transient problems with the NSFV action syntax.
Specification(s): transient-action
Design: PINSFVEnergyTimeDerivative
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.207The system shall be able to solve transient relaxations within the weakly compressible approximation, with fluid energy diffusion, advection and convection with the solid phase in a 2D channel, modeling both fluid and solid temperature and show a perfect Jacobian.
Specification(s): transient-jac
Design: PINSFVEnergyTimeDerivative
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- navier_stokes: INSFVMomentumTimeDerivative
- 10.3.162The system shall be able to solve transient relaxations with fluid energy diffusion, advection and convection with the solid phase in a 2D channel, modeling both fluid and solid temperature.
Specification(s): transient
Design: PINSFVEnergyTimeDerivativeINSFVMomentumTimeDerivative
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PINSFVMomentumBoussinesq
- 10.3.164The system shall be able to solve for fluid energy diffusion, advection and convection with the solid phase in a 2D channel with a Boussinesq approximation for the influence of temperature on density.
Specification(s): boussinesq
Design: PINSFVMomentumBoussinesq
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: Finite Volume Incompressible Porous media Navier Stokes
- 10.3.166The system shall be able to model a smooth porosity gradient in a 2D channel.
Specification(s): smooth-jump
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.167The system shall be able to model a discontinuous porosity jump in a 1D channel with average interpolation of velocity and advected quantity.
Specification(s): 1d-discontinuous-jump-average-average
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.168The system shall be able to model a discontinuous porosity jump in a 1D channel with average interpolation of velocity and upwinding of the advected quantity.
Specification(s): 1d-discontinuous-jump-average-upwind
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.169The system shall be able to model a discontinuous porosity jump in a 1D channel with Rhie Chow interpolation of velocity and averaging of the advected quantity.
Specification(s): 1d-discontinuous-jump-rc-average
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.170The system shall be able to model a discontinuous porosity jump in a 1D channel with Rhie Chow interpolation of velocity and upwinding of the advected quantity.
Specification(s): 1d-discontinuous-jump-rc-upwind
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.171The system shall be able to model a discontinuous porosity jump in a 2D channel.
Specification(s): discontinuous-jump
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.172The system shall exhibit a monotonic pressure profile when a number of reconstructions (essentially smoothing) are applied to the porosity.
Specification(s): reconstruct-porosity
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.173The system shall error if the user attempts to create a reconstructed field from a variable.
Specification(s): reconstruct-error
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.174The system shall be able to model free-slip conditions in a porous media channel; specifically the tangential velocity shall have a uniform value of unity, the normal velocity shall have a uniform value of zero, and the pressure shall not change.
Specification(s): free-slip
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.175The system should be able to run a porous medium channel computation using the NSFV action.
Specification(s): free-slip-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.176The system shall be able to model free-slip conditions in a porous media cylindrical channel; specifically the tangential velocity shall have a uniform value of unity, the normal velocity shall have a uniform value of zero, and the pressure shall not change.
Specification(s): free-slip-rz
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.177The system shall be able to model no-slip conditions in a porous media channel; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): no-slip
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.178The system shall be able to model no-slip conditions in a porous media channel with flow driven by a pressure differential; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): no-slip-pressure-driven
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.179The system shall be able to model no-slip conditions in a porous media channel with flow driven by a pressure differential using the NSFVAction syntax.
Specification(s): no-slip-pressure-driven-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.180The system shall be able to model no-slip conditions in a porous media channel with a set mean pressure; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): no-slip-pressure-average
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.181The system shall be able to model no-slip conditions in a porous media channel using the NSFV action and a set mean pressure.
Specification(s): no-slip-pressure-average-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.182The system shall be able to model no-slip conditions in a porous media channel using an average interpolation for velocity; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): no-slip-average
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.183The system shall be able to model no-slip conditions in a porous media channel with a porosity of 1; specifically, it should match a regular INSFV simulation results.
Specification(s): no-slip-match
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.184The system shall be able to model no-slip conditions in a porous media channel with reflective boundary conditions on one side; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): symmetry
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.185The system shall be able to model no-slip conditions in a symmetric porous media channel using the NSFV action.
Specification(s): symmetry-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.186The system shall be able to model no-slip conditions in a cylindrical porous media channel with reflective boundary conditions on one side; specifically, moving down the channel, the tangential velocity shall develop a parabolic profile.
Specification(s): symmetry-rz
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.187The system shall be able to model porous flow with volumetric friction, using the Darcy and Forchheimer friction models with no slip boundary conditions on the channel walls.
Specification(s): friction
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.188The system shall be able to model porous flow with volumetric friction, using the Darcy and Forchheimer friction models and the NSFV action input syntax.
Specification(s): friction-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.189The system shall be able to model porous flow with volumetric friction, using the Darcy and Forchheimer friction models with free slip boundary conditions on the channel walls.
Specification(s): friction-free-slip
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #16765
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.190The system shall be able to model porous flow with volumetric friction, using the Darcy and Forchheimer friction models with free slip boundary conditions using the NSFV action.
Specification(s): friction-free-slip-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.191The system shall be able to model porous flow with block-restricted volumetric friction.
Specification(s): friction-block
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #16765
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.192The system shall be able to model porous flow with block-restricted volumetric friction using the NSFV action.
Specification(s): friction-block-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #19472
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.193The system shall be able to solve the porous flow equations in RZ geometry using an integration by parts of the pressure term.
Specification(s): rz-by-parts
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Issue(s): #18478
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.196The system shall be able to solve the incompressible porous flow Navier-Stokes equations using a Rhie-Chow interpolation scheme in a 1D channel with a continuously varying porosity and produce second order convergence for all variables.
Specification(s): 1D_continuous_porosity
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.197The system shall be able to solve the incompressible porous flow Navier-Stokes equations using a Rhie-Chow interpolation scheme in a 2D channel with a continuously varying porosity and produce second order convergence for all variables.
Specification(s): 2D_continuous_porosity
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.198The system shall show second order convergence for all variables when the porosity is interpolated and reconstructed multiple times and when a correction is applied to the pressure interpolation.
Specification(s): pressure-corrected
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.199The system shall show second order convergence for all variables when using porosity reconstructions and friction corrections together with NSFV action syntax.
Specification(s): pressure-corrected-action
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.200The system shall show a perfect Jacobian when the porosity is interpolated and reconstructed multiple times and when a correction is applied to the pressure interpolation.
Specification(s): pressure-corrected-jac
Design: Finite Volume Incompressible Porous media Navier StokesNSFVAction
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.3.201The system shall be able to solve the incompressible porous flow Navier-Stokes equations in a 1D channel using a Rhie-Chow interpolation scheme and produce second order convergence for all variables.
Specification(s): rc
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.202The system shall be able to solve the incompressible porous flow Euler equations in a 1D channel using a Rhie-Chow interpolation scheme for velocity and upwind interpolation for advected quantities and produce first order convergence for pressure and 1.5 order for velocity.
Specification(s): rc-no-diffusion
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.203The system shall be able to solve the incompressible porous flow Euler equations in a 1D channel using a Rhie-Chow interpolation scheme for velocity and upwind interpolation for advected quantities and produce first order convergence for pressure and 1.5 order for velocity with using flux boundary conditions for both variables.
Specification(s): rc-no-diffusion-strong-bc
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 10.3.204The system shall be able to solve the incompressible porous flow Navier-Stokes equations in a 2D channel using a Rhie-Chow interpolation scheme and produce second order convergence for all variables.
Specification(s): rc-2d
Design: Finite Volume Incompressible Porous media Navier Stokes
Issue(s): #16756
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- navier_stokes: PINSFVSpeedFunctorMaterial
- 10.3.194The system shall be able to compute the speed, eg the norm of the interstitial velocity, in a porous media incompressible flow problem.
Specification(s): check_material
Design: PINSFVSpeedFunctorMaterialNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.195The system shall be able to compute the speed in a porous media incompressible flow problem from within the NSFVAction.
Specification(s): check_material-action
Design: PINSFVSpeedFunctorMaterialNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: WCNSFVInletVelocityBC
- 10.3.208The system shall be able to use Dirichlet boundary conditions for specifying inlet conditions in a weakly compressible fluid flow simulation
- using a velocity postprocessor
- using a mass flow rate postprocessor
Specification(s): dirichlet/using_velocity, dirichlet/using_mdot
Design: WCNSFVInletVelocityBCWCNSFVInletTemperatureBC
Issue(s): #18086
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.210The system shall error out if
- the inlet velocity cannot be determined from the mass flow rate due to insufficient parameters
- the inlet temperature cannot be determined because neither the temperature or the energy flow rate have been provided
- the inlet temperature cannot be determined from the energy flow rate due to missing fluid velocity information
- the inlet temperature cannot be determined from the velocity due to insufficient parameters
- the inlet temperature cannot be determined from the mass flow rate due to insufficient parameters
Specification(s): exceptions_dirichlet_bcs/missing_info_dirichlet_velocity, exceptions_dirichlet_bcs/missing_info_dirichlet_temperature, exceptions_dirichlet_bcs/missing_info_dirichlet_temperature_from_energy_flow, exceptions_dirichlet_bcs/missing_info_dirichlet_temperature_from_velocity, exceptions_dirichlet_bcs/missing_info_dirichlet_temperature_from_mdot
Design: WCNSFVInletVelocityBCWCNSFVInletTemperatureBC
Issue(s): #18086
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.211The system shall return a warning if
- redundant information is provided for setting the inlet velocity
- redundant information is provided for setting the inlet temperature
Specification(s): warnings_dirichlet_bcs/both_velocity_and_mdot, warnings_dirichlet_bcs/both_temperature_and_mdot
Design: WCNSFVInletVelocityBCWCNSFVInletTemperatureBC
Issue(s): #18086
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- navier_stokes: WCNSFVInletTemperatureBC
- 10.3.208The system shall be able to use Dirichlet boundary conditions for specifying inlet conditions in a weakly compressible fluid flow simulation
- using a velocity postprocessor
- using a mass flow rate postprocessor
Specification(s): dirichlet/using_velocity, dirichlet/using_mdot
Design: WCNSFVInletVelocityBCWCNSFVInletTemperatureBC
Issue(s): #18086
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.210The system shall error out if
- the inlet velocity cannot be determined from the mass flow rate due to insufficient parameters
- the inlet temperature cannot be determined because neither the temperature or the energy flow rate have been provided
- the inlet temperature cannot be determined from the energy flow rate due to missing fluid velocity information
- the inlet temperature cannot be determined from the velocity due to insufficient parameters
- the inlet temperature cannot be determined from the mass flow rate due to insufficient parameters
Specification(s): exceptions_dirichlet_bcs/missing_info_dirichlet_velocity, exceptions_dirichlet_bcs/missing_info_dirichlet_temperature, exceptions_dirichlet_bcs/missing_info_dirichlet_temperature_from_energy_flow, exceptions_dirichlet_bcs/missing_info_dirichlet_temperature_from_velocity, exceptions_dirichlet_bcs/missing_info_dirichlet_temperature_from_mdot
Design: WCNSFVInletVelocityBCWCNSFVInletTemperatureBC
Issue(s): #18086
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.211The system shall return a warning if
- redundant information is provided for setting the inlet velocity
- redundant information is provided for setting the inlet temperature
Specification(s): warnings_dirichlet_bcs/both_velocity_and_mdot, warnings_dirichlet_bcs/both_temperature_and_mdot
Design: WCNSFVInletVelocityBCWCNSFVInletTemperatureBC
Issue(s): #18086
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- navier_stokes: WCNSFVMassFluxBC
- 10.3.209The system shall be able to use flux boundary conditions for specifying inlet conditions in a weakly compressible fluid flow simulation
- specifying the flux values directly though the flow rates
- using the inlet velocity to compute the fluxes
- using the inlet velocity to compute the fluxes with the NSFV action syntax
- using the inlet mass flow rate to compute the fluxes
- using the inlet mass flow rate to compute the fluxes with NSFVAction syntax
Specification(s): flux/direct, flux/from_velocity, flux/from_velocity_action, flux/from_mdot, flux/from_mdot_action
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBCNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.212The system shall error out if
- only the mass flow rate is provided to compute the inlet mass flux
- only the velocity is provided to compute the inlet mass flux
- only the mass flow rate is provided to compute the inlet momentum flux
- only the velocity is provided to compute the inlet momentum flux
- the inlet energy cannot be determined because neither the temperature or the energy flow rate have been provided
- the inlet energy flux cannot be determined because the temperature was provided but neither the inlet mass flow rate or velocity were provided
- the inlet energy flux cannot be determined because the temperature and velocity were provided but the density or specific heat capacity were not
- the inlet energy flux cannot be determined because the temperature and mass flow rate were provided but the specific heat capacity or flow area were not
- neither the scalar quantity flux or boundary values are specified when attempting to compute the scalar quantity flux
- only the mass flow rate is provided to compute the inlet scalar quantity flux
- only the scalar quantity boundary value is provided to compute the inlet scalar quantity flux
Specification(s): exceptions_flux_bcs/mass_mdot_needs_area, exceptions_flux_bcs/mass_velocity_needs_density, exceptions_flux_bcs/momentum_mdot_needs_area, exceptions_flux_bcs/momentum_velocity_needs_density, exceptions_flux_bcs/energy_need_temperature, exceptions_flux_bcs/energy_temperature_needs_velocity_or_mdot, exceptions_flux_bcs/energy_temperature_velocity_needs_density, exceptions_flux_bcs/energy_temperature_mdot_needs_cp, exceptions_flux_bcs/scalar_need_flux_or_value, exceptions_flux_bcs/scalar_mdot_needs_area, exceptions_flux_bcs/scalar_need_some_velocity_info
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBC
Issue(s): #19543
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.213The system shall return a warning if
- redundant information is provided for setting the inlet mass flux
- redundant information is provided for setting the inlet momentum flux
- redundant information is provided for setting the inlet energy flux
- redundant information is provided for setting the inlet scalar flux
Specification(s): warnings_flux_bcs/mass_both_velocity_and_mdot, warnings_flux_bcs/momentum_both_velocity_and_mdot, warnings_flux_bcs/both_temperature_and_mdot, warnings_flux_bcs/both_scalar_and_mdot
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBC
Issue(s): #19543
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- navier_stokes: WCNSFVMomentumFluxBC
- 10.3.209The system shall be able to use flux boundary conditions for specifying inlet conditions in a weakly compressible fluid flow simulation
- specifying the flux values directly though the flow rates
- using the inlet velocity to compute the fluxes
- using the inlet velocity to compute the fluxes with the NSFV action syntax
- using the inlet mass flow rate to compute the fluxes
- using the inlet mass flow rate to compute the fluxes with NSFVAction syntax
Specification(s): flux/direct, flux/from_velocity, flux/from_velocity_action, flux/from_mdot, flux/from_mdot_action
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBCNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.212The system shall error out if
- only the mass flow rate is provided to compute the inlet mass flux
- only the velocity is provided to compute the inlet mass flux
- only the mass flow rate is provided to compute the inlet momentum flux
- only the velocity is provided to compute the inlet momentum flux
- the inlet energy cannot be determined because neither the temperature or the energy flow rate have been provided
- the inlet energy flux cannot be determined because the temperature was provided but neither the inlet mass flow rate or velocity were provided
- the inlet energy flux cannot be determined because the temperature and velocity were provided but the density or specific heat capacity were not
- the inlet energy flux cannot be determined because the temperature and mass flow rate were provided but the specific heat capacity or flow area were not
- neither the scalar quantity flux or boundary values are specified when attempting to compute the scalar quantity flux
- only the mass flow rate is provided to compute the inlet scalar quantity flux
- only the scalar quantity boundary value is provided to compute the inlet scalar quantity flux
Specification(s): exceptions_flux_bcs/mass_mdot_needs_area, exceptions_flux_bcs/mass_velocity_needs_density, exceptions_flux_bcs/momentum_mdot_needs_area, exceptions_flux_bcs/momentum_velocity_needs_density, exceptions_flux_bcs/energy_need_temperature, exceptions_flux_bcs/energy_temperature_needs_velocity_or_mdot, exceptions_flux_bcs/energy_temperature_velocity_needs_density, exceptions_flux_bcs/energy_temperature_mdot_needs_cp, exceptions_flux_bcs/scalar_need_flux_or_value, exceptions_flux_bcs/scalar_mdot_needs_area, exceptions_flux_bcs/scalar_need_some_velocity_info
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBC
Issue(s): #19543
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.213The system shall return a warning if
- redundant information is provided for setting the inlet mass flux
- redundant information is provided for setting the inlet momentum flux
- redundant information is provided for setting the inlet energy flux
- redundant information is provided for setting the inlet scalar flux
Specification(s): warnings_flux_bcs/mass_both_velocity_and_mdot, warnings_flux_bcs/momentum_both_velocity_and_mdot, warnings_flux_bcs/both_temperature_and_mdot, warnings_flux_bcs/both_scalar_and_mdot
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBC
Issue(s): #19543
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- navier_stokes: WCNSFVEnergyFluxBC
- 10.3.209The system shall be able to use flux boundary conditions for specifying inlet conditions in a weakly compressible fluid flow simulation
- specifying the flux values directly though the flow rates
- using the inlet velocity to compute the fluxes
- using the inlet velocity to compute the fluxes with the NSFV action syntax
- using the inlet mass flow rate to compute the fluxes
- using the inlet mass flow rate to compute the fluxes with NSFVAction syntax
Specification(s): flux/direct, flux/from_velocity, flux/from_velocity_action, flux/from_mdot, flux/from_mdot_action
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBCNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.212The system shall error out if
- only the mass flow rate is provided to compute the inlet mass flux
- only the velocity is provided to compute the inlet mass flux
- only the mass flow rate is provided to compute the inlet momentum flux
- only the velocity is provided to compute the inlet momentum flux
- the inlet energy cannot be determined because neither the temperature or the energy flow rate have been provided
- the inlet energy flux cannot be determined because the temperature was provided but neither the inlet mass flow rate or velocity were provided
- the inlet energy flux cannot be determined because the temperature and velocity were provided but the density or specific heat capacity were not
- the inlet energy flux cannot be determined because the temperature and mass flow rate were provided but the specific heat capacity or flow area were not
- neither the scalar quantity flux or boundary values are specified when attempting to compute the scalar quantity flux
- only the mass flow rate is provided to compute the inlet scalar quantity flux
- only the scalar quantity boundary value is provided to compute the inlet scalar quantity flux
Specification(s): exceptions_flux_bcs/mass_mdot_needs_area, exceptions_flux_bcs/mass_velocity_needs_density, exceptions_flux_bcs/momentum_mdot_needs_area, exceptions_flux_bcs/momentum_velocity_needs_density, exceptions_flux_bcs/energy_need_temperature, exceptions_flux_bcs/energy_temperature_needs_velocity_or_mdot, exceptions_flux_bcs/energy_temperature_velocity_needs_density, exceptions_flux_bcs/energy_temperature_mdot_needs_cp, exceptions_flux_bcs/scalar_need_flux_or_value, exceptions_flux_bcs/scalar_mdot_needs_area, exceptions_flux_bcs/scalar_need_some_velocity_info
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBC
Issue(s): #19543
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.213The system shall return a warning if
- redundant information is provided for setting the inlet mass flux
- redundant information is provided for setting the inlet momentum flux
- redundant information is provided for setting the inlet energy flux
- redundant information is provided for setting the inlet scalar flux
Specification(s): warnings_flux_bcs/mass_both_velocity_and_mdot, warnings_flux_bcs/momentum_both_velocity_and_mdot, warnings_flux_bcs/both_temperature_and_mdot, warnings_flux_bcs/both_scalar_and_mdot
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBC
Issue(s): #19543
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- navier_stokes: WCNSFVScalarFluxBC
- 10.3.209The system shall be able to use flux boundary conditions for specifying inlet conditions in a weakly compressible fluid flow simulation
- specifying the flux values directly though the flow rates
- using the inlet velocity to compute the fluxes
- using the inlet velocity to compute the fluxes with the NSFV action syntax
- using the inlet mass flow rate to compute the fluxes
- using the inlet mass flow rate to compute the fluxes with NSFVAction syntax
Specification(s): flux/direct, flux/from_velocity, flux/from_velocity_action, flux/from_mdot, flux/from_mdot_action
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBCNSFVAction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.212The system shall error out if
- only the mass flow rate is provided to compute the inlet mass flux
- only the velocity is provided to compute the inlet mass flux
- only the mass flow rate is provided to compute the inlet momentum flux
- only the velocity is provided to compute the inlet momentum flux
- the inlet energy cannot be determined because neither the temperature or the energy flow rate have been provided
- the inlet energy flux cannot be determined because the temperature was provided but neither the inlet mass flow rate or velocity were provided
- the inlet energy flux cannot be determined because the temperature and velocity were provided but the density or specific heat capacity were not
- the inlet energy flux cannot be determined because the temperature and mass flow rate were provided but the specific heat capacity or flow area were not
- neither the scalar quantity flux or boundary values are specified when attempting to compute the scalar quantity flux
- only the mass flow rate is provided to compute the inlet scalar quantity flux
- only the scalar quantity boundary value is provided to compute the inlet scalar quantity flux
Specification(s): exceptions_flux_bcs/mass_mdot_needs_area, exceptions_flux_bcs/mass_velocity_needs_density, exceptions_flux_bcs/momentum_mdot_needs_area, exceptions_flux_bcs/momentum_velocity_needs_density, exceptions_flux_bcs/energy_need_temperature, exceptions_flux_bcs/energy_temperature_needs_velocity_or_mdot, exceptions_flux_bcs/energy_temperature_velocity_needs_density, exceptions_flux_bcs/energy_temperature_mdot_needs_cp, exceptions_flux_bcs/scalar_need_flux_or_value, exceptions_flux_bcs/scalar_mdot_needs_area, exceptions_flux_bcs/scalar_need_some_velocity_info
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBC
Issue(s): #19543
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 10.3.213The system shall return a warning if
- redundant information is provided for setting the inlet mass flux
- redundant information is provided for setting the inlet momentum flux
- redundant information is provided for setting the inlet energy flux
- redundant information is provided for setting the inlet scalar flux
Specification(s): warnings_flux_bcs/mass_both_velocity_and_mdot, warnings_flux_bcs/momentum_both_velocity_and_mdot, warnings_flux_bcs/both_temperature_and_mdot, warnings_flux_bcs/both_scalar_and_mdot
Design: WCNSFVMassFluxBCWCNSFVMomentumFluxBCWCNSFVEnergyFluxBCWCNSFVScalarFluxBC
Issue(s): #19543
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- navier_stokes: Weakly Compressible Finite Volume Navier Stokes
- 10.3.214The system shall be able to solve for a transient 2D channel case with a weakly compressible formulation.
Specification(s): transient
Design: Weakly Compressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.215The system shall be able to solve for a transient 2D channel case with a weakly compressible formulation using the NSFV action syntax.
Specification(s): transient-action
Design: Weakly Compressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.216The system shall be able to solve for a transient 2D channel case with a weakly compressible formulation and a mixing length turbulence model.
Specification(s): turbulence
Design: Weakly Compressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.217The system shall be able to solve for a transient 2D channel case with a weakly compressible formulation and a mixing length turbulence model using the NSFV action syntax.
Specification(s): turbulence-action
Design: Weakly Compressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.218The system shall be able to solve for a transient 2D channel case with a weakly compressible formulation and show a perfect Jacobian.
Specification(s): transient-jac
Design: Weakly Compressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.3.219The system shall be able to solve for a transient 2D channel case with a weakly compressible formulation and a mixing length turbulence model and show a perfect Jacobian.
Specification(s): turbulence-jac
Design: Weakly Compressible Finite Volume Navier Stokes
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 10.3.220The system shall be able to use realistic fluid properties in a weakly compressible flow simulation
Specification(s): transient
Design: Weakly Compressible Finite Volume Navier Stokes
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 10.3.221The system shall be able to output gradeurs, derivatives and adimensional quantities from realistic functor fluid properties
Specification(s): fluidprops
Design: Weakly Compressible Finite Volume Navier Stokes
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: NSInitialCondition
- 10.4.1The system shall be able to set initial conditions for fluid flow variables.
Specification(s): ns_ics
Design: NSInitialCondition
Issue(s): #17900
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: NSFunctionInitialCondition
- 10.4.2The system shall be able to set initial conditions for fluid flow variables using functions.
Specification(s): ns_function_ics
Design: NSFunctionInitialCondition
Issue(s): #17900
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: PNSInitialCondition
- 10.4.3The system shall be able to set intial conditions for porous flow variables.
Specification(s): cns_ics
Design: PNSInitialCondition
Issue(s): #17900
Collection(s): FUNCTIONAL
Type(s): Exodiff
- navier_stokes: VolumetricFlowRate
- 10.5.1The system shall be able to compute mass and momentum flow rates at internal and external boundaries of a straight channel with a finite element incompressible Navier Stokes model.
Specification(s): fe
Design: VolumetricFlowRate
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 10.5.2The system shall be able to compute mass and momentum flow rates at internal and external boundaries of a diverging channel with a finite element incompressible Navier Stokes model.
Specification(s): fe_diverging
Design: VolumetricFlowRate
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 10.5.3The system shall be able to compute flow rates and prove mass, momentum and energy conservation at internal and external boundaries of a frictionless heated straight channel with a finite volume incompressible Navier Stokes model.
Specification(s): insfv_straight
Design: VolumetricFlowRate
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 10.5.4The system shall be able to compute flow rates and prove mass, momentum and energy conservation at internal and external boundaries of a frictionless heated diverging channel with a finite volume incompressible Navier Stokes model,
- with a quadrilateral mesh in XY geometry, with mass flow measured using either a variable or material property,
- with a quadrilateral mesh in RZ geometry,
- with a triangular mesh in XY geometry,
- with upwind interpolation of advected quantities,
- and with no-slip boundary conditions, for which momentum and energy will be dissipated at the wall.
Specification(s): insfv_diverging/insfv_quad_xy, insfv_diverging/insfv_quad_rz, insfv_diverging/insfv_tri_xy, insfv_diverging/insfv_quad_xy_upwind, insfv_diverging/insfv_quad_xy_noslip
Design: VolumetricFlowRate
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 10.5.5The system shall be able to compute flow rates and prove mass, momentum and energy conservation at internal and external boundaries of a frictionless heated straight channel with a finite volume porous media incompressible Navier Stokes model.
Specification(s): pinsfv_straight
Design: VolumetricFlowRate
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 10.5.6The system shall be able to compute flow rates and prove mass, momentum and energy conservation at internal and external boundaries of a frictionless heated diverging channel with a finite volume porous media incompressible Navier Stokes model,
- with a quadrilateral mesh in XY geometry, with mass flow measured using either a variable or material property,
- with a quadrilateral mesh in RZ geometry,
- with upwind interpolation of advected quantities,
- and with no-slip boundary conditions, for which momentum and energy will be dissipated at the wall.
Specification(s): pinsfv_diverging/pinsfv_quad_xy, pinsfv_diverging/pinsfv_quad_rz, pinsfv_diverging/pinsfv_quad_xy_upwind, pinsfv_diverging/pinsfv_quad_xy_noslip
Design: VolumetricFlowRate
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- navier_stokes: RayleighNumber
- 10.5.7The system shall be able to compute the Rayleigh number in a natural convection flow simulation
Specification(s): rayleigh
Design: RayleighNumber
Issue(s): #20091
Collection(s): FUNCTIONAL
Type(s): CSVDiff