Reconstructed Discontinuous Galerkin Requirements Traceability Matrix

This template follows Idaho National Laboratory (INL) template TEM-214, "IT System Requirements Traceability Matrix."

commentnote

This document serves as an addendum to Framework Requirements Traceability Matrix and captures information for Requirement Traceability Matrix (RTM) specific to the Reconstructed Discontinuous Galerkin application.

Introduction

Minimum System Requirements

In general, the following is required for MOOSE-based development:

  • GCC/Clang C++17 compliant compiler (GCC @ 7.5.0, Clang @ 5.0.2 or greater)

    • Note: Intel compilers are not supported.

  • Memory: 16 GBs (debug builds)

  • Processor: 64-bit x86

  • Disk: 30GB

System Purpose

The Multiphysics Object Oriented Simulation Environment (MOOSE) is a tool for solving complex coupled Multiphysics equations using the finite element method. MOOSE uses an object-oriented design to abstract data structure management, parallelism, threading and compiling while providing an easy to use interface targeted at engineers that may not have a lot of software development experience. MOOSE will require extreme scalability and flexibility when compared to other FEM frameworks. For instance, MOOSE needs the ability to run extremely complex material models, or even third-party applications within a parallel simulation without sacrificing parallelism. This capability is in contrast to what is often seen in commercial packages, where custom material models can limit the parallel scalability, forcing serial runs in the most severe cases. When comparing high-end capabilities, many MOOSE competitors target modest-sized clusters with just a few thousand processing cores. MOOSE, however, will be required to routinely executed on much larger clusters with scalability to clusters available in the top 500 systems (top500.org). MOOSE will also be targeted at smaller systems such as high-end laptop computers.

The design goal of MOOSE is to give developers ultimate control over their physical models and applications. Designing new models or solving completely new classes of problems will be accomplished by writing standard C++ source code within the framework's class hierarchy. Scientists and engineers will be free to implement completely new algorithms using pieces of the framework where possible, and extending the framework's capabilities where it makes sense to do so. Commercial applications do not have this capability, and instead opt for either a more rigid parameter system or a limited application-specific metalanguage.

System Scope

MOOSE's scope is to provide a set of interfaces for building Finite Element Method (FEM) simulations. Abstractions to all underlying libraries are provided.

Solving coupled problems where competing physical phenomena impact one and other in a significant nonlinear fashion represents a serious challenge to several solution strategies. Small perturbations in strongly-coupled parameters often have very large adverse effects on convergence behavior. These adverse effects are compounded as additional physics are added to a model. To overcome these challenges, MOOSE employs three distinct yet compatible systems for solving these types of problems.

First, an advanced numerical technique called the Jacobian-Free Newton-Krylov (JFNK) method is employed to solve the most fully-coupled physics in an accurate, consistent way. An example of this would be the effect of temperature on the expansion or contraction of a material. While the JFNK numerical method is very effective at solving fully-coupled equations, it can also be computationally expensive. Plus, not all physical phenomena in a given model are truly coupled to one another. For instance, in a reactor, the speed of the coolant flow may not have any direct effect on the complex chemical reactions taking place inside the fuel rods. We call such models "loosely-coupled". A robust, scalable system must strike the proper balance between the various modeling strategies to avoid performing unnecessary computations or incorrectly predicting behavior in situations such as these.

MOOSE's Multiapp system will allow modelers to group physics into logical categories where MOOSE can solve some groups fully-coupled and others loosely-coupled. The Multiapp system goes even further by also supporting a "tightly-coupled" strategy, which falls somewhere between the "fully-coupled" and "loosely-coupled" approaches. Several sets of physics can then be linked together into logical hierarchies using any one of these coupling strategies, allowing for several potential solution strategies. For instance, a complex nuclear reactor model might consist of several tightly-coupled systems of fully-coupled equations.

Finally, MOOSE's Transfers system ties all of the physics groups contained within the Multiapp system together and allows for full control over the flow of information among the various groups. This capability bridges physical phenomena from several different complementary scales simultaneously. When these three MOOSE systems are combined, myriad coupling combinations are possible. In all cases, the MOOSE framework handles the parallel communication, input, output and execution of the underlying simulation. By handling these computer science tasks, the MOOSE framework keeps modelers focused on doing research.

MOOSE innovates by building advanced simulation capabilities on top of the very best available software technologies in a way that makes them widely accessible for innovative research. MOOSE is equally capable of solving small models on common laptops and the very biggest FEM models ever attempted—all without any major changes to configuration or source code. Since its inception, the MOOSE project has focused on both developer and computational efficiency. Improved developer efficiency is achieved by leveraging existing algorithms and technologies from several leading open-source packages. Additionally, MOOSE uses several complementary parallel technologies (both the distributed-memory message passing paradigm and shared-memory thread-based approaches are used) to lay an efficient computational foundation for development. Using existing open technologies in this manner helps the developers reduce the scope of the project and keeps the size of the MOOSE code base maintainable. This approach provides users with state-of-the-art finite element and solver technology as a basis for the advanced coupling and solution strategies mentioned previously.

MOOSE's developers work openly with other package developers to make sure that cutting-edge technologies are available through MOOSE, providing researchers with competitive research opportunities. MOOSE maintains a set of objects that hide parallel interfaces while exposing advanced spatial and temporal coupling algorithms in the framework. This accessible approach places developmental technology into the hands of scientists and engineers, which can speed the pace of scientific discovery.

Assumptions and Dependencies

The Reconstructed Discontinuous Galerkin application is developed using MOOSE and is based on various modules, as such the RTM for Reconstructed Discontinuous Galerkin is dependent upon the files listed at the beginning of this document.

Pre-test Instructions/Environment/Setup

Ideally all testing should be performed on a clean test machine following one of the supported configurations setup by the test system engineer. Testing may be performed on local workstations and cluster systems containing supported operating systems.

The repository should be clean prior to building and testing. When using "git" this can be done by doing a force clean in the main repository and each one of the submodules:


git clean -xfd
git submodule foreach 'git clean -xfd'

All tests must pass in accordance with the type of test being performed. This list can be found in the Software Test Plan.

System Requirements Traceability

Functional Requirements

  • rdg: Actions
  • 11.1.1The system shall allow the shortcut syntax specifying an AuxKernel
    1. nested under an AuxVariable, and
    2. it shall produce the same output as with the standard syntax.

    Specification(s): syntax/nested, syntax/standard

    Design: AddAuxKernelAction

    Issue(s): #20753

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.1.2The system shall error if the supplied order of scalar auxiliary variable is of an unknown order.

    Specification(s): invalid_order_high

    Design: AuxVariables System

    Issue(s): #960#2294#4668

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.1.3The system shall support calculations with an auxiliary scalar variable represented with a 21st order monomial function.

    Specification(s): high_order_scalar

    Design: AuxVariables System

    Issue(s): #960#2294#4668

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.1.4The system shall report an informative error when object parameters are constructed using legacy methods

    Specification(s): test

    Design: CheckLegacyParamsAction

    Issue(s): #19439

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.1.5The system shall be capable of reporting Action object dependencies.

    Specification(s): test_show_actions_dependency

    Design: MOOSE Action System

    Issue(s): #11971

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.1.6The system shall be capable of reporting Action object task information.

    Specification(s): test_show_actions_tasks

    Design: MOOSE Action System

    Issue(s): #11971

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.1.7The system shall support the detailed on-screen output of all of the Reporters that were declared and requested, including type, producer, context, and consumers.

    Specification(s): test

    Design: Reporter System

    Issue(s): #17605

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.1.8The system shall be able to retrieve other Action objects from within another Action object.

    Specification(s): get_actions

    Design: MOOSE Action System

    Issue(s): #7905

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.1.9The Action system shall allow Action objects to create other Action objects.

    Specification(s): test_meta_action

    Design: MOOSE Action System

    Issue(s): #1478

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.1.10The Action system shall allow the creation of Action objects with multiple tasks.

    Specification(s): circle_quads

    Design: MOOSE Action System

    Issue(s): #10619

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Adaptivity
  • 11.2.1The Adaptivity system shall allow for multiple mesh adaptivity steps per timestep.

    Specification(s): test

    Design: Adaptivity System

    Issue(s): #830

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.2.2The Adaptivity system shall support mesh adaptivity during initial setup.

    Specification(s): test

    Design: Adaptivity SystemMarkers System

    Issue(s): #1700

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.2.3The Adaptivity system shall support marking elements for refinement during initial setup using a different marker than used during execution.

    Specification(s): test

    Design: Adaptivity SystemMarkers System

    Issue(s): #1700

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.2.4The Adaptivity system shall support execution at every n timestep.

    Specification(s): test

    Design: Adaptivity SystemMarkers System

    Issue(s): #13561

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.2.5The Adaptivity system shall be capable of restricting the element refinement level.

    Specification(s): test

    Design: Adaptivity System

    Issue(s): #1699

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.2.6The Adaptivity system shall allow for Marker objects to be recomputed with each adaptivity cycle.

    Specification(s): test

    Design: Adaptivity SystemMarkers System

    Issue(s): #6663

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.2.7The system shall support initial uniform mesh refinement within a subdomain for a steady-state calculation.

    Specification(s): steady

    Design: Adaptivity System

    Issue(s): #18656#18655

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Bcs
  • 11.4.1The system shall support Neumann type boundary conditions for a 1D problem.

    Specification(s): test

    Design: NeumannBC

    Issue(s): #1654

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.2The system shall support Neumann type boundary conditions for a 1D problem using an imported mesh.

    Specification(s): from_cubit

    Design: NeumannBC

    Issue(s): #1654

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • The system shall support Neumann type boundary conditions using automatic differentiation for a 1D problem
    1. using a generated mesh.
    2. and shall be able to produce the exact Jacobian
    3. using an imported mesh.

    Specification(s): ad/test, ad/jac, ad/from_cubit

    Design: ADNeumannBC

    Issue(s): #1654

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.4.4The system shall support setting AD Dirichlet type boundary conditions, supplied as a function, directly to the solution vector prior to the solve.

    Specification(s): bc_function_nodal_test

    Design: ADFunctionDirichletBC

    Issue(s): #13261

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.5The system shall support setting AD Dirichlet type boundary conditions directly to the solution vector prior to the solve.

    Specification(s): bc_preset_nodal_test

    Design: ADDirichletBC

    Issue(s): #13261

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.6The system shall support setting AD Dirichlet type boundary conditions, supplied as a function, directly to the solution vector prior to the solve and have perfect Jacobians.

    Specification(s): bc_function_nodal_test-jac

    Design: ADFunctionDirichletBC

    Issue(s): #13261

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.4.7The system shall support setting AD Dirichlet type boundary conditions directly to the solution vector prior to the solve and have perfect Jacobians.

    Specification(s): bc_preset_nodal_test-jac

    Design: ADDirichletBC

    Issue(s): #13261

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.4.8We shall be able to produce the expected result using ADKernel, ADNodalBC, and ADIntegratedBC

    Specification(s): test

    Design: ADFunctionDirichletBCADDiffusion

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.9We shall be able to produce the exact Jacobian using ADKernel, ADNodalBC, and ADIntegratedBC with a first order variable

    Specification(s): jac

    Design: ADFunctionDirichletBCADDiffusion

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.4.10We shall be able to produce the exact Jacobian using ADKernel, ADNodalBC, and ADIntegratedBC with a second order variable

    Specification(s): 2nd_order_jac

    Design: ADFunctionDirichletBCADDiffusion

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.4.11We shall be able to produce the expected result using ADVectorKernel, ADVectorNodalBC, and ADVectorIntegratedBC

    Specification(s): vector_test

    Design: ADVectorFunctionDirichletBCADVectorDiffusion

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.12We shall be able to produce the exact Jacobian using ADVectorKernel, ADVectorNodalBC, and ADVectorIntegratedBC with a first order variable

    Specification(s): vector_jac

    Design: ADVectorFunctionDirichletBCADVectorDiffusion

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.4.13We shall be able to produce the exact Jacobian using ADVectorKernel, ADVectorNodalBC, and ADVectorIntegratedBC with a second order variable

    Specification(s): 2nd_order_vector_jac

    Design: ADVectorFunctionDirichletBCADVectorDiffusion

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.4.14The system shall be able to couple a lower-dimensional variable into a boundary condition for a higher-dimensional variable.

    Specification(s): couple_lower

    Design: Coupleable

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • The system shall support Dirichlet type boundary conditions defined by a function
    1. using automatic differentiation.
    2. using automatic differentiation and shall be able to produce the exact Jacobian.

    Specification(s): ad/test, ad/test-jac

    Design: ADFunctionDirichletBC

    Issue(s): #13261

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • The system shall support Neumann type boundary conditions defined by a function
    1. using automatic differentiation.
    2. using automatic differentiation and shall be able to produce the exact Jacobian.

    Specification(s): ad/test, ad/test-jac

    Design: ADFunctionNeumannBC

    Issue(s): #12903

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.4.17The system shall support matching variable values on a boundary using automatic differentiation

    Specification(s): test

    Design: ADMatchedValueBC

    Issue(s): #18212

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.18The system shall produce the exact Jacobian for BC matching variable values on a boundary using automatic differentiation

    Specification(s): jacobian

    Design: ADMatchedValueBC

    Issue(s): #18212

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • The system shall support the application of Dirichlet type boundary conditions using the penalty method using the AD system
    1. with a constant value on the boundary.
    2. with a constant value on the boundary and shall be able to produce the exact Jacobian.
    3. with a value on the boundary set by a function.
    4. with a value on the boundary set by a function and shall be able to produce the exact Jacobian.

    Specification(s): ad/penalty_dirichlet_bc_test, ad/penalty_dirichlet_bc_test-jac, ad/function_penalty_dirichlet_bc_test, ad/function_penalty_dirichlet_bc_test-jac

    Design: ADPenaltyDirichletBCADFunctionPenaltyDirichletBC

    Issue(s): #12903

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.4.20The system shall provide array vacuum boundary condition.

    Specification(s): test

    Design: ArrayVacuumBC

    Issue(s): #6881

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.21The system shall support setting Dirichlet type boundary conditions, supplied as a function, directly to the solution vector prior to the solve.

    Specification(s): bc_function_nodal_test

    Design: FunctionDirichletBC

    Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.22The system shall support setting Dirichlet type boundary conditions directly to the solution vector prior to the solve.

    Specification(s): bc_preset_nodal_test

    Design: DirichletBC

    Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.23The system shall support the creation of BoundaryCondition objects that support conditional activation.

    Specification(s): test

    Design: BCs System

    Issue(s): #1771

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.24The system shall support the creation of BoundaryCondition objects that couple to nonlinear variables.

    Specification(s): test

    Design: BCs System

    Issue(s): #656

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.25The system shall support coupled Neumann type boundary conditions.

    Specification(s): test

    Design: CoupledVarNeumannBC

    Issue(s): #13502

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.26The system shall enable scaling of the Neumann type boundary conditions.

    Specification(s): on_off

    Design: CoupledVarNeumannBC

    Issue(s): #15421

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.27When coupling nonlinear variables into a Neumann type boundary condition, the system shall
    1. generate accurate results
    2. generate a perfect Jacobian

    Specification(s): nonlinear/exo, nonlinear/jac

    Design: CoupledVarNeumannBC

    Issue(s): #13502

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.4.28The system shall be able to determine if a non-scalable algorithm is being used for ghosting boundaries.

    Specification(s): check

    Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator

    Issue(s): #15501

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.4.29The system shall make sure that boundaries are actually distributed.

    Specification(s): check_one_step

    Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator

    Issue(s): #15501

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.4.30The system shall support periodic boundary conditions in a parallel generated 2D mesh.

    Specification(s): 2d

    Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator

    Issue(s): #15501

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.31The system shall support periodic boundary conditions in a parallel generated 3D mesh.

    Specification(s): 3d

    Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator

    Issue(s): #15501

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.32The system shall support periodic boundary conditions in a parallel generated 1D mesh.

    Specification(s): 1d

    Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator

    Issue(s): #15501

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.33The system shall support Dirichlet type boundary conditions defined by a function.

    Specification(s): test

    Design: FunctionDirichletBC

    Issue(s): #1214

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.34The system shall support applying a function of space-time as a Neumann boundary condition.

    Specification(s): test

    Design: FunctionNeumannBC

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.35The system shall support applying a material property as a Neumann boundary condition.

    Specification(s): test

    Design: MatNeumannBC

    Issue(s): #17791

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.36The system shall support applying a material property as a Neumann boundary condition using AD.

    Specification(s): ad_test

    Design: MatNeumannBC

    Issue(s): #17791

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.37The system shall support matching variable values on a boundary.

    Specification(s): test

    Design: BCs System

    Issue(s): #656

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.38The system shall support the ability to create convective flux boundary conditions.

    Specification(s): convective_flux_bc_test

    Design: BCs System

    Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.39The system shall support a vacuum boundary condition for neutron diffusion on the boundary.

    Specification(s): vacuumbc_test

    Design: BCs System

    Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.40The system shall support Neumann type boundary conditions where the specified value is defined as the value of a vector, , in the direction of the boundary outward facing normal, (i.e., ).

    Specification(s): vector_neumann_test

    Design: BCs System

    Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.41The system shall support the 'no boundary condition' type boundary condition (Griffiths, 1997).

    Specification(s): weak_gradient_bc_test

    Design: BCs System

    Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.42The system shall be capable of computing the nodal normals for triangle elements.

    Specification(s): circle_tris

    Design: NodalNormals System

    Issue(s): #1871

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.43The system shall be capable of computing the nodal normals for quadrilateral elements.

    Specification(s): circle_quads

    Design: NodalNormals System

    Issue(s): #1871

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.44The system shall be capable of computing the nodal normals for first order hexahedron elements.

    Specification(s): cylinder_hexes

    Design: NodalNormals System

    Issue(s): #1871

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.45The system shall be capable of computing the nodal normals for second order hexahedron elements.

    Specification(s): cylinder_hexes_2nd

    Design: NodalNormals System

    Issue(s): #1871

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.46The system shall be capable of computing the first order nodal normals for second order hexahedron elements.

    Specification(s): cylinder_hexes_1st_2nd

    Design: NodalNormals System

    Issue(s): #1871

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.47The system shall be capable of computing the nodal normals for quadrilateral elements on a square domain.

    Specification(s): small_sqaure

    Design: NodalNormals System

    Issue(s): #1871

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.48The system shall support the application of Dirichlet type boundary conditions using the penalty method.

    Specification(s): test_penalty_dirichlet_bc

    Design: PenaltyDirichletBC

    Issue(s): #5268

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.49The system shall support the application of Dirichlet type boundary conditions, defined by a function, using the penalty method.

    Specification(s): test_function_penalty_dirichlet_bc

    Design: PenaltyDirichletBC

    Issue(s): #5268

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.50The system shall support periodic boundary conditions with transforms defined as functions.

    Specification(s): all_periodic_trans_test

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.51The system shall support periodic boundary conditions with transforms that are computed automatically in the 'x' and 'y' directions.

    Specification(s): auto_wrap_2d_test

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.52The system shall support periodic boundary conditions with transforms that are computed automatically in the 'x' and 'y' directions using a non-generated mesh.

    Specification(s): auto_wrap_2d_test_non_generated

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.53The system shall produce an error within the PeriodicDistanceAux object when a point is provided that is outside the mesh domain.

    Specification(s): auto_wrap_2d_test_error_check

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

    Prerequisite(s): 11.4.51

  • 11.4.54The system shall support periodic boundary conditions with transforms that are computed automatically in the 'x', 'y', and 'z' directions.

    Specification(s): auto_wrap_3d_test

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.55The system shall support periodic boundary conditions on orthogonal boundaries with transforms defined as functions.

    Specification(s): orthogonal_pbc_on_square_test

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.56The system shall support periodic boundary conditions on parallel boundaries with transforms defined as functions.

    Specification(s): parallel_pbc_using_trans_test

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.57The system shall support periodic boundary conditions with mesh adaptivity.

    Specification(s): testlevel1

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.58The system shall support periodic boundary conditions with transforms prescribed as a translation.

    Specification(s): testperiodic

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.59The system shall support periodic boundary conditions on vector variables with transforms prescribed as a translation.

    Specification(s): testperiodic_vector

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.60The system shall support periodic boundary conditions with displacements.

    Specification(s): testperiodic_dp

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.61The system shall support periodic boundary conditions on a trapezoid domain with transforms prescribed as functions.

    Specification(s): testtrapezoid

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.62The system shall support calls to periodic distance and bounds methods on the mesh when periodic boundary conditions are not used.

    Specification(s): trapezoid_non_periodic

    Design: MooseMesh

    Issue(s): #11939

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.63The system shall support periodic boundary conditions on a wedge domain with transforms prescribed as functions.

    Specification(s): testwedge

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.64The system shall support periodic boundary conditions for a single variable on a wedge domain with transforms prescribed as functions.

    Specification(s): testwedgesys

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.65The system shall support periodic boundary conditions for input meshes that have repeated element ids.

    Specification(s): auto_dir_repeated_id

    Design: Periodic System

    Issue(s): #935#1530

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.66When using periodic boundary detection, the system shall not attempt to add periodic boundary conditions to scalar variables.

    Specification(s): no_add_scalar

    Design: AddPeriodicBCAction

    Issue(s): #11417

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.67The system shall support the application of a Neumann boundary condition computed via Postprocessor object.

    Specification(s): test

    Design: PostprocessorNeumannBC

    Issue(s): #5680

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.68The system shall properly compute second derivatives within BoundaryCondition objects.

    Specification(s): test_lap_bc

    Design: BCs System

    Issue(s): #6327

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.69The system shall support creating sidesets from nodesets for hexahedron elements to use with Boundary Condition objects.

    Specification(s): test_hex

    Design: Mesh SystemBCs System

    Issue(s): #687

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.70The system shall support creating sidesets from nodesets for tetrahedron elements to use with Boundary Condition objects.

    Specification(s): test_tet

    Design: Mesh SystemBCs System

    Issue(s): #687

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.71The system shall include the ability to apply a Neumann boundary condition according to a sin function.

    Specification(s): sinneumann_test

    Design: SinNeumannBC

    Issue(s): 0d86cfce0b83e2efaa0647d8e1f1ca5e755872fc

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.72The system shall include the ability to apply a Dirichlet boundary condition according to a sin function.

    Specification(s): sindirichlet_test

    Design: SinDirichletBC

    Issue(s): 0d86cfce0b83e2efaa0647d8e1f1ca5e755872fc

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.4.73BoundaryCondition objects shall support retrieval of VectorPostprocessor data.

    Specification(s): test

    Design: BCs System

    Issue(s): #9285

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Controls
  • 11.6.1The Control system shall allow a boolean parameter to be controlled with a function.

    Specification(s): single

    Design: Controls SystemBoolFunctionControl

    Issue(s): #15402

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.6.2The Control system shall be capable of activating or deactivating MOOSE objects using a conditional function.

    Specification(s): test

    Design: Controls SystemConditionalFunctionEnableControl

    Issue(s): #5676#13295

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.6.3The MOOSE control system shall allow parameters from differing objects, with differing names to be associated and changed together.

    Specification(s): direct

    Design: Controls System

    Issue(s): #9087#5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.4The MOOSE control system shall allow parameters from objects to be assigned aliases for the purpose of changing the value.

    Specification(s): alias

    Design: Controls System

    Issue(s): #9087#5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.5The system shall allow controlling piecewise functions and material properties.

    Specification(s): controlled_piecewise

    Design: PiecewiseLinearPiecewiseLinearInterpolationMaterial

    Issue(s): #15321

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.6The Control system shall support explicitly defined dependencies.

    Specification(s): test

    Design: Controls System

    Issue(s): #9483#5676

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.6.7The Control system shall error if an attempt to alter a non-controllable parameter is performed.

    Specification(s): non_controllable_error

    Design: Controls System

    Issue(s): #5676

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.6.8The Control system shall error if multiple controllable parameters exists, but only a single parameter is expected to be controlled.

    Specification(s): multiple_params_found_warning

    Design: Controls System

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.6.9The Control system shall error if an unknown parameter is supplied for control.

    Specification(s): no_param_found

    Design: Controls System

    Issue(s): #5676

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.6.10The Control system shall error if a thread id greater than the number of threads available is supplied when retrieving a Control object.

    Specification(s): tid_warehouse_error

    Design: Controls System

    Issue(s): #5676

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.6.11The Control system shall error if an attempt is made to disable the Executioner.

    Specification(s): disable_executioner

    Design: Controls System

    Issue(s): #5676

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.6.12The Control system shall error if an invalid control name is supplied to the Control dependency resolution procedure.

    Specification(s): non_existing_dependency

    Design: Controls System

    Issue(s): #5676

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.6.13The Control system shall support the modification of a single parameter using the objects base class name, object name, and parameter name.

    Specification(s): base_object_param

    Design: Controls System

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.14The Control system shall support the modification of multiple parameters using the objects base class and the parameter name.

    Specification(s): base_param

    Design: Controls System

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.15The Control system shall include a means to output information regarding the controlled parameters.

    Specification(s): test

    Design: Controls SystemControlOutput

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.6.16The Control system shall include a means to output information regarding the controlled parameters, including only showing information regarding a parameter if it has changed since the last output.

    Specification(s): clear

    Design: Controls SystemControlOutput

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.6.17The system shall include a command line flag for displaying controllable parameter information.

    Specification(s): cli_args

    Design: Controls SystemControlOutput

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.6.18The Control system shall include a means to output information regarding the objects with controllable parameters.

    Specification(s): active

    Design: Controls SystemControlOutput

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.6.19The Control system shall be able to control an input parameter to make a postprocessor match a target value,
    1. using the principle of Proportional Integral Derivative control,
    2. using a input postprocessor in lieu of an input parameter,
    3. with integral windup control, resetting the integral term if the error crosses zero,
    4. keeping the PID process within a single timestep,
    5. and resetting the PID process correctly if the solver fails during a Picard/coupling iteration.

    Specification(s): pid/basic, pid/basic_postprocessor, pid/windup, pid/picard, pid/resistance_to_solver_fails

    Design: Controls SystemPIDTransientControl

    Issue(s): #17271

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.6.20The Control system shall allow a scalar parameter to be controlled with a function.

    Specification(s): single

    Design: Controls SystemRealFunctionControl

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.6.21The Control system shall allow multiple scalar parameters to be controlled with a function.

    Specification(s): multiple

    Design: Controls SystemRealFunctionControl

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.6.22The MOOSE control system shall be capable of restricting parameters to be controlled for specific execution flags.

    Specification(s): error

    Design: Controls System

    Issue(s): #12576

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.6.23The Control system shall allow multiple parameters to be changed by the parameter name alone using input syntax format.

    Specification(s): param

    Design: Controls System

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.24The Control system shall allow multiple parameters to be changed given the object and parameter names using input syntax format.

    Specification(s): object_param

    Design: Controls System

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.25The Control system shall allow for a single parameter to be changes given the input syntax, object name, and parameter name.

    Specification(s): system_object_param

    Design: Controls System

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.26The Control system shall allow for multiple parameters to be changed given input syntax and a parameter name.

    Specification(s): system_asterisk_param

    Design: Controls System

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.27The Control system shall allow multiple parameters to be changed by the parameter name alone using a tag.

    Specification(s): param

    Design: Controls System

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.28The Control system shall allow multiple parameters to be changed given a tag and parameter names, given a tag assigned across input blocks.

    Specification(s): object_param

    Design: Controls System

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.29The Control system shall allow for a single parameter to be changes given a tag and parameter name, given a tag assigned to a single object.

    Specification(s): system_object_param

    Design: Controls System

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.30The Control system shall allow for multiple parameters to be changed given a tag and a parameter name, given a tag assigned within a single input block on multiple objects.

    Specification(s): system_asterisk_param

    Design: Controls System

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.31The Control system shall be capable of activating or deactivating AuxKernel objects with time.

    Specification(s): test

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.32The Control system shall be capable of activating or deactivating AuxScalarKernel objects with time, given identical start end times.

    Specification(s): multi_same_times

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.6.33The Control system shall be capable of activating or deactivating AuxScalarKernel objects with time, given differing start end times.

    Specification(s): multi_different_times

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.6.34The system shall be capable of activating and/or deactivating boundary contributions to the residual with time
    1. for contributions from finite element nodes,
    2. for contributions integrated over a finite element side,
    3. for contributions from automatic differentiation, and
    4. perform the activation/deactivation with a single control.

    Specification(s): tests/dirichlet, tests/integrated, tests/ad, tests/enable_disable

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.35The Control system shall be capable of activating or deactivating Constraint objects with time.

    Specification(s): test

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.36The system shall support disabling an object using an input parameter.

    Specification(s): enable_false

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.6.37The system shall support enabling an object using an input parameter.

    Specification(s): enable_true

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.6.38The system shall be capable of activating or deactivating Damper objects with time via the Control system.

    Specification(s): control

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.6.39The Control system shall be capable of activating or deactivating DGKernel objects with time.

    Specification(s): test

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.40The Control system shall be capable of activating or deactivating DiracKernel objects with time.

    Specification(s): test

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.41The TimePeriod object shall error when used with a steady state problem.

    Specification(s): steady_error

    Design: TimePeriod

    Issue(s): #5676

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.6.42The TimePeriod object shall error when the start and end time parameters are not the same length.

    Specification(s): start_end_size_mismatch

    Design: TimePeriod

    Issue(s): #5676

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.6.43The TimePeriod object shall error when start and end time parameters differ in length than the supplied object list.

    Specification(s): time_disable_size_mismatch

    Design: TimePeriod

    Issue(s): #5676

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.6.44The TimePeriod object shall error when a list of objects to control is omitted.

    Specification(s): enable_disable_not_set

    Design: TimePeriod

    Issue(s): #5676

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.6.45The TimePeriod object shall error when start time is greater than the end time.

    Specification(s): start_greater_than_end_error

    Design: TimePeriod

    Issue(s): #5676

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.6.46The system shall be capable of activating or deactivating volume residual contributions with time:
    1. for non-automatic differentiation and
    2. automatic differentiation terms.

    Specification(s): test/non_ad, test/ad

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.47The system shall be capable of activating or deactivating materials in the input file depending on time.

    Specification(s): test

    Design: TimePeriod

    Issue(s): #5676#18994

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.6.48The Control system shall be capable of activating or deactivating MultiApp objects with time.

    Specification(s): test

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.49The Control system shall be capable of activating or deactivating NodalKernel objects with time.

    Specification(s): test

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.50The Control system shall be capable of activating or deactivating ScalarKernel objects with time.

    Specification(s): test

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.6.51The Control system shall be capable of activating or deactivating Transfer objects with time.

    Specification(s): test

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.6.52The Control system shall be capable of activating or deactivating UserObject objects with time.

    Specification(s): test

    Design: Controls SystemTimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • rdg: DGKernel Objects
  • 11.9.1The system shall support solving 1D advection using the discontinous Galerkin method.

    Specification(s): test

    Design: ConservativeAdvectionDGConvection

    Issue(s): #869

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.2The system shall support solving 2D diffusion using the discontinuous Galerkin method.

    Specification(s): test

    Design: DGFunctionDiffusionDirichletBCDGDiffusion

    Issue(s): #869

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.3DGKernels shall coexist with stateful material properties

    Specification(s): stateful_props

    Design: DGKernels System

    Issue(s): #11766

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.9.4The system shall not perform memory allocation automatic scaling when computing values using discontinuous finite element methods.

    Specification(s): no_mallocs_during_scaling

    Design: FEProblemSolve.md

    Issue(s): #12601

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.9.5When objects that need one layer of coupling (like DGKernels) are added via action, we shall ensure that we have added a proper relationship manager and thus incur no mallocs during calls to MatSetValues. We will not apply algebraic ghosting nor reinitialize system vectors in serial, but we will reinitialize the matrix sparsity

    Specification(s): proper_ghosting_with_action_serial

    Design: RelationshipManager

    Issue(s): #13736

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.6When objects that need one layer of coupling (like DGKernels) are added via action, we shall ensure that we have added a proper relationship manager and thus incur no mallocs during calls to MatSetValues. We will also apply algebraic ghosting in parallel which will require reinitializing the system; the sparsity pattern will also have to be reinitialized

    Specification(s): proper_ghosting_with_action_parallel

    Design: RelationshipManager

    Issue(s): #13736

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.7If a RelationshipManager with sufficient coverage has already been added through a MooseObjectAction, then the CouplingFunctorCheck action shall not add any relationship managers, avoiding reinitialization of system vectors and the system matrix

    Specification(s): no_additional_rms

    Design: RelationshipManager

    Issue(s): #13736

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.8This test shall have one more rm than its replicated counter part because of the geometric-only GhostPointNeighbors rm, also demonstrating no mallocs. Sparsity will be reinitialized but not vectors

    Specification(s): proper_ghosting_with_action_serial_distributed

    Design: RelationshipManager

    Issue(s): #13736

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.9This test shall have one more rm than its replicated counter part because of the geometric-only GhostPointNeighbors rm, also demonstrating no mallocs. Sparsity and vectors will both be reinitialized

    Specification(s): proper_ghosting_with_action_parallel_distributed

    Design: RelationshipManager

    Issue(s): #13736

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.10This test shall have one more rm than its replicated counter part because of the geometric-only GhostPointNeighbors rm, also demonstrating no addition of rms by the CouplingFunctorCheckAction

    Specification(s): no_additional_rms_distributed

    Design: RelationshipManager

    Issue(s): #13736

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.11The system shall support solving 3D diffusion using the discontinuous Galerkin method.

    Specification(s): test

    Design: DGFunctionDiffusionDirichletBCDGDiffusion

    Issue(s): #869

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.12We shall be able to use constant monomials with AD

    Specification(s): exo

    Design: ADDGKernel

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.9.13MOOSE should support AD in DG Kernels

    Specification(s): test

    Design: ADDGKernel

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.14Adaptivity shall work with dg kernels as long as stateful properties are not used.

    Specification(s): dg_adaptivity

    Design: DGKernels System

    Issue(s): #10977

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.15The system shall error if the triad of dg kernels, adaptivity, and stateful properties are used together.

    Specification(s): error_stateful_dg_adaptivity

    Design: DGKernels System

    Issue(s): #10977

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.9.16The system shall be able to solve the advection diffusion equation using the discontinuous Galerkin method.

    Specification(s): resid

    Design: DGKernels System

    Issue(s): #8408

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.17The system shall compute the correct Jacobian for the advection diffusion equation using the discontinuous Galerkin method.

    Specification(s): jac

    Design: DGKernels System

    Issue(s): #8408

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.9.18The DGKernel system shall support restriction to subdomains, in 1D.

    Specification(s): 1D_test

    Design: DGKernels System

    Issue(s): #6042

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.19The DGKernel system shall support restriction to subdomains, in 2D.

    Specification(s): 2D_test

    Design: DGKernels System

    Issue(s): #6042

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.20The DGKernel system shall operate with displaced meshes.

    Specification(s): test

    Design: DGKernels System

    Issue(s): #3536

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.9.21The DGCoupledDiffusion object shall compute the correct Jacobian.

    Specification(s): jacobian_test

    Design: DGKernels System

    Issue(s): #629

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

  • 11.9.22The system shall be able to use variables when initializing stateful material properties on neighbor materials used for the discontinuous Galerkin method.

    Specification(s): run

    Design: Materials System

    Issue(s): #19735

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • rdg: Executors
  • 11.12.1The system shall be able to utilize a modular/nested system of execution

    Specification(s): test

    Design: Executor

    Issue(s): #5229#18180

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.12.2The system shall error if the Executor system contains an infinite cycle

    Specification(s): cycle

    Design: Executor

    Issue(s): #5229#18180

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.12.3The system shall only have one root node in the Executor tree

    Specification(s): multi_root

    Design: Executor

    Issue(s): #5229#18180

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.12.4The system shall be able to experimentally use the executor system instead of an executioner.

    Specification(s): test_executor_interface

    Design: Executor

    Issue(s): #5229#18180

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • rdg: Fixedbugs
  • 11.13.1The Material objects provided on all subdomains shall satisfy requests for objects on all subdomains.

    Specification(s): test

    Design: Materials System

    Issue(s): #8575

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • rdg: Functions
  • 11.14.1Generate the fine tabulated function data for the coarsened_piecewise_linear test

    Specification(s): prepare_data

    Design: CoarsenedPiecewiseLinear

    Issue(s): #2272

    Collection(s): FUNCTIONAL

    Type(s): RunCommand

  • 11.14.2The Function system shall include an object that creates a function based on x- and y-data pairs, reduces the number of data points based on a user supplied cut-off and returns a linearly interpolated value from the coarsened data.

    Specification(s): coarsened_piecewise_linear

    Design: CoarsenedPiecewiseLinear

    Issue(s): #2272

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.14.1

  • 11.14.3The Function system shall include a constant function.

    Specification(s): test

    Design: ConstantFunction

    Issue(s): #1678

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.4The Function system shall include the ability to set default values for input parameters expecting a function name.

    Specification(s): test

    Design: Functions System

    Issue(s): #2880

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.5The Function system shall include the ability to read comma or space separated data and perform linear interpolation using the supplied data.

    Specification(s): test

    Design: Functions SystemPiecewiseLinear

    Issue(s): cf61044773b14d5560e583867462fe9831dd1f3e

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.6The system shall be able to initialize a variable with values computed using a user-specified function
    1. using the function directly.
    2. with a scaling factor applied to the function.

    Specification(s): test/basic, test/scaling

    Design: FunctionIC

    Issue(s): f792fc7ff9f8d8dfa8b3272117745fc422295ca1

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.7The Function object shall include a callback executed during each timestep.

    Specification(s): test

    Design: Functions System

    Issue(s): #1017

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.8The Material system shall support defining properties within the input file that are associated with functions.

    Specification(s): scalar

    Design: GenericFunctionMaterial

    Issue(s): #1335

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.9The Material system shall support defining vector properties within the input file that are associated with functions.

    Specification(s): vector

    Design: GenericFunctionVectorMaterial

    Issue(s): #18372

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.10The Material system shall error out if the number of functions supplied does not match the size of the vector function material properties.

    Specification(s): vector_error

    Design: GenericFunctionVectorMaterial

    Issue(s): #18372

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.11The system shall allow for piecewise functions to directly set the x and y data internally.

    Specification(s): hardcoded_piecewise_linear

    Design: PiecewiseLinear

    Issue(s): #14220

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.14.12The system shall include the ability to create functions from image files that errors if
    1. an unsupported file type is provided;
    2. if an invalid component value is supplied;
    3. if an invalid filename is provided; and
    4. the system is not configured with the correct dependencies.

    Specification(s): errors/file_suffix, errors/component, errors/invalid_file, errors/no_vtk

    Design: ImageFunctionImageMesh

    Issue(s): #5927

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.13The system shall include the ability to define a function based on a 2D image and initialize a nodal variable.

    Specification(s): 2d

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.14The system shall include the ability to define a function based on a 2D image and initialize a elemental variable.

    Specification(s): 2d_elemental

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.15The system shall include the ability to define a function based on a stack of images and initialize a nodal variable.

    Specification(s): 3d

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.16The system shall include the ability to define a function based on a subset stack of images and initialize a nodal variable.

    Specification(s): 3d_subset

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.17The system shall allow the image data within the ImageFunction object to be set as one of two values based on a threshold value.

    Specification(s): threshold

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.18The system shall be capable of initializing a variable from image data and perform initial adaptivity based on the data.

    Specification(s): threshold_adapt

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.19The system shall be capable of initializing a variable from image data and perform initial adaptivity based on the data, in parallel.

    Specification(s): threshold_adapt_parallel

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.20The system shall be capable of initializing a variable from image data and perform initial adaptivity based on the data, in parallel and produce Nemesis output files.

    Specification(s): threshold_adapt_parallel_check_files

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.14.21The system shall be capable of limiting the supplied data to the ImageFunction object to a single component of the RGB image data.

    Specification(s): component

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.22The system shall be capable of shifting and scaling the supplied image data to the ImageFunction object.

    Specification(s): shift_and_scale

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.23The system shall be capable of operating on domains that are larger than the image size in the ImageFunction object.

    Specification(s): subset

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.24The system shall be capable of flipping image data along the vertical axis in the ImageFunction object.

    Specification(s): flip

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.25The system shall be capable of flipping image data along vertical axis and shifting the origin using the ImageFunction object.

    Specification(s): flip_dual

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.26The system shall be capable of flipping image data along vertical and horizontal axis within the ImageFunction object.

    Specification(s): flip_quad

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.27The system shall be capable of operating on domains that are smaller than the image size within the ImageFunction object.

    Specification(s): crop

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.28The system shall be capable of generating a 3D mesh based on a stack of 2D images using the ImageMesh object.

    Specification(s): image_mesh_3d

    Design: ImageMesh

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.29The system shall be capable of generating a 2D mesh based on an image using the ImageMesh object.

    Specification(s): image_mesh_2d

    Design: ImageMesh

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • The system shall perform shift and scale options independently using the ImageFunction object.

    Specification(s): moose_logo

    Design: ImageFunction

    Issue(s): #3544#5927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.31The LinearCombinationFunction shall report an error if the parameters listing the functions differs in size than the list of coefficients.

    Specification(s): except1

    Design: LinearCombinationFunction

    Issue(s): #4828

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.32The LinearCombinationFunction shall be capable of computing the sum of function values, each multiplied by a scale factor.

    Specification(s): lcf1

    Design: LinearCombinationFunction

    Issue(s): #4828

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.14.33The LinearCombinationFunction shall be capable of computing the sum of function gradients, each multiplied by a scale factor.

    Specification(s): lcf_grad

    Design: LinearCombinationFunction

    Issue(s): #4828

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.14.34The LinearCombinationFunction shall be capable of computing the sum of vector functions, each multiplied by a scale factor.

    Specification(s): lcf_vector

    Design: LinearCombinationFunction

    Issue(s): #4828

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.35The Function system shall support the creation of objects that execute a function defined within the input file.

    Specification(s): steady

    Design: ParsedFunction

    Issue(s): #1902

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.36The ParsedFunction object shall be capable of defining function within the input file for use with the method of manufactured solutions.

    Specification(s): transient

    Design: ParsedFunction

    Issue(s): #1902

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.37The Function system shall support the creation of objects that execute a vector function defined within the input file.

    Specification(s): vector

    Design: ParsedFunction

    Issue(s): #2273

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.38The Function system shall support the creation of objects that execute a function defined within the input file that includes a scalar variable.

    Specification(s): scalar

    Design: ParsedFunction

    Issue(s): #5041

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.39The ParsedFunction object shall support the use of other functions specified by their names in its expression.

    Specification(s): function

    Design: ParsedFunction

    Issue(s): #12179

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.40The ParsedFunction object shall support the use of functions, scalar values and postprocessor values specified by their names in its expression at the same time.

    Specification(s): combined

    Design: ParsedFunction

    Issue(s): #12179

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.41The Function system shall support the creation of objects that execute a curl of a vector function defined within the input file.

    Specification(s): function_curl

    Design: ParsedFunction

    Issue(s): #13041

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.42The ParsedFunction object shall fail with a human readable error if a vals entry is supplied that is neither a valid postprocessor, scalar variable, function, or real number.

    Specification(s): vals_error

    Design: ParsedFunction

    Issue(s): #14169

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.43The Function system shall include an object that creates a function based on x- and y-data pairs and returns an explicit value from the supplied data when queried (i.e., linear interpolation is not performed).

    Specification(s): piecewise_constant

    Design: PiecewiseConstant

    Issue(s): #2272

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.44The Function system shall include an object that creates a function based on x- and y-data pairs and returns an explicit value from the supplied data when queried (i.e., linear interpolation is not performed) in a simple simulation, with both negative and positive values.

    Specification(s): piecewise_constant_simple

    Design: PiecewiseConstant

    Issue(s): #2272

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.14.45The Function system shall include a function that can obtain data from a CSV file
    1. with data sorted by element ids
    2. with data sorted by node ids
    3. with data at given locations and using nearest neighbor interpolation between those data points
    4. using nearest neighbor interpolation with a random tesselation
    5. with data at given locations and using nearest neighbor interpolation between those data points, with periodic boundaries
    6. with data sorted by blocks and with constant values on each block.

    Specification(s): csv_read/element, csv_read/node, csv_read/voronoi, csv_read/random_voronoi, csv_read/periodic_voronoi, csv_read/block

    Design: PiecewiseConstantFromCSV

    Issue(s): #19109

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.46The system shall error out if
    1. if the CSV reader object and the function expect the CSV data to be ordered differently
    2. if the desired column number in the CSV file is higher than the number of columns in the file
    3. if the data saught exceeds the row number in the CSV file
    4. if the number of blocks specified to a CSV reader reading block-data is 0
    5. if the number of nearest-neighbor regions specified to a CSV reader reading nearest-neighbor-region-data is 0

    Specification(s): errors/read_type, errors/num_columns, errors/num_rows, errors/zero_blocks, errors/zero_voronoi

    Design: PiecewiseConstantFromCSV

    Issue(s): #19109

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.47The system shall issue a warning if
    1. if the desired column number in the CSV file is known to be a column holding point coordinates
    2. if the data file contains more points/rows than the reader needs

    Specification(s): warnings/num_columns, warnings/too_much_data_in_file

    Design: PiecewiseConstantFromCSV

    Issue(s): #19109

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.48The Function system shall include an object that creates a function based on x- and y-data pairs and does not extrapolate.

    Specification(s): no_extrap

    Design: PiecewiseLinear

    Issue(s): #20024

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.14.49The Function system shall include an object that creates a function based on x- and y-data pairs and does extrapolate.

    Specification(s): extrap

    Design: PiecewiseLinear

    Issue(s): #20024

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.14.50The PiecewiseMultilinear object will error if the supplied file fails to open.

    Specification(s): except1

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.51The PiecewiseMultiInterpolation object shall error if the supplied data is not monotonically increasing.

    Specification(s): except2

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.52The PiecewiseMultiInterpolation object shall error if the number of requested functions differ than the number available from the file.

    Specification(s): except3

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.53The PiecewiseMultiInterpolation errors if the axes supplied are not independent.

    Specification(s): except4

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.54The PiecewiseMultilinear shall error if the axis lines are not located in the supplied data.

    Specification(s): except5

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.55The PiecewiseMultilinear object shall perform interpolation on a 1D domain.

    Specification(s): oneDa

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.14.56The PiecewiseMultilinear object shall perform interpolation on a 1D domain that compares to an equivalent known function.

    Specification(s): oneDb

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.14.57The PiecewiseMultilinear object shall perform interpolation of time-dependent data.

    Specification(s): time

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.14.58The PiecewiseMultilinear object shall perform interpolation on a 2D domain.

    Specification(s): twoDa

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.14.59The PiecewiseMultilinear object shall perform interpolation on a 2D domain that compares to an equivalent known function.

    Specification(s): twoDb

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.60The PiecewiseMultilinear object shall perform constant interpolation on a 2D domain.

    Specification(s): twoD_const

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.61The PiecewiseMultilinear object shall perform interpolation on a 3D domain with time-dependent data.

    Specification(s): fourDa

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.62The Function object shall support the ability to couple Postprocessor values.

    Specification(s): test_pp_function_test

    Design: Postprocessor System

    Issue(s): #1199

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.63The SolutionFunction object shall be capable of evaluating a solution read from XDA mesh and solution files.

    Specification(s): test

    Design: SolutionFunction

    Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.64The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file with temporal interpolation.

    Specification(s): exodus_interp_test

    Design: SolutionFunction

    Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.65The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file.

    Specification(s): exodus_test

    Design: SolutionFunction

    Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.66The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and rotated 45 degrees about the z-axis.

    Specification(s): rot1

    Design: SolutionFunction

    Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.67The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and rotated 45 degrees about the y-axis.

    Specification(s): rot2

    Design: SolutionFunction

    Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.68The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and rotated 90 degrees about the z-axis and 45 degress about the x-axis.

    Specification(s): rot3

    Design: SolutionFunction

    Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.69The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and rotated 45 degrees about the z-axis for a 2D domain.

    Specification(s): rot4

    Design: SolutionFunction

    Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.70The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and scaled by a factor in the x and y directions as well as translated in the x-direction.

    Specification(s): scale_transl

    Design: SolutionFunction

    Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.71The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and scaled by a factor of two in the x and y directions.

    Specification(s): scale_mult

    Design: SolutionFunction

    Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.72The SolutionFunction object shall error if a variable that does not exist is requested.

    Specification(s): nonexistent_var_err

    Design: SolutionFunction

    Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.14.73The system shall be capable of evaluating the gradient of a solution
    1. created in a simulation
    2. and read from another.

    Specification(s): solution_function/grad_p1, solution_function/grad_p2

    Design: SolutionFunction

    Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.74The VectorPostprocessorFunction shall be capable of linear interpolating data generated by a VectorPostprocessor object.

    Specification(s): test_spatial_data

    Design: VectorPostprocessorFunction

    Issue(s): #8713

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.14.75The VectorPostprocessorFunction shall be capable of linear interpolating data generated by a VPP with respect to time.

    Specification(s): test_time_data

    Design: VectorPostprocessorFunction

    Issue(s): #14700

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • rdg: Fvbcs
  • 11.15.1The system shall run a simple 1D diffusion problem with a Neumann BC value.

    Specification(s): fv_neumann

    Design: FVNeumannBC

    Issue(s): #16477

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.15.2The system shall error out if a finite volume flux boundary condition, in this case a finite volume Neumann boundary condition, is used inside the domain.

    Specification(s): fvbcs_internal

    Design: FVNeumannBC

    Issue(s): #16882

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.15.3The system shall error out if a finite volume flux boundary condition is used on a mesh element face that is not connected to an element with the corresponding finite volume variable.

    Specification(s): fvbcs_disconnected_from_variable

    Design: FVNeumannBC

    Issue(s): #16882

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.15.4The system shall run a simple 1D diffusion problem with a Dirichlet BC value set by a postprocessor.

    Specification(s): fv_pp_dirichlet

    Design: FVPostprocessorDirichletBC

    Issue(s): #16477

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Fviks
  • 11.16.1The system shall be able to solve a diffusion problem with finite volumes with the domain split in half and force the two variables living on each side of the domain to match on the interface.

    Specification(s): continuity

    Design: FVTwoVarContinuityConstraint

    Issue(s): #17638

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.16.2The system shall be able to solve a diffusion problem with the domain split in half and two finite volume variables living on each side.

    Specification(s): diffusion

    Design: FVDiffusionInterface

    Issue(s): #17638

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.16.3The system shall error if a user specified variable on the 1st side of an interface does not actually exist on the 1st side.

    Specification(s): run_except1

    Design: FVInterfaceKernels System

    Issue(s): #17087

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.16.4The system shall error if a user specified variable on the 2nd side of an interface does not actually exist on the 2nd side.

    Specification(s): run_except2

    Design: FVInterfaceKernels System

    Issue(s): #17087

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.16.5The system shall error if a user does not specify a variable on the 2nd side of an interface, leading the system to assume that the variable on the 1st side of the interface should be used on the 2nd side, and the variable on the 1st side does not exist on the 2nd side.

    Specification(s): run_except3

    Design: FVInterfaceKernels System

    Issue(s): #17087

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.16.6The system shall be able to solve a diffusion problem with finite volumes with the domain split in half and show first order convergence due to its treatment of coefficient discontinuities both
    1. with an interfacing object
    2. without an interfacing object

    Specification(s): first_order_convergence/with-ik, first_order_convergence/without-ik

    Design: FVOneVarDiffusionInterface

    Issue(s): #17087

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • rdg: Fvkernels
  • 11.17.1The system shall support block restriction of finite volume variables and kernels, and shall properly handle material evaluation in block-restricted settings, in a one-dimensional example.

    Specification(s): 1d

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15894

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.2The system shall allow definition of a functor material property with the same name by different block-restricted materials on neighboring subdomains even when there are different sets of finite volume flux kernels on those same neighboring subdomains.

    Specification(s): overlapping-mats

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16809

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.3The system shall support simultaneous block restriction of finite volume and finite element variables and have coupling of the finite volume variables into the finite element equations.

    Specification(s): distinct-mats

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15894

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.17.2

  • 11.17.4The system shall compute a perfect Jacobian when coupling block-restricted finite volume variables into block-restricted finite element calculations.

    Specification(s): jac

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15894

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.17.5The system shall allow different materials to define the same material property name on different sides of an interface when the finite volume physics is the same on both sides of the interface.

    Specification(s): just-mat-blk-restriction

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15894

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.6The system shall compute a perfect Jacobian when different materials define the same material property on different sides of a interface and the finite volume physics are the same on both sides of the interface.

    Specification(s): just-mat-blk-restriction-jac

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15894

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.17.7The system shall be able to impose a constraint on the domain integral of a variable.

    Specification(s): integral

    Design: FVIntegralValueConstraint

    Issue(s): #20607

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.8The system shall be able to impose a constraint on a single point value of a variable.

    Specification(s): point_value

    Design: FVPointValueConstraint

    Issue(s): #20607

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.9The system shall be able to impose bounds for the values of a variable.

    Specification(s): bound

    Design: FVBoundedValueConstraint

    Issue(s): #20607

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.10The system shall be able to couple both finite element and finite volume variables, as functors, into functor material property calculations.

    Specification(s): fe-and-fv-with-functors

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16809

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.11The system shall support coupling of a finite volume variable into a finite element calculation.

    Specification(s): coupled-gold

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15894

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.17.10

  • 11.17.12The system shall compute a perfect Jacobian when coupling a finite volume variable into a finite element calculation.

    Specification(s): jac

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15894

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.17.13The system shall allow a finite volume object to consume a material property that depends on another material property that is computed in a material that couples in a finite element variable.

    Specification(s): dep-in-same-mat-as-coupled-fe

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16809

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.17.11

  • 11.17.14The system shall suggest that the user add a finite volume variable if a finite volume object cannot retrieve one

    Specification(s): var_except

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.17.15The system shall be able to perform finite volume simulations with adaptivity and give correct results

    Specification(s): adapt

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.16The system shall be able to combat a singular solve, resulting from two term boundary expansion during gradient computation, by reverting to a one term boundary expansion.

    Specification(s): steady-coarse

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16822

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.17The system shall display second order convergence when there is some skewness due to mismatch between cell levels.

    Specification(s): steady-mms

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.18The system shall be able to solve the Burgers equation in 1D using the FV method

    Specification(s): fv_burgers

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.19The system shall run a 2D linear advection problems using the finite volume method a regular mesh.

    Specification(s): fv_2D_constant_scalar_advection

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.20The system shall be able to produce correct mathematical results for a coupled-reaction problem
    1. using both finite element and finite volume discretizations with
    2. the correct Jacobian entries.

    Specification(s): test/exo, test/jac

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.17.21The system shall be able to compute the second time derivative of a variable when using the finite volume method and automatic differentiation.

    Specification(s): csv

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #18178

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.17.22The system shall be able to couple variables at faces when using the finite volume method.

    Specification(s): exo

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.23The system shall have an accurate Jacobian when coupling variables at faces and using the finite volume method.

    Specification(s): jac

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.17.24The system shall support caching of functor evaluations performed with boundary face arguments.

    Specification(s): ssf_caching

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #20470

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.25The system shall run a simple 2D linear diffusion problem using the finite volume method with Dirichlet boundary conditions on a regular mesh.

    Specification(s): dirichlet

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.26The system shall run a simple 2D linear diffusion problem in RZ coordinates using the finite volume method with Dirichlet boundary conditions on a regular mesh.

    Specification(s): dirichlet_rz

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.27The system shall be able to compute a full Jacobian matrix when performing finite volume computations

    Specification(s): dirichlet_full_jac

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.17.25

  • 11.17.28The system shall run a simple 2D linear diffusion problem using the finite volume method with Neumann and Dirichlet boundary conditions on a regular mesh.

    Specification(s): neumann

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.29The system shall run a simple 2D transient linear diffusion problem using the finite volume method with Dirichlet boundary conditions on a regular mesh.

    Specification(s): transient

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.30The system shall be able to solve a finite-volume-only problem
    1. on an unrefined mesh
    2. and on a mesh that has been refined to have the same amount of elements and achieve identical results

    Specification(s): refinement/no_refinement, refinement/refinement

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.31The system shall be able solve a three-dimensional diffusion problem using the finite volume method.

    Specification(s): 3d_dirichlet

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.32The system shall be able solve a one-dimensional diffusion problem using the finite volume method.

    Specification(s): 1d_dirichlet

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.33The system shall correctly account for differences between gradient and divergence operators in cylindrical coordinates.

    Specification(s): unstructured-rz

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15063

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.34The system shall be able to perform Laplacian-based adaptivity with finite volume variables.

    Specification(s): gradient-jump

    Design: GradientJumpIndicator

    Issue(s): #20705

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.17.35The system shall be able to to solve an advection-diffusion equation with a dirichlet condition on the left boundary and a zero gradient condition on the right boundary and display second order convergence with the finite volume method.

    Specification(s): test

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.36The system shall, while using an advective outflow boundary condition, demonstrate second order convergence if a two term Taylor series is used to approximate the face value and first order convergence if a one term Taylor series is used.

    Specification(s): outflow

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.37The system shall be able to do one-term and two-term Taylor expansions for extrapolating finite volume solutions to boundary faces, and these extrapolations should be usable by flux kernels at inflow/outflow boundaries to produce first and second order accurate solutions respectively as measured by an L2 norm.

    Specification(s): extrapolate

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16169

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.38The system shall display first order convergence with an upwind limiter.

    Specification(s): UpwindLimiter

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.39The system shall display second order convergence with a central-differencing limiter.

    Specification(s): CentralDifferenceLimiter

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.40The system shall display second order convergence with a Van-Leer limiter.

    Specification(s): VanLeerLimiter

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.41The system shall display second order convergence with a min-mod limiter.

    Specification(s): MinModLimiter

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.42The system shall display second order convergence with a second-order-upwind limiter.

    Specification(s): SOULimiter

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.43The system shall display second order convergence with a QUICK limiter.

    Specification(s): QUICKLimiter

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.44The system shall provide a Kurganov-Tadmor scheme for evaluating convective intercell fluxes
    1. with central difference interpolation of face values and resulting second order convergence
    2. with upwind interpolation of face values and resulting first order convergence
    3. with central difference interpolation with Van-Leer limiting of face values and resulting two and a half order convergence

    Specification(s): kt/KTLimitedCD, kt/KTLimitedUpwind, kt/KTLimitedVanLeer

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.45The system shall be able to solve the diffusion equation in 2D axisymmetric coordinates using the finite volume method, and display a second order convergence rate.

    Specification(s): diffusion

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.46The system shall be able to solve a pure advection problem in 1D cylindrical coordinates using the finite volume method, and display a second order convergence rate.

    Specification(s): advection

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.47The system shall be able to solve a advection-reaction problem in 2D axisymmetric coordinates using the finite volume method, and display a second order convergence rate.

    Specification(s): advection-reaction

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.48The system shall be able to solve a advection-diffusion-reaction problem in 2D axisymmetric coordinates using the finite volume method, and display a second order convergence rate.

    Specification(s): advection-diffusion-reaction

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.49The system shall be able to implement advection through an element based kernel, that leverages the system's ability to reconstruct gradients, and demonstrate second order convergence on a cartesian coordinate system.

    Specification(s): cartesian

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15066

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.50The system shall be able to retrieve and usefinite volume variable gradients in materials using a coupling interface and reproduce element-based advection results based on direct use of the variable gradient in a Cartesian coordinate system.

    Specification(s): mat-cartesian

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16963

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.51The system shall be able to implement advection through an element based kernel, that leverages the system's ability to reconstruct gradients, and demonstrate second order convergence in an axisymmetric coordinate system.

    Specification(s): rz

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15066

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.52The system shall be able to retrieve and usefinite volume variable gradients in materials using a coupling interface and reproduce element-based advection results based on direct use of the variable gradient in an axisymmetric coordinate system.

    Specification(s): mat-rz

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16963

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.53The system shall be able to solve a coupled mass and momentum-type two equation system, which includes advection and diffusion, using the finite volume method, and display second order convergence for both variables.

    Specification(s): test

    Design: FVKernels System

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.54The system shall display second order convergence, when using face side neighbors to compute face midpoint values during gradient reconstruction.

    Specification(s): compact

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15063

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.55The system shall display 1.5 order convergence, when using face vertex neighbors to compute face midpoint values during gradient reconstruction.

    Specification(s): extended

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #15063

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.56The system shall display first order convergence with regular face averaging in an advection diffusion problem.

    Specification(s): average

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16239

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.57The system shall display second order convergence with skew-corrected face averaging for the diffusion term in an advection diffusion problem.

    Specification(s): skewcorrected

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16239

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.58The system shall display second order convergence with skew-corrected face averaging for the diffusion and advection terms in an advection diffusion problem.

    Specification(s): skewcorrected-advection

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16239

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.59The system shall display first order convergence, when averaging face side neighbors to compute face midpoint values during gradient reconstruction.

    Specification(s): average

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16239

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.60The system shall display second order convergence, when skewness-corrected averaging to compute face midpoint values during gradient reconstruction.

    Specification(s): skewcorrected

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16239

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.61The system shall display first order convergence when using a skew-corrected average-based face-interpolation together with extrapolated BCs.

    Specification(s): skewcorrected

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #16239

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.17.62The system shall be able to solve a diffusion problem with the finite volume method and display second order convergence.

    Specification(s): diffusion

    Design: FVKernels System

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.63The system shall be able to solve a advection-diffusion problem with the finite volume method and display second order convergence.

    Specification(s): advection-diffusion

    Design: FVKernels System

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.64The system shall be able to solve a advection-diffusion problem with the finite volume method, using a velocity supplied by a material, and display second order convergence.

    Specification(s): mat-advection-diffusion

    Design: FVKernels System

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.65The system shall be able to solve a advection problem with the finite volume method and display second order convergence.

    Specification(s): advection

    Design: FVKernels System

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.66The system shall be able to solve a advection problem with the finite volume method, using a velocity supplied by a material, and display second order convergence.

    Specification(s): mat-advection

    Design: FVKernels System

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.67The system shall be able to solve a advection-diffusion problem with the finite volume method and display first order convergence with an upwind scheme for the advection operator.

    Specification(s): upwind-advection-diffusion

    Design: FVKernels System

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.68The system shall be able to solve a advection problem with the finite volume method and display first order convergence with an upwind scheme.

    Specification(s): upwind-advection

    Design: FVKernels System

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.69The system shall be able to solve diffusion on an orthogonal grid using a diffusion kernel which accounts only for orthogonal diffusion.

    Specification(s): orthogonal-diffusion

    Design: FVOrthogonalDiffusionFVOrthogonalBoundaryDiffusion

    Issue(s): #16758

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.70The system shall be able to identify and show when a matrix is ill conditioned.

    Specification(s): bad

    Design: NonlinearSystemBase

    Issue(s): #15732

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.17.71The system shall be able to condition a system automatically through variable scaling factors.

    Specification(s): good

    Design: NonlinearSystemBase

    Issue(s): #15732

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.17.70

  • 11.17.72The system shall be able to condition a system manually through variable scaling factors.

    Specification(s): good_manual

    Design: NonlinearSystemBase

    Issue(s): #15732

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.17.71

  • 11.17.73The system shall be able to sequentially apply manual and automatic scaling and in the case of poor manual scaling, restore the condition number automatically.

    Specification(s): combined_manual_automatic

    Design: NonlinearSystemBase

    Issue(s): #15732

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.17.72

  • 11.17.74The system shall be able to evaluate functors with single sided face information arguments.

    Specification(s): single_sided_face

    Design: MooseVariableBase

    Issue(s): #16809

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.17.75The system shall be able to run a flux boundary condition and a flux kernel for different variables on the same boundary and calculate correct function and Jacobian values.

    Specification(s): jac

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.17.76The system shall be able to perform limiting schemes on Euclidean vector functors. These limiting schemes include
    1. first-order upwind
    2. central differencing
    3. vanLeer

    Specification(s): limiting_schemes/upwind, limiting_schemes/central_difference, limiting_schemes/vanLeer

    Design: Finite Volume Design Decisions in MOOSE

    Issue(s): #20493

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Geomsearch
  • 11.18.1The system shall be capable of computing the distance between two disjoint boundaries on a 1D domain.

    Specification(s): test

    Design: PenetrationAux

    Issue(s): #1693

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.2The system shall be capable of computing the distance as well as transfer data between interior boundaries on a 2D domain.

    Specification(s): test

    Design: PenetrationAuxGapValueAux

    Issue(s): #2713

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.3The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 2D.

    Specification(s): pl_test1

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.4The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 2D using second order elements.

    Specification(s): pl_test1q

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.5The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance.

    Specification(s): pl_test1tt

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.6The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance and second order elements.

    Specification(s): pl_test1qtt

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.7The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 2D.

    Specification(s): pl_test2

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.8The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 2D with second order elements.

    Specification(s): pl_test2q

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.9The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 2D using a tangential tolerance for the distance.

    Specification(s): pl_test2tt

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.10The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 2D using a tangential tolerance for the distance and second order elements.

    Specification(s): pl_test2qtt

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.11The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D.

    Specification(s): pl_test3

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.12The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D and second order elements.

    Specification(s): pl_test3q

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.13The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance.

    Specification(s): pl_test3tt

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.14The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance and second order elements.

    Specification(s): pl_test3qtt

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.15The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using normal smoothing for the distance.

    Specification(s): pl_test3ns

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.16The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using normal smoothing for the distance and second order elements.

    Specification(s): pl_test3qns

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.17The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using nodal normal based smoothing for the distance.

    Specification(s): pl_test3nns

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.18The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using nodal normal based smoothing for the distance and second order elements.

    Specification(s): pl_test3qnns

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.19The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D.

    Specification(s): pl_test4

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.20The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using second order elements.

    Specification(s): pl_test4q

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.21The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance.

    Specification(s): pl_test4tt

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.22The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance and second order elements.

    Specification(s): pl_test4qtt

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.23The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using normal smoothing for the distance.

    Specification(s): pl_test4ns

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.24The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using normal smoothing for the distance and second order elements.

    Specification(s): pl_test4qns

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.25The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using nodal normal based smoothing.

    Specification(s): pl_test4nns

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.26The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using nodal normal based smoothing and second order elements.

    Specification(s): pl_test4qnns

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.27The systems shall be capable of performing simulations with geometric penetration
    1. computed within one simulation
    2. that are restarted from a another.

    Specification(s): restart/part1, restart/part2

    Design: PenetrationAux

    Issue(s): #852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.28The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces in 2D.

    Specification(s): test

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.29The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces in 2D with triangular elements.

    Specification(s): 2d_triangle

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.30The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 3D.

    Specification(s): pl_test1

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.31The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 3D using second order elements.

    Specification(s): pl_test1q

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.32The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 3D using a tangential tolerance of for the distance.

    Specification(s): pl_test1tt

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.33The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 3D using a tangential tolerance of for the distance and second order elements.

    Specification(s): pl_test1qtt

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.34The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 3D.

    Specification(s): pl_test2

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.35The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 3D with second order elements.

    Specification(s): pl_test2q

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.36The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 3D using a tangential tolerance for the distance.

    Specification(s): pl_test2tt

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.37The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 3D using a tangential tolerance for the distance and second order elements.

    Specification(s): pl_test2qtt

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.38The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 3D.

    Specification(s): pl_test3

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.39The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 3D and second order elements.

    Specification(s): pl_test3q

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.40The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 3D using a tangential tolerance of for the distance and second order elements.

    Specification(s): pl_test3tt

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.41The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 3D.

    Specification(s): pl_test4

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.42The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 3D using second order elements.

    Specification(s): pl_test4q

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.43The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 3D using a tangential tolerance of for the distance.

    Specification(s): pl_test4tt

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.44The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two disjoint surfaces:
    1. with nodal normal based smoothing;
    2. with nodal normal based smoothing and a specified tangential tolerance;
    3. with a specified normal smoothing distance;
    4. with a specified normal smoothing distance and a specified tangential tolerance;
    5. with second-order elements and third-order quadrature; and
    6. with second-order elements and third-order quadrature and a specified tangential tolerance.

    Specification(s): disjoint/pl_test3nns, disjoint/pl_test3nnstt, disjoint/pl_test3ns, disjoint/pl_test3nstt, disjoint/pl_test3qns, disjoint/pl_test3qnstt

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.45The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two overlapping surfaces:
    1. with nodal normal based smoothing;
    2. with nodal normal based smoothing and a specified tangential tolerance;
    3. with a specified normal smoothing distance;
    4. with a specified normal smoothing distance and a specified tangential tolerance;
    5. with second-order elements and third-order quadrature; and
    6. with second-order elements and third-order quadrature and a specified tangential tolerance.

    Specification(s): overlapping/pl_test4nns, overlapping/pl_test4nnstt, overlapping/pl_test4ns, overlapping/pl_test4nstt, overlapping/pl_test4qns, overlapping/pl_test4qnstt

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.46The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces in 3D.

    Specification(s): test

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.47The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces in 2D with tetrahedron elements.

    Specification(s): 3d_tet

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.48The NearestNodeDistanceAux object shall be capable of computing the shortest distance between a boundary and subdomain.

    Specification(s): test

    Design: NearestNodeDistanceAux

    Issue(s): #3964

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.49The NearestNodeDistanceAux shall be capable of computing the shortest distance between two boundaries.

    Specification(s): test

    Design: NearestNodeDistanceAux

    Issue(s): #1570

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.50The NearestNodeDistanceAux shall be capable of computing the shortest distance between two boundaries with adaptivity.

    Specification(s): adapt

    Design: NearestNodeDistanceAux

    Issue(s): #1570

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.51The system shall support a means for updating the geometric search patch dynamically that may be disabled.

    Specification(s): never

    Design: GapValueAuxMesh System

    Issue(s): #3901

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.52The system shall support a means for updating the geometric search patch dynamically that automatically determines when an update to the patch shall occur.

    Specification(s): auto

    Design: GapValueAuxMesh System

    Issue(s): #3901

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.53The system shall support a means for updating the geometric search patch dynamically that updates the patch prior to each solve.

    Specification(s): always

    Design: GapValueAuxMesh System

    Issue(s): #3901

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.54The system shall support a means for updating the geometric search patch dynamically that updates the patch prior to each iteration.

    Specification(s): nonlinear_iter

    Design: GapValueAuxMesh System

    Issue(s): #3901

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.18.53

  • 11.18.55The system shall error in the penetration locator system if penetration is not detected.

    Specification(s): never_warning

    Design: GapValueAuxMesh System

    Issue(s): #3901

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

    Prerequisite(s): 11.18.51

  • 11.18.56The system shall be able to perform patch updates on every non-linear iteration while performing uniform coarsening and refinement from grid sequencing.

    Specification(s): always-grid-sequencing

    Design: Mesh SystemGapValueAuxFEProblemBase

    Issue(s): #14166

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.57The PenetrationAux object shall compute the distance between two boundaries in 3D that overlap.

    Specification(s): test

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.58The PenetrationAux object shall compute, in parallel, the distance between two boundaries in 3D that overlap.

    Specification(s): parallel_test

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.18.111.18.211.18.2811.18.4611.18.4811.18.4911.18.57

  • 11.18.59The nonlinear system shall be able to augment its sparsity based on constraints when we have a quadrature nearest-node locator.

    Specification(s): quadrature_locator_plus_constraint

    Design: GeometricSearchData

    Issue(s): #5234

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.18.60The NearestNodeDistanceAux object shall compute the shortest distance between nodes on two overlapping boundaries using a constant monomial auxiliary variable.

    Specification(s): qnnl

    Design: NearestNodeDistanceAux

    Issue(s): #1462

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.61Volumetric AD assembly data shall be properly sized when reinitializing faces

    Specification(s): qnnl_ad

    Design: NearestNodeDistanceAux

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.62The PenetrationAux object shall compute the distance between two overlapping boundaries using a constant monomial auxiliary variable.

    Specification(s): qpl

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.18.63The PenetrationAux object shall compute the distance between two overlapping boundaries using a constant monomial auxiliary variable in 1D.

    Specification(s): 1d_qpl

    Design: PenetrationAux

    Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Globalparams
  • 11.19.1The system shall include an input file syntax that supports defining global options.

    Specification(s): global_param_test

    Design: Parser

    Issue(s): #437

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Ics
  • 11.20.1The system shall allow to set constant initial conditions for an array variable.

    Specification(s): array_constant_ic

    Design: ArrayConstantIC

    Issue(s): #6881

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.2The system shall error if the wrong number of components are provided in a constant initial condition for array variables.

    Specification(s): size_error

    Design: ArrayConstantIC

    Issue(s): #6881

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.20.3The system shall allow to set initial conditions for an array variable based on functions.

    Specification(s): array_constant_ic

    Design: ArrayFunctionIC

    Issue(s): #6881

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.4The system shall error if the wrong number of components are provided in a functionalized initial condition for array variables.

    Specification(s): size_error

    Design: ArrayFunctionIC

    Issue(s): #6881

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.20.5The system shall support setting initial conditions on boundaries.

    Specification(s): test

    Design: ICs System

    Issue(s): #534

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.6Generates a rectangular IC

    Specification(s): test

    Design: BoundingBoxIC

    Issue(s): #11034

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.7BoundingBoxIC shall have a diffuse interface option.

    Specification(s): diffuse

    Design: BoundingBoxIC

    Issue(s): #13331

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.8The system shall report an error when multiple initial conditions are applied to the same boundary.

    Specification(s): ics_on_same_boundary

    Design: ICs System

    Issue(s): #6580

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.20.9The system shall report an error when multiple initial conditions are applied to the same subdomain.

    Specification(s): ics_on_same_block

    Design: ICs System

    Issue(s): #6580

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.20.10The system shall report an error when a global initial conditions overlap on the same variable.

    Specification(s): ics_on_same_block_both_global

    Design: ICs System

    Issue(s): #6580

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.20.11The system shall report an error when a global and subdomain restricted initial conditions overlap on the same variable.

    Specification(s): ics_on_same_block_first_global

    Design: ICs System

    Issue(s): #6580

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.20.12The system shall support setting different values for each coefficient of higher-order scalar values.

    Specification(s): test

    Design: ICs System

    Issue(s): #2085

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.13The system shall support setting initial conditions of field variables to a constant value.

    Specification(s): test

    Design: ICs System

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.14The system shall support setting initial conditions of subdomain restricted field variables to a constant value.

    Specification(s): subdomain_test

    Design: ICs System

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.15The system shall provide current node or element pointers when possible when evaluating initial conditions at a point in the domain.

    Specification(s): test

    Design: ICs System

    Issue(s): #4953

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.16The system shall allow setting field initial condition from an user object

    Specification(s): ic_depend_on_uo

    Design: InitialConditionUserObjectInterface

    Issue(s): #8810

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.17The system shall allow setting scalar initial condition from an user object

    Specification(s): scalar_ic_from_uo

    Design: ScalarInitialConditionUserObjectInterface

    Issue(s): #13357

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.20.18The system shall allow nodal initial condition objects to couple to other nodal variables for computing values for the current variable.

    Specification(s): test

    Design: ICs System

    Issue(s): #534

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.19The system shall allow elemental initial condition objects to couple to other elemental variables for computing values for the current variable.

    Specification(s): monomial

    Design: ICs System

    Issue(s): #534

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.20The system shall write output files containing nodal solutions in ExodusII format suitable for restart.

    Specification(s): nodal_var_1

    Design: ICs System

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.21The system shall be able to populate nodal initial conditions from a previous solution file in ExodusII format.

    Specification(s): nodal_var_2

    Design: ICs System

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.20.20

  • 11.20.22The system shall write output files containing elemental solutions in ExodusII format suitable for restart.

    Specification(s): elem_var_1

    Design: ICs System

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.23The system shall be able to populate elemental initial conditions from a previous solution file in ExodusII format.

    Specification(s): elem_var_2

    Design: ICs System

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.20.22

  • 11.20.24The system shall write output files containing elemental array variable solutions in ExodusII format suitable for restart.

    Specification(s): array_elem_var_1

    Design: ICs System

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.25The system shall be able to populate elemental array variable initial conditions from a previous solution file in ExodusII format.

    Specification(s): array_elem_var_2

    Design: ICs System

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.20.24

  • 11.20.26The system shall write output files containing nodal array variable solutions in ExodusII format suitable for restart.

    Specification(s): array_nodal_var_1

    Design: ICs System

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.27The system shall be able to populate nodal array variable initial conditions from a previous solution file in ExodusII format.

    Specification(s): array_nodal_var_2

    Design: ICs System

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.20.26

  • 11.20.28The system shall support setting gradient values for shape functions that support them.

    Specification(s): parsed_function

    Design: ICs System

    Issue(s): #3312

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.29The system shall support using a spline function to set both value and gradient values in an initial condition.

    Specification(s): spline_function

    Design: ICs System

    Issue(s): #3312

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.30The system shall support setting a scalar initial condition by evaluating a function.

    Specification(s): test

    Design: ICs System

    Issue(s): #6309

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.20.31The system shall support setting initial conditions for the Hermite set of shape functions.

    Specification(s): test

    Design: ICs System

    Issue(s): #1493

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.32The system shall error if
    1. the postprocessor does not have execute_on initial
    2. the postprocessor for normalization is zero

    Specification(s): errors/missing_initial, errors/zero_integral

    Design: IntegralPreservingFunctionIC

    Issue(s): #19476

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.20.33The system shall be able to apply a normalized sinusoidal initial condition.

    Specification(s): sinusoidal

    Design: IntegralPreservingFunctionIC

    Issue(s): #19476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.34The system shall support initial conditions on second order Lagrange variables in 3D space.

    Specification(s): 3d_second_order

    Design: ICs System

    Issue(s): #1493

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.35The system shall allow initial conditions to retrieve post-processor values.

    Specification(s): test

    Design: InitialConditionPostprocessorInterface

    Issue(s): #17692

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.20.36The system shall generate parallel agnostic random initial conditions

    Specification(s): test

    Design: RandomIC

    Issue(s): #5567#11901

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.37The system shall generate threaded agnostic random initial conditions

    Specification(s): test_threaded

    Design: RandomIC

    Issue(s): #5567#11901

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.20.511.20.611.20.1211.20.1311.20.1511.20.1811.20.3011.20.3111.20.3511.20.3611.20.45

  • 11.20.38The system shall allow to set constant vector-valued initial conditions.

    Specification(s): vector_constant_ic

    Design: VectorConstantIC

    Issue(s): #12311

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.39The system shall allow to set constant vector-valued initial conditions when adding vector variables.

    Specification(s): vector_short_constant_ic

    Design: VectorConstantIC

    Issue(s): #12311

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.40The system shall allow vector-valued initial conditions be set using a vector function.

    Specification(s): vector_function_ic

    Design: VectorConstantIC

    Issue(s): #13309

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.41The system shall allow vector-valued initial conditions be set using a function by components.

    Specification(s): vector_function_ic_comp

    Design: VectorConstantIC

    Issue(s): #13309

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.20.42The system shall error if the 'function' and 'function_x' parameters are both set within the VectorFunctionIC object.

    Specification(s): comp_x_error

    Design: VectorConstantIC

    Issue(s): #13309

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.20.43The system shall error if the 'function' and 'function_y' parameters are both set within the VectorFunctionIC object.

    Specification(s): comp_y_error

    Design: VectorConstantIC

    Issue(s): #13309

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.20.44The system shall error if the 'function' and 'function_z' parameters are both set within the VectorFunctionIC object.

    Specification(s): comp_z_error

    Design: VectorConstantIC

    Issue(s): #13309

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.20.45The system should supply a special convenience "zero" variable that can be indexed like a normal coupled variable.

    Specification(s): test

    Design: FEProblemBase

    Issue(s): #11202

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • rdg: Indicators
  • 11.21.1The system shall include the ability to compute the square of the difference between a solution variable and an analytical function for the purpose of performing automatic mesh adaptivity.

    Specification(s): analytical

    Design: AnalyticalIndicator

    Issue(s): #1275#16069

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.21.2The system shall include the ability to compute the square of the difference between a FV solution variable and an analytical function for the purpose of performing automatic mesh adaptivity.

    Specification(s): analytical_fv

    Design: AnalyticalIndicator

    Issue(s): #1275#16069

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.21.3The system shall include the ability to compute the square of the change in the gradient of a variable across element boundaries for the purpose of performing automatic mesh adaptivity.

    Specification(s): test

    Design: GradientJumpIndicator

    Issue(s): #1275

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.21.4The system shall include the ability to compute the square of the change in the Laplacian of a variable across element boundaries for the purpose of performing automatic mesh adaptivity:
    1. with a penalty based flux boundary condition;
    2. with a weakly imposed flux boundary condition; and
    3. for transient calculations.

    Specification(s): group/test_biharmonic, group/test_biharmonic_weak_bc, group/test_biharmonic_transient

    Design: LaplacianJumpIndicator

    Issue(s): #1275

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.21.5The system shall include the ability to compute the square of the change in a variable across element boundaries for the purpose of performing automatic mesh adaptivity:

    Specification(s): test

    Design: ValueJumpIndicator

    Issue(s): #1275#16069

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.21.6The system shall include the ability to compute the square of the change in a FV variable across element boundaries for the purpose of performing automatic mesh adaptivity:

    Specification(s): fv

    Design: ValueJumpIndicator

    Issue(s): #1275#16069

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: InterfaceKernel Objects
  • 11.22.1Interface kernels shall provide integrated conditions between subdomains, and shall work with boundary restricted materials with stateful properties.

    Specification(s): interface_diffusion

    Design: InterfaceKernels System

    Issue(s): #11258#869

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.2The interface diffusion penalty method should reproduce the analytic solution

    Specification(s): interface_diffusion_penalty

    Design: InterfaceKernels System

    Issue(s): #11765

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.22.1

  • 11.22.3The InterfaceKernel system shall use with interface material in 1D.

    Specification(s): interface_diffusion_penalty_with_jump_material

    Design: InterfaceKernels System

    Issue(s): #12066

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.22.1

  • 11.22.4The system shall support the evaluation of neighboring quantities on elements containing different shape functions.

    Specification(s): mixed_shapes_test

    Design: InterfaceKernels System

    Issue(s): #13232

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.5The system shall produce correct Jacobians for coupled flux on an interface.

    Specification(s): jacobian_test

    Design: InterfaceKernels System

    Issue(s): #13232

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

  • 11.22.6The system shall support produce correct Jacobians when evaluating neighboring quantities on elements containing different shape functions.

    Specification(s): mixed_shapes_jacobian_test

    Design: InterfaceKernels System

    Issue(s): #13232

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

  • 11.22.7The system shall produce correct Jacobians for single variable coupled flux on an interface.

    Specification(s): single_variable_jacobian_test

    Design: InterfaceKernels System

    Issue(s): #13232

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

  • 11.22.8Save-in shall record the correct residuals and Jacobians representing the interface kernel. This applies the DirichletBC to side a (block 0) of the interface.

    Specification(s): ik_save_in

    Design: InterfaceKernels System

    Issue(s): #9854

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.9Save-in shall record the correct residuals and Jacobians representing the interface kernel. This applies the DirichletBC to side b (block 1) of the interface.

    Specification(s): ik_save_in_other_side

    Design: InterfaceKernels System

    Issue(s): #13232

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.10The interface reaction kernel should reproduce the analytic solution

    Specification(s): reaction_1D_steady_CSVDiff

    Design: InterfaceReaction

    Issue(s): #13365

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.22.11The interface reaction kernel should work with interface diffusion kernel

    Specification(s): reaction_1D_steady_ExoDiff

    Design: InterfaceReaction

    Issue(s): #13365

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.22.10

  • 11.22.12The solution should be discontinued at the interface due to the reaction taking place

    Specification(s): reaction_1D_transient

    Design: InterfaceReaction

    Issue(s): #13365

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.13The Jacobian from InterfaceReaction shall be perfect

    Specification(s): reaction_1D_transient_Jac

    Design: InterfaceReaction

    Issue(s): #13365

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.22.14The system shall ensure that interfacial materials are sorted such that consumers execute after producers.

    Specification(s): sort_interface_materials

    Design: Materials System

    Issue(s): #17171

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.15The system shall not try to reinit a displaced interface, leading to failed point inversions, if a displaced interface kernel has not been added to the simulation.

    Specification(s): no_failed_point_inversions

    Design: InterfaceKernels System

    Issue(s): #18175

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.16The InterfaceKernel system shall operate with coupled variables in 2D. This uses a penalty implementation that is optimally convergent.

    Specification(s): test

    Design: InterfaceKernels System

    Issue(s): #7885

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.17Allow the interface to impose the same time derivative on two neighboring variables. This uses a penalty implementation that is optimally convergent.

    Specification(s): test_dot

    Design: InterfaceKernels System

    Issue(s): #12372

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.18The InterfaceKernel system shall use with interface material in 2D.

    Specification(s): test_jump_material

    Design: InterfaceKernels System

    Issue(s): #12066

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.19The Jacobian evaluation for InterfaceKernel objects in 2D shall be analytically correct.

    Specification(s): jacobian_test

    Design: InterfaceKernels System

    Issue(s): #7437

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

    Prerequisite(s): 11.22.1611.22.32

  • 11.22.20The finite difference preconditioner shall work in parallel.

    Specification(s): parallel_fdp_test

    Design: FDP

    Issue(s): #10375

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.22.1611.22.32

  • 11.22.21The InterfaceKernel system shall support Vector Finite Elements in 2D.

    Specification(s): vector_2d

    Design: InterfaceKernels System

    Issue(s): #13354

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.22The system shall not perform memory allocation for automatic scaling when computing values.

    Specification(s): no_mallocs_during_scaling

    Design: FEProblemSolve.md

    Issue(s): #12601

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.22.23The InterfaceKernel system shall operate with coupled variables in 3D. This uses a penalty implementation that is optimally convergent.

    Specification(s): coupled_3d

    Design: InterfaceKernels System

    Issue(s): #7885

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.24The InterfaceKernel system shall support Vector Finite Elements in 3D.

    Specification(s): vector_3d

    Design: InterfaceKernels System

    Issue(s): #13354

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.25The InterfaceKernel system shall use with interface material in 3D.

    Specification(s): test_jump_material

    Design: InterfaceKernels System

    Issue(s): #12066

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.26The system shall be able to solve a simple interfacial source problem using automatic differentiation in which the slope on the left-hand side of the interface has a slope greater by two than the slope on the right-hand side.

    Specification(s): exo

    Design: Automatic Differentiation

    Issue(s): #15307

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.27The system shall be able to couple variables at interfaces and have an accurate Jacobian provided through automatic differentiation.

    Specification(s): jac

    Design: Automatic Differentiation

    Issue(s): #15307

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.22.28The system shall be able to solve a simple interfacial source problem using automatic differentiation and vector variables in which the slope on the left-hand side of the interface has a slope greater by two than the slope on the right-hand side.

    Specification(s): exo

    Design: Automatic Differentiation

    Issue(s): #15307

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.29The system shall be able to couple vector variables at interfaces and have an accurate Jacobian provided through automatic differentiation.

    Specification(s): jac

    Design: Automatic Differentiation

    Issue(s): #15307

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.22.30Adaptivity shall work with interface kernels as long as stateful properties are not used.

    Specification(s): ik_adaptivity

    Design: InterfaceKernels System

    Issue(s): #10977

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.31The system shall error if the triad of interface kernels, adaptivity, and stateful properties are used together.

    Specification(s): error_stateful_ik_adaptivity

    Design: InterfaceKernels System

    Issue(s): #10977

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.22.32The system shall be able to execute interfacial conditions on sidesets generated by gmsh.

    Specification(s): test

    Design: InterfaceKernels System

    Issue(s): #15203

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.33The system shall support Dirichlet and Neumann interface conditions.

    Specification(s): matchedvalue

    Design: InterfaceKernels System

    Issue(s): #7437

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.34The system shall support penalty interface conditions.

    Specification(s): penalty

    Design: InterfaceKernels System

    Issue(s): #7437

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.22.33

  • 11.22.35The system shall support matched-value interface with different variable coefficients with automatic differentiation.

    Specification(s): variable_coeffs_AD

    Design: InterfaceKernels System

    Issue(s): #7437

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.36The system shall support matched-value interface with different variable coefficients.

    Specification(s): variable_coeffs

    Design: InterfaceKernels System

    Issue(s): #7437

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.22.35

  • 11.22.37When computing residuals and jacobians on an interface, the system shall be able to use element information from the displaced mesh when requested

    Specification(s): displaced

    Design: InterfaceKernels System

    Issue(s): #14876

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.38When computing residuals and jacobians on an interface, the system shall be able to use element information from the reference mesh

    Specification(s): undisplaced

    Design: InterfaceKernels System

    Issue(s): #14876

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.22.39During mesh displacement, the system shall be able to compute different element Jacobians for different sides of an interface.

    Specification(s): jxw_neighbor

    Design: InterfaceKernels System

    Issue(s): #14870

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Kernels
  • 11.24.1The system shall provide an ability to solve a 2D diffusion problem with Dirichlet boundary conditions.

    Specification(s): testdirichlet

    Design: DirichletBC

    Issue(s): #6397

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.2The system shall provide an ability to solve a 2D diffusion problem with Neumann boundary conditions.

    Specification(s): testneumann

    Design: NeumannBC

    Issue(s): #1410

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.3The system shall provide a diffusion kernel that obtains the diffusion coefficient from a material property

    Specification(s): testmatdiffusion

    Design: MatDiffusion

    Issue(s): #12074

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.4The system shall provide an ability to solve a 2D diffusion problem including a volumetric source term.

    Specification(s): testbodyforce

    Design: BodyForce

    Issue(s): #6136

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.5The system shall provide a tester that checks hand-coded Jacobian against finite difference Jacobian using -snes_type=test option.

    Specification(s): test_jacobian

    Design: Framework Software Test Plan

    Issue(s): #2337

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.6The system shall force the solver to take at least one iteration regardless of the initial residual norm when the snes_force_iteration option is specified.

    Specification(s): test_force_iteration

    Design: Transient

    Issue(s): #10594

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.111.24.54

  • 11.24.7The system shall not compute an extra residual if the linear solver is used.

    Specification(s): actual_linear_solver

    Design: FEProblem

    Issue(s): #11760

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.24.8The system shall provide an ability to solve a 2D diffusion problem with Dirichlet boundary conditions using
    1. automatic differentiation and
    2. compute the correct Jacobian matrix.

    Specification(s): dirichlet/ad, dirichlet/ad-jac

    Design: ADDirichletBC

    Issue(s): #13260

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.24.9The system shall provide an ability to solve a 2D diffusion problem Neumann boundary conditions using
    1. automatic differentiation and
    2. compute the correct Jacobian matrix.

    Specification(s): neumann/ad, neumann/ad-jac

    Design: ADNeumannBC

    Issue(s): #12903

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.24.10The system shall provide an ability to solve a 2D diffusion problem including a volumetric source term using
    1. automatic differentiation and
    2. compute the correct Jacobian matrix.

    Specification(s): bodyforce/ad, bodyforce/ad-jac

    Design: ADBodyForce

    Issue(s): #13260

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.24.11Coupled variable gradient Jacobian entries generated with AD shall be accurate

    Specification(s): test

    Design: Coupleable

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.12The system shall provide a source term proportional to the value of
    1. an aux variable and shall be able to produce the exact Jacobian
    2. an finite element primary variable and shall be able to produce the exact Jacobian

    Specification(s): jacobians/aux, jacobians/fe

    Design: CoupledForce / ADCoupledForce

    Issue(s): #18214

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.13Coupled variable value Jacobian entries generated with AD shall be accurate

    Specification(s): test

    Design: Coupleable

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.14We shall be able to get aux variable values through adCoupledValue with the knowledge that the derivatives will always be zero

    Specification(s): test_coupled_aux

    Design: Coupleable

    Issue(s): #12852

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.15Getting a constant aux variable through adCoupledValue shall not destroy our Jacobian

    Specification(s): test_coupled_aux_jac

    Design: Coupleable

    Issue(s): #12852

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.16We shall be able to get dot aux variable values through adCoupledValue with the knowledge that the time derivatives will always be zero

    Specification(s): test_coupled_dot_aux

    Design: Coupleable

    Issue(s): #12996

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.17The system will output the required number of derivative entries needed for automatic differentiation calculations

    Specification(s): test_ad_output

    Design: DualReal

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.24.18The system shall automatically generate a full coupling matrix when doing global AD indexing such that there are no new matrix memory allocations.

    Specification(s): no_mallocs_pjfnk

    Design: Coupleable

    Issue(s): #16396

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.1111.24.1311.24.3011.24.3311.24.4011.24.5211.24.8811.24.9511.24.10611.24.10711.24.10811.24.11711.24.123

  • 11.24.19The system shall automatically generate a full coupling matrix when doing global AD indexing, resulting in a perfect Jacobian even when the user has not requested full coupling.

    Specification(s): perfect_jac_pjfnk_global_ad

    Design: Coupleable

    Issue(s): #16396

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.20The system shall allow the user to override the automated generation of a full coupling matrix when doing global AD indexing, which for this test results in a new nonzero allocation because there is off-diagonal coupling.

    Specification(s): trust_user_and_then_error

    Design: Coupleable

    Issue(s): #16396

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.21Jacobians calculated by ADTimeDerivative and ADBodyForce shall be perfect.

    Specification(s): testbodyforce-jac

    Design: ADTimeDerivative

    Issue(s): #13260

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.22The Jacobian of ADBodyForce with a force function shall be perfect.

    Specification(s): testbodyforce-adfunction-jac

    Design: BodyForce

    Issue(s): #13260

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.23The system shall solve a one-dimensional Diffusion problem with a material property diffusivity and match a known solution.
    1. without and
    2. with automatic differentiation including
    3. the correct Jacobian matrix.

    Specification(s): 1D/1D_transient, 1D/ad_1D_transient, 1D/ad_1D_transient_jacobian

    Design: ADMatDiffusion

    Issue(s): #2582#5658#12633#13632

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.24.24The system shall solve a two-dimenional Diffusion problem with a material property diffusivity and match a known solution.
    1. without and
    2. with automatic differentiation including
    3. the correct Jacobian matrix.

    Specification(s): 2D/2D_steady_state, 2D/ad_2D_steady_state, 2D/ad_2D_steady_state_jacobian

    Design: ADMatDiffusion

    Issue(s): #2582#5658#12633#13632

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.24.25The system will error and tell the user if they use derivative storage that is too small

    Specification(s): ad_max_dofs_per_elem_error

    Design: DualReal

    Issue(s): #5658

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.26The system shall contain a consuming reaction term object whose Jacobian is calculated via forward automatic differentiation.

    Specification(s): ad_reaction

    Design: Reaction / ADReaction

    Issue(s): #21009

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.27The system shall produce a perfect Jacobian for a consuming reaction term object using forward automatic differentiation.

    Specification(s): ad_reaction_jac

    Design: Reaction / ADReaction

    Issue(s): #21009

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.28The system shall contain a consuming reaction term object with a scalar coefficient whose Jacobian is calculated via forward automatic differentiation.

    Specification(s): ad_coef_reaction

    Design: CoefReaction / ADCoefReaction

    Issue(s): #21009

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.29The system shall produce a perfect Jacobian for a consuming reaction term object with a scalar coefficient using forward automatic differentiation.

    Specification(s): ad_coef_reaction_jac

    Design: CoefReaction / ADCoefReaction

    Issue(s): #21009

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.30Jacobian entries generated with AD for a simple diffusion problem shall be accurate

    Specification(s): test

    Design: ADDiffusion

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.31The system shall be able to solve a transient diffusion problem with
    1. automatic differentiation and
    2. compute the correct Jacobian matrix.

    Specification(s): transient_diffusion/ad, transient_diffusion/jac_ad_transient_diffusion

    Design: ADTimeDerivative

    Issue(s): #5658#12633

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.24.32The system shall be able to solve a transient diffusion problem with vector variables
    1. automatic differentiation and
    2. compute the correct Jacobian matrix.

    Specification(s): transient_vector_diffusion/ad, transient_vector_diffusion/jac_ad

    Design: ADVectorTimeDerivative

    Issue(s): #13017

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 11.24.33Jacobian entries generated with AD shall match hand-coded Jacobian entries as measured through save-in values

    Specification(s): test

    Design: Kernels System

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.34The system shall provide a generic kernel object that allows for easy switching between hand-coded and automatic computation of the Jacobian, and encourages maximum kernel code-reuse.

    Specification(s): generic_test

    Design: Kernels System

    Issue(s): #15552

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.35The system shall support coupling of variables with automatic differentiation and vector values.

    Specification(s): ad_vector_couple

    Design: Coupleable

    Issue(s): #12836

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.36The system shall support coupling to the gradient of variables with automatic differentiation and vector values.

    Specification(s): ad_grad_vector_couple

    Design: Coupleable

    Issue(s): #12836

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.37The system shall support coupling of default values for variables with automatic differentiation and vector values.

    Specification(s): ad_vector_couple_default

    Design: Coupleable

    Issue(s): #12836

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.38The system shall run a coupled diffusion-advection problem with higher-order variables on a non-regular mesh domain:
    1. in a steady-state calculation, and
    2. in a transient calculation.

    Specification(s): adv_diff_reaction/steady, adv_diff_reaction/transient

    Design: Kernels System

    Issue(s): #1410

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.39The system shall support direct tensor-vector products and vector dot products to maintain dimension agnostic formulations where possible.

    Specification(s): test_aniso

    Design: AnisotropicDiffusion

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.40The system shall provide array diffusion kernels on an array variable.

    Specification(s): test

    Design: ArrayMooseVariable

    Issue(s): #6881#14057

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.41The system shall provide array reaction kernels on an array variable.

    Specification(s): test_diffusion_reaction

    Design: ArrayMooseVariable

    Issue(s): #6881#14057

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.42The system shall provide array DG diffusion kernels on an elemental array variable.

    Specification(s): test_diffusion_reaction_dg

    Design: ArrayMooseVariable

    Issue(s): #6881#14057

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.43The system shall provide coupling of standard variables in array kernels.

    Specification(s): test_diffusion_reaction_coupling

    Design: ArrayMooseVariable

    Issue(s): #6881#14057

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.44The system shall provide coupling of array variables in standard kernels.

    Specification(s): test_diffusion_reaction_other_coupling

    Design: ArrayMooseVariable

    Issue(s): #6881#14057

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.45The system shall provide residual save-in and Jacobian diagonal save-in for
    1. array and
    2. standard variables.

    Specification(s): save_in/array, save_in/test_standard_save_in

    Design: ArrayMooseVariable

    Issue(s): #6881#14057

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.46The system shall provide array time derivative kernels on an array variable.

    Specification(s): test_diffusion_reaction_transient

    Design: ArrayMooseVariable

    Issue(s): #6881#14057

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.47The system shall provide array body-force kernels on an array variable.

    Specification(s): test_body_force

    Design: ArrayMooseVariable

    Issue(s): #6881#14057

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.48We shall be able to show that without automatic scaling, this system is singular

    Specification(s): poorly-conditioned-field-scalar-system

    Design: ExecutionerFEProblemSolve.md

    Issue(s): #12601

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.24.49We shall be able to show that with automatic scaling, this system is non-singular

    Specification(s): auto-scaled-field-scalar-system

    Design: ExecutionerFEProblemSolve.md

    Issue(s): #12601

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.50We shall be able to show that with automatic scaling we can run this problem successfully in parallel

    Specification(s): auto-scaled-field-scalar-system-parallel

    Design: ExecutionerFEProblemSolve.md

    Issue(s): #12601

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.49

  • 11.24.51The system shall support the ability to apply a kernel to a subset of the domain
    1. through a subdomain restriction on the kernel, and
    2. through a subdomain restriction on the variable.

    Specification(s): block_restriction/kernel, block_restriction/variable

    Design: BlockRestrictable Interface

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.52The system shall support scaling the computed time derivative by a scalar coefficient.

    Specification(s): test

    Design: CoefTimeDerivative

    Issue(s): #11047

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.53The system shall include the ability to compute the residual contribution from the conservative form of the advection operator
    1. without upwinding in 3D,
    2. with upwinding in 3D,
    3. without upwinding in 1D,
    4. with upwinding in 1D,
    5. without upwinding in 2D,
    6. with upwinding in 2D,
    7. with upwinding and an outflow boundary condition, and
    8. without any outflow boundary conditions.

    Specification(s): upwinding/no_upwinding_jacobian, upwinding/full_upwinding_jacobian, upwinding/no_upwinding_1D, upwinding/full_upwinding_1D, upwinding/no_upwinding_2D, upwinding/full_upwinding_2D, upwinding/none_in_all_out, upwinding/none_in_none_out

    Design: ConservativeAdvection

    Issue(s): #11852

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterCSVDiffExodiff

  • 11.24.54A coupled time derivative kernel shall be provided

    Specification(s): testdirichlet

    Design: CoupledTimeDerivative

    Issue(s): #9786

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.55A coupled time derivative kernel with forward mode automatic differentiation shall be provided

    Specification(s): adtestdirichlet

    Design: ADCoupledTimeDerivative

    Issue(s): #13138

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.111.24.54

  • 11.24.56A coupled time derivative kernel compatible with vector variables with hand-coded jacobians shall be provided

    Specification(s): vectortestdirichlet

    Design: VectorCoupledTimeDerivative

    Issue(s): #13913

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.57The Jacobian from VectorCoupledTimeDerivative shall be perfect

    Specification(s): jac_vectortestdirichlet

    Design: VectorCoupledTimeDerivative

    Issue(s): #13913

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.58The SMP Jacobian for a problem with a hanging-node shall be non-singular

    Specification(s): test_smp

    Design: Diffusion

    Issue(s): libmesh#1985

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.59The colored finite difference Jacobian for a problem with a hanging-node shall be non-singular

    Specification(s): test_fd_coloring

    Design: Diffusion

    Issue(s): libmesh#1985

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.58

  • 11.24.60The standard finite difference Jacobian for a problem with a hanging-node shall be non-singular

    Specification(s): test_fd_standard

    Design: Diffusion

    Issue(s): libmesh#1985

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.59

  • 11.24.61A matrix-free operator shall be able to solve the hanging-node problem, indicating it is non-singular

    Specification(s): test_mf

    Design: Diffusion

    Issue(s): libmesh#1985

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.60

  • 11.24.62The SMP Jacobian shall be perfect for the hanging-node problem

    Specification(s): test_smp_jacobian

    Design: Diffusion

    Issue(s): libmesh#1985

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.63The system shall compute a perfect Jacobian via automatic differentiation for a hanging-node problem and simultaneously handle automatic differentiation objects that do not actually have nonlinear variable dependence.

    Specification(s): test_ad_smp_jacobian

    Design: Diffusion

    Issue(s): libmesh#1985#15732

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.64The system shall support applying a function of space-time as a forcing function to the mesh domain.

    Specification(s): body_force

    Design: Kernels System

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.65The system shall report an error when a parsed function expression contains quote characters.

    Specification(s): parsed_func_error_check

    Design: Kernels System

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.66The system shall support hybrid finite element method (HFEM) calculations with Dirichlet boundary conditions using standard variables.

    Specification(s): dirichlet

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.67The system shall support hybrid finite element method (HFEM) calculations with Dirichlet boundary conditions using array variables.

    Specification(s): array_dirichlet

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.68The system shall support hybrid finite element method (HFEM) calculations with preconditioner only using the block diagonal Jacobian.

    Specification(s): array_dirichlet_pjfnk

    Design: DGKernels System

    Issue(s): #20029

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.69The system shall support hybrid finite element method (HFEM) calculations with coupling of components of array variables on internal sides.

    Specification(s): array_dirichlet_transform

    Design: DGKernels System

    Issue(s): #20029

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.70The system shall support hybrid finite element method (HFEM) calculations with coupling of components of array variables on boundary sides.

    Specification(s): array_dirichlet_transform_bc

    Design: DGKernels System

    Issue(s): #20029

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.71The system shall support hybrid finite element method (HFEM) calculations with Neumann boundary conditions using standard variables.

    Specification(s): neumann

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.72The system shall support hybrid finite element method (HFEM) calculations with Neumann boundary conditions using array variables.

    Specification(s): array_neumann

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.73The system shall support hybrid finite element method (HFEM) calculations with Robin boundary conditions using standard variables.

    Specification(s): robin

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.74The system shall support hybrid finite element method (HFEM) calculations with Robin boundary conditions using array variables.

    Specification(s): array_robin

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.75The system shall support hybrid finite element method (HFEM) calculations with high order shape functions.

    Specification(s): high_order

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.76The system shall support hybrid finite element method (HFEM) calculations with Robin boundary conditions through Lagrange multipliers.

    Specification(s): variable_robin

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.77The system shall support hybrid finite element method (HFEM) calculations with displaced meshes.

    Specification(s): robin_displaced

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.78The system shall issue an error for unsupported mesh adaptation with hybrid finite element method (HFEM) calculations.

    Specification(s): robin_adpatation

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.79The system shall support hybrid finite element method (HFEM) calculations with Dirichlet boundary conditions with boundary values specified by variables.

    Specification(s): variable_dirichlet

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.80The system shall issue an error for not fully supported distributed mesh with hybrid finite element method (HFEM) calculations.

    Specification(s): robin_distributed_mesh

    Design: DGKernels System

    Issue(s): #17447

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.81The system shall be able to compute lower dimensional element volumes using element Jacobian information computed earlier during finite element object reinitialization and when the highest dimension of the mesh is
    1. two
    2. three

    Specification(s): accurate_lower_d_volumes/2d, accurate_lower_d_volumes/3d

    Design: DGKernels System

    Issue(s): #17938

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.82We shall automatically capture the dependence of things like JxW and grad_test on (second order) displacements

    Specification(s): jxw_jacobian

    Design: DisplacedProblem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.83We shall automatically capture the dependence of things like JxW and grad_test on (first order) displacements

    Specification(s): jxw_jacobian_2

    Design: DisplacedProblem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

    Prerequisite(s): 11.24.82

  • 11.24.84We shall automatically capture the dependence of things like JxW and grad_test on (second order) displacements for a cylindrical geometry

    Specification(s): jxw_jacobian_cylindrical

    Design: DisplacedProblem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.85We shall automatically capture the dependence of things like JxW and grad_test on (first order) displacements for a cylindrical geometry

    Specification(s): jxw_jacobian_2_cylindrical

    Design: DisplacedProblem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

    Prerequisite(s): 11.24.84

  • 11.24.86We shall automatically capture the dependence of things like JxW and grad_test on (second order) displacements for a spherical geometry

    Specification(s): jxw_jacobian_spherical

    Design: DisplacedProblem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.87We shall automatically capture the dependence of things like JxW and grad_test on (first order) displacements for a spherical geometry

    Specification(s): jxw_jacobian_2_spherical

    Design: DisplacedProblem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

    Prerequisite(s): 11.24.86

  • 11.24.88The system shall provide optimized kernels for residuals with the test function or its gradient factored out.

    Specification(s): test

    Design: Kernel

    Issue(s): #3492#12658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.89The system shall provide optimized kernels for residuals with the test function or its gradient factored out in the automatic differentiation system.

    Specification(s): adtest

    Design: Kernel

    Issue(s): #3492#12658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.1111.24.1311.24.3011.24.3311.24.4011.24.5211.24.8811.24.9511.24.10611.24.10711.24.10811.24.11711.24.123

  • 11.24.90The system shall calculate perfect Jacobians for the automatic differentiation precompute problem.

    Specification(s): adtest-jac

    Design: Kernel

    Issue(s): #3492#12658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

    Prerequisite(s): 11.24.89

  • 11.24.91The system shall support the ability to use mass lumping for time derivative terms.

    Specification(s): mass_lumping

    Design: MassLumpedTimeDerivative

    Issue(s): #2689

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.92The system shall verify that the Jacobian terms when using mass lumping for time derivative terms are computed correctly.

    Specification(s): mass_lumping_jacobian

    Design: MassLumpedTimeDerivative

    Issue(s): #2689

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.93The system shall support a kernel for coupling the sum of several products of material properties with variables and constant coefficients

    Specification(s): material_coupled_force

    Design: MatCoupledForce

    Issue(s): #14665

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.94The system shall have the ability to declare the derivatives of material properties.

    Specification(s): test_jacobian

    Design: Kernels System

    Issue(s): #8377

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.95The system shall have the ability to verify individual Jacobian contributions before they are scaled by other finite element factors in the system.

    Specification(s): test

    Design: MaterialPropertyValue

    Issue(s): #14823

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.96The system shall support solving Ordinary Differential Equations in explicit form.

    Specification(s): test_expl

    Design: ScalarKernels System

    Issue(s): #726

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.97The system shall support solving Ordinary Differential Equations in implicit form.

    Specification(s): test_sys_impl

    Design: ScalarKernels System

    Issue(s): #726

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.98The system shall support solving ODEs specified within the input file through parsed function syntax.

    Specification(s): test_parsed_sys_impl

    Design: ParsedODEKernel

    Issue(s): #726

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.97

  • 11.24.99The system support coupling of postprocessor values in the parsed function ODE kernel.

    Specification(s): test_parsed_pp

    Design: ParsedODEKernel

    Issue(s): #14034

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.24.100The system shall support solving Coupled Ordinary Differential Equations.

    Specification(s): test_coupled_ode_td

    Design: ScalarKernels System

    Issue(s): #726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.24.101The system shall allow scalar variable initial condition to be loaded from a file mesh

    Specification(s): test_coupled_ode_td_var_ic_from_mesh

    Design: SystemBase

    Issue(s): #13040

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.24.100

  • 11.24.102The system shall allow auxscalar variable initial condition to be loaded from a file mesh

    Specification(s): test_coupled_ode_td_auxvar_ic_from_mesh

    Design: SystemBase

    Issue(s): #13040

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.24.100

  • 11.24.103The system shall solve the constrained Neumann problem using the Lagrange multiplier approach.

    Specification(s): kernel

    Design: ScalarKernels System

    Issue(s): cbf6d2235379f6ad75908b0f9d4be792dbce6c3d

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.104The system shall solve the constrained Neumann problem using the Lagrange multiplier approach when displacements are active.

    Specification(s): kernel_disp

    Design: ScalarKernels System

    Issue(s): #7699

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.105The system shall support the ability to set Dirichlet boundary conditions using the Lagrange multiplier approach.

    Specification(s): bc

    Design: ScalarKernels System

    Issue(s): #1800

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.106The system shall support retrieving a vector of values in a kernel object for the purpose of computing a residual statement.

    Specification(s): test

    Design: Kernels System

    Issue(s): #7425

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.107The system shall run a simple 2D linear diffusion problem with Dirichlet boundary conditions on a regular mesh.

    Specification(s): test

    Design: Diffusion

    Issue(s): #1493

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.108The system shall be able to run a transient diffusion problem

    Specification(s): test

    Design: TimeDerivative

    Issue(s): #000

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.109The system shall not do any mallocs in MatSetValues for simple kernels

    Specification(s): test_mallocs

    Design: TimeDerivative

    Issue(s): #13736

    Collection(s): FUNCTIONAL

    Type(s): RunApp

    Prerequisite(s): 11.24.1111.24.1311.24.3011.24.3311.24.4011.24.5211.24.8811.24.9511.24.10611.24.10711.24.10811.24.11711.24.123

  • 11.24.110We shall not be able to solve a problem where the physics Jacobians are very large compared to the jacobian from a Dirichlet BC (unity)

    Specification(s): cant-solve-poorly-scaled

    Design: FEProblemSolve.md

    Issue(s): #12601

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.111We shall be able to solve an initially poorly scaled problem by using MOOSE's automatic scaling feature

    Specification(s): automatic-scaling-done-once

    Design: FEProblemSolve.md

    Issue(s): #12601

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.112We shall be able to solve an initially poorly scaled problem by using MOOSE's automatic scaling feature in parallel

    Specification(s): automatic-scaling-done-once-parallel-preconditioner

    Design: FEProblemSolve.md

    Issue(s): #12601

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.111

  • 11.24.113We shall not be able to solve a problem where the physics has large changes over time if we only scale once

    Specification(s): cant-solve-large-transient-changes

    Design: FEProblemSolve.md

    Issue(s): #12601

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.114We shall be able to solve a problem where the physics has large changes over time if we scale on every time step

    Specification(s): automatic-scaling-done-per-time-step

    Design: FEProblemSolve.md

    Issue(s): #12601

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.115We shall be able to solve a problem where the physics has large changes over time if we scale on every time step in parallel

    Specification(s): automatic-scaling-done-per-time-step-parallel-preconditioner

    Design: FEProblemSolve.md

    Issue(s): #12601

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.114

  • 11.24.116The system shall be able to do on the fly time derivative and gradient evaluations of variable functors.

    Specification(s): dot_grad_test

    Design: MooseVariableBase

    Issue(s): #16809

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.117The system shall error if the volumetric residual calculation is not assigned an associated vector within the numerical solving routine.

    Specification(s): test

    Design: Kernels System

    Issue(s): #9669

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.118Time kernel requires a transient executioner

    Specification(s): bad_transient

    Design: TaggingInterface

    Issue(s): #9669

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.119The kernel can be only assigned to the existing vector tags in the system

    Specification(s): bad_vector_tag

    Design: TaggingInterface

    Issue(s): #9669

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.120The kernel can be only assigned to the existing matrix tags in the system

    Specification(s): bad_matrix_tag

    Design: TaggingInterface

    Issue(s): #9669

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.121The system shall be able to reproduce the simple_transient_diffusion test with VectorTimeDerivative (hand-coded Jacobian).

    Specification(s): transient_vector_diffusion

    Design: VectorTimeDerivative

    Issue(s): #13913

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.122The Jacobian from VectorTimeDerivative shall be perfect

    Specification(s): jac_transient_vector_diffusion

    Design: VectorTimeDerivative

    Issue(s): #13913

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.123The system shall compute second-order time derivatives for vector variables

    Specification(s): test

    Design: Coupleable

    Issue(s): #13913

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.124The system shall be able to solve a curl-curl problem using NEDELEC_ONE elements.

    Specification(s): vector_fe

    Design: Variables System

    Issue(s): #10049

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.125The system shall be able to couple a vector variable into a standard kernel.

    Specification(s): coupled_scalar_vector

    Design: Variables System

    Issue(s): #10049

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.126The system shall be able to assign a default value for a vector variable from the source file.

    Specification(s): coupled_scalar_default_vector_source

    Design: Variables System

    Issue(s): #10049

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.127The system shall warn when assigning a default value with number of components less than LIBMESH_DIM, and it shall be able to assign the default value from the input file.

    Specification(s): coupled_scalar_default_vector_input_and_warn

    Design: Variables System

    Issue(s): #10049

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.128The system shall be able to assign a default value for a vector variable from the input file and still have the correct jacobian.

    Specification(s): coupled_scalar_default_vector_jacobian

    Design: Variables System

    Issue(s): #10049

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.129The system shall be able to solve multi-dimensional problems with LAGRANGE_VEC variables.

    Specification(s): lagrange_vec

    Design: Variables System

    Issue(s): #10049

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.130The system shall be able to solve one-dimensional problems with LAGRANGE_VEC variables.

    Specification(s): lagrange_vec_1d

    Design: Variables System

    Issue(s): #10049

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.131The system shall be able to solve one-dimensional problems with LAGRANGE_VEC variables and produce the correct Jacobian.

    Specification(s): lagrange_vec_1d_jac

    Design: Variables System

    Issue(s): #10049

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.132The system shall be able to solve multi-d LAGRANGE_VEC problems with automatic differentiation and reproduce the hand-coded result.

    Specification(s): ad_lagrange_vec

    Design: ADVectorFunctionDirichletBC

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.24.129

  • 11.24.133The system shall be able to solve multi-d LAGRANGE_VEC problems with automatic differentiation and have a perfect Jacobian.

    Specification(s): ad_lagrange_vec_jacobian

    Design: ADVectorFunctionDirichletBC

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.134The system shall be able to couple a vector variable into a standard kernel and produced the correct Jacobian.

    Specification(s): jacobian

    Design: Variables System

    Issue(s): #10049

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.135The system shall be able to couple a standard variable into a vector kernel. Additionally, The system shall be able to calculate time derivatives of variable gradients.

    Specification(s): coupled_gradient_dot_em_gauge

    Design: Variables SystemVectorBodyForce

    Issue(s): #10861

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.136The system shall be able to compute the correct Jacobian when coupling a standard variable into a vector kernel and taking time derivatives of variable gradients.

    Specification(s): coupled_gradient_dot_jacobian

    Design: Variables SystemVectorBodyForce

    Issue(s): #10861

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.24.137The system shall be able to assign dirichlet boundary conditions for LAGRANGE_VEC variables; obtain coupled vector variable gradients; and correctly initialize both volume and face curl shape functions when the curl of a variable is requested.

    Specification(s): coupled_vector_gradient

    Design: Variables SystemVectorDiffusionVectorDirichletBCVectorFunctionDirichletBC

    Issue(s): #11150

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.24.138The system shall error if the 'function' and 'function_x' parameters are both set when defining a vector function Dirichlet boundary condition.

    Specification(s): comp_error

    Design: VectorBodyForce

    Issue(s): #13309

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.24.139The system shall error if the 'function' and 'function_x' parameters are both set within the ADVectorFunctionDirichletBC object.

    Specification(s): ad_comp_error

    Design: ADVectorFunctionDirichletBC

    Issue(s): #13309

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • rdg: Markers
  • 11.26.1The system shall include the ability to mark a mesh subdomain for uniform refinement.

    Specification(s): test

    Design: Markers System

    Issue(s): #6665

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.2The adaptivity system shall create an auxiliary field variable that marks elements for refinement adjacent to a boundary.

    Specification(s): adjacent

    Design: Markers SystemBoundaryMarker

    Issue(s): #1275

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.3The adaptivity system shall create an auxiliary field variable that marks elements for refinement within a given distance of a boundary.

    Specification(s): distance

    Design: Markers SystemBoundaryMarker

    Issue(s): #1275

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.4The adaptivity system shall create an auxiliary field variable that marks elements for refinement within a rectangular region.

    Specification(s): mark_only

    Design: Markers SystemBoxMarker

    Issue(s): #1275

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.5The adaptivity system shall adapt the mesh within a rectangular region.

    Specification(s): mark_and_adapt

    Design: Markers SystemBoxMarker

    Issue(s): #1275

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.6The system shall include the ability to combine multiple mesh refinement markers into a single value.

    Specification(s): test

    Design: ComboMarker

    Issue(s): #1303

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.7The system shall include the ability to mark elements within a subdomain to be unchanged for mesh adaptivity.

    Specification(s): test

    Design: Adaptivity SystemBoxMarker

    Issue(s): #1275

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.8The system shall include a means for setting mesh refinement flags based on percent of error for a sorted vector of error values computed for each finite element.

    Specification(s): test

    Design: Errorfractionmarker

    Issue(s): #1301

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.9The system shall include the ability to use the same error extremes during all calculations of error fraction values during mesh adaptivity.

    Specification(s): no_clear

    Design: Errorfractionmarker

    Issue(s): #9914

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.10The system shall include a means for setting mesh refinement flags based on percent of error for a sorted vector of error values computed for each finite element using FV variables

    Specification(s): fv

    Design: Errorfractionmarker

    Issue(s): #16069

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.11The system shall include a means for computing mesh refinement flags based on an absolute values of error.

    Specification(s): test

    Design: ErrorToleranceMarker

    Issue(s): #1301#1275

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.12The system shall include a means for performing mesh adaptivity based on an absolute values of error.

    Specification(s): adapt_test

    Design: ErrorToleranceMarker

    Issue(s): #1301#1275

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.13It shall not be possible to specify Markers to run on the displaced mesh.

    Specification(s): displaced_error

    Design: Markers System

    Issue(s): #11430

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.26.14The system shall support the ability to mark elements for mesh adaptivity based on a bounding box with arbitrary orientation.

    Specification(s): obm

    Design: OrientedBoxMarker

    Issue(s): #2514

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.15The system shall support access to finite element quadrature point locations during the calculation of refinement marker flags.

    Specification(s): test

    Design: Markers System

    Issue(s): #3279

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.16The adaptivity system shall create an auxiliary field variable that marks elements containing the points from the reporter for refinement.

    Specification(s): mark_only

    Design: Markers SystemReporterPointMarker

    Issue(s): #18886

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.17The marker shall create an error if the coordinate vectors are not all the same size

    Specification(s): wrong_size_error

    Design: Markers SystemReporterPointMarker

    Issue(s): #18886

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.26.18The marker shall be used for adaptivity for a moving point, being able to coarsen elements the point moves out of but not coarsen elements if it contains point.

    Specification(s): adaptivity

    Design: Markers SystemReporterPointMarker

    Issue(s): #18886

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.26.19The system shall support the capability of creating a tool for marking finite elements for mesh refinement, for example:
    1. adding elements within the intersection of two circles;
    2. adding elements within the intersection of two circles and removing elements outside the circles; and
    3. performing adaptivity when a non-uniform initial condition is defined.

    Specification(s): group/two_circle_marker, group/two_circle_marker_coarsen, group/two_circle_marker_gaussian_ic

    Design: Markers System

    Issue(s): #8890

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.20The system shall support marking the entire finite element mesh for refinement.

    Specification(s): test

    Design: UniformMarker

    Issue(s): #1566

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.21The system shall include the ability to mark elements within a finite element mesh for adaptivity based on if the value of a variable is within a specific range.

    Specification(s): test

    Design: ValueRangeMarker

    Issue(s): #1815

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.26.22The system shall include the ability to mark elements within a finite element mesh for adaptivity based on if the value of a variable is above or below a threshold.

    Specification(s): test

    Design: ValueThresholdMarker

    Issue(s): #1313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Mesh
  • 11.28.1The system shall support importing mesh information from Abaqus that includes
    1. element identifiers,
    2. element sets, and
    3. element sets with extra space in file.

    Specification(s): abaqus/testcube_elem_id, abaqus/testcube_elset_name, abaqus/testcube_elset_name_ws

    Design: FileMesh

    Issue(s): #14302

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.2The system shall perform identical adaptivity patterns on both the reference mesh and the displaced mesh when it exists.

    Specification(s): displaced_test

    Design: Adaptivity System

    Issue(s): #443

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.3The system shall support toggling adaptivity on/off during a simulation.

    Specification(s): test_time

    Design: Adaptivity System

    Issue(s): #1755#447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.4The system shall perform one or more adaptivity steps on the mesh before the simulation begins.

    Specification(s): initial_adaptivity_test

    Design: Adaptivity System

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.5The system shall support patch-based error estimation among a stencil of elements.

    Specification(s): patch_test

    Design: Adaptivity System

    Issue(s): #833

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.6The system shall support multiple adaptive steps per solve.

    Specification(s): adapt_cycles_test

    Design: Adaptivity System

    Issue(s): #830

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.7The system shall perform adaptivity on systems containing multiple independent field variables.

    Specification(s): test

    Design: Adaptivity System

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.8The system shall support running adaptivity on an interval basis (every several time steps).

    Specification(s): interval

    Design: Adaptivity System

    Issue(s): #6888

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.9The system shall support weighted error estimation when considering multiple field variables for adaptivity.

    Specification(s): test

    Design: Adaptivity System

    Issue(s): #447

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.10The system shall output all boundary and subdomain connections.

    Specification(s): boundary_subdomain_connections

    Design: MooseMesh

    Issue(s): #14971#15019

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.28.11The system shall support the use of a centroid-based parallel partitioning scheme.

    Specification(s): centroid_partitioner_test

    Design: Mesh System

    Issue(s): #2270#2289

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.12The system shall generate pre-split mesh files using a standard input file combined with command line arguments.

    Specification(s): test_2

    Design: Mesh Splitting

    Issue(s): #8472#7752#11004

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.13The system shall use pre-split binary mesh files using a standard input file combined with command line arguments.

    Specification(s): test_2a

    Design: Mesh Splitting

    Issue(s): #8472#7752#11004

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.14The system shall auto-detect and use pre-split meshes using a standard input file combined with command line arguments.

    Specification(s): test_4

    Design: Mesh Splitting

    Issue(s): #8472#7752#11004

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.15The system shall use pre-split ascii meshes when the command line parameter also includes the pre-split suffix.

    Specification(s): test_4a

    Design: Mesh Splitting

    Issue(s): #8472#7752#11004

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.16The system shall use pre-splits for several different numbers of processors auto-detected from the number of MPI processors used.

    Specification(s): test_8

    Design: Mesh Splitting

    Issue(s): #8472#7752#11004

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.17The system shall use pre-splits for several different numbers of processors when the command line parameter also includes the pre-split suffix.

    Specification(s): test_8a

    Design: Mesh Splitting

    Issue(s): #8472#7752#11004

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.18The system shall generate a quadrilateral mesh consisting of concentric circles.

    Specification(s): test

    Design: ConcentricCircleMesh

    Issue(s): #11656

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.19The system shall support the ability to create custom objects for performing mesh partitioning, for example
    1. a linear partitioner that
    2. operates with a displaced configuration and
    3. is capable of restarting.

    Specification(s): group/custom_linear_partitioner, group/custom_linear_partitioner_displacement, group/custom_linear_partitioner_restart

    Design: Partitioner System

    Issue(s): #5543

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.20The system shall compute and store internal face data on request for
    1. quadrilateral elements,
    2. triangular elements, and
    3. quadrilateral elements in multiple regions.

    Specification(s): face_info/quad, face_info/tri, face_info/two_region_quads

    Design: Mesh System

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.28.21The system shall read GMesh (.msh) format file meshes.

    Specification(s): gmsh_test

    Design: FileMesh

    Issue(s): #2105

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.22The system shall read GMesh (.msh) format file meshes containing multiple boundaries.

    Specification(s): gmsh_bc_test

    Design: FileMesh

    Issue(s): #1402

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.23The system shall support refinement of QUAD4 mesh elements.

    Specification(s): test_quad4_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.24The system shall support refinement of QUAD8 mesh elements.

    Specification(s): test_quad8_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.25The system shall support refinement of QUAD9 mesh elements.

    Specification(s): test_quad9_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.26The system shall support refinement of TRI3 mesh elements.

    Specification(s): test_tri3_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.27The system shall support refinement of TRI6 mesh elements.

    Specification(s): test_tri6_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.28The system shall support refinement of HEX8 mesh elements.

    Specification(s): test_hex8_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.29The system shall support refinement of HEX20 mesh elements.

    Specification(s): test_hex20_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.30The system shall support refinement of HEX27 mesh elements.

    Specification(s): test_hex27_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.31The system shall support refinement of TET4 mesh elements.

    Specification(s): test_tet4_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.32The system shall support refinement of TET10 mesh elements.

    Specification(s): test_tet10_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.33The system shall support refinement of PRISM6 mesh elements.

    Specification(s): test_prism6_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.34The system shall support refinement of PRISM15 mesh elements.

    Specification(s): test_prism15_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.35The system shall support refinement of PRISM18 mesh elements.

    Specification(s): test_prism18_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.36The system shall support refinement of PYRAMID5 mesh elements.

    Specification(s): test_pyramid5

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.37The system shall support refinement of PYRAMID13 mesh elements.

    Specification(s): test_pyramid13

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.38The system shall support refinement of PYRAMID14 mesh elements.

    Specification(s): test_pyramid14

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.39The system shall generate a structured mesh on a Cartesian domain.

    Specification(s): test

    Design: GeneratedMesh

    Issue(s): #760

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.40The system shall generate first-order, structured meshes with biasing in the x, y, and z directions.

    Specification(s): mesh_bias

    Design: GeneratedMesh

    Issue(s): #6129

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.41The system shall generate second-order, structured meshes with biasing in the x, y, and z directions.

    Specification(s): mesh_bias_quadratic

    Design: GeneratedMesh

    Issue(s): #6129

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.42The system shall include the ability to generate an annular mesh that errors when
    1. the min radius is larger than the max radius;
    2. the min angle is greater than or equal to the max angle;
    3. the angle separation is larger than 360 degrees;
    4. the number of elements in the angular direction is too small due to the number of elements; and
    5. the number of elements in the angular direction is too small due to the maximum angle.
    6. shall throw an error if the quadrilateral and triangular subdomain ids are the same.
    7. shall throw an error if both radial positions and the number of radial elements are prescribed.
    8. shall throw an error if both radial positions and the radius growth parameter are prescribed.
    9. shall throw an error if any of the radial positions fall out of the bounds between rmin and rmax.

    Specification(s): annular_errors/annular_except1, annular_errors/annular_except2, annular_errors/annular_except3, annular_errors/annular_except4, annular_errors/annular_except5, annular_errors/annular_except6, annular_errors/annular_except7, annular_errors/annular_except8, annular_errors/annular_except9

    Design: AnnularMeshGenerator

    Issue(s): #8432#18486

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.28.43The system shall include the ability to create
    1. an annulus using quad elements;
    2. an annulus sector using quad elements;
    3. a circular disk using quad elements; and
    4. circular disk sector using quad elements.

    Specification(s): annular/annulus, annular/annulus_sector, annular/disc, annular/disc_sector

    Design: AnnularMeshGenerator

    Issue(s): #8432

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.44The system shall have an algorithm for meshing an annular region with triangular elements.

    Specification(s): spiral_annular_mesh

    Design: SpiralAnnularMesh

    Issue(s): #12205

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.45The system shall have an algorithm for generating triangular and quadrilateral meshes for the Ringleb problem.

    Specification(s): ringleb_mesh

    Design: RinglebMesh

    Issue(s): #12246

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.52The system shall allow writing out the mesh without running a simulation.

    Specification(s): mesh_only_test

    Design: Mesh System

    Issue(s): #1568

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.53The system shall print out information about the mesh when writing out the mesh.

    Specification(s): mesh_info

    Design: Mesh System

    Issue(s): #11917#11921

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.28.54The system shall warn when using –mesh-only and there is no clear filename to use

    Specification(s): mesh_only_warning

    Design: Mesh System

    Issue(s): #1568

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.28.55The system shall support overriding output dimension when necessary to store coordinates in higher planes

    Specification(s): output_dimension_override

    Design: Mesh System

    Issue(s): #12757

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.56The system shall support writing parallel checkpoint files with –mesh-only

    Specification(s): mesh_only_checkpoint

    Design: Mesh System

    Issue(s): #14312

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.28.57The system shall support simulations on meshes containing both 1D and 2D element types.

    Specification(s): oned_twod_test

    Design: Mesh System

    Issue(s): #1710#2130#2105

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.58The system shall support proper material evaluations on meshes containing both 1D and 2D element types.

    Specification(s): oned_twod_w_matl_test

    Design: Mesh System

    Issue(s): #1710#2130#2105

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.59The system shall support simulations on meshes containing both 1D and 3D element types.

    Specification(s): oned_threed_test

    Design: Mesh System

    Issue(s): #1710#2130#2105

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.60The system shall generate meshes with different sets of element integers and properly stitch them.

    Specification(s): mesh_integer

    Design: Mesh System

    Issue(s): #13764

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.61The system shall support interchangeable use of integer and string identifiers for mesh entities.

    Specification(s): test_names

    Design: Mesh System

    Issue(s): #979

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.62The system shall support interchangeable use of integer and string identifiers for mesh entities read from the XDA format.

    Specification(s): test_names_xda

    Design: Mesh System

    Issue(s): #1055

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.63The system shall support interchangeable use of integer and string identifiers within the BCs/Periodic block.

    Specification(s): test_periodic_names

    Design: Mesh System

    Issue(s): #979

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.64The system shall support the ability to assign and use string names to mesh entities during the simulation startup.

    Specification(s): on_the_fly_test

    Design: Mesh System

    Issue(s): #979

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.65The system shall support writing solution data in the Nemesis parallel file format.

    Specification(s): nemesis_test

    Design: Mesh SystemNemesis

    Issue(s): #2520

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.66The system shall support the re-partitioning of mesh files input using the Nemesis format.

    Specification(s): nemesis_repartitioning_test

    Design: Mesh SystemNemesis

    Issue(s): #2520

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.28.67The system shall issue an error if no Mesh block is provided.

    Specification(s): no_mesh_block_err

    Design: Mesh System

    Issue(s): #2408

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.28.68The system shall issue a diagnostic when a referenced node set does not exist in the mesh

    Specification(s): test

    Design: MooseMesh

    Issue(s): #13509#6985#6987

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.28.69The system shall generate a mesh using one or more meshes stitched into a pattern controlled by a 2D array.

    Specification(s): patterned_generation

    Design: PatternedMesh

    Issue(s): #6950

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.70The system shall read in a previously generated "patterned mesh" and run a simulation using that mesh.

    Specification(s): patterned_run

    Design: PatternedMesh

    Issue(s): #6950

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.28.69

  • 11.28.71The system shall produce a valid periodic node map with only one periodic constraint direction.

    Specification(s): 1D

    Design: Mesh System

    Issue(s): #11891

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.28.72The system shall produce a valid periodic node map with two periodic constraint directions.

    Specification(s): 2D

    Design: Mesh System

    Issue(s): #11891

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.28.73The system shall produce a valid periodic node map with three periodic constraint directions.

    Specification(s): 3D

    Design: Mesh System

    Issue(s): #11891

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.28.74The system shall issue a diagnostic when a referenced side set does not exist in the mesh.

    Specification(s): missing_side_set

    Design: MooseMesh

    Issue(s): #13509

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.28.75The system shall have the ability to construct a side set from a set of nodes.

    Specification(s): construct_side_sets

    Design: MooseMesh

    Issue(s): #13509

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.76The system shall support optionally allowing uniform refinements when using a pre-split mesh

    Specification(s): square

    Design: Mesh SystemMesh Splitting

    Issue(s): #18575

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.77A mesh can be split into a specified number of files using command line options.

    Specification(s): make_split

    Design: Mesh Splitting

    Issue(s): #10623

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.28.78A mesh can be pre-split properly and used to generate equivalent results to running a simulation with the unsplit mesh.

    Specification(s): use_split

    Design: Mesh Splitting

    Issue(s): #10623

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.28.77

  • 11.28.79Console output should include an indicator that a pre-split mesh is being used when using –split-mesh in distributed = auto mode
    1. without and
    2. with the forced option.

    Specification(s): check/pre_split, check/forced_pre_split

    Design: Mesh Splitting

    Issue(s): #11825

    Collection(s): FUNCTIONAL

    Type(s): RunApp

    Prerequisite(s): 11.28.77

  • 11.28.80The mesh splitter will throw an error when an attempt is made to split a "DistributedMesh".

    Specification(s): split_with_distributed_error

    Design: Mesh Splitting

    Issue(s): #11434

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.28.81The mesh splitter capability will honor geometric RelationshipManager objects.

    Specification(s): split_with_RM_part1

    Design: Mesh Splitting

    Issue(s): #11434

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.28.82Meshes that are pre-split with active RelationshipManager objects work the same as if using an online DistributedMesh.

    Specification(s): split_with_RM_part2

    Design: Mesh Splitting

    Issue(s): #11434

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.28.81

  • 11.28.83Splitting meshes from file should work with custom partitioners.

    Specification(s): grid_from_file

    Design: Mesh Splitting

    Issue(s): #11944

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.28.84Splitting meshes from a generated mesh should work with custom partitioners.

    Specification(s): grid_from_generated

    Design: Mesh Splitting

    Issue(s): #11944

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.28.85The system shall support the creating a single mesh from multiple meshes stitched together.

    Specification(s): test

    Design: StitchedMesh

    Issue(s): #8308

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.86The system shall error if at least one mesh file is not supplied when creating a mesh from multiple meshes stitched together.

    Specification(s): files_error

    Design: StitchedMesh

    Issue(s): #8308

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.28.87The system shall provide a parallel partition based on mesh subdomains

    Specification(s): test

    Design: Partitioner System

    Issue(s): #8672#8747#8950#8956

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.88The parallel partitioning capability by subdomain shall report a reasonable error when a given subdomain does not exist

    Specification(s): missing_block

    Design: Partitioner System

    Issue(s): #8672#8747#8950#8956

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.28.89The system shall read TetGen file meshes.

    Specification(s): mesh_only_warning

    Design: FileMeshGenerator

    Issue(s): #20694

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.90The system shall construct a mesh by "tiling" another mesh repeatedly.

    Specification(s): tiled_mesh_test

    Design: TiledMesh

    Issue(s): #1729

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.91The system shall support avoiding repartitioning the mesh and deleting remote elements after uniform refinements

    Specification(s): square

    Design: Mesh System

    Issue(s): #18571

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.28.92The system shall support having a truly unique_id (never recycled) for all mesh elements and nodes when using replicated mesh.

    Specification(s): replicated_mesh

    Design: Mesh System

    Issue(s): #2142

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.28.93The system shall support having a truly unique_id (never recycled) for all mesh elements and nodes when using distributed mes.

    Specification(s): distributed_mesh

    Design: Mesh System

    Issue(s): #2142

    Collection(s): FUNCTIONAL

    Type(s): RunApp

    Prerequisite(s): 11.28.92

  • rdg: Minimal App
  • 11.31.1The system shall support the programmatic creation of a simulation tools without the need of an input file.

    Specification(s): minimal

    Design: MooseApp

    Issue(s): #6126

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • rdg: Misc
  • 11.32.1We shall be able to call AD variable methods on an auxiliary variable in a transient simulation and not hit assertions for both regular and neighbor calculations

    Specification(s): guard_time_deriv_for_ad_aux

    Design: MooseVariableFE

    Issue(s): #13171

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.2Coupling an auxiliary variable into a DGKernel shall not destroy the Jacobian

    Specification(s): neighbor_ad_with_aux_jac

    Design: MooseVariableFE

    Issue(s): #13171

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.32.3We shall be able to do NL variable coupling into a DGKernel

    Specification(s): neighbor_ad_with_nl

    Design: MooseVariableFE

    Issue(s): #13171

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.4We shall be able to do NL variable coupling into a DGKernel and have a good Jacobian

    Specification(s): neighbor_ad_with_nl_jac

    Design: MooseVariableFE

    Issue(s): #13171

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.32.5The compiled application shall be capable of returning the name used for registering objects.

    Specification(s): test

    Design: MooseApp

    Issue(s): #11337

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.6The system shall be able to run a specific application by passing a command line option.

    Specification(s): specified_app

    Design: MooseApp

    Issue(s): #20062

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.7The system shall report an error when a material property is not defined on a boundary.

    Specification(s): bc_check

    Design: Problem system overview

    Issue(s): #9835#5309#9482

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.8The system shall report an error when a material property requested by a UserObject is not defined on a boundary.

    Specification(s): side_uo_check

    Design: Problem system overview

    Issue(s): #9835#5309#9482

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.9The system shall report an error when a material property requested by a DGKernel is not defined on a boundary.

    Specification(s): dgkernel_check_boundary

    Design: Problem system overview

    Issue(s): #9835#5309#9482

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.10The system shall report an error when a material property requested by a DGKernel is not defined on a subdomain.

    Specification(s): dgkernel_check_block

    Design: Problem system overview

    Issue(s): #9835#5309#9482

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.11The system shall verify that objects that use subdomain restricted variables are defined on a subset of the restricted domain area.

    Specification(s): variable_interface_run

    Design: Problem system overview

    Issue(s): #9889

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.12The system shall produce an error when an object's discretization area is explicitly set to a value greater than the area of the underlying variable used by the object.

    Specification(s): variable_interface_error_block_set

    Design: Problem system overview

    Issue(s): #9889

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.13The system shall produce an error when an object's discretization area is greater than the area of the underlying variable used by the object.

    Specification(s): variable_interface_error_block_any

    Design: Problem system overview

    Issue(s): #9889

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.14The system shall produce an error when an object's discretization area is explicitly set to a different area than the area of a coupled variable used by the object.

    Specification(s): coupleable_error_block_set

    Design: Problem system overview

    Issue(s): #9889

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.15The system shall produce an error when an object's discretization area is different than an explicitly set variable on only defined on a different portion of the mesh.

    Specification(s): coupleable_error_block_set2

    Design: Problem system overview

    Issue(s): #9889

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.16The system shall produce an error when an object's discretization area is covers the whole mesh but a coupled variable only exists on a portion of the mesh.

    Specification(s): coupleable_error_block_any

    Design: Problem system overview

    Issue(s): #9889

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.19The system shall report an error when a null pointer-checked parameter is retrieved from the InputParameters object.

    Specification(s): checked_pointer_param_test

    Design: Problem system overview

    Issue(s): #10356

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.20The system shall report an error when multiple AuxVariables are added to the system with conflicting types.

    Specification(s): add_aux_variable_multiple_test

    Design: Problem system overview

    Issue(s): #1222

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.21The system shall report an error when multiple Scalar AuxVariables are added to the system with conflicting types.

    Specification(s): add_aux_scalar_variable_multiple_test

    Design: Problem system overview

    Issue(s): #9313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.22The system shall report an error when an attempt is made to instantiate a non-existent BoundaryCondition object.

    Specification(s): bad_bc_test

    Design: Problem system overview

    Issue(s): #10486

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.23The system shall report an error when a non-existent nonlinear variable name is used by a MooseObject.

    Specification(s): bad_bc_var_test

    Design: Problem system overview

    Issue(s): #11227

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.24The system shall report an error message when an invalid enumeration is supplied in any MooseEnum type.

    Specification(s): bad_enum_test

    Design: Problem system overview

    Issue(s): #489

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.25The system shall report an error message when an invalid Executioner is specified.

    Specification(s): bad_executioner_test

    Design: Problem system overview

    Issue(s): #12106

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.26The system shall report an error message when an invalid Kernel is specified.

    Specification(s): bad_kernel_test

    Design: Problem system overview

    Issue(s): #12106

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.27The system shall report an error message when a Kernel object attempts to access a non-existent variable.

    Specification(s): bad_kernel_var_test

    Design: Problem system overview

    Issue(s): #11227

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.28The system shall report an error when an invalid Material is specified.

    Specification(s): bad_material_test

    Design: Problem system overview

    Issue(s): #12106

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.29The system shall report an error when a previously undeclared variable is used in a parsed function expression.

    Specification(s): bad_parsed_function_vars_test

    Design: Problem system overview

    Issue(s): #4683

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.30The system shall report an error when a first order element is used with a second order discretization.

    Specification(s): bad_second_order_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.31The system shall report an error message when a deprecated input file block is used.

    Specification(s): deprecated_block_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.32The system shall report a warning when a deprecated parameter with a default value is explicitly set by the user.

    Specification(s): deprecated_param_default

    Design: Problem system overview

    Issue(s): #1951

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.33The system shall report a warning when an optional deprecated parameter is explicitly set by the user.

    Specification(s): deprecated_param_no_default

    Design: Problem system overview

    Issue(s): #1951

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.34The system shall report an error when conflicting domain restrictions are applied to a single object.

    Specification(s): double_restrict_uo_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.35The system shall report an error when the number of ids and corresponding block names are mismatched.

    Specification(s): dynamic_check_name_block_mismatch_test

    Design: Problem system overview

    Issue(s): #8596

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.36The system shall report an error when a duplicate name is provided for a set of unique block ids.

    Specification(s): dynamic_check_name_block_test

    Design: Problem system overview

    Issue(s): #8596

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.37The system shall report an error when the number of ids and corresponding boundary names are mismatched.

    Specification(s): dynamic_check_name_boundary_mismatch_test

    Design: Problem system overview

    Issue(s): #8596

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.38The system shall report an error when a duplicate name is provided for a set of unique boundary ids.

    Specification(s): dynamic_check_name_boundary_test

    Design: Problem system overview

    Issue(s): #8596

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.39The system shall report an error when the linear interpolation utility is supplied with bad domain values.

    Specification(s): linear_interp_material_check

    Design: Problem system overview

    Issue(s): #5886

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.40The system shall report an error when the Piecewise utility encounters an unexpected column data format.

    Specification(s): function_file_test1

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.41The system shall report an error when the Piecewise utility encounters an unexpected row data format.

    Specification(s): function_file_test2

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.42The system shall report an error when the Piecewise utility encounters inconsistent domain and range data.

    Specification(s): function_file_test3

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.43The system shall report an error when an invalid enumeration is supplied in the Piecewise utility.

    Specification(s): function_file_test4

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.44The system shall report an error when the Piecewise data is over-specified with the data file option.

    Specification(s): function_file_test5

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.45The system shall report an error when the Piecewise data is over-specified with row/column data.

    Specification(s): function_file_test6

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.46The system shall report an error when either the domain or range is missing when using the domain/range option in the Piecewise utility.

    Specification(s): function_file_test7

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.47The system shall report and error if the supplied domain/range pairs are not even in the Piecewise utility.

    Specification(s): function_file_test8

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.48The system shall report an error if no function is supplied in the Piecewise utility.

    Specification(s): function_file_test9

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.49The system shall report an error if the xy_data is supplied but the function is missing in the Piecewise utility.

    Specification(s): function_file_test10

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.50The system shall report an error when the number of columns appears incorrect in the Piecewise utility.

    Specification(s): function_file_test11

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.51The system shall report an error when an out of range y-column index is supplied in the Piecewise utility.

    Specification(s): function_file_test12

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.52The system shall report an error when an out of range x-column index is supplied in the Piecewise utility.

    Specification(s): function_file_test13

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.53The system shall report an error if too many rows are supplied when the data is expected to contain row information.

    Specification(s): function_file_test14

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.54The system shall report an error when an out of range x-row index is supplied in the Piecewise utility.

    Specification(s): function_file_test15

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.55The system shall report an error when an out of range y-row index is supplied in the Piecewise utility.

    Specification(s): function_file_test16

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.56The system shall report an error when the x and y index in file are equal in the Piecewise utility.

    Specification(s): function_file_test17

    Design: Problem system overview

    Issue(s): #2421

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.57The system shall report an error if one or more domain blocks do not have any active Kernels objects assigned.

    Specification(s): incomplete_kernel_block_coverage_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.58The system shall report an error if one or more variables do not have any active Kernel objects assigned.

    Specification(s): incomplete_kernel_variable_coverage_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.59The system shall report an error if one or more domain blocks do not have any active FVKernels objects assigned.

    Specification(s): incomplete_fvkernel_block_coverage_test

    Design: Problem system overview

    Issue(s): #1405#15196

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.60The system shall report an error if one or more variables do not have any active FVKernel objects assigned.

    Specification(s): incomplete_fvkernel_variable_coverage_test

    Design: Problem system overview

    Issue(s): #1405#15196

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.61The system shall report an error when an elemental variable (no continuity) is coupled to a variable with continuity.

    Specification(s): invalid_elemental_to_nodal_couple_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.62The system shall report an error when an active input block section is specified but missing.

    Specification(s): missing_active_section_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.63The system shall report an error when a material property is requested but not supplied on a mesh block.

    Specification(s): missing_coupled_mat_prop_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.64The system shall report an error when a coupled variable is supplied that was not added as a valid parameter.

    Specification(s): coupled_grad_without_declare

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.65The system shall report an error when the data file is non-existent or not-readable in the Piecewise utility.

    Specification(s): missing_function_file_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.66The system shall report an error when the coupled function does not exist or can not be parsedfor the Piecewise utility.

    Specification(s): missing_function_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.67The system shall report an error when one or more material properties are missing from any mesh block.

    Specification(s): missing_material_prop_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.68The system shall report an error when a material property is supplied on some blocks but missing on other blocks where it is requested.

    Specification(s): missing_material_prop_test2

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.69The system shall report an error when only "old" properties are supplied but current properties are requested.

    Specification(s): bad_stateful_material_only_old

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.70The system shall report an error when only "older" properties are supplied but current properties are requested.

    Specification(s): bad_stateful_material_only_older

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.71The system shall report an error when the mesh file cannot be found.

    Specification(s): missing_mesh_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.72The system shall report an error when a required parameter is not supplied in an Action.

    Specification(s): missing_req_par_action_obj_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.73The system shall report an error when a specific mesh required parameter is not supplied.

    Specification(s): missing_req_par_mesh_block_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.74The system shall report an error when the special "type" parameter is not supplied for a MooseObject.

    Specification(s): missing_req_par_moose_obj_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.75The system shall report an error when a required parameter is not supplied in a MooseObject.

    Specification(s): missing_var_in_kernel_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.76The system shall report an error when a required coupling parameter is missing.

    Specification(s): missing_required_coupled_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.77The system shall report an error when more than one preconditioner block is supplied.

    Specification(s): multi_precond_test

    Design: Problem system overview

    Issue(s): #1904

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.78The system shall abort the solve and report a floating point error when a NaN is produced during user computation with the Steady executioner.

    Specification(s): nan_no_trap_fpe_test

    Design: Problem system overview

    Issue(s): #374#3614

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.79The system shall abort the solve and report a floating point error when a NaN is produced during user computation with the Transient executioner.

    Specification(s): nan_no_trap_fpe_test_trans

    Design: Problem system overview

    Issue(s): #374#3614

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.80The system shall report an error when a nodal AuxKernel attempts to access a material property.

    Specification(s): nodal_material_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.81The system shall report an error when the same named parameter appears multiple times in the same input file.

    Specification(s): override_name_variable_test

    Design: Problem system overview

    Issue(s): #9617

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.82The system shall report an error when the coordinate transformation conflicts with the underlying element types.

    Specification(s): rz_3d_error_check_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.83The system shall report an error when nonlinear and auxiliary variables are declared with the same name.

    Specification(s): same_name_variable_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.84The system shall report an error when an AuxKernel is applied outside of the domain where a restricted variable exists.

    Specification(s): subdomain_restricted_auxkernel_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.85The system shall report an error when a Kernel is applied outside of the domain where a restricted variable exists.

    Specification(s): subdomain_restricted_kernel_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.86The system shall report a warning when an unused parameter is provided through the input file or an Action.

    Specification(s): unused_param_test

    Design: Problem system overview

    Issue(s): #709#759#4101

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.87The system shall report a warning when an unused parameter is supplied on the command line.

    Specification(s): unused_param_test_cli

    Design: Problem system overview

    Issue(s): #709#759#4101

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.88The system shall report an error when a UserObject and a Postprocessor are added with the same names.

    Specification(s): uo_pps_name_collision_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.89The system shall report and error when a UserObject and a VectorPostprocessor are added with the same names.

    Specification(s): uo_vector_pps_name_collision_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.90The system shall report an error when an input file block associated with on pluggable system is asked to build an object from a different system.

    Specification(s): wrong_object_test

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.91The system shall report a standard Unix usage statement when an invalid command line switch is used.

    Specification(s): wrong_input_switch

    Design: Problem system overview

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.92The system shall report an error when a required variable is missing from the ICs input file block.

    Specification(s): ics_missing_variable

    Design: Problem system overview

    Issue(s): #534

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.93The system shall report an error when a boundary restriction is applied to a non-nodal variable discretization.

    Specification(s): ic_bnd_for_non_nodal

    Design: Problem system overview

    Issue(s): #534

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.94The system shall report an error when coupling to old temporal solution vectors in a Steady (no time) Executioner.

    Specification(s): old_integrity_check

    Design: Problem system overview

    Issue(s): #380

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.95The system shall report an error when coupling to a time derivative solution vector in a Steady (no time) Executioner.

    Specification(s): dot_integrity_check

    Design: Problem system overview

    Issue(s): #10810

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.96The system shall report an error when an older scalar solution variable is accessed in a Steady (no time) Executioner.

    Specification(s): scalar_old_integrity_check

    Design: Problem system overview

    Issue(s): #10810

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.97The system shall report an error when an older time derivative scalar solution variable is accessed in a Steady (no time) Executioner.

    Specification(s): scalar_dot_integrity_check

    Design: Problem system overview

    Issue(s): #10810

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.98The system shall report an error when a coupled variable is not defined in the same region as the variable performing the coupling.

    Specification(s): node_value_off_block

    Design: Problem system overview

    Issue(s): #2849

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.99The system shall report the successful parsing and interpretation of input file syntax when using the "–check-input" command line flag.

    Specification(s): check_syntax_ok

    Design: Problem system overview

    Issue(s): #4437

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.100The system shall report an error when performing nodal constraints when there is a mismatch in the number of constrained nodes.

    Specification(s): check_syntax_error

    Design: Problem system overview

    Issue(s): #4437

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.101The system shall report an error when requested to check the syntax in an input file but no input file is supplied.

    Specification(s): check_syntax_no_input

    Design: Problem system overview

    Issue(s): #4437

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.102The system shall report an error when multiple time schemes are specified in the same input file.

    Specification(s): multiple_time_int_check

    Design: Problem system overview

    Issue(s): #5463

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.103The system shall report an error when there is a mismatch between the parameter for an object and the type of object are mismatched.

    Specification(s): calling_wrong_feproblem_method

    Design: Problem system overview

    Issue(s): #6383

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.104The system shall report an error when the variables representing displacement are of a lower order than the mesh.

    Specification(s): wrong_displacement_order

    Design: Problem system overview

    Issue(s): #6561

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.105The system shall report an error when the name of a function could be misinterpreted because it could also be evaluated (e.g. a function name of "x").

    Specification(s): function_conflict

    Design: Problem system overview

    Issue(s): #8412

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.106The system shall report an error when floating point input parameter types fail to parse as floating point numbers.

    Specification(s): bad_number

    Design: Problem system overview

    Issue(s): #10310

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.107The system shall report an error when a scalar variable is used where a spatial variable is expected.

    Specification(s): coupling_field_into_scalar

    Design: Problem system overview

    Issue(s): #10398

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.108The system shall report an error when a field variable is used where a scalar variable is expected.

    Specification(s): coupling_scalar_into_field

    Design: Problem system overview

    Issue(s): #10398

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.109The system shall report an error when an invalid coupled spatial variable is requested.

    Specification(s): coupling_nonexistent_field

    Design: Problem system overview

    Issue(s): #10398

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.110The system shall report an error when an invalid coupled scalar variable is requested.

    Specification(s): coupling_nonexistent_scalar

    Design: Problem system overview

    Issue(s): #10398

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.111The system shall report an error when an attempt is made to couple a variable with itself.

    Specification(s): coupling_itself

    Design: Problem system overview

    Issue(s): #10398

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.112The system shall report an error when an attempt is made to couple a variable with itself in coupled force term using automated differentiation.

    Specification(s): coupling_itself_ad

    Design: Problem system overview

    Issue(s): #18214

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.113The system shall report an error when an input file cannot be opened and read.

    Specification(s): missing_input

    Design: Problem system overview

    Issue(s): #10909

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.114The system shall report an error when a Kernel attempts to use an auxiliary variable.

    Specification(s): kernel_with_aux_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.115The system shall report an error when a boundary condition object attempts to use an auxiliary variable.

    Specification(s): bc_with_aux_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.116The system shall report an error when an AuxKernel specifies a non-existent variable.

    Specification(s): aux_kernel_with_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.117The system shall report an error when a scalar Kernel specifies a non-existent variable.

    Specification(s): scalar_kernel_with_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.118The system shall report an error when a nodal Kernel attempts to use an auxiliary variable.

    Specification(s): nodal_kernel_with_aux_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.119The system shall report an error when a constraint attempts to use an auxiliary variable.

    Specification(s): constraint_with_aux_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.120The system shall report an error when a scalar auxiliary Kernel attempts to use a solution variable.

    Specification(s): scalar_aux_kernel_with_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.121The system shall report an error when a DiracKernel attempts to use an auxiliary variable.

    Specification(s): dirac_kernel_with_aux_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.122The system shall report an error when a discontinuous Galerkin Kernel attempts to use a solution variable.

    Specification(s): dg_kernel_with_aux_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.123The system shall report an error when an interface Kernel attempts to use an auxiliary variable.

    Specification(s): interface_kernel_with_aux_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.124The system shall report an error when a Kernel attempts to retrieve an empty string variable.

    Specification(s): kernel_with_empty_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.125The system shall report an error when a vector Kernel attempts to use a scalar solution variable.

    Specification(s): vector_kernel_with_standard_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.126The system shall report an error when a Kernel attempts to use a vector solution variable.

    Specification(s): kernel_with_vector_var

    Design: Problem system overview

    Issue(s): #11039

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.127The system shall report an error if users try to get nodal values of non-nodal variables.

    Specification(s): coupled_nodal_for_non_nodal_variable

    Design: Coupleable

    Issue(s): #11623

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.128The system shall report an error if users try to get old nodal values of non-nodal variables.

    Specification(s): coupled_nodal_for_non_nodal_variable_old

    Design: Coupleable

    Issue(s): #11623

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.129The system shall report an error if users try to get older nodal values of non-nodal variables.

    Specification(s): coupled_nodal_for_non_nodal_variable_older

    Design: Coupleable

    Issue(s): #11623

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.130The system shall have an integrity check that ensures an Executioner object exists in the system.

    Specification(s): missing_executioner

    Design: Executioner System

    Issue(s): #11586

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.131The system shall report an error when nodal boundary condition is applied on a non-nodal variable.

    Specification(s): nodal_bc_on_elemental_var

    Design: NonlinearSystem

    Issue(s): #14019

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.132The system shall report an error when a git-lfs file pointer is encountered.

    Specification(s): check_git_lfs_pointer

    Design: MooseUtils Namespace

    Issue(s): #17407

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.133The system shall support the ability for actions to query the existence of a mesh attribute (meta data).

    Specification(s): check_mesh_meta_data

    Design: MeshMetaDataInterface

    Issue(s): #15987

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.134The system shall be to find data files in designated directories, regardless of the source repository or install location.

    Specification(s): exists

    Design: MooseObject

    Issue(s): #20839

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.135The system shall throw an exception if a data file cannot be found in any of the designated directories.

    Specification(s): error

    Design: MooseObject

    Issue(s): #20839

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.136The system shall support the output a processor id field for the purposes of debugging

    Specification(s): test

    Design: SetupDebugActionProcessorIDAux

    Issue(s): #16154

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.137The system shall produce a warning when non-expired deprecated code is executed.

    Specification(s): deprecated

    Design: MooseApp

    Issue(s): #10745

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.138The system shall produce a warning when expired deprecated code is executed.

    Specification(s): expired

    Design: MooseApp

    Issue(s): #10745

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.139The system shall produce an error when the –no-deprecated-flag is passed and deprecated code is executed.

    Specification(s): expired_error

    Design: MooseApp

    Issue(s): #10745

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.140The system shall produce a warning indicating a possible replacement when deprecated code is superseded.

    Specification(s): renamed

    Design: MooseApp

    Issue(s): #10745

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.141The system shall be able to deprecate coupled variable names, while enabling user code to only use the new, blessed name

    Specification(s): deprecated_coupled_var

    Design: InputParameters

    Issue(s): #15497

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.142The system shall not give a deprecation warning if the user uses the blessed coupled variable name instead of the deprecated coupled variable name.

    Specification(s): blessed_coupled_var

    Design: InputParameters

    Issue(s): #15497

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.143The system allow coupling between variables on or off displaced meshes
    1. not using automatic differentiation methods
    2. using automatic differentiation methods

    Specification(s): g/nonad, g/ad

    Design: MooseApp

    Issue(s): #9659

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.144The system shall support throwing an exception during the residual calculation, which will cut back the time step.

    Specification(s): parallel_exception_residual_transient

    Design: MooseException

    Issue(s): #3777#9181

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.145The system shall support throwing an exception during the residual calculation on a non-zero rank, which will cut back the time step.

    Specification(s): parallel_exception_residual_transient_non_zero_rank

    Design: MooseException

    Issue(s): #3777#9181

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.32.144

  • 11.32.146The system shall support throwing an exception during the Jacboain calculation, which will cut back the time step.

    Specification(s): parallel_exception_jacobian_transient

    Design: MooseException

    Issue(s): #3777#9181

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.147The system shall support throwing an exception during the Jacobian calculation on a non-zero rank, which will cut back the time step.

    Specification(s): parallel_exception_jacobian_transient_non_zero_rank

    Design: MooseException

    Issue(s): #3777#9181

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.32.146

  • 11.32.148The system shall support throwing an exception during the initial condition calculation, which will terminate the solve.

    Specification(s): parallel_exception_initial_condition

    Design: MooseException

    Issue(s): #3777#9181

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.149The system shall support throwing an error during a residual calculation, which will terminate the solve.

    Specification(s): parallel_error_residual_transient_non_zero_rank

    Design: MooseException

    Issue(s): #3777#9181

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.150The system shall support throwing an error during a Jacobian calculation, which will terminate the solve.

    Specification(s): parallel_error_jacobian_transient_non_zero_rank

    Design: MooseException

    Issue(s): #3777#9181

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.151The system shall allow users to skip exception checks to avoid global communication.

    Specification(s): skip_exception_check

    Design: MooseException

    Issue(s): #3777#9181

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.152The system shall maintain a flag available for inspection indicating the current "execution stage" enumeration.

    Specification(s): test

    Design: SetupInterface (execute_on)

    Issue(s): #8610

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.153The hit find command shall be able to find
    1. files with specific parameters,
    2. files not containing a specified parameter,
    3. parameters set to an exact specified value,
    4. parameters not set to an exact specified value,
    5. parameters with additional pattern constraints,
    6. parameters with additional inverted pattern constraints.

    Specification(s): find/parameter_exists, find/parameter_does_not_exist, find/positive_pattern, find/negative_pattern, find/additional_pattern, find/additional_pattern_negative

    Design: The hit command

    Issue(s): #19001

    Collection(s): FUNCTIONAL

    Type(s): RunCommand

  • 11.32.154The hit merge command shall be able to combine input files.

    Specification(s): merge

    Design: The hit command

    Issue(s): #19001

    Collection(s): FUNCTIONAL

    Type(s): RunCommand

  • 11.32.155The hit diff command shall be able to
    1. show differences between input files,
    2. show differences between input files marked up using terminal colors,
    3. show differences between input files with verbose explanations,
    4. show differences between input files with verbose explanations marked up using terminal colors,
    5. show common parameters/value pairs between input files,

    Specification(s): diff/vanilla, diff/color, diff/verbose, diff/verbose_color, diff/common

    Design: The hit command

    Issue(s): #19001

    Collection(s): FUNCTIONAL

    Type(s): RunCommand

  • 11.32.156The system shall verify equality among the current, old, and older solution vectors prior to running the simulation.

    Specification(s): equal_solutions

    Design: ICs System

    Issue(s): #1396

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.157The system shall support a testing mechanism that fails intermittently.

    Specification(s): intermittent_failure

    Design: Framework Software Test Plan

    Issue(s): #13334

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.158We shall be able the scrape the DOFMapOutput and determine when the Jacobian is slightly off

    Specification(s): simple

    Design: Assembly

    Issue(s): #4182

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

  • 11.32.159We shall be able the scrape the DOFMapOutput and determine when the Jacobian is questionable

    Specification(s): med

    Design: Assembly

    Issue(s): #4182

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

  • 11.32.160We shall throw no errors if the off-diagonal Jacobian is wrong if we are only testing the on-diagonal Jacobian

    Specification(s): offdiag

    Design: Assembly

    Issue(s): #6624

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

  • 11.32.161If use_displaced_mesh = false then MOOSE will not throw an exception if elements are inverted to produce a negative element Jacobian, in 3D simulations

    Specification(s): no_negative_jacobian

    Design: Assembly

    Issue(s): #9740

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.162A 3D simulation shall throw an exception if there is a zero element Jacobian, when use_displaced_mesh = true

    Specification(s): jacobian_zero

    Design: Assembly

    Issue(s): #9740

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

    Prerequisite(s): 11.32.161

  • 11.32.163A 3D simulation shall throw an exception if there is a negative element Jacobian, when use_displaced_mesh = true

    Specification(s): jacobian_negative

    Design: Assembly

    Issue(s): #9740

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

    Prerequisite(s): 11.32.161

  • 11.32.164If use_displaced_mesh = false then MOOSE will not throw an exception if elements are inverted to produce a negative element Jacobian, in 2D simulations

    Specification(s): no_negative_jacobian_2D

    Design: Assembly

    Issue(s): #9740#10229

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.165If use_displaced_mesh = false then MOOSE will not throw an exception if elements are distored to produce a zero element Jacobian, in 2D simulations

    Specification(s): zero_jacobian_2D_ok

    Design: Assembly

    Issue(s): #9740#10229

    Collection(s): FUNCTIONAL

    Type(s): RunApp

    Prerequisite(s): 11.32.164

  • 11.32.166A 2D simulation shall throw an exception if there is a zero element Jacobian, when use_displaced_mesh = true

    Specification(s): jacobian_zero_2D

    Design: Assembly

    Issue(s): #9740#10229

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

    Prerequisite(s): 11.32.165

  • 11.32.167The PETSc Jacobian test shall reveal nans if there are nans in the matrix

    Specification(s): inf_nan

    Design: Assembly

    Issue(s): #10788

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.32.168The system shall support embedding a 1D block inside of a 3D block.

    Specification(s): test

    Design: Mesh System

    Issue(s): #3990

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.169The maximum number of degrees of freedom for a single variable on a 1D EDGE2 elem shall be 2

    Specification(s): 1d

    Design: MaxVarNDofsPerElem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.170The maximum number of degrees of freedom for a single variable on a 2D QUAD4 elem shall be 4

    Specification(s): 2d

    Design: MaxVarNDofsPerElem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.171The maximum number of degrees of freedom for a single variable on a 2D QUAD9 elem shall be 9

    Specification(s): 2d_high_order

    Design: MaxVarNDofsPerElem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.172The maximum number of degrees of freedom for a single variable on a 2D TRI3 elem shall be 3

    Specification(s): triangles

    Design: MaxVarNDofsPerElem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.173The maximum number of degrees of freedom for a single variable on a 2D TRI6 elem shall be 6

    Specification(s): triangles_high_order

    Design: MaxVarNDofsPerElem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.174The maximum number of degrees of freedom for a single variable on a 3D HEX8 elem shall be 8

    Specification(s): 3d

    Design: MaxVarNDofsPerElem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.175The testing system shall support the ability to disable geometrical mapping of mesh elements for comparison purposes.

    Specification(s): test

    Design: Framework Software Test Plan

    Issue(s): #6011

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.176The system shall use the default PETSc option database in the master app to handle system-level PETSc parameters

    Specification(s): test_options_not_left

    Design: FEProblem

    Issue(s): #15129

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.177The system shall print an understandable message when a user-specified path/file does not exist.

    Specification(s): except01

    Design: Parser

    Issue(s): #15718

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.178The system shall be capable of storing residual contributions as an auxiliary field variable for
    1. continuous Galerkin and
    2. discontinuous Galerkin methods.

    Specification(s): save_in/cg, save_in/dg

    Design: Kernels System

    Issue(s): 4cb5e2a9f87973dba738584db39f7db935b65ce5

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.179The system shall error if the residual calculation contribution is assigned to the incorrect variable for
    1. on-diagonal and
    2. off-diagonal terms.

    Specification(s): error/test_soln_var_err, error/test_diag_sol_var_err

    Design: Kernels System

    Issue(s): 4cb5e2a9f87973dba738584db39f7db935b65ce5

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.32.180The system shall be able to compute the same value for a block-restricted save-in variable regardless of the number of processes used to run a simulation.

    Specification(s): block-restricted-save-in

    Design: Kernels System

    Issue(s): #12239

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.181The system shall only reinitialize variables values that are consumed by other active objects in the system.

    Specification(s): test

    Design: FEProblemBase

    Issue(s): #1386#18777

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.182The system shall make a serialized solution vector available when requested by objects in the system.

    Specification(s): test

    Design: SystemBase

    Issue(s): #4490

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.183The system shall make a serialized solution vector available when requested by objects in the system when uniform refinement is active.

    Specification(s): uniform_refine

    Design: SystemBase

    Issue(s): #4490

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.184The system shall make a serialized solution vector available when requested by objects in the system when adaptivity is active.

    Specification(s): adapt

    Design: SystemBase

    Issue(s): #4490

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.185The test system shall have the ability to execute a specific input file.

    Specification(s): execute

    Design: Framework Software Test Plan

    Issue(s): #7215

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.186The test system shall have the ability to run a test that neither clears expected outputs or runs the expected executeable for multiple output testing.

    Specification(s): dont

    Design: Framework Software Test Plan

    Issue(s): #7215

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.32.185

  • 11.32.187The system shall support pausing execution for the purpose of attaching a debugger after launch.

    Specification(s): test

    Design: MooseApp

    Issue(s): #11166

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.188The system shall support running a user-defined subroutine each time a subdomain change occurs when iterating over the mesh.

    Specification(s): test

    Design: SetupInterface (execute_on)

    Issue(s): #9474

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.32.189The application executable shall report the version with the –version command line argument.

    Specification(s): print_version_long

    Design: MooseApp

    Issue(s): #10163

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.32.190The application executable shall report the version with the -v command line argument.

    Specification(s): print_version_short

    Design: MooseApp

    Issue(s): #10163

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • rdg: Mortar
  • 11.33.1The system shall support the use of constrains using the mortar method in 1D.

    Specification(s): test

    Design: NodalEqualValueConstraintOneDEqualValueConstraintBC

    Issue(s): #4211

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.2We shall be able to enforce periodic boundary conditions on 3d domains using mortar constraints.

    Specification(s): 3d_periodic_mortar

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.3The system shall be able to compute the gap between secondary and primary bodies using the mortar method and auxiliary kernels
    1. when the gap auxiliary variable and mesh are both first order
    2. when the gap auxiliary variable is first order and the mesh is second order
    3. when the gap auxiliary variable and mesh are both second order

    Specification(s): gap/first_order, gap/mismatched_order, gap/second_order

    Design: WeightedGapAux

    Issue(s): #20001

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.4The system shall be able to run mortar auxiliary kernels when no constraints are present in the simulation.

    Specification(s): no_constraint

    Design: WeightedGapAux

    Issue(s): #20214

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.33.5We shall be able to enforce solution continuity on a conforming mesh for one variable

    Specification(s): conforming

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.6We shall be able to enforce solution gradient continuity on a conforming mesh for one variable

    Specification(s): equalgradient

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.7We shall be able to enforce solution continuity on a conforming mesh for two variables

    Specification(s): conforming_two_var

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.8We shall be able to enforce solution continuity on a conforming mesh for one variable using second order shape functions for both primal and lagrange variables. Note that this may be a relatively unstable discretization

    Specification(s): conforming-2nd-order

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.9We shall be able to produce the expected result for a solution continuity test case using the mortar method, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): soln-continuity

    Design: Constraints System

    Issue(s): #13080#15215

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.10We shall be able to produce the expected result for a solution continuity test case using the first order dual basis.

    Specification(s): dual-soln-continuity

    Design: Constraints System

    Issue(s): #13080#15215

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.11We shall be able to produce the expected result for a solution continuity test case using the second order dual basis.

    Specification(s): dual-soln-continuity-2nd-order

    Design: Constraints System

    Issue(s): #13080#15215

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.12We shall be able to produce the expected result for a fine mesh solution continuity test case using the mortar method, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): soln-continuity-fine

    Design: Constraints System

    Issue(s): #13080#15215

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.13The Jacobian for the solution continuity test case shall be perfect

    Specification(s): soln-continuity-jac

    Design: Constraints System

    Issue(s): #13080#15215

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

    Prerequisite(s): 11.33.9

  • 11.33.14The system shall be able to prolong and restrict stateful material properties because of mesh adaptivity in the presense of lower dimensional subdomains that do not have materials and when stateful properties are needed on boundaries (because of integrated boundary conditions)

    Specification(s): sequencing-stateful-soln-continuity

    Design: Constraints System

    Issue(s): #13080#15215

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.15We shall be able to produce the expected result for a solution continuity test case with the first order dual basis using VCP.

    Specification(s): vcp

    Design: Constraints System

    Issue(s): #13080#15215

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.16We shall be able to produce the expected result for a solution continuity test case with the second order dual basis using VCP.

    Specification(s): vcp-2nd-order

    Design: Constraints System

    Issue(s): #13080#15215

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.17The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a HEX8 mesh with curved geometry, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): continuity_sphere_hex8

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.18The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a HEX27 mesh with curved geometry, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): continuity_sphere_hex27

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.19The system shall generate a debug mortar mesh the parameter debug_mesh is passed to a mortar constraint

    Specification(s): continuity_sphere_hex27-debug-mesh

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.20The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a TET4 conforming mesh, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): continuity_tet4

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.21The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a TET10 conforming mesh, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): continuity_tet10

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.22The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a TET4 non-conforming mesh, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): continuity_nonconforming_tet

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.23The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a mesh with mixed element types, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): continuity_mixed

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.24The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a HEX20 mesh with curved geometry, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): continuity_sphere_hex20

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.25The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1 for a mortar solution continuity problem with conforming and non-conforming (HEX8) geometric discretization when using a first order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.

    Specification(s): p1p0

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.26The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 2 for a mortar solution continuity problem with conforming and non-conforming (HEX8) geometric discretization when using a first order basis for the temperature variable and a first order basis for the Lagrange multiplier.

    Specification(s): p1p1

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.27The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1.5 for a mortar solution continuity problem with conforming and non-conforming (HEX8) geometric discretization when using a first order basis for the temperature variable and a first order dual basis for the Lagrange multiplier.

    Specification(s): p1p1dual

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.28The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 1 for a mortar solution continuity problem with conforming and non-conforming (HEX27) geometric discretization when using a second order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.

    Specification(s): p2p0

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.29The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 2 for a mortar solution continuity problem with conforming and non-conforming (HEX27) geometric discretization when using a second order basis for the temperature variable and a first order basis for the Lagrange multiplier.

    Specification(s): p2p1

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.30The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 3 for a mortar solution continuity problem with conforming and non-conforming (HEX27) geometric discretization when using a second order basis for the temperature variable and a second order basis for the Lagrange multiplier.

    Specification(s): p2p2

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.31The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 3 for a mortar gap-conductance problem with equal, coarse-secondary, and coarse-primary geometric discretizations when using a second order basis for the temperature variable and a second order basis for the Lagrange multiplier.

    Specification(s): p2p2

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.32The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 2 for a mortar gap-conductance problem with equal, coarse-secondary, and coarse-primary geometric discretizations when using a second order basis for the temperature variable and a first order basis for the Lagrange multiplier.

    Specification(s): p2p1

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.33The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1 for a mortar gap-conductance problem with equal, coarse-secondary, and coarse-primary geometric discretizations when using a second order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.

    Specification(s): p2p0

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.34The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 2 for a mortar gap-conductance problem with equal, coarse-secondary, and coarse-primary geometric discretizations when using a first order basis for the temperature variable and a first order basis for the Lagrange multiplier.

    Specification(s): p1p1

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.35The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1 for a mortar gap-conductance problem with equal, coarse-secondary, and coarse-primary geometric discretizations when using a first order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.

    Specification(s): p1p0

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.36The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 3 for a mortar solution continuity problem with an equal geometric discretization when using a second order basis for the temperature variable and a second order basis for the Lagrange multiplier.

    Specification(s): p2p2

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.37The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 2 for a mortar solution continuity problem with an equal geometric discretization when using a second order basis for the temperature variable and a first order basis for the Lagrange multiplier.

    Specification(s): p2p1

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.38The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1 for a mortar solution continuity problem with an equal geometric discretization when using a second order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.

    Specification(s): p2p0

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.39The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 2 for a mortar solution continuity problem with an equal geometric discretization when using a first order basis for the temperature variable and a first order basis for the Lagrange multiplier.

    Specification(s): p1p1

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.40The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1 for a mortar solution continuity problem with an equal geometric discretization when using a first order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.

    Specification(s): p1p0

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.33.41We shall be able to couple variables between boundary auxiliary kernels and mortar constraints.

    Specification(s): gap-conductance-bnd-aux-kernel

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.42We shall be able to use boundary-restricted material properties in mortar constraints.

    Specification(s): gap-conductance-bnd-material

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.43We shall be able to do gap conductance on a dynamic mesh using auxiliary displacements

    Specification(s): dynnamic_mortar_gap_conductance

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.44The Jacobian for the dynamic aux displacement gap conductance test case shall be perfect

    Specification(s): dynamic_gap_jacobian

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

    Prerequisite(s): 11.33.43

  • 11.33.45We shall be able to do gap conductance on a dynamic mesh using auxiliary displacements on a fine mesh

    Specification(s): dynamic_gap_conductance_fine

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.46We shall generate the exact expected analytic solution for the gap conductance problem

    Specification(s): linear_exact_verification

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.47We shall be able to produce the expected result for a gap conductance test case using the mortar method. Specifically, this test yields lagrange multipliers that are correctly proportional to the delta of temperature across the gap, e.g. the heat flux

    Specification(s): real_mortar_gap_conductance

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.48The Jacobian for the gap conductance test case shall be perfect

    Specification(s): gap_jacobian

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

    Prerequisite(s): 11.33.47

  • 11.33.49We shall be able to produce the expected result for a gap conductance test case using the mortar method on a fine mesh. Specifically, this test yields lagrange multipliers that are correctly proportional to the delta of temperature across the gap, e.g. the heat flux

    Specification(s): gap_conductance_fine

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.50The system shall give access to the locations in physical space of mortar segment element quadrature points.

    Specification(s): exo

    Design: Constraints System

    Issue(s): #16177

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.51The system shall compute an exact Jacobian for a simulation involving the physical space location of mortar quadrature points.

    Specification(s): jac

    Design: Constraints System

    Issue(s): #16177

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.33.52We shall be able to enforce periodic boundary conditions on a non-uniform mesh using the mortar method

    Specification(s): exo

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.33.53The Jacobian for mortar enforcement of periodic boundary conditions shall be perfect

    Specification(s): jac

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • rdg: Nodalkernels
  • 11.35.1The system shall include ability to include contributions to the residual nodes of a finite element mesh
    1. on a single and
    2. multiple threads.

    Specification(s): group/test, group/threaded

    Design: NodalKernels System

    Issue(s): #3029

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.35.2The system shall be able to enforce a lower bound on a variable using nodal NCP, nodal application of resultant forces,
    1. have no oscillations in the solution, and
    2. have a non-singular matrix

    Specification(s): lower_bound/exo, lower_bound/non_singular

    Design: LowerBoundNodalKernel

    Issue(s): #2999

    Collection(s): FUNCTIONAL

    Type(s): RunAppExodiff

  • 11.35.3The system shall be able to enforce an upper bound on a variable using nodal NCP, nodal application of resultant forces,
    1. have no oscillations in the solution, and
    2. have a non-singular matrix

    Specification(s): upper_bound/exo, upper_bound/non_singular

    Design: UpperBoundNodalKernel

    Issue(s): #2999

    Collection(s): FUNCTIONAL

    Type(s): RunAppExodiff

  • 11.35.4The system shall be able to enforce an upper and lower bound on a variable using nodal NCP, nodal application of resultant forces,
    1. have no oscillations in the solution, and
    2. work with automatic differentiation, and
    3. have a non-singular matrix, and
    4. be incompataible with algebraic multigrid

    Specification(s): upper_and_lower_bound/exo, upper_and_lower_bound/ad_exo, upper_and_lower_bound/non_singular, upper_and_lower_bound/amg_fail

    Design: UpperBoundNodalKernel

    Issue(s): #2999

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunExceptionRunAppExodiff

  • 11.35.5The system shall be able to enforce an upper and lower bound on a variable using a variational inequality
    1. reduced space active set solver, which
    2. is compatible with algebraic multigrid, and
    3. a semi-smooth solver, which
    4. is also compatible with algebraic multigrid
    5. The reduced space active set method shall work with a matrix-free approximation of the Jacobian, and the function evaluations corresponding to the nonlinear residual and the base for finite-differencing shall be equivalent.

    Specification(s): vi/rsls, vi/rsls_amg, vi/ssls, vi/ssls_amg, vi/rsls_pjfnk

    Design: ConstantBoundsAux

    Issue(s): #2999

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.35.6The system shall show violation of bounds when a non-variational-inequality solver is used

    Specification(s): unbounded

    Design: ConstantBoundsAux

    Issue(s): #2999

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.35.7The system shall support the use of Crank-Nicolson time integration scheme.

    Specification(s): test

    Design: TimeIntegrator System

    Issue(s): #3029#5883#5949

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.35.8The system shall include ability to include contributions to the residual nodes of a finite element mesh using an LU preconditioner.

    Specification(s): test

    Design: NodalKernels System

    Issue(s): #3029#10620

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.35.9The system shall include ability to include contributions to the residual nodes of a finite element mesh and compute the correct Jacobian terms for
    1. subdomain and
    2. boundary restricted terms.

    Specification(s): group/block_jacobian_test, group/bc_jacobian_test

    Design: NodalKernels System

    Issue(s): #3029#10620

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.35.10The system shall not duplicate computation of kernels on a node that is shared between two subdomains.

    Specification(s): exo

    Design: NodalKernels System

    Issue(s): #16265

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.35.11The system shall support the application of Dirichlet type boundary conditions using the penalty method for nodesets.

    Specification(s): test

    Design: PenaltyDirichletNodalKernel

    Issue(s): #14092

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.35.12The system shall apply scaling to residuals and Jacobians for volumetric PDE terms applied at nodes

    Specification(s): scaling

    Design: NonlinearSystem

    Issue(s): #12601

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Outputs
  • 11.36.1The system shall support the ability to append the date to output filenames.

    Specification(s): test

    Design: FileOutput

    Issue(s): #6001

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.2The system shall support outputting of checkpoint files:
    1. at a specific interval while only maintaining a specified number of recent files and
    2. be capable of restarting a simulation from previously exported data at this interval.

    Specification(s): interval/test_files, interval/test_recover

    Design: Checkpoint

    Issue(s): #1927#2395

    Collection(s): FUNCTIONAL

    Type(s): ExodiffCheckFiles

  • 11.36.3The system shall support outputting of checkpoint files, using a simplified input format:
    1. at every timestep while maintaining the most recent two files and
    2. be capable of restarting a simulation from the output data.

    Specification(s): default/recover_half_transient, default/recover

    Design: Checkpoint

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): ExodiffCheckFiles

  • 11.36.4The system shall support outputting of checkpoint files, using a complete input block:
    1. at every timestep while maintaining the most recent two files and
    2. be capable of restarting a simulation from the output data.

    Specification(s): block/recover_with_checkpoint_block_half_transient, block/recover_with_checkpoint_block

    Design: Checkpoint

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): ExodiffCheckFiles

  • 11.36.5The system shall support outputting of simulation data using the ExodusII format using simplified input file syntax.

    Specification(s): exodus

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.6The system shall by default display data on the console from:
    1. the Postprocessor system and
    2. the scalar variable system.

    Specification(s): console/postprocessors, console/scalar_variables

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.7The system shall output a running list of coupling iteration residual norms during multiapp coupling iterations.

    Specification(s): picard_norm_output

    Design: TransientMultiApp

    Issue(s): #12708

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.8The system shall only output the coupling iteration residual TIMESTEP_BEGIN norms when there are no TIMESTEP_END Multiapps.

    Specification(s): ts_begin_multi_output

    Design: TransientMultiApp

    Issue(s): #12708

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.9The system shall only output the coupling iteration TIMESTEP_END norms when there are no TIMESTEP_BEGIN Multiapps.

    Specification(s): ts_end_multi_output

    Design: TransientMultiApp

    Issue(s): #12708

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.10The system shall output the coupling iteration residual norm for TIMESTEP_BEGIN and TIMESTEP_END Multiapps when both exist in the simulation.

    Specification(s): ts_both_multi_output

    Design: TransientMultiApp

    Issue(s): #12708

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.11The system shall run a simulation without producing any file-based output.

    Specification(s): no_outputs_block

    Design: Console

    Issue(s): #3320

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.12The system shall support outputting table based Postprocessor data.

    Specification(s): postprocessors

    Design: Console

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.13The system shall output Scalar Variables on the console in a table to the screen.

    Specification(s): scalar_variables

    Design: Console

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.14The system shall warning when multiple console outputs attempt to write to the screen simultaneously.

    Specification(s): warning

    Design: Console

    Issue(s): #3286

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.15The system shall support outputting console information to a file.

    Specification(s): file_system_information

    Design: Console

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.16The system shall output Scalar Variables on the console in a table to a file.

    Specification(s): file_postprocessor

    Design: Console

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.17The system shall support outputting Scalar Variables to a file.

    Specification(s): file_scalar_aux

    Design: Console

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.18The system shall support writing the console solve log to an output file.

    Specification(s): file_solve_log

    Design: Console

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.19The system shall support writing norms to the console for each nonlinear variable in the simulation.

    Specification(s): norms

    Design: Console

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.20The system shall output a Performance log based on a command line flag.

    Specification(s): timing

    Design: Console

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.21The system shall support writing negative time information in the console.

    Specification(s): transient

    Design: Console

    Issue(s): #1927#2728

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.22The system shall support outputting the Performance Log at user specified intervals.

    Specification(s): transient_perf_int

    Design: Console

    Issue(s): #1927#2728

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.23The system shall support writing to a buffered console object from every MooseObject-derived object.

    Specification(s): _console

    Design: Console

    Issue(s): #3286

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.24The system shall support writing to a buffered console object from const methods in MooseObject-derived objects.

    Specification(s): _console_const

    Design: Console

    Issue(s): #3286

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.25The system shall support outputting a transformed input file to the screen.

    Specification(s): input_output

    Design: Console

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.26The system shall support disabling the linear residual output.

    Specification(s): print_linear_residuals_disable

    Design: Console

    Issue(s): #4497

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.27The system shall output a Performance Log based on a single input file parameter.

    Specification(s): perf_graph

    Design: Console

    Issue(s): #4497

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.28The system shall override Performance Log output when conflicting values appear on the command line and input file.

    Specification(s): perf_graph_disable

    Design: Console

    Issue(s): #4497

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.29The system shall support adding an additional output time option without clobbering existing default options.

    Specification(s): additional_output_on

    Design: Console

    Issue(s): #4497

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.30The system shall output a "final" label at the end of the simulation before additional screen output occurs.

    Specification(s): console_final

    Design: Console

    Issue(s): #5756

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.31The system shall error when specifying an invalid table fit width option.

    Specification(s): console_fit_width_error

    Design: Console

    Issue(s): #1927

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.32The system shall support the output of postprocessors and scalars to CSV files for steady state problems.

    Specification(s): steady

    Design: Output SystemCSV

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.33The system shall support the output of postprocessors and scalars to CSV files for transient propblems.

    Specification(s): transient

    Design: Output SystemCSV

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.34The system shall support the output of postprocessors and scalars to CSV files for transient problems without a time column.

    Specification(s): no_time

    Design: Output SystemCSV

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.35The system shall support the output of postprocessors and scalars to Exodus files for transient problems.

    Specification(s): transient_exodus

    Design: Output SystemCSV

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.36.2111.36.33

  • 11.36.36The system shall support the output of CSV data:
    1. with checkpoint enabled and
    2. when restarted creates a new output file or
    3. optionally appends the existing file from the first part.

    Specification(s): restart/restart_part1, restart/restart_part2, restart/restart_part2_append

    Design: Output SystemCSV

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.37The system shall support CSV output aligned columns and a custom delimiter.

    Specification(s): align

    Design: Output SystemCSV

    Issue(s): #3229

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.38The system shall support CSV output to the console that is sorted by the variable name.

    Specification(s): sort

    Design: Output SystemCSV

    Issue(s): #8974

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.39The CSV output object shall create a symlink to the final output with with a '_FINAL' suffix for VectorPostprocessor data when there are execute flags in addition to FINAL.

    Specification(s): final

    Design: VectorPostprocessors SystemCSV

    Issue(s): #11087

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.40The CSV output object shall create a symlink to the final output with with a '_FINAL' suffix for VectorPostprocessor data when the execute flag is set to FINAL.

    Specification(s): final_only

    Design: VectorPostprocessors SystemCSV

    Issue(s): #11087

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

    Prerequisite(s): 11.36.39

  • 11.36.41The CSV output object 'create_final_symlink' parameter shall be able to disable the creation of the final symlink.

    Specification(s): no_link

    Design: VectorPostprocessors SystemCSV

    Issue(s): #11087

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

    Prerequisite(s): 11.36.40

  • 11.36.42The CSV output object shall create a symlink to the most recent output with with a '_LATEST' suffix for VectorPostprocessor data.

    Specification(s): latest

    Design: VectorPostprocessors SystemCSV

    Issue(s): #11087

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.43The CSV output object 'create_latest_symlink' parameter shall be able to disable the creation of the latest symlink.

    Specification(s): no_latest

    Design: VectorPostprocessors SystemCSV

    Issue(s): #11087

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

    Prerequisite(s): 11.36.42

  • 11.36.44The system shall be include the ability to display variable residual norms.

    Specification(s): show_var_residual_norms

    Design: VariableResidualNormsDebugOutput

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.45The system shall include debug syntax that includes the ability to enable variable residual norm output.

    Specification(s): show_var_residual_norms_debug

    Design: VariableResidualNormsDebugOutputDebug System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.46The system shall be include the ability to display material property information.

    Specification(s): show_material_props

    Design: MaterialPropertyDebugOutput

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.47The system shall include debug syntax that includes the ability to enable material property information output.

    Specification(s): show_material_props_block

    Design: MaterialPropertyDebugOutputDebug System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.48The system shall be include the ability to display residual information for variables.

    Specification(s): show_top_residuals

    Design: TopResidualDebugOutput

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.49The system shall include debug syntax that includes the ability to enable variable residual information.

    Specification(s): show_top_residuals_debug

    Design: TopResidualDebugOutputDebug System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.50The system shall be include the ability to display residual information for variables that is limited to non-linear iterations.

    Specification(s): show_top_residuals_nonlinear_only

    Design: TopResidualDebugOutput

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.51The system shall be include the ability to display residual information for scalar variables.

    Specification(s): show_top_residuals_scalar

    Design: TopResidualDebugOutput

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.52The system shall include debug syntax that includes material property consumption information.

    Specification(s): show_material_properties_consumed

    Design: MaterialPropertyDebugOutputDebug System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.53The system shall be able to output the displaced mesh for a model with adaptive mesh refinement.

    Specification(s): use_displaced

    Design: Output SystemAdaptivity System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.54If the user requested the output of a displaced problem and there is none present, the system shall fallback to using the non-displaced problem.

    Specification(s): non_displaced_fallback

    Design: Output System

    Issue(s): #11309

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.55If the user asks for no displaced mesh to be created, even though displacements are provided in the mesh block, the system shall not create a displaced mesh

    Specification(s): mesh_use_displaced_mesh_false

    Design: Mesh System

    Issue(s): #12580

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

    Prerequisite(s): 11.36.54

  • 11.36.56The Output system shall be capable of applying displacements directly to the outputted mesh for steady problems.

    Specification(s): test

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.57The Output system shall be capable of applying displacements directly to the outputted mesh for transient problems with Kernels using the displaced configuration.

    Specification(s): displaced_eq_test

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.58The Output system shall be capable of applying displacements directly to the outputted mesh for transient problems.

    Specification(s): displacement_transient_test

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.59The system shall support the ability to output the degree-of-freedom information:
    1. to a json file,
    2. to the screen,
    3. with uniform refinement, and
    4. with transient adaptivity.

    Specification(s): group/simple, group/simple_screen, group/uniform_refine, group/transient

    Design: DOFMap

    Issue(s): #3847

    Collection(s): FUNCTIONAL

    Type(s): RunAppCheckFiles

  • 11.36.60The system shall error when two outputs with the same name are created.

    Specification(s): duplicate_objects

    Design: Output System

    Issue(s): #1927

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.61The system shall error when two outputs produce a file with the same name.

    Specification(s): duplicate_output_files

    Design: Output System

    Issue(s): #1927

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.62The system shall reserve names for output objects:
    1. "none" and
    2. "all."

    Specification(s): reserved/none_reserved, reserved/all_reserved

    Design: Output System

    Issue(s): #1927

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.63The system shall support ExodusII output.

    Specification(s): basic

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.64The system ExodusII output shall not use HDF5 unless requested.

    Specification(s): hdf5

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunCommand

    Prerequisite(s): 11.36.6311.36.12211.36.12411.36.162

  • 11.36.65The system shall support including the executed input file within the ExodusII output.

    Specification(s): input

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.66The system shall support inclusion of initial condition data within the ExodusII output.

    Specification(s): enable_initial

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.67The system shall support writing non-linear, auxililary, scalar, and postprocessor variables to ExodusII format.

    Specification(s): output_all

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.68The system shall support the exclusion of non-linear, scalar, and postprocessor variables from ExodusII output.

    Specification(s): hide_output

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.69The system shall error if the supplied names for including or excluding variables is invalid.

    Specification(s): invalid_hide

    Design: Exodus

    Issue(s): #1927

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.70The system shall support outputting elemental and scalar variables as nodal variables within ExodusII output.

    Specification(s): nodal_output

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.71The system shall support outputting discontinuous finite element types with the ExodusII format.

    Specification(s): discontinuous

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.72The system shall support Nemesis output.

    Specification(s): nemesis_out_test

    Design: Nemesis

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.73The system shall support GMV output.

    Specification(s): gmv_out_test

    Design: GMV

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.74The system shall be able to dump YAML data.

    Specification(s): yaml_dump_test

    Design: YAMLFormatter

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.75The system shall only give Executioner output once.

    Specification(s): no_double_executioner_output

    Design: YAMLFormatter

    Issue(s): #2855

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.76The system shall support Tecplot output.

    Specification(s): tecplot_out_test

    Design: Tecplot

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.77If the Tecplot API is available, the system shall support Tecplot output given in Tecplot binary format.

    Specification(s): tecplot_bin_test

    Design: Tecplot

    Issue(s): #3403

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.78If the Tecplot API is not available, the system shall support Tecplot output given in ASCII format.

    Specification(s): tecplot_bin_test_override

    Design: Tecplot

    Issue(s): #3403

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.79The system shall be able to generate gnuplot PostScript output.

    Specification(s): gnuplot_ps_out_test

    Design: Gnuplot

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.80The system shall be able to generate gnuplot PNG output.

    Specification(s): gnuplot_png_out_test

    Design: Gnuplot

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.81The system shall be able to generate gnuplot GIF output.

    Specification(s): gnuplot_gif_out_test

    Design: Gnuplot

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.82If a postprocessor utilizes the "outputs" parameter, but postprocessor output is disabled for the console object, the system shall warn the user.

    Specification(s): pps_screen_out_warn_test

    Design: Output System

    Issue(s): #1426

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.83The system shall print parameters when the --show-input flag is used on the command line.

    Specification(s): show_input_test

    Design: MooseApp

    Issue(s): #1404#1131

    Collection(s): FUNCTIONAL

    Type(s): RunApp

    Prerequisite(s): 11.36.73

  • 11.36.84Solution history output shall work

    Specification(s): sln_out_test

    Design: SolutionHistory

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.85The system shall support XDR output.

    Specification(s): xdr_output

    Design: XDA/XDR

    Issue(s): #2243

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.86The system shall be able to dump input file syntax in JSON format.

    Specification(s): json_full

    Design: JsonInputFileFormatterMooseApp

    Issue(s): #7855#7661#2881#10839#12455

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.36.87The system shall be able to dump input file syntax in JSON format and exclude test object syntax.

    Specification(s): json_no_test_objects

    Design: JsonInputFileFormatterMooseApp

    Issue(s): #7855#7661#2881#10839#12455

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.36.88The system shall be able to dump a subset of JSON formatted syntax.

    Specification(s): json_search

    Design: JsonInputFileFormatterMooseApp

    Issue(s): #7855#7661#2881#10839#12455

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.36.89The system shall dump line information along with JSON formatted syntax.

    Specification(s): json_line_info

    Design: JsonInputFileFormatterMooseApp

    Issue(s): #7855#7661#2881#10839#12455

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.36.90The system shall not include RESIDUAL and JACOBIAN template arguments in the JSON syntax format.

    Specification(s): json_no_template

    Design: JsonInputFileFormatter

    Issue(s): #12960

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.36.91The system shall be able to dump input file (HIT) syntax.

    Specification(s): hit

    Design: JsonInputFileFormatterMooseApp

    Issue(s): #7855#7661#2881#10839#12455

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.36.92The system shall be able to dump a subset of input file (HIT) syntax.

    Specification(s): hit_search

    Design: JsonInputFileFormatterMooseApp

    Issue(s): #7855#7661#2881#10839#12455

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 11.36.93The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check InputChoices

    Specification(s): definition_input_choices_test

    Design: SONDefinitionFormatter

    Issue(s): #16165

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.94The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check ChildAtLeastOne

    Specification(s): definition_childatleastone_test

    Design: SONDefinitionFormatter

    Issue(s): #9651

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.95The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check ValEnums

    Specification(s): definition_valenum_test

    Design: SONDefinitionFormatter

    Issue(s): #9651

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.96The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check active parameter

    Specification(s): definition_active_parameter_test

    Design: SONDefinitionFormatter

    Issue(s): #9651

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.97The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check normal_sub

    Specification(s): definition_normal_sub_test

    Design: SONDefinitionFormatter

    Issue(s): #9651

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.98The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check type_sub

    Specification(s): definition_type_sub_test

    Design: SONDefinitionFormatter

    Issue(s): #9651

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.99The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check default type

    Specification(s): definition_default_type_test

    Design: SONDefinitionFormatter

    Issue(s): #9651

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.100The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check MinValInc

    Specification(s): definition_minvalinc_inputdefault_test

    Design: SONDefinitionFormatter

    Issue(s): #9651

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.101The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check default types child parameter promotion

    Specification(s): definition_default_types_child_parameter_promotion_test

    Design: SONDefinitionFormatter

    Issue(s): #18639

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.102The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check default subblock_types child parameter promotion

    Specification(s): definition_default_subblock_types_child_parameter_promotion_test

    Design: SONDefinitionFormatter

    Issue(s): #18639

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.103The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check Mesh file parameter requirement removal

    Specification(s): definition_mesh_file_parameter_requirement_removal_test

    Design: SONDefinitionFormatter

    Issue(s): #18639

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.104The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check Boolean type ValEnums choices

    Specification(s): definition_boolean_type_valenum_choices_test

    Design: SONDefinitionFormatter

    Issue(s): #18639

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.105The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check beginning and ending markers

    Specification(s): definition_scraping_markers

    Design: SONDefinitionFormatter

    Issue(s): #17324

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.106The system shall support outputting data to the general mesh viewer format.

    Specification(s): test

    Design: GMV

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.107The system shall support limiting vector postrocessor data to a specific CSV output object.

    Specification(s): test

    Design: OutputInterface

    Issue(s): #1927#7511

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.108The system shall support the ability to control the output of an aggregate calculation via a parameter of the object itself.

    Specification(s): test

    Design: Reporter System

    Issue(s): #16666

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.36.109The system shall support specifying an output interval for an output input file block.

    Specification(s): time_step

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.110The system shall support specifying an output interval for all outputs.

    Specification(s): common_time_step

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.36.109

  • 11.36.111The system shall support limiting output to the final timestep of a simulation.

    Specification(s): output_final

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.112The system shall support output at specific simulation times.

    Specification(s): sync_times

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.113The system shall support multiple output objects that have different simulation synchronization times specified.

    Specification(s): multiple_sync_times

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.114The system shall support the disabling of an output object by restricting the execution settings.

    Specification(s): no_output

    Design: Output System

    Issue(s): #1927

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.115The system shall support the ability to limit output objects only at the beginning and end of a simulation.

    Specification(s): no_intermediate

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.116The system shall not output the same information multiple times when an output object is defined to operate on the end of each timestep and the final timestep.

    Specification(s): no_final_repeat

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.117The system shall support output during linear and non-linear iterations during transient simulations using the ExodusII format.

    Specification(s): exodus

    Design: Output System

    Issue(s): #2617

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.118The system shall support output during linear and non-linear iterations during steady simulations using the ExodusII format:
    1. in a single file or
    2. in a sequence of files.

    Specification(s): iterative/exodus_steady, iterative/exodus_steady_sequence

    Design: Output System

    Issue(s): #2617

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.119The system shall support output during linear and non-linear iterations during transient simulations using the VTK format.

    Specification(s): vtk

    Design: Output System

    Issue(s): #2617

    Collection(s): FUNCTIONAL

    Type(s): XMLDiff

  • 11.36.120The system shall support output during linear and non-linear iterations during transient simulations using the CSV format.

    Specification(s): csv

    Design: Output System

    Issue(s): #2617

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.121The system shall support output during linear and non-linear iterations during transient simulations:
    1. with both the start and end times defined,
    2. with only the start time defined,
    3. with the start and end timestep provided,
    4. with the start timestep given, and
    5. with the end timestep provided.

    Specification(s): start_stop/exodus_inline, start_stop/exodus_start_time, start_stop/output_step_window, start_stop/output_start_step, start_stop/output_end_step

    Design: Output System

    Issue(s): #2617

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.122The system shall support JSON output for data.

    Specification(s): basic

    Design: JSON

    Issue(s): #11323

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.123The system shall include the ability to output simulation data in JSON format:
    1. that produces multiple files for parallel distributed data and
    2. for parallel replicated data in a single file.

    Specification(s): info/default, info/limit

    Design: JSON

    Issue(s): #11323

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.124The system shall support creating unique JSON output files per timestep.

    Specification(s): basic

    Design: JSON

    Issue(s): #18133

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.36.125The system shall provide an API for retrieving an output object by type and name.

    Specification(s): getOutput

    Design: OutputWarehouse

    Issue(s): #2885

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.126The system shall provide an API for retrieving all output objects of a type.

    Specification(s): getOutputs

    Design: OutputWarehouse

    Issue(s): #2885

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.127The system shall provide an API for retrieving output objects for the given names and type.

    Specification(s): getOutputs_with_names

    Design: OutputWarehouse

    Issue(s): #2885

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.128The system shall provide an API for retrieving all output object names of a type.

    Specification(s): getOutputNames

    Design: OutputWarehouse

    Issue(s): #2885

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.129The system shall support the naming of output files based on the input file block name.

    Specification(s): default_names

    Design: OutputWarehouse

    Issue(s): #2885

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.130The Nemesis Output object shall output separate files per process for visualization purposes.

    Specification(s): test

    Design: Output System

    Issue(s): #2122

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.131The Nemesis Output object shall support writing elemental variables.

    Specification(s): nemesis_elemental_replicated

    Design: Output System

    Issue(s): #2122

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.132The Nemesis Output object shall support writing elemental variables with the same numbering on DistributedMesh.

    Specification(s): nemesis_elemental_distributed

    Design: Output System

    Issue(s): #2122

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.133The Nemesis Ouput object shall support writing scalar variables.

    Specification(s): nemesis_scalar_replicated

    Design: Output System

    Issue(s): #2122

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.134The Nemesis Ouput object shall support writing scalar variables when using DistributedMesh.

    Specification(s): nemesis_scalar_distributed

    Design: Output System

    Issue(s): #2122

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.135The system shall support the ability to specify the output dimension when outputting in ExodusII format.

    Specification(s): test

    Design: Exodus

    Issue(s): #9205

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.136The system shall support the ability to limit output to certain sub-applications based on name.

    Specification(s): dt_from_master

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.137The system shall include the ability to limit automatic output of adaptivity objects, including
    1. indicators and
    2. markers.

    Specification(s): group/indicators, group/markers

    Design: OutputInterface

    Issue(s): #3702

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.138The system shall allow the user to select different console output intervals.

    Specification(s): postprocessor

    Design: Console

    Issue(s): #4454

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.139The system shall display active output information with corresponding execute flags.

    Specification(s): show_outputs

    Design: Console

    Issue(s): #4454

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.140The system shall provide a system for outputting solution variables with a uniformly refined mesh:
    1. with a shift in output position,
    2. with a custom filename,
    3. with mesh adaptivity,
    4. with a generated mesh,
    5. with a file mesh, and
    6. with second order elements from a file mesh.

    Specification(s): group/oversample, group/oversample_filemesh, group/adapt, group/test_gen, group/test_file, group/test_first_order

    Design: Output System

    Issue(s): #1927#2646

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.141The system shall include an example demonstrating the use of oversampling.
    1. without and
    2. with mesh adaptivity.

    Specification(s): example/ex02, example/ex02_adapt

    Design: Output System

    Issue(s): #1927#2646

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.142The system shall include the ability to overwrite existing timesteps when writing ExodusII format.

    Specification(s): test

    Design: Exodus

    Issue(s): #5857

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.143The system shall output a performance log information for sub-applications
    1. that are transient,
    2. use differing time steps from the main, and
    3. execute an entire simulation.

    Specification(s): perf/with_multi, perf/with_sub_cycle, perf/with_full

    Design: PerfGraphOutput

    Issue(s): #11551#11453#12186

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.144The system shall have the ability to output a detailed performance log

    Specification(s): test

    Design: PerfGraphOutput

    Issue(s): #11551

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.145The system shall be able to produce png images:
    1. for 2D square images,
    2. arbitrary shapped domains,
    3. and complex shapes with periodic boudary conditions.

    Specification(s): image_tests/square_domain, image_tests/adv_diff_reaction, image_tests/wedge

    Design: PNGOutput (Outputs)

    Issue(s): #12846

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.146The system shall support offseting the spatial position of a domain during output.

    Specification(s): test

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.147The system shall support the ability to specify the output object for postprocessor data from within the input file block defining the postprocessor.

    Specification(s): limit

    Design: Output SystemOutputInterface

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.148The system shall error if an invalid output name is provided within the postprocessor input file block.

    Specification(s): invalid_outputs

    Design: Output SystemOutputInterface

    Issue(s): #1927

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.149The system shall support limiting postprocessor output to the screen.

    Specification(s): console

    Design: Output SystemOutputInterface

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.150The system shall support limiting postprocessor output to from within the input file syntax of an output object.

    Specification(s): show_hide

    Design: Output SystemOutputInterface

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.151The system shall error if a postprocessor variable is listed for suppression and inclusion within an output object block in the input file.

    Specification(s): test_hidden_shown

    Design: Output SystemOutputInterface

    Issue(s): #1927

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.152The system shall support limiting the output of comma seperated value data to the final timestep:
    1. for all scalar data and
    2. for postprocessor data only.

    Specification(s): group/test, group/execute_pps_on_final

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.153The system shall support the ability to output single value aggregate calculations to JSON format.

    Specification(s): test

    Design: JSON

    Issue(s): #16543

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.36.154Correctly set up initial recover files for the part2 test.

    Specification(s): part1

    Design: RestartableDataIO

    Issue(s): #2661

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.155A simulation executed using the "–recover" flag successfully runs a simulation using the specified recover file argument.

    Specification(s): part2

    Design: RestartableDataIO

    Issue(s): #2661

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.36.154

  • 11.36.156Correctly set up initial recover files for the part2_latest test.

    Specification(s): part1_latest

    Design: RestartableDataIO

    Issue(s): #10494#12403

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

    Prerequisite(s): 11.36.155

  • 11.36.157A simulation executed using the "–recover" flag with a file argument using the placeholder "LATEST" successfully runs a simulation using most recent checkpoint/recover file from the specified directory.

    Specification(s): part2_latest

    Design: RestartableDataIO

    Issue(s): #10494#12403

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.36.156

  • 11.36.158The system shall automatically output values to a comma separated (CSV) file in
    1. root/replicated mode
    2. and distributed mode.

    Specification(s): csv/root, csv/distributed

    Design: Reporter System

    Issue(s): #11323

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.36.159The system shall support the ability to output the residual norms of individual nodal variables.

    Specification(s): test

    Design: Debug System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.160The system shall support the ability to output the residual norms of individual elemental variables.

    Specification(s): elem

    Design: Debug System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.161The system shall support writing file to sub-directories.

    Specification(s): test

    Design: Output System

    Issue(s): #3249

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.162The system shall print the various components of the simulation information header to the screen

    Specification(s): basic

    Design: Output SystemConsole

    Issue(s): #2173

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.163The system shall print the mesh information to the screen when the mesh changes

    Specification(s): mesh

    Design: Output SystemConsole

    Issue(s): #2173

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.164The system shall print the auxiliary system information to the screen when the mesh changes

    Specification(s): aux

    Design: Output SystemConsole

    Issue(s): #2173

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.165The system shall print the nonlinear system information to the screen when the mesh changes

    Specification(s): nonlinear

    Design: Output SystemConsole

    Issue(s): #2173

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.36.166The system shall support writing ASCII Tecplot output.

    Specification(s): test

    Design: Tecplot

    Issue(s): #440#1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.167The system shall support appending Tecplot output files.

    Specification(s): test_append

    Design: Tecplot

    Issue(s): #440#1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.168The system shall optionally support writing binary Tecplot files.

    Specification(s): test_binary

    Design: Tecplot

    Issue(s): #440#1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.169The system shall guarantee that scalar variables are in the proper state for output when outputting:
    1. ExodusII format and
    2. CSV format.

    Specification(s): group/exodus, group/csv

    Design: OutputWarehouse

    Issue(s): #4474

    Collection(s): FUNCTIONAL

    Type(s): CSVDiffExodiff

  • 11.36.170The system shall support outputting field and scalar data to the ExodusII format.

    Specification(s): test

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.171The system shall error if a variable is marked for output and output suppression.

    Specification(s): test_hidden_shown

    Design: Output System

    Issue(s): #1927

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.172The system shall error if a variable is perscribed for output but does not exist.

    Specification(s): test_nonexistent

    Design: Output System

    Issue(s): #1927

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.36.173The system shall test that output of an auxiliary field can be disabled within the input block defining the variable.

    Specification(s): block_hide

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.174The system shall support a system for including or suppressing output variables the operates when only a single variable for each type exists.

    Specification(s): show_single_vars

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.175The system shall support a system for including or suppressing output variables.

    Specification(s): show_hide

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.176The variables specified in an Output object's 'hide = ' list shall not appear in the output file.

    Specification(s): nemesis_hide

    Design: Output System

    Issue(s): #1895

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.36.177The system shall support the ability to output vector aggregate calculations to JSON format.

    Specification(s): test

    Design: JSON

    Issue(s): #16543

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.36.178The system shall optionally support output of files using the VTK format:
    1. in serial and
    2. in parallel.

    Specification(s): files/serial, files/parallel

    Design: VTK

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.179The system shall support the output of data using native libMesh formats:
    1. in XDA (ASCII) format and
    2. in XDR (binary) format.

    Specification(s): group/xda, group/xdr

    Design: XDA/XDR

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.180The system shall support simultaneous output of the ASCII and binary forms of the libMesh native format.

    Specification(s): both_xda_and_xdr

    Design: XDA/XDR

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.36.181The system shall support XML output for vector data that is
    1. replicated or
    2. distributed in parallel.

    Specification(s): parallel/replicated, parallel/distributed

    Design: XMLOutput

    Issue(s): #14634

    Collection(s): FUNCTIONAL

    Type(s): XMLDiff

  • 11.36.182The system shall support XML output for vector data during nonlinear solve.

    Specification(s): iterations

    Design: XMLOutput

    Issue(s): #14634

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • rdg: Parser
  • 11.37.1The system shall support active/inactive parameters to selectively enable/disable subblocks within all input file blocks.

    Specification(s): inactive_active

    Design: Parser

    Issue(s): #9411#9571

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.37.2The system shall produce an error when the active parameter refers to a non-exiseant block.

    Specification(s): active_section_missing

    Design: Parser

    Issue(s): #9411#9571

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.37.3The system shall produce an error when the inactive parameter refers to a non-existent block.

    Specification(s): inactive_section_missing

    Design: Parser

    Issue(s): #9411#9571

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.37.4The system shall produce an error when both the active and inactive parameters are present in the same block.

    Specification(s): inactive_active_combo

    Design: Parser

    Issue(s): #9411#9571

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.37.5The system shall honor the active or inactive parameters at the top (root) level.

    Specification(s): top_level

    Design: Parser

    Issue(s): #9411#9571

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.37.6The system shall support the ability to override input file parameters from the command line.

    Specification(s): test

    Design: CommandLine

    Issue(s): #581

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.37.7The system shall support the ability to globally change MultiApp input file syntax from the command line.

    Specification(s): cli_override_all

    Design: CommandLine

    Issue(s): #2137

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.37.8The system shall support the ability to change a whole MultiApp's (multiple SubApps) input file syntax from the command line.

    Specification(s): cli_override_group

    Design: CommandLine

    Issue(s): #2137

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.37.9The system shall support the ability to change individual SubApp input file syntax from the command line.

    Specification(s): cli_override_single

    Design: CommandLine

    Issue(s): #2137

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.37.10The system shall produce an error when a SubApp command line override index is not valid.

    Specification(s): cli_override_error_check

    Design: CommandLine

    Issue(s): #2137

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

    Prerequisite(s): 11.37.9

  • 11.37.11The system shall output all registered objects in HIT format.

    Specification(s): hit_registry

    Design: MooseApp

    Issue(s): #10952

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.37.12The system shall output all registered objects in single line format.

    Specification(s): registry

    Design: MooseApp

    Issue(s): #10952

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.37.13The system shall report an error if the supplied input file is not formatted correctly.

    Specification(s): error

    Design: InputParameters

    Issue(s): #16410

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.37.14The system shall be able to read input file syntax and write into map parameters.

    Specification(s): test

    Design: Parser

    Issue(s): #14894

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.37.15The system shall error if a user supplies an odd number of entries, implying an unbalanced key-value set, to a map parameter.

    Specification(s): odd_entries

    Design: Parser

    Issue(s): #14894

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.37.16The system shall error if a user supplies syntax in a map parameter that cannot be cast to the requested mapped type.

    Specification(s): bad_value

    Design: Parser

    Issue(s): #14894

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.37.17The system shall support for multiple input files, which are merged into one input specification for a simulation
    1. where no parameters overlap
    2. where input files may override parameters in previous inputs
    3. while locating input errors in the correct file
    4. and inform the user of parameters from earlier files being overidden by later files

    Specification(s): merging/two_inputs, merging/three_inputs_override, merging/three_inputs_error, merging/three_inputs_override_message

    Design: Parser

    Issue(s): #17989#18221

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunExceptionRunAppExodiff

  • 11.37.18The system shall raise an error if no input files were specified after the -i option

    Specification(s): no_file

    Design: Parser

    Issue(s): #17989#18221

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.37.19The system shall support parameter substitution in input files using command line variable expressions.

    Specification(s): param_substitution_cli

    Design: Parser

    Issue(s): #5649

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.37.20The system shall support parameter substitution in input files using variable expressions from within the same input file.

    Specification(s): param_substitution_in_file

    Design: Parser

    Issue(s): #5649

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.37.19

  • 11.37.21The system shall support unit conversion in input files using variable expressions.

    Specification(s): unit_conversion

    Design: Parser

    Issue(s): #14827

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.37.22The system shall support reading in jagged double-indexed arrays from the input file using two delimiters for columns and rows respectively.

    Specification(s): parse_double_index

    Design: Parser

    Issue(s): #6442

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.37.23The system shall support vector size checking on input parameter vectors:
    1. for ints,
    2. for Reals.

    Specification(s): vector_len_checks/realvectorlength, vector_len_checks/intvectorlength

    Design: InputParameters

    Issue(s): #3988

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.37.24The system shall support vector element checking:
    1. against constant expressions,
    2. against other unsigned int vector elements,
    3. against other long vector elements,
    4. against other int vector elements, and
    5. against other Real vector elements.

    Specification(s): vector_elem_checks/all_element_check, vector_elem_checks/elementcompare_unsigned_int, vector_elem_checks/elementcompare_long, vector_elem_checks/elementcompare_int, vector_elem_checks/elementcompare_real

    Design: InputParameters

    Issue(s): #3988

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.37.25The system shall support vector bounds checking on input parameter vectors.

    Specification(s): outofbounds

    Design: InputParameters

    Issue(s): #3988

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.37.26The system shall support checking for non-empty input parameter vectors.

    Specification(s): checkempty

    Design: InputParameters

    Issue(s): #3988

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • rdg: Phi Zero
  • 11.40.1The system shall be able to construct zero objects for shape functions and shape function gradients consistent with the maximum number ofshape functions and quadrature points in the simulation.

    Specification(s): phi_zero_linear

    Design: PhiZero

    Issue(s): #15204

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.40.2The system shall be able to construct zero objects for shape functions and shape function gradients consistent with the maximum number ofshape functions and quadrature points in the simulation. This test checks the size of zero objects when using second-order elements and second order-variables.

    Specification(s): phi_zero_quadratic

    Design: PhiZero

    Issue(s): #15204

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • rdg: Preconditioners
  • 11.42.1The system shall support the disabling of an automatically created preconditioning object when preforming a Newton solve.

    Specification(s): manual

    Design: CreateExecutionerAction

    Issue(s): #13411

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.42.2The system shall automatically create the correct preconditioning object when preforming a Newton solve.

    Specification(s): auto

    Design: CreateExecutionerAction

    Issue(s): #13411

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.42.1

  • 11.42.3The system shall not automatically create a preconditioning object when preforming a Newton solve if the auto preconditioning capability is disabled.

    Specification(s): fail

    Design: CreateExecutionerAction

    Issue(s): #13411

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.42.4The system shall produce a perfect coloring for the Jacobian when using the finite difference preconditioner.

    Specification(s): jacobian_fdp_coloring_full_test

    Design: FDP

    Issue(s): #13232

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

  • 11.42.5The system shall produce a perfect Jacobian when using the stadard finite difference preconditioner.

    Specification(s): jacobian_fdp_standard_test

    Design: FDP

    Issue(s): #13232

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

    Prerequisite(s): 11.42.4

  • 11.42.6The system shall detect missing off-diagonal Jacobian entries when using a full finite different preconditioner.

    Specification(s): jacobian_fdp_coloring_diagonal_test_fail

    Design: FDP

    Issue(s): #13232

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

    Prerequisite(s): 11.42.5

  • 11.42.7The system shall support the use of field split preconditioner on
    1. a single subdomain and
    2. multiple subdomains.

    Specification(s): group/test, group/fsp_image

    Design: FSP

    Issue(s): #1851

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.42.8The system shall support the use of HMG (high performance MG)

    Specification(s): hmg

    Design: HMG

    Issue(s): #16210

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.42.9The system shall support the use of HMG (high performance MG) for 3D problems

    Specification(s): hmg_3D

    Design: HMG

    Issue(s): #16210

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.42.10The system shall support the use of strumpack (sparse direct solver) for 3D problems

    Specification(s): hmg_strumpack

    Design: HMG

    Issue(s): #16501

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.42.11The system shall support the ability to use multiple cycles within hypre during preconditioning with PETSc.

    Specification(s): test

    Design: Preconditioning System

    Issue(s): #1048

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.42.12The system shall support the use of a physics based preconditioner
    1. without and
    2. with mesh adaptivity.

    Specification(s): pbp/test, pbp/pbp_adapt_test

    Design: PBP

    Issue(s): #1048#18777

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.42.13The system shall support the ability to add arbitrary options to the solver when using a physics based precondioner.

    Specification(s): check_petsc_options_test

    Design: PBP

    Issue(s): #1048#18777

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.42.14The system shall support the ability to control the variable solve order when using a physics base preconditioner.

    Specification(s): lots_of_variables

    Design: PBP

    Issue(s): #1048#18777

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.42.15The system shall support the ability to use the conjugate gradient method for preconditioning with PETSc.

    Specification(s): test

    Design: Preconditioning System

    Issue(s): #8681

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.42.16The system shall support the use of a single matrix preconditioner
    1. without and
    2. with mesh adaptivity.

    Specification(s): smp/smp_test, smp/smp_adapt_test

    Design: SMP

    Issue(s): #1048

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.42.17The system shall support the ability to group variables when using a single matrix preconditioner.

    Specification(s): smp_group_test

    Design: SMP

    Issue(s): #1048

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.42.18The system shall converge when using the VCP interface with AMG as the preconditioner.

    Specification(s): condense_amg_test

    Design: VCP

    Issue(s): #15215

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.42.19The system shall converge while computing the full inverse of the coupling matrix.

    Specification(s): condense_amg_test_dinv

    Design: VCP

    Issue(s): #15215

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.42.20The system shall converge while using LU as the solver.

    Specification(s): no-condense_amg_test

    Design: VCP

    Issue(s): #15215

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • rdg: Problems
  • 11.44.1The system shall allow the creation of a custom problem through a user-defined Action.

    Specification(s): no_problem_block

    Design: Problem system overview

    Issue(s): #12002

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.44.2The system shall support the creation of a custom problem with parameters in Problem block.

    Specification(s): with_problem_block_without_type

    Design: Problem system overview

    Issue(s): #12002

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.44.3The system shall error out when Problem block type is not specified.

    Specification(s): with_problem_block_with_wrong_type

    Design: Problem system overview

    Issue(s): #12002

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.44.4The system shall support the creation of a custom problem through Problem block with type specified.

    Specification(s): with_problem_block_with_type

    Design: Problem system overview

    Issue(s): #12002

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.44.5The system shall support the ability to extend the basic "Problem" interface.

    Specification(s): test

    Design: Problem system overview

    Issue(s): #12060

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.44.6The system shall have a capability to dump the equivalent input file syntax for all objects added by a given action.

    Specification(s): add_mat_and_kernel

    Design: DumpObjectsProblem

    Issue(s): #8875

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.44.7The system shall include the support for Eigen value calculations that utilize
    1. an array of residual contributions;
    2. multiple variables; and
    3. multiple variables with Eigen values include in preconditioning matrix.

    Specification(s): eigen/array_kernel, eigen/two_variables, eigen/two_variables_precond_include_eigen_kernels

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.8Eigenvalue system should support standard eigenvalue problems

    Specification(s): test

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.9Eigenvalue system should support generalized eigenvalue problems

    Specification(s): gipm_test

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.10Eigenvalue system should support IntegratedBC

    Specification(s): gipm_ibc

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.11Eigenvalue system should not allow users to use inhomogeneous nodal boundary conditions

    Specification(s): wrong_dirichlet_value_eigen

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.44.12Eigenvalue system should use homogeneous boundary conditions only

    Specification(s): wrong_NodalBC_type_eigen

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.44.13Eigenvalue system requires SLEPc installed

    Specification(s): no_slepc

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.44.14Eigenvalue system should be able to solve a nonlinear eigenvalue problem

    Specification(s): nonlinear_power

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.15Eigenvalue system should be able to solve a nonlinear eigenvalue problem using Newton

    Specification(s): monolith_newton

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.16Eigenvalue system should be able to solve a deficient eigenvalue problem

    Specification(s): ne_deficient

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.17Eigenvalue system should be able to compute a nonlinear eigenvalue problem

    Specification(s): nonlinear_laplace

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.18Eigenvalue system should be able to compute a coupled nonlinear eigenvalue problem

    Specification(s): coupled_system

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.19Eigenvalue system should be able to handle scalar kernels

    Specification(s): eigen_scalar_kernel

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.20Eigenvalue system should be able to handle DG kernels

    Specification(s): dg_krylovschur

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.21Eigenvalue system shall support Picard iteration using eigenvalue executioner as a master.

    Specification(s): eigen_as_master

    Design: Eigenvalue

    Issue(s): #15513

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.22Eigenvalue system shall support Picard iteration using eigenvalue executioner as a master and output eigen vectors as an exodus file.

    Specification(s): eigen_as_master_exodus

    Design: Eigenvalue

    Issue(s): #15513

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.44.21

  • 11.44.23Eigenvalue system shall support Picard iteration using eigenvalue executioner as a sub app.

    Specification(s): eigen_as_sub

    Design: Eigenvalue

    Issue(s): #15513

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.24Eigenvalue system shall support Picard iteration using eigenvalue executioner as a sub app and output eigen vectors as an exodus file.

    Specification(s): eigen_as_sub_exodus

    Design: Eigenvalue

    Issue(s): #15513

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.44.23

  • 11.44.25Eigenvalue system should be able scale eigenvector such that postprocessor is a certain value

    Specification(s): scaled_eigenvector

    Design: Eigenvalue

    Issue(s): #14500

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.44.26The system shall be able to automatically condition a nonlinear eigen-solve based on diagonal entries in the preconditioning matrix.

    Specification(s): coupled-system-auto-scaling

    Design: Eigenvalue

    Issue(s): #15048

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.27The system shall be able to automatically scale a nonlinear eigen-solve based on entries in the non-eigen residual vector.

    Specification(s): coupled-system-resid-auto-scaling

    Design: Eigenvalue

    Issue(s): #15048

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.28The system shall provide an initial guess to Newton if users request.

    Specification(s): newton_intial_guess

    Design: Eigenvalue

    Issue(s): #15513#12767#14292

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.29The system shall support eigenvalue execution without free power iterations.

    Specification(s): newton_no_free_power

    Design: Eigenvalue

    Issue(s): #17026

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.30The system shall provide an option to output the eigenvalue as its inverse.

    Specification(s): inverse_eigenvalue_postprocessor

    Design: Eigenvalue

    Issue(s): #15513#12767#14292

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.31The system shall provide an option to output the eigenvalue on screen as its inverse.

    Specification(s): output_inverse_eigenvalue

    Design: Eigenvalue

    Issue(s): #15513#12767#14292

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.44.32The system shall support extra power iterations.

    Specification(s): extra_power_iterations

    Design: Eigenvalue

    Issue(s): #15513#12767#14292

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.44.33The system shall support extra power iterations and check eigenvalue.

    Specification(s): extra_power_iterations_csv

    Design: Eigenvalue

    Issue(s): #15513#12767#14292

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.44.32

  • 11.44.34The system shall support eigenvalue calculations with an initial condition including the initial solution vector and the initial eigenvalue.

    Specification(s): newton_with_exact_initialization

    Design: Eigenvalue

    Issue(s): #20454

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.44.35The system shall support use of matrix-vector multiplication as residual evaluation for eigenvalue calculations

    Specification(s): ne_array_mo

    Design: Eigenvalue

    Issue(s): #18493#21056

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.36The system shall support evaluation of auxiliary variables on linear with the matrix-only eigenvalue solve type

    Specification(s): ne_mo_with_linear_aux

    Design: Eigenvalue

    Issue(s): #18493#21056

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.37The system shall support use of matrix-vector multiplication as residual evaluation for eigenvalue calculations with constant matrices

    Specification(s): const_mats

    Design: Eigenvalue

    Issue(s): #18493#21056

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.44.35

  • 11.44.38The system shall support compatibility of solve type and constant-matrices flag

    Specification(s): check_solve_type

    Design: Eigenvalue

    Issue(s): #18493#21056

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

    Prerequisite(s): 11.44.37

  • 11.44.39The system shall support use of matrix-vector multiplication as residual evaluation for coupled eigenvalue problems

    Specification(s): ne_coupled_mo

    Design: Eigenvalue

    Issue(s): #18493#21056

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.40The system shall support use of matrix-vector multiplication with full-coupled matrices (by default) as residual evaluation for coupled eigenvalue problems

    Specification(s): ne_coupled_mo_full

    Design: Eigenvalue

    Issue(s): #18493#21056

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.44.39

  • 11.44.41The system shall support use of matrix-vector multiplication as residual evaluation for non-homogeneous problems

    Specification(s): non-homogeneous

    Design: Eigenvalue

    Issue(s): #18493#21056

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.42Eigen solver should work with a physics-based preconditioner

    Specification(s): newton_pbp

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.44.43The system shall support a physics-based preconditioner with using JFNK

    Specification(s): JFNK_pbp

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.44.42

  • 11.44.44Eigen solver should work with a physics-based preconditioner with a shell preconditioning matrix

    Specification(s): newton_pbp_shell_precond

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.44.43

  • 11.44.45Eigen solver should work with a physics-based preconditioner with a PETSc shell matrix

    Specification(s): newton_pbp_shell_precond_shell_matrix

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): RunApp

    Prerequisite(s): 11.44.44

  • 11.44.46Eigen solver should work with a physics-based preconditioner with including eigen kernels in the preconditioning matrix

    Specification(s): newton_pbp_precond_include_eigen_kernels

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.44.44

  • 11.44.47The system shall support an code coupling interface that can trigger external solves.

    Specification(s): external_steady

    Design: ExternalProblem

    Issue(s): #12024

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.44.48The system shall support an code coupling interface that can trigger external solves for transient simulations.

    Specification(s): external_transient

    Design: ExternalProblem

    Issue(s): #12024

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.44.49The system shall support different coordinate systems on different subdomains within the mesh.

    Specification(s): test

    Design: Problem system overview

    Issue(s): #1216

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.44.50The system shall support the ability to disable the check for PDE operators in all or some parts of the domain.

    Specification(s): test

    Design: Problem system overview

    Issue(s): #2291

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.44.51The system shall support the ability to disable the check for active materials in all parts of the domain.

    Specification(s): test

    Design: Problem system overview

    Issue(s): #5306

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.44.52The system shall support the ability to disable the check for the existence of all dependent properties within a domain.

    Specification(s): test

    Design: Problem system overview

    Issue(s): #5306

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.44.53The system shall have the ability to disable the actual nonlinear system solve in a simulation.

    Specification(s): test

    Design: Problem system overview

    Issue(s): #1978

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.44.54The system shall have the ability to base convergence on the comparison of individual variables to reference quantities of those variables.

    Specification(s): base

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.44.55The system shall fail to find a converged solution when basing convergence on individual variable reference quantities with poor scaling.

    Specification(s): scaled_bad

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.44.56The system shall have the ability to automatically scale a originally poorly scaled problem and achieve convergence based on individual reference quantities

    Specification(s): scaled_good

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.44.57The system shall have the ability to base system convergence on the convergence of a subset of variables.

    Specification(s): converge_on

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.44.58The system shall require all grouped variables to be included in the convergence check.

    Specification(s): converge_on_group_error

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.44.59The system shall support wildcards for choosing the variables to base convergence on.

    Specification(s): wildcard

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • rdg: Quadrature
  • 11.45.1The system shall support the use of Gauss-Lobatto quadrature for numerical integration.

    Specification(s): gauss_lobatto

    Design: Quadrature System

    Issue(s): 8f90ad2609945db87dc89c5e06a5a1554eb8f4a6

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.45.2The system shall support the ability to manually increase the quadrature order used for numerical integration on the entire mesh.

    Specification(s): order3

    Design: Quadrature System

    Issue(s): #3380

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.45.3The system shall support the ability to manually specify the quadrature order used for numerical integration on a per-block basis with face quadrature between blocks preferring the higher-order between the two sides.

    Specification(s): per-block-order

    Design: Quadrature System

    Issue(s): #14055

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.45.4The system shall support the ability for objects to increase quadrature order in code during runtime.

    Specification(s): code-order-bump

    Design: Quadrature System

    Issue(s): #14055

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.45.5The system shall support the ability to control the volumetric and side quadrature orders used for numerical integration on the entire mesh.

    Specification(s): elem5_side7

    Design: Quadrature System

    Issue(s): #3380

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.45.6The system shall support the ability to allow object code to increase the quadrature order used for numerical integration on a per-block basis.

    Specification(s): material-bumps-block-order

    Design: Quadrature System

    Issue(s): #14055#15072

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.45.7The system shall support the ability to force positive quadrature weights.

    Specification(s): weights

    Design: SetupQuadratureAction

    Issue(s): #19066

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Relationship Managers
  • 11.46.1The CouplingFunctorCheckAction shall add a default coupling functor if it's needed and hasn't already been added by another Action

    Specification(s): run

    Design: RelationshipManager

    Issue(s): #13736

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.46.2The system shall be able to indicate when libMesh Ghosting Functors are in use.

    Specification(s): test

    Design: RelationshipManager

    Issue(s): #13206

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.46.3The system shall ghost additional solution information when running in parallel with an active RelationshipManager

    Specification(s): evaluable_neighbors_replicated

    Design: RelationshipManager

    Issue(s): #10455#11981

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.46.4The system shall ghost additional neighboring elements surrounding a partition when running in parallel with DistributedMesh

    Specification(s): edge_neighbor

    Design: RelationshipManager

    Issue(s): #10455#11981

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.46.5The system shall ghost additional neighboring elements surrounding a partition when running in parallel with DistributedMesh with 3D

    Specification(s): edge_neighbor_3D

    Design: RelationshipManager

    Issue(s): #10455#11981

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.46.6The system shall be able to ghost elements for algebraic relationships.

    Specification(s): all_systems_evaluable

    Design: RelationshipManager

    Issue(s): #14536

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.46.7The system shall ghost additional neighboring elements without also supplying solution information when a developer registers a RelationshipManager with an optional second argument to restrict functionality

    Specification(s): geometric_edge_neighbor

    Design: RelationshipManager

    Issue(s): #10455

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.46.8The system shall ghost additional neighboring elements without also supplying solution information when a developer registers a RelationshipManager with an optional second argument to restrict functionality in 3D

    Specification(s): geometric_edge_neighbor_3D

    Design: RelationshipManager

    Issue(s): #10455

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.46.9The system shall allow multiple active objectsto manage ghosting for the same object using
    1. replicated and
    2. distributed parallelism of the mesh.

    Specification(s): evaluable_neighbors/replicated, evaluable_neighbors/distributed

    Design: RelationshipManager

    Issue(s): #10455#11981

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Reporters
  • 11.47.1The system shall be able to accumulate reporter values over time steps into a vector reporter value.

    Specification(s): accumulate_reporter

    Design: AccumulateReporter

    Issue(s): #18469#20467

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.47.2The system shall have a system for computing and retrieving aggregate values of arbitrary type.

    Specification(s): base

    Design: Reporter System

    Issue(s): #11323

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.47.3The system shall error if an invalid name is provided when retrieving aggregate value.

    Specification(s): error

    Design: Reporter System

    Issue(s): #11323

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.47.4The system shall report a reasonable error when declaring a Reporter value and
    1. the parameter that contains the name was not found,
    2. the parameter that contains the name is not of the correct type,
    3. a Reporter with the same name has already been declared, and
    4. a Reporter with the same name but a different type has been requested.

    Specification(s): errors/missing_param, errors/bad_param, errors/already_declared, errors/requested_different_type

    Design: Reporter System

    Issue(s): #11323

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.47.5The system shall support the mixing of computing and retreiving aggregate values of arbitrary types with the Postprocessor and VectorPostprocessor system.

    Specification(s): special_types

    Design: Reporter System

    Issue(s): #11323

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.47.6The system shall be able to produce arbitrary integer, real number, dof_id_types and string scalar/vector values for use in other calculations.

    Specification(s): constant_reporter

    Design: ConstantReporter

    Issue(s): #16055#20467

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.47.7The system shall throw an error when producing constant reporter values if
    1. no values are specified,
    2. no names are specified,
    3. or the number of values and names are not equal.

    Specification(s): errors/no_values, errors/no_names, errors/mismatch

    Design: ConstantReporter

    Issue(s): #16055#20467

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.47.8The system shall output aggregate simulation information to JSON format
    1. when the aggregate value is declared after object construction
    2. and with other values declared at construction time.

    Specification(s): declareInitialSetup/initialSetup_only, declareInitialSetup/initialSetup_with_info

    Design: Reporter SystemJSON

    Issue(s): #16584

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.47.9The system shall support getting a reference to an aggregate calculation before it is created.

    Specification(s): decalareInitialSetup_with_get

    Design: Reporter SystemJSON

    Issue(s): #17468

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.47.10The system shall be able to report the variable integral parsed by extra IDs to the JSON format:
    1. single variable integral with single extra ID
    2. single variable integral with multiple extra IDs
    3. multiple variable integrals with multiple extra IDs

    Specification(s): test/default, test/multi_ids, test/multi_ids_multi_vars

    Design: ExtraIDIntegralReporter

    Issue(s): #19617

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.47.11The system shall include the ability to report iteration information:
    1. that outputs all information be default;
    2. that outputs specific information;
    3. automatically disables items based on execution;

    Specification(s): info/default, info/limit, info/steady

    Design: IterationInfo

    Issue(s): #11323

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.47.12The system shall include the ability to report mesh information:
    1. that outputs all information be default and
    2. that outputs specific information.

    Specification(s): info/default, info/limit

    Design: MeshInfo

    Issue(s): #11323#16886#16887

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.47.13The system shall include the ability to report performance information
    1. in JSON format
    2. and shall provide a tool to post process said information

    Specification(s): test/run, test/verify

    Design: PerfGraphReporter

    Issue(s): #16256

    Collection(s): FUNCTIONAL

    Type(s): RunCommandRunApp

  • 11.47.14The system shall include the ability to serialize report performance information with the recover system

    Specification(s): recover_initial

    Design: PerfGraphReporter

    Issue(s): #16256

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.47.15The system shall include the ability to report performance information from a recovered solve
    1. in JSON format
    2. and shall provide a tool to post process said information

    Specification(s): recover/run, recover/verify

    Design: PerfGraphReporter

    Issue(s): #16256

    Collection(s): FUNCTIONAL

    Type(s): RunCommandRunApp

    Prerequisite(s): 11.47.14

  • rdg: Restrictable
  • 11.49.1The system shall include an interface to allow objects to be restricted to subdomains.

    Specification(s): block_solution_working

    Design: BlockRestrictable Interface

    Issue(s): #2096

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.49.2The system shall error if an object is restricted to a set of subdomains that differs from a dependant object.

    Specification(s): block_undefined_var_block

    Design: BlockRestrictable Interface

    Issue(s): #2096

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.49.3The system shall include an interface that provides a method for returning all associated subdomains:
    1. as a list of names or
    2. as a list of ids.

    Specification(s): ids/blocks, ids/hasBlocks

    Design: BlockRestrictable Interface

    Issue(s): #2096

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.49.4The system shall include an interface that provides methods for indicating if the supplied subdomain identifier(s) exists on the object:
    1. if a single subdomain is supplied ant the object is not restricted;
    2. if a single subdoman is supplied and the object is restricted to a set of subdomains; and
    3. if multiple boundaries are supplied and the object is restricted to a set of subdomains.

    Specification(s): has/hasBlocks_ANY_BLOCK_ID, has/blockIDs, has/isBlockSubset

    Design: BlockRestrictable Interface

    Issue(s): #2096

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.49.5The system shall include an interface that provides a method for indicating if the supplied material property exists on the same subdomains as the object:
    1. the method shall return true if the property subdomains match with the object subdomains and
    2. the method shall return false if the property subdomains dot not match with the object subdomains.

    Specification(s): mat/hasBlockMaterialProperty_true, mat/hasBlockMaterialProperty_false

    Design: BlockRestrictable Interface

    Issue(s): #2096

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.49.6The system shall include an interface that provides a method for returning all associated boundaries:
    1. as a list of names or
    2. as a list of ids.

    Specification(s): ids/boundary, ids/boundaryIDs

    Design: BoundaryRestrictable Interface

    Issue(s): #2149

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.49.7The system shall include an interface that provides methods for indicating if the supplied boundary identifier(s) exists on the object:
    1. if a single boundary is supplied and the object is restricted to a set of boundaries and
    2. if multiple boundaries are supplied.

    Specification(s): has/hasBoundary, has/isBoundarySubset

    Design: BoundaryRestrictable Interface

    Issue(s): #2149

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.49.8The system shall include an interface that provides a method for indicating if the supplied material property exists on the same boundaries as the object:
    1. the method shall return true if the property boundaries match with the object boundaries and
    2. the method shall return false if the property boundaries dot not match with the object boundaries.

    Specification(s): mat/hasBoundaryMaterialProperty_true, mat/hasBoundaryMaterialProperty_false

    Design: BoundaryRestrictable Interface

    Issue(s): #2149

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.49.9The system shall error if an object restricted to subdomains is created without valid data
    1. regarding the problem being solved or
    2. information regarding the finite element mesh.

    Specification(s): errors/fe_problem_null, errors/mesh_null

    Design: BlockRestrictable Interface

    Issue(s): #2411

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.49.10The system shall support the ability to restrict user defined calculations to sides of a subdomain.

    Specification(s): test

    Design: BlockRestrictable Interface

    Issue(s): #2411

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.49.11The system shall issue an error when a referenced subdomain does not exist in the mesh.

    Specification(s): block

    Design: MooseMesh

    Issue(s): #2757

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • rdg: Scalar Kernels
  • 11.51.1We shall be able to couple a scalar variable into AD objects and do some meaningful physics: depleting boundary source diffusion problem

    Specification(s): exo

    Design: ScalarKernels System

    Issue(s): #13703

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.51.2We shall be able to couple a scalar variable into AD objects and get the correct Jacobian

    Specification(s): jac

    Design: ScalarKernels System

    Issue(s): #13703

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.51.3The system shall be able to correctly compute the Jacobian of an ADScalarKernel using automatic differentiation.

    Specification(s): jacobian

    Design: ScalarKernels System

    Issue(s): #18535

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 11.51.4The system shall provide the ability to compute the time derivative of a scalar variable and have its Jacobian computed using automatic differentiation.

    Specification(s): test

    Design: ADScalarTimeDerivative

    Issue(s): #18535

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • rdg: Scaling
  • 11.52.1The system shall ignore particular variable automatic scaling factors

    Specification(s): ignore

    Design: NonlinearSystem

    Issue(s): #19573

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.52.2The system shall not allow ignoring of particular variable automatic scaling factors if they are grouped with other variables for scaling

    Specification(s): fail_with_group

    Design: NonlinearSystem

    Issue(s): #19573

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.52.3The system shall be able to automatically compute scaling factors based on Jacobian
    1. data solely along the diagonal
    2. data both on- and off-diagonal

    Specification(s): auto_scaling/on_diag, auto_scaling/off_diag

    Design: NonlinearSystemBase

    Issue(s): #16212

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.52.4The system shall be able to automatically scale variables and produce a good condition number from a naturally ill-conditioned system using
    1. automatic and
    2. manual prescribed settings.

    Specification(s): scaling/automatic, scaling/manual

    Design: NonlinearSystemBase

    Issue(s): #15732

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.52.5The system shall display a very poor condition number for an ill-conditioned system.

    Specification(s): bad

    Design: NonlinearSystemBase

    Issue(s): #15732

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.52.6The system shall be able to conduct residual based automatic scaling such that the largest residual vector component corresponding to each variable has magnitude unity
    1. in a one variable problem
    2. and in a two variable problem.

    Specification(s): residual-based/one-var, residual-based/two-var

    Design: NonlinearSystem

    Issue(s): #14397

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.52.7The system shall be able to conduct jacobian based automatic scaling such that the largest jacobian diagonal component corresponding to each variable has magnitude unity
    1. in a one variable problem
    2. and in a two variable problem

    Specification(s): jacobian-based/one-var, jacobian-based/two-var

    Design: NonlinearSystem

    Issue(s): #14397

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.52.8The system shall print current variable automatic scaling factors

    Specification(s): up-to-date-scale-factors

    Design: NonlinearSystem

    Issue(s): #12601

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Time Steppers
  • 11.56.1The system shall calculate the time step size based one the number of steps and the end time of the simulation when the initial time step size is not supplied:
    1. when the start time is not supplied, and
    2. when the start time is supplied.

    Specification(s): calc_dt_from_inputs/no_start_time, calc_dt_from_inputs/with_start_time

    Design: TimeStepper System

    Issue(s): #5095

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.2The system shall include a means for performing simulations with a constant time step.

    Specification(s): constant_dt

    Design: TimeStepper System

    Issue(s): #1953

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.3The system shall support the ability to regrow a time step that has been previously cut due to a solve failure.

    Specification(s): test

    Design: TimeStepper System

    Issue(s): #3765#3764

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.4The system shall support how time step size is cut, using user-specified cutback_factor_at_failure, due to a solve failure. Here, the original time step size is specified as a constant value.

    Specification(s): constant_dt_cutback

    Design: TimeStepper System

    Issue(s): #13874

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.5The system shall support how time step size is cut, using user-specified cutback_factor_at_failure, due to a solve failure. Here, the original time step size is specified as a function of time.

    Specification(s): function_dt_cutback

    Design: TimeStepper System

    Issue(s): #13874

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.6The system shall suppport the ability to sample a piecewise linear function for time step sizes while supporting a minimum time step size.

    Specification(s): function_dt_min

    Design: TimeStepper System

    Issue(s): #10612#9498#6337

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.7The system shall support the ability to sample a piecewise constant function for time step sizes choosing either the left or right values between adjacent constants.

    Specification(s): function_dt_no_interpolation

    Design: TimeStepper System

    Issue(s): #10612#9498#6337

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.8The system shall support the ability to force time steps consistent with points specified in a function.

    Specification(s): hit_knot

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.9The system shall check that a timestep limiting function has been defined when a user specifies the 'force_step_every_function_point' parameter as true.

    Specification(s): hit_knot_err1

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.56.10The system shall check that a timestep limiting function has been defined when a user specifies a value for the 'max_function_change' parameter.

    Specification(s): hit_knot_err2

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.56.11The system shall support the ability to grow the time step size when specifying the initial value of dt in the TimeStepper.

    Specification(s): grow_init_dt

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.12The system shall support the ability to grow the time step size when specifying the initial value of dt in the TimeStepper after a restart.

    Specification(s): grow_init_dt_restart

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.56.11

  • 11.56.13The system shall support the ability to grow the time step size when specifying the values of t and dt in the TimeStepper.

    Specification(s): adapt_tstep_grow_dtfunc

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.56.14The system shall support the ability to grow the time step size when specifying the values of t and dt in the TimeStepper after a restart.

    Specification(s): adapt_tstep_grow_dtfunc_restart

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.56.13

  • 11.56.15The system shall support the ability to limit the time step size based on the optimal iterations and linear_iteration ratio.

    Specification(s): shrink_init_dt

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.16The system shall support the ability to limit the time step size based on the optimal iterations and linear_iteration ratio after a restart.

    Specification(s): shrink_init_dt_restart

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.56.15

  • 11.56.17The system shall support the ability to limit the time step size based on a postprocessor value.

    Specification(s): pps_lim

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.18The system shall support the ability to reject a time step based on a threshold value for the ratio of the ideal step size to the limit.

    Specification(s): reject_large_dt

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.19The system shall support the ability to force time steps to resolve sudden changes in piecewise linear functions.

    Specification(s): piecewise_linear

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.56.20The system shall support the ability to force time steps to match changes in piecewise constant functions.

    Specification(s): piecewise_constant

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.56.21The system shall support the ability to force time steps to hit all nodes in a set of piecewise linear functions.

    Specification(s): multi_piecewise_linear_function_point

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.56.22The system shall support the ability to force time steps to resolve sudden changes in multiple piecewise linear functions.

    Specification(s): multi_piecewise_linear_function_change

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.56.23The system shall support the ability to force time steps to hit all nodes in a set of piecewise linear and constant functions.

    Specification(s): multi_piecewise

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.56.24The system shall support the ability to set a new time step size after syncing the previous time step with piecewise linear and constant functions.

    Specification(s): multi_piecewise_sync_dt

    Design: IterationAdaptiveDT

    Issue(s): #5535

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.56.25The system shall support the ability to select a time step size based upon a scaled log-constant calculation.

    Specification(s): logconstant_dt

    Design: LogConstantDT

    Issue(s): #9312

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.26The system shall support the ability to use a scalar value computed after a solve to be used as a scaled time step size.

    Specification(s): test

    Design: PostprocessorDT

    Issue(s): #1963

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.27The system shall support the ability to select time step sizes based upon the ratio of the real (wall) time of the solve and the size of the time step.

    Specification(s): test

    Design: TimeStepper System

    Issue(s): #2288#18863

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.56.28The system shall support the ability to choose time step sizes based on a sequence of increasing numbers:
    1. beginning at the default start time,
    2. beginning at an earlier time than the sequence numbers,
    3. beginning at a time somewhere in-between existing sequence numbers, and
    4. when reading the sequence from an ExodusII formatted input file.
    5. that must be sorted in ascending order,
    6. that must be sorted in strictly ascending order,
    7. when reading the sequence from a comma-separated input file.

    Specification(s): time_sequence/timesequence_no_start_time, time_sequence/timesequence_earlier_start_time, time_sequence/timesequence_later_start_time, time_sequence/exodustimesequence, time_sequence/not_sorted, time_sequence/not_sorted_strictly, time_sequence/csvtimesequence

    Design: TimeSequenceStepper

    Issue(s): #9698#6353#6795

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunExceptionExodiff

  • 11.56.29The system shall support the ability to override time sequence time step sizes when solves fail.

    Specification(s): timesequence_failed

    Design: TimeSequenceStepper

    Issue(s): #9698#6353#6795

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.30The system shall support the ability to run a calculation for the purpose of creating a time sequence restart file:
    1. when writing the checkpoint file,
    2. when restarting where the time sequence is identical, and
    3. when restarting where the time sequence is different after the point of the checkpoint.

    Specification(s): restart/timesequence_restart1, restart/timesequence_restart2, restart/timesequence_restart3

    Design: TimeSequenceStepper

    Issue(s): #9698#6353#6795

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.56.31The system shall support the ability to run a calculation for the purpose of creating a time sequence restart file suitable for failure:
    1. when writing the checkpoint file,
    2. when restarting where the time sequence is different prior to the failure.

    Specification(s): restart_failure/timesequence_restart_failure_1, restart_failure/timesequence_restart_failure2

    Design: TimeSequenceStepper

    Issue(s): #9698#6353#6795

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunExceptionExodiff

  • 11.56.32The system shall report an error if the initial time step size is calculated to be zero.

    Specification(s): test

    Design: TimeStepper System

    Issue(s): #10553

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • rdg: Utils
  • 11.60.1The system shall support a piecewise bilinear interpolation object to be constructed from x, y data read from an external file.

    Specification(s): test

    Design: BilinearInterpolation

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.60.2The system shall support a piecewise bilinear interpolation object to be constructed from x, y data.

    Specification(s): test_internal

    Design: BilinearInterpolation

    Issue(s): #5991

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Prerequisite(s): 11.60.111.60.611.60.711.60.17

  • 11.60.3The system shall error when a file and data are supplied simultaneously in the PiecewiseBilinear object.

    Specification(s): data_file_and_xyz_error

    Design: BilinearInterpolation

    Issue(s): #5991

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.60.4The system shall error when there is a mismatch in vector lengths in the PiecewiseBilinear object.

    Specification(s): size_xyz_error

    Design: BilinearInterpolation

    Issue(s): #5991

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.60.5The system shall error when there are insufficient parameters supplied for the PiecewiseBilinear object.

    Specification(s): xyz_error

    Design: BilinearInterpolation

    Issue(s): #5991

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.60.6The system shall provide a method for transferring common parameters from one object to another.

    Specification(s): test

    Design: InputParameters

    Issue(s): #3352

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.60.7The system shall prevent the user from copying InputParameters objects inside of MooseObject-derived objects.

    Specification(s): test

    Design: InputParameters

    Issue(s): #5439

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.60.8The system shall throw an error
    1. when encountering an unsupported activation function for the neural network.
    2. when encountering the wrong number of activation functions.

    Specification(s): libtorch-nn-errors/wrong-activation, libtorch-nn-errors/wrong-activation-number

    Design: LibtorchArtificialNeuralNet

    Issue(s): #19571

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.60.9The system shall be able to create and evaluate a neural network with
    1. relu activation functions.
    2. sigmoid activation functions.
    3. gelu activation functions.
    4. elu activation functions.
    5. linear activation functions.

    Specification(s): libtorch-nn-activation/relu, libtorch-nn-activation/sigmoid, libtorch-nn-activation/gelu, libtorch-nn-activation/elu, libtorch-nn-activation/linear

    Design: LibtorchArtificialNeuralNet

    Issue(s): #19571

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.60.10The system shall have a function that evaluates the polynomial and derivative of polyonimal of varying degree and arbitrary coefficients

    Specification(s): poly

    Design: MathUtils Namespace

    Issue(s): #13184

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.60.11The system shall have a clamp function that returns a value limited to upper and lower bounds

    Specification(s): clamp

    Design: MathUtils Namespace

    Issue(s): #13231

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.60.12The system shall have a smootherstep function that returns a smooth transition value between an upper and lower bound

    Specification(s): smootherstep

    Design: MathUtils Namespace

    Issue(s): #13231

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.60.13The system shall support the use of the Dennis-Schnabel method for computing the finite difference parameter for matrix free finite difference solver.

    Specification(s): mffd_test

    Design: Executioner System

    Issue(s): #584

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.60.14The mesh system shall report a reasonable error when using a subdomain name that is reserved for internal use

    Specification(s): get_subdomain_id_any

    Design: MooseMesh

    Issue(s): #17710

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.60.15The system shall automatically report input errors when a required parameter is not specified.

    Specification(s): error

    Design: InputParameters

    Issue(s): #16410

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.60.16The PerfGraph shall report a reasonable error when
    1. registering a section without a name
    2. registering a section without a live message
    3. requesting the ID of a section that does not exist
    4. requesting the section info for a section that does not exist

    Specification(s): errors/register_no_section, errors/register_no_live_message, errors/section_id_missing, errors/section_info_missing

    Design: PerfGraph

    Issue(s): #15444

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.60.17The system shall allow for timing sections of code and having automated print-outs when they take too long or use too much memory

    Specification(s): test

    Design: PerfGraph

    Issue(s): #15444

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.60.18The system shall include a utility for swapping values within a vector of data.

    Specification(s): swap

    Design: Samplers System

    Issue(s): #14830

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.60.19The system shall include a utility for shuffling values within a vector of data.

    Specification(s): serial

    Design: Samplers System

    Issue(s): #14830

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.60.20The system shall include a utility for resampling values within a vector of data.

    Specification(s): resample

    Design: Samplers System

    Issue(s): #14830

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 11.60.21The system shall include a utility for computing spline functions.

    Specification(s): regular_spline

    Design: SplineFunction

    Issue(s): #10918

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.60.22The system shall include a utility for computing bicubic spline functions
    1. using the x-component, and
    2. using the y-component.
    3. using the z-component,

    Specification(s): bicubic/spline_x, bicubic/spline_y, bicubic/spline_z

    Design: SplineFunction

    Issue(s): #10918

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • rdg: Vectorpostprocessors
  • 11.62.1Line sampling shall account for floating point precision error.

    Specification(s): test

    Design: LineMaterialRealSampler

    Issue(s): #9500

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.2The system shall be able to produce arbitrary vectors of values for use in other calculations.

    Specification(s): constant_vector_postprocessor

    Design: VectorPostprocessors System

    Issue(s): #3087

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.3The system shall be able to produce multiple arbitrary vectors of values for use in other calculations.

    Specification(s): constant_vector_postprocessor_multcol

    Design: VectorPostprocessors System

    Issue(s): #14569

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.4The system shall support the ability to read a comma separated file into an object and make it accessible through easy to use standard C++ containers.

    Specification(s): read

    Design: CSVReader

    Issue(s): #9167

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.5The system shall support the ability to read CSV data on only one processor and broadcast it to other ranks.

    Specification(s): parallel

    Design: CSVReader

    Issue(s): #9167

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.62.6The system shall error if the broadcast CSV data does not match on all ranks in a parallel job.

    Specification(s): tester_fail

    Design: CSVReader

    Issue(s): #9167

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.62.7The system shall support the ability to read a comma separated file into an object prior to initial setup.

    Specification(s): read_preic

    Design: CSVReader

    Issue(s): #14785

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.8The system shall issue an error if the CSVReader is used in a UserObjectTransfer because the former does not have any notion of "spatial" information.

    Specification(s): csv_reader_in_transfer

    Design: CSVReader

    Issue(s): #9860

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.62.9The system shall support the computation of averages of variables over cylindrical shells.

    Specification(s): cyl_average

    Design: CylindricalAverage

    Issue(s): #12979

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.10The system shall support writing a vector of data
    1. that is completely stored on a single processor or
    2. distributed across many and
    3. allows for the creation of symbolic links to the the most recent and final files on each processor.

    Specification(s): parallel_type/replicated, parallel_type/distributed, parallel_type/distributed_symlinks

    Design: VectorPostprocessors System

    Issue(s): #14480

    Collection(s): FUNCTIONAL

    Type(s): CSVDiffCheckFiles

  • 11.62.11The system shall support dynamic numbers of sample points during the simulation.

    Specification(s): dynamic_point_sampler

    Design: LineValueSampler

    Issue(s): #12934

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.12The system shall support dynamic numbers of sample points during the simulation with move semantics of the points vector.

    Specification(s): dynamic_point_sampler_transfer

    Design: LineValueSampler

    Issue(s): #12934

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.62.11

  • 11.62.13The system shall have the ability to retrieve element integers when visiting elements.

    Specification(s): element_counter_with_ids

    Design: ElementIDInterface

    Issue(s): #15534#13764

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.14The system shall have the ability to retrieve element integers when visiting elements only on certain subdomains.

    Specification(s): element_counter_with_ids_block_restricted

    Design: ElementIDInterface

    Issue(s): #15534#13764

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.15The system shall have the ability to retrieve element integers of attached elements when visiting sides of a side set.

    Specification(s): element_counter_with_ids_on_side

    Design: ElementIDInterface

    Issue(s): #15534#13764

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.16The system shall have the ability to retrieve element integers of attached elements on both sides when visiting internal interfaces.

    Specification(s): element_counter_with_ids_on_interface

    Design: ElementIDInterface

    Issue(s): #15534#13764

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.17The system shall have the ability to retrieve element integers of attached elements on both sides when visiting all internal sides.

    Specification(s): element_counter_with_ids_on_internal_side

    Design: ElementIDInterface

    Issue(s): #15534#13764

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.18The system shall support sampling of a field variable at the centroid of every element in the domain
    1. for elemental FE variables and
    2. for FV variables,
    3. but not for nodal variables.

    Specification(s): element_value_sampler/monomial, element_value_sampler/fv, element_value_sampler/lagrange

    Design: ElementValueSampler

    Issue(s): #11594

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunExceptionCSVDiff

  • 11.62.19The system shall be capable of locating the maximum distances (the element) between two field variables:
    1. the true maximum involving a simple difference, and
    2. the absolute maximum involving the difference between absolute values.

    Specification(s): max_difference/true, max_difference/absolute

    Design: ElementVariablesDifferenceMax

    Issue(s): #9231

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.20The ElementsAlongLine VectorPostprocessor shall output the IDs of all elements intersected by a line on a 1D mesh

    Specification(s): 1d

    Design: ElementsAlongLine

    Issue(s): #4345

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.21The ElementsAlongLine VectorPostprocessor shall output the IDs of all elements intersected by a line on a 2D mesh

    Specification(s): 2d

    Design: ElementsAlongLine

    Issue(s): #4345

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.22The ElementsAlongLine VectorPostprocessor shall output the IDs of all elements intersected by a line on a 3D mesh

    Specification(s): 3d

    Design: ElementsAlongLine

    Issue(s): #4345

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.23The ElementsAlongPlane VectorPostprocessor shall output the IDs of all elements intersected by a plane on a 1D mesh

    Specification(s): 1d

    Design: ElementsAlongPlane

    Issue(s): #6852

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.24The ElementsAlongPlane VectorPostprocessor shall output the IDs of all elements intersected by a plane on a 2D mesh

    Specification(s): 2d

    Design: ElementsAlongPlane

    Issue(s): #6852

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.25The ElementsAlongPlane VectorPostprocessor shall output the IDs of all elements intersected by a plane on a 3D mesh

    Specification(s): 3d

    Design: ElementsAlongPlane

    Issue(s): #6852

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.26The system shall be able to integrate variables parsed by extra IDs
    1. with a single variable integral and a single extra ID
    2. with a single variable integral and multiple extra IDs
    3. with multiple variable integrals and multiple extra IDs

    Specification(s): test/default, test/multi_ids, test/multi_ids_multi_vars

    Design: ExtraIDIntegralVectorPostprocessor

    Issue(s): #19617

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.27The system shall be able to compute a histogram of each vector of data produced by a vector data producer (VectorPostprocessor).

    Specification(s): test

    Design: HistogramVectorPostprocessor

    Issue(s): #11218

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.28The histogram vector postprocessor shall generate an error if the vector postprocessor that it operates on does not have any declared vectors

    Specification(s): test_size0_err

    Design: HistogramVectorPostprocessor

    Issue(s): #18459

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.62.29The system shall support finding all of the elements intersected by a line:
    1. in 1D,
    2. in 2D, and
    3. in 3D.

    Specification(s): intersecting_elems/1d, intersecting_elems/2d, intersecting_elems/3d

    Design: IntersectionPointsAlongLine

    Issue(s): #5897

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.30The system shall have late binding producers of vector quantities (VectorPostprocessors) that may be declared after system initialization.

    Specification(s): test

    Design: VectorPostprocessors System

    Issue(s): #7809#7819

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.31The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a first-order polynomial sampled from a solution field using LineValueSampler with shifting and scaling parameters specified

    Specification(s): least_squares

    Design: LeastSquaresFitLineValueSampler

    Issue(s): #7907#4464

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.32The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a zeroth-rder polynomial with data provided by a CSVReader

    Specification(s): least_squares_csv0

    Design: LeastSquaresFitCSVReader

    Issue(s): #13498

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.33The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a first-rder polynomial with data provided by a CSVReader

    Specification(s): least_squares_csv1

    Design: LeastSquaresFitCSVReader

    Issue(s): #13498

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.34The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a second-rder polynomial with data provided by a CSVReader

    Specification(s): least_squares_csv2

    Design: LeastSquaresFitCSVReader

    Issue(s): #13498

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.35The LeastSquaresFit vectorpostprocessor shall generate an error if a fit for a third-order polynomial is requested and only three data points are provided

    Specification(s): least_squares_csv3_order_err

    Design: LeastSquaresFitCSVReader

    Issue(s): #13498

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.62.36The system shall support computing the least squares fit of a set of time values obtained from an aggregate operation defined by the developer.

    Specification(s): least_squares_history

    Design: LeastSquaresFitHistory

    Issue(s): #11709

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.37The system shall support sampling one or more spatial functions along a line with fixed sampling intervals.

    Specification(s): test

    Design: LineFunctionSampler

    Issue(s): #6438

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.38The system shall support the ability to sample a scalar material along an arbitrary line through the mesh domain.

    Specification(s): test

    Design: LineMaterialRealSampler

    Issue(s): #4462#16959

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.39The system shall allow sampling of variables at equally spaced points for outputting.

    Specification(s): test

    Design: LineValueSampler

    Issue(s): #3087

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.40The system shall allow sampling of variables at equally spaced points in parallel.

    Specification(s): parallel

    Design: LineValueSampler

    Issue(s): #3087

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Prerequisite(s): 11.62.111.62.2711.62.3011.62.3711.62.3811.62.3911.62.4611.62.4811.62.5011.62.5511.62.5911.62.6111.62.6211.62.6311.62.64

  • 11.62.41The system shall allow scaling the line value sampler with a postprocessor.

    Specification(s): scaling

    Design: LineValueSampler

    Issue(s): #12314

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.42The system shall allow sampling of auxvariables at equally spaced points with CSV delimiter and precision setting.

    Specification(s): delimiter

    Design: LineValueSampler

    Issue(s): #3593

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 11.62.43The system shall be able to output material properties calculated at quadrature points on user-defined elements in a comma separated format.

    Specification(s): basic

    Design: MaterialVectorPostprocessor

    Issue(s): #8436

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.44The system shall issue an error if material output samples are attempted for elements:
    1. but the material is restricted to a boundary, or
    2. the material is restricted to a block not containing the desired elements.

    Specification(s): errors/boundary_restrict, errors/block_restrict

    Design: MaterialVectorPostprocessor

    Issue(s): #8436

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.62.45The system shall compute integrals computed from the closest values for a list of points and output to a spatial vector postprocessor with one point per point

    Specification(s): points_from_uo

    Design: NearestPointIntegralVariablePostprocessor

    Issue(s): #18931

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.46The system shall support sampling of a field variable at every node in the domain.

    Specification(s): test

    Design: NodalValueSampler

    Issue(s): #3087

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.47The system shall issue an error when a nodal sampler is used on a field that does not have values defined at the nodes.

    Specification(s): not_nodal

    Design: NodalValueSampler

    Issue(s): #3087

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.62.48The system shall provide VectorPostprocessor results to all processors as scattered data.

    Specification(s): test

    Design: VectorPostprocessors System

    Issue(s): #11408

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.62.49The system shall provide VectorPostprocessor results to all processors as replicated data.

    Specification(s): broadcast

    Design: VectorPostprocessors System

    Issue(s): #11408

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 11.62.50The system shall support the ability to sample field variables at user specified points.

    Specification(s): test

    Design: PointValueSampler

    Issue(s): #3087#16099

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.51The system shall support the ability to sample field FV variables at user specified points.

    Specification(s): test_fv

    Design: PointValueSampler

    Issue(s): #3087#16099

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.52The system shall report an error when requested sample points do not fall within the mesh domain.

    Specification(s): error

    Design: PointValueSampler

    Issue(s): #3087#16099

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.62.53The system shall report a warning when variables requested are discontinuous and requested sample points are
    1. on element faces and
    2. on element nodes.

    Specification(s): warning_discontinuous_variable/on_face, warning_discontinuous_variable/at_node

    Design: PointValueSampler

    Issue(s): #17115

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 11.62.54The system shall make a consistent choice as to which element value to report when variables requested are discontinuous and requested sample points are
    1. on element faces and
    2. on element nodes.
    3. whether elements are renumbered or not and
    4. on process domain boundaries.

    Specification(s): consistent_discontinuous_variable/on_face, consistent_discontinuous_variable/at_node, consistent_discontinuous_variable/at_node_no_renumbering, consistent_discontinuous_variable/on_domain_boundary

    Design: PointValueSampler

    Issue(s): #17115

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.55The VectorPostprocessor system takes a parameter "contains_complete_history" which guarentees the vector state is left alone between invocations resulting in a single CSV output file.

    Specification(s): test

    Design: VectorPostprocessors System

    Issue(s): #11300

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.56The system shall be capable of sampling one or more field variables along a side/boundary at each quadrature point along the side.

    Specification(s): external

    Design: SideValueSampler

    Issue(s): #3087

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.57The system shall be capable of sampling one or more field variables along an internal side at each quadrature point along the side.

    Specification(s): internal

    Design: SideValueSampler

    Issue(s): #3087

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.58The system shall allow outputting relevant information about sidesets

    Specification(s): sideset_info

    Design: SidesetInfoVectorPostprocessor

    Issue(s): #14275

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.59The system shall be able to query a spatial user object and aggregate the results into a vector postprocessor.

    Specification(s): test

    Design: SpatialUserObjectVectorPostprocessor

    Issue(s): #18473

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.60The system shall error if the points are specified in more than one manner for a spatial vector postprocessor.

    Specification(s): missing_pts

    Design: SpatialUserObjectVectorPostprocessor

    Issue(s): #19831

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 11.62.61The system shall support computing the spherical average of a variable as a function of radius throughout the mesh domain.

    Specification(s): test

    Design: SphericalAverage

    Issue(s): #7810

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.62The system shall support the ability to output a separate comma separated value file containing time and time time information corresponding to vector Postprocessor output.

    Specification(s): test

    Design: VectorPostprocessors System

    Issue(s): #6618

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.63The system shall allow support the creation of histogram or binned data of volume fractions with respect to variable values.

    Specification(s): test

    Design: VariableValueVolumeHistogram

    Issue(s): #7803#7801

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.64The system shall be able to aggregate an arbitrary set of scalar data producers (Postprocessors) into a single vector of Postprocessors.

    Specification(s): test

    Design: VectorOfPostprocessors

    Issue(s): #4176

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 11.62.65The system shall have the ability to compute several statistics related to the balance of the mesh partitioning
    1. on replicated meshes, and
    2. on distributed meshes.

    Specification(s): work_balance/replicated, work_balance/distributed

    Design: WorkBalance

    Issue(s): #11209#11274

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

Usability Requirements

Performance Requirements

System Interface Requirements

References

  1. D. F. Griffiths. The `No Boundary Condition' outflow boundary condition. International Journal of Numerical Methods in Fluids, 24(4):393–411, 1997. URL: http://tinyurl.com/y77au2k.[BibTeX]