Navier Stokes System Requirement Specification

Introduction

The SRS for Navier Stokes describes the system functional and non-functional requirements that describe the expected interactions that the software shall provide.

Dependencies

The Navier Stokes application is developed using MOOSE and is based on various modules, as such the SRS for Navier Stokes is dependent upon the following documents.

Requirements

The following is a complete list for all the functional requirements for Navier Stokes.

Functional Requirements

  • navier_stokes: Bcs
  • 10.1.1The system shall compute inflow and outflow boundary conditions for advected variables
  • 10.1.2We shall error if the user provides less velocity components than the mesh dimension
  • 10.1.3We shall error if the user provides more than 3 velocity components
  • 10.1.4We shall allow the user to supply more velocity components than the mesh dimension (up to 3 components)
  • navier_stokes: Bump
  • 10.2.1The system shall be able to solve the Euler equations for subsonic flow with a bump in the channel.
  • navier_stokes: Finite Volume
  • 10.3.1The system shall be able to solve the 1D Sod shock-tube benchmark problem using an HLLC scheme to compute convective fluxes.
  • 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
  • 10.3.3The system shall be able to impose boundary advective fluxes for HLLC discretizations that use implicit/interior cell information.
  • 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.
  • 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
    1. constant porosity
    2. varying porosity
  • 10.3.6The system shall be able to use a primitive variable set and compute intercell fluxes using a Kurganov-Tadmor scheme
    1. when using central differencing to interpolate cell center values to faces and display second order convergence
    2. when using directional upwinding to interpolate cell center values to faces and display first order convergence
    3. when using linear interpolation of cell center values to faces with Van-Leer limiting and display at least second order convergence
  • 10.3.7The system shall be able to use a conserved variable set and compute intercell fluxes using a Kurganov-Tadmor scheme
    1. when using central differencing to interpolate cell center values to faces and display second order convergence
    2. when using directional upwinding to interpolate cell center values to faces and display first order convergence
    3. when using linear interpolation of cell center values to faces with Van-Leer limiting and display at least second order convergence
  • 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
    1. when using central differencing to interpolate cell center values to faces and display second order convergence
    2. when using directional upwinding to interpolate cell center values to faces and display first order convergence
    3. when using linear interpolation of cell center values to faces with Van-Leer limiting and display at least second order convergence
  • 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
    1. when using central differencing to interpolate cell center values to faces and display second order convergence
    2. when using directional upwinding to interpolate cell center values to faces and display first order convergence
    3. when using linear interpolation of cell center values to faces with Van-Leer limiting and display at least second order convergence
  • 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
    1. when using central differencing to interpolate cell center values to faces and display second order convergence
    2. when using directional upwinding to interpolate cell center values to faces and display first order convergence
  • 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
    1. when the source has a cell-centered volumetric discretization
  • 10.3.12On a regular grid, using a HLLC scheme to calculate inter-cell fluxes, the system shall show, via the momentum variable
    1. conservation of mass when no sources are present
    2. violation of conservation of mass when sources are present
    3. lesser violation of conservation of mass when sources are present and the mesh is refined
  • 10.3.13The 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.
  • 10.3.14The system shall be able to solve steady natural convection simulations using the finite volume method, a density-based compressible Navier-Stokes equation set, and central differencing of the advection terms for Rayleigh numbers of
    1. 1.7e4
    2. 1.4e5
  • 10.3.15The system shall be able to model subsonic nozzle flow using an HLLC discretization with a specified outlet pressure.
  • 10.3.16The system shall be able to advect a scalar using density and velocity computed through solution of the Euler equations.
  • 10.3.17The system shall be able to run a two-dimensional version of Sod's shocktube problem.
  • 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.
  • 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
    1. the Kurganov-Tadmor scheme
    2. the HLLC scheme
  • 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).
  • 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).
  • 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.
  • 10.3.23The system shall be able to run a two-dimensional symmetric flow problem with an HLLC discretization for advection.
  • 10.3.24The system shall be able to compute wave speeds for HLLC Riemann solvers.
  • 10.3.25The system shall be able to compute wave speeds for HLLC Riemann solvers in multiple dimensions.
  • 10.3.26The system shall provide a boundary condition to split a constant heat flux according to local values of porosity.
  • 10.3.27The system shall provide a boundary condition to split a constant heat flux according to domain-averaged values of porosity.
  • 10.3.28The system shall provide a boundary condition to split a constant heat flux according to local values of thermal conductivity.
  • 10.3.29The system shall provide a boundary condition to split a constant heat flux according to domain-averaged values of thermal conductivity.
  • 10.3.30The system shall provide a boundary condition to split a constant heat flux according to local values of effective thermal conductivity.
  • 10.3.31The system shall provide a boundary condition to split a constant heat flux according to domain-averaged values of effective thermal conductivity.
  • 10.3.32The system shall be able to impose a wall shear stress at the wall according to the algebraic wall function.
  • 10.3.33The system shall be able to solve for wall-convection with a user-specified heat transfer coefficient
    1. for a cavity problem
    2. and for a channel problem.
  • 10.3.34The system shall be able to block-restrict all variables in a heated channel simulation with passive scalar advection.
  • 10.3.35The system shall be able to reproduce benchmark results for a Rayleigh number of 1e3 using a finite volume discretization.
  • 10.3.36The system shall be able to reproduce benchmark results for a Rayleigh number of 1e4 using a finite volume discretization.
  • 10.3.37The system shall be able to reproduce benchmark results for a Rayleigh number of 1e5 using a finite volume discretization.
  • 10.3.38The system shall be able to reproduce benchmark results for a Rayleigh number of 1e6 using a finite volume discretization.
  • 10.3.39The 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.
  • 10.3.40The 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.
  • 10.3.41The 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.
  • 10.3.42The system shall be able to solve a diverging channel problem in cylindrical coordinates with no slip boundary conditions.
  • 10.3.43The system shall be able to solve a diverging channel problem in cylindrical coordinates with free slip boundary conditions.
  • 10.3.44The system shall conserve mass when solving a Cartesian channel flow problem with one symmetry boundary condition and one no-slip wall boundary condition.
  • 10.3.45The 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.
  • 10.3.46The 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.
  • 10.3.47The 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.
  • 10.3.48The system shall be able to transport arbitrary scalar field variables in a fluid flow field.
  • 10.3.49The system shall be able to use flux boundary conditions for the momentum and match results produced by using flux kernels.
  • 10.3.50The 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.
  • 10.3.51The 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
  • 10.3.52The system shall be able to model linear volumetric friction in a channel.
  • 10.3.53The system shall be able to model quadratic volumetric friction in a channel.
  • 10.3.54The system shall be able to model ambient volumetric convection in a channel.
  • 10.3.55The system shall be able to run incompressible Navier-Stokes channel-flow simulations with
    1. two-dimensional triangular elements
    2. three-dimensional tetrahedral elements
  • 10.3.56The 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.
  • 10.3.57The system shall be able to solve the incompressible Navier-Stokes equations in a lid-driven cavity using the finite volume method.
  • 10.3.58The 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.
  • 10.3.59The system shall be able to compute a perfect Jacobian when solving a lid-driven incompressible Navier-Stokes problem with the finite volume method.
  • 10.3.60The system shall be able to transport scalar quantities using the simultaneously calculated velocity field from the incompressible Navier Stokes equations.
  • 10.3.61The system shall be able to transport scalar quantities using the simultaneously calculated velocity field from the transient incompressible Navier Stokes equations.
  • 10.3.62The system shall be able to compute the turbulent viscosity based on the capped mixing length model and store it in a variable.
  • 10.3.63The system shall be able to calculate the material property comprising the total turbulent viscosity, based on the capped mixing length model.
  • 10.3.64The 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.
  • 10.3.65The 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.
  • 10.3.66The 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.
  • 10.3.67The 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.
  • 10.3.68The 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.
  • 10.3.69The 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.
  • 10.3.70The 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.
  • 10.3.71The 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.
  • 10.3.72The 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.
  • 10.3.73The 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.
  • 10.3.74The 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.
  • 10.3.75The 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.
  • 10.3.76The 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.
  • 10.3.77The 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.
  • 10.3.78The 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.
  • 10.3.79The 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.
  • 10.3.80The 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.
  • 10.3.81The 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.
  • 10.3.82The 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.
  • 10.3.83The system shall be able to compute the turbulent viscosity based on the capped mixing length model.
  • 10.3.84The system shall be able to solve for fluid energy diffusion, advection and convection with the solid phase in a 2D channel
    1. with a Cartesian geometry, only modeling the fluid phase,
    2. in rz geometry,
    3. with an effective diffusion coefficient,
  • 10.3.85The 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.
  • 10.3.86The 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.
  • 10.3.87The system shall be able to model a smooth porosity gradient in a 2D channel.
  • 10.3.88The system shall be able to model a discontinuous porosity jump in a 1D channel with average interpolation of velocity and advected quantity.
  • 10.3.89The 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.
  • 10.3.90The 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.
  • 10.3.91The 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.
  • 10.3.92The system shall be able to model a discontinuous porosity jump in a 2D channel.
  • 10.3.93The 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.
  • 10.3.94The 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.
  • 10.3.95The 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.
  • 10.3.96The 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.
  • 10.3.97The 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.
  • 10.3.98The 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.
  • 10.3.99The 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.
  • 10.3.100The 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.
  • 10.3.101The 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.
  • 10.3.102The system shall be able to model porous flow with volumetric friction, using the Darcy and Forchheimer friction models.
  • 10.3.103The 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.
  • 10.3.104The 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.
  • 10.3.105The 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.
  • 10.3.106The 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.
  • navier_stokes: Ics
  • 10.4.1The system shall be able to set initial conditions for fluid flow variables.
  • 10.4.2The system shall be able to set intial conditions for porous flow variables.
  • navier_stokes: Ins
  • 10.5.1The system shall be able to solve the incompressible Navier-Stokes equations in an RZ coordinate system while not integrating the pressure term by parts.
  • 10.5.2The system shall be able to solve the incompressible Navier-Stokes equations in an RZ coordinate system while integrating the pressure term by parts.
  • 10.5.3The system shall be able to solve the incompressible Navier-Stokes equations for a high Reynolds number in an RZ coordinate system.
  • 10.5.4The system shall be able to compute an accurate Jacobian for the incompressible Navier-Stokes equations in an RZ coordinate system.
  • 10.5.5The 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.
  • 10.5.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 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.
  • 10.5.7The 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.
  • 10.5.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 integrating the pressure term by parts and applying a natural outflow boundary condition
  • 10.5.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 not integrating the pressure term by parts and applying a NoBC outflow boundary condition.
  • 10.5.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 integrating the pressure term by parts and applying a NoBC outflow boundary condition
  • 10.5.11The 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.
  • 10.5.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 integrating the pressure term by parts and applying a natural outflow boundary condition and reproduce the results of the AD, vector variable implementation.
  • 10.5.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 not integrating the pressure term by parts and applying a NoBC outflow boundary condition and reproduce the results of the AD, vector variable implementation.
  • 10.5.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 integrating the pressure term by parts and applying a NoBC outflow boundary condition and reproduce the results of the AD, vector variable implementation.
  • 10.5.15The system shall be able to solve the steady incompressible Navier-Stokes equationswith 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.
  • 10.5.16The system shall be able to solve the steady incompressible Navier-Stokes equationswith 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.
  • 10.5.17The system shall be able to solve the steady incompressible Navier-Stokes equationswith 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.
  • 10.5.18The system shall be able to solve the steady incompressible Navier-Stokes equationswith 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.
  • 10.5.19The system shall be able to solve the steady incompressible Navier-Stokes equationswith 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.
  • 10.5.20The system shall be able to solve the steady incompressible Navier-Stokes equationswith 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.
  • 10.5.21The system shall be able to solve the steady incompressible Navier-Stokes equationswith 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.
  • 10.5.22The system shall be able to solve the steady incompressible Navier-Stokes equationswith 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.
  • 10.5.23The 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
  • 10.5.24The system shall be able to solve the steady incompressible Navier-Stokes equationswith 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.
  • 10.5.25The system shall be able to solve the steady incompressible Navier-Stokes equationswith 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.
  • 10.5.26The system shall be able to solve the steady incompressible Navier-Stokes equationswith 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.
  • 10.5.27The system shall be able to solve two different kernel sets with two different material domains.
  • 10.5.28The system shall be able to solve two different kernel sets within one material domain.
  • 10.5.29The system shall be able to solve one kernel set with two different material domains.
  • 10.5.30The system shall be able to reproduce benchmark results for a Rayleigh number of 1e3.
  • 10.5.31The system shall be able to reproduce benchmark results for a Rayleigh number of 1e4.
  • 10.5.32The system shall be able to reproduce benchmark results for a Rayleigh number of 1e5.
  • 10.5.33The system shall be able to reproduce benchmark results for a Rayleigh number of 1e6.
  • 10.5.34The system shall be able to simulate natural convection by adding the Boussinesq approximation to the incompressible Navier-Stokes equations.
  • 10.5.35The system shall be able to solve mass, momentum, and energy incompressible Navier-Stokes equations with multiple threads.
  • 10.5.36The system shall have an accurate Jacobian provided by automatic differentiation when computing the Boussinesq approximation.
  • 10.5.37The system shall be able to support SUPG and PSPG stabilization of the incompressible Navier Stokes equations including the Boussinesq approximation.
  • 10.5.38The system shall be able to solve stablized mass, momentum, and energy incompressible Navier-Stokes equations with multiple threads.
  • 10.5.39The system shall have an accurate Jacobian provided by automatic differentiation when computing the Boussinesq approximation with SUPG and PSPG stabilization.
  • 10.5.40The system shall be able to reproduce results of incompressible Navier-Stokes with Boussinesq approximation using a customized and condensed action syntax.
  • 10.5.41The system shall be able to solve mass, momentum, and energy incompressible Navier-Stokes equations with a custom action syntax using multiple threads.
  • 10.5.42The system shall be able to apply an external force to the incompressible Navier-Stokes momentum equation through a coupled variable.
  • 10.5.43The 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.
  • 10.5.44The system shall be able to apply an external force to the incompressible Navier-Stokes momentum equation through a vector function.
  • 10.5.45The 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.
  • 10.5.46The 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.
  • 10.5.47The 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.
  • 10.5.48The 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.
  • 10.5.49The 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.
  • 10.5.50The system shall be able to solve the Navier-Stokes equations with a coupled variable force and a gravity force
    1. provided through a dedicated object,
    2. or through a generic object that can simultaneously add multiple forces through both a coupled variable and a function.
    3. The generic object shall also be able to compute the forces solely through multiple coupled variables,
    4. or solely through multiple vector functions.
    5. 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,
    6. two coupled variables,
    7. or two functions.
  • 10.5.51The system shall be able to model a volumetric heat source and included it in stabilization terms.
  • 10.5.52The system shall be able to build a volumetric heat source model using an automatic action syntax.
  • 10.5.53The system shall be able to model a volumetric heat source with a coupled variable and included it in stabilization terms.
  • 10.5.54The system shall be able to build a volumetric heat source model, provided through a coupled variable, using an automatic action syntax.
  • 10.5.55The system shall be able to model the effect of gravity on incompressible flow using a finite element discretization.
  • 10.5.56The system shall compute accurate Jacobians for the incompressible Navier-Stokes equation.
  • 10.5.57The system shall compute accurate Jacobians for the incompressible Navier-Stokes equation with stabilization.
  • 10.5.58The system shall compute accurate Jacobians for the incompressible Navier-Stokes equation with stabilization with a traction boundary condition.
  • 10.5.59The system shall be able to solve Jeffery-Hamel flow in a 2D wedge and compare to the analytical solution
    1. with pressure Dirichlet boundary conditions
    2. and with natural advection boundary conditions.
  • 10.5.60The system shall support solving a steady energy equation and transient momentum equations and apply the correct stabilization.
  • 10.5.61The system shall support solving a steady energy equation and transient momentum equations with correct stabilization and compute a perfect Jacobian.
  • 10.5.62We shall be able to solve a canonical lid-driven problem without stabilization, using mixed order finite elements for velocity and pressure.
  • 10.5.63We shall be able to reproduce the results from the hand-coded lid-driven simulation using automatic differentiation objects.
  • 10.5.64We shall be able to run lid-dirven simulation using a global mean-zero pressure constraint approach.
  • 10.5.65The Jacobian for the mixed-order INS problem shall be perfect when provided through automatic differentiation.
  • 10.5.66We 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.
  • 10.5.67We shall be able to reproduce the hand-coded stabilized results with automatic differentiation objects.
  • 10.5.68The Jacobian for the automatic differentiation stabilized lid-driven problem shall be perfect.
  • 10.5.69Simulation with equal-order shape functions without pressure stabilization shall be unstable.
  • 10.5.70We shall be able to solve the INS equations using the classical Chorin splitting algorithm.
  • 10.5.71The system shall be able to reproduce unstabilized incompressible Navier-Stokes results with hand-coded Jacobian using a customized and condensed action syntax.
  • 10.5.72The system shall be able to reproduce stabilized incompressible Navier-Stokes results with hand-coded Jacobian using a customized and condensed action syntax.
  • 10.5.73The system shall be able to reproduce unstabilized incompressible Navier-Stokes results with auto-differentiation using a customized and condensed action syntax.
  • 10.5.74The system shall be able to reproduce stabilized incompressible Navier-Stokes results with auto-differentiation using a customized and condensed action syntax.
  • 10.5.75The system shall be able to solve a steady stabilized mass/momentum/energy incompressible Navier-Stokes formulation.
  • 10.5.76The system shall be able to solve a transient stabilized mass/momentum/energy incompressible Navier-Stokes formulation.
  • 10.5.77The system shall be able to solve a steady stabilized mass/momentum/energy incompressible Navier-Stokes formulation with action syntax.
  • 10.5.78The system shall be able to solve a transient stabilized mass/momentum/energy incompressible Navier-Stokes formulation with action syntax.
  • 10.5.79The system shall be able to solve a transient incompressible Navier-Stokes with nonlinear Smagorinsky eddy viscosity.
  • 10.5.80The system shall be able to apply pressure stabilization using an alpha parameter of 1e-6 on a
    1. 4x4,
    2. 8x8,
    3. 16x16,
    4. and 32x32 mesh.
  • 10.5.81The system shall be able to apply pressure stabilization using an alpha parameter of 1e-3 on a
    1. 4x4,
    2. 8x8,
    3. 16x16,
    4. and 32x32 mesh.
  • 10.5.82The system shall be able to apply pressure stabilization using an alpha parameter of 1e0 on a
    1. 4x4,
    2. 8x8,
    3. 16x16,
    4. and 32x32 mesh.
  • 10.5.83The system shall be able to apply streamline-upwind stabilization using an alpha parameter of 1e-6 on a
    1. 4x4,
    2. 8x8,
    3. 16x16,
    4. and 32x32 mesh.
  • 10.5.84The system shall be able to apply streamline-upwind stabilization using an alpha parameter of 1e-3 on a
    1. 4x4,
    2. 8x8,
    3. 16x16,
    4. and 32x32 mesh.
  • 10.5.85The system shall be able to apply streamline-upwind stabilization using an alpha parameter of 1e0 on a
    1. 4x4,
    2. 8x8,
    3. 16x16,
    4. and 32x32 mesh.
  • 10.5.86The 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
  • 10.5.87The 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
  • 10.5.88The system shall allow MOOSE applications to specify nonzero malloc behavior; for the Navier-Stokes application, new nonzero allocations shall be errors.
  • 10.5.89The system shall be able to solve for incompressible fluid flowing through a 2D channel driven by pressure inlet and outlet boundary conditions
    1. using the kernel formulation,
    2. using the action formulation
    3. and using a field split preconditioning.
  • 10.5.90The system shall be able to solve for incompressible fluid evolving in a corner cavity with Dirichlet boundary conditions on velocity.
    1. in 2D
    2. and in 2D RZ axisymmetric simulations.
  • 10.5.91The system shall be able to solve for incompressible fluid flowing through a 2D channel with only inlet velocity boundary conditions
    1. with the regular volumetric integration of the momentum pressure term
    2. and with the momentum pressure term integrated by parts.
  • 10.5.92The system shall be able to model heat transfer from ambient surroundings using a volumetric approximation.
  • 10.5.93The system shall be able to build a simulation, modeling heat transfer from ambient surroundings, using an automated action syntax.
  • 10.5.94The 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.
  • navier_stokes: Postprocessors
  • 10.6.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.
  • 10.6.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.
  • 10.6.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.
  • 10.6.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,
    1. with a quadrilateral mesh in XY geometry, with mass flow measured using either a variable or material property,
    2. with a quadrilateral mesh in RZ geometry,
    3. with a triangular mesh in XY geometry,
    4. with Rhie Chow velocity interpolation,
    5. with upwind interpolation of advected quantities,
    6. and with no-slip boundary conditions, for which momentum and energy will be dissipated at the wall.
  • 10.6.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.
  • 10.6.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,
    1. with a quadrilateral mesh in XY geometry, with mass flow measured using either a variable or material property,
    2. with a quadrilateral mesh in RZ geometry,
    3. with Rhie Chow velocity interpolation,
    4. with upwind interpolation of advected quantities,
    5. and with no-slip boundary conditions, for which momentum and energy will be dissipated at the wall.
  • navier_stokes: Scalar Adr
  • 10.7.1The system shall be able to solve for an incompressible fluid flowing through a 1D channel with Streamline Upwind Petrov Galerkin stabilization.
    1. using the optimal tau stabilization,
    2. using the modified tau stabilization,
    3. and still satisfy MMS testing in 1D
    4. and in 2D.

Usability Requirements

Performance Requirements

System Requirements