Framework System Design Description

This template follows INL template TEM-140, "IT System Design Description."

Introduction

Frameworks are a software development construct aiming to simplify the creation of specific classes of applications through abstraction of low-level details. The main objective of creating a framework is to provide an interface to application developers that saves time and provides advanced capabilities not attainable otherwise. The MOOSE mission is just that: provide a framework for engineers and scientists to build state-of-the-art, computationally scalable finite element or finite volume based simulation tools.

MOOSE was conceived with one major objective: to be as easy and straightforward to use by scientists and engineers as possible. MOOSE is meant to be approachable by non-computational scientists who have systems of PDEs they need to solve. Every single aspect of MOOSE was driven by this singular principle from the build system to the API to the software development cycle. At every turn, decisions were made to enable this class of users to be successful with the framework. The pursuit of this goal has led to many of the unique features of MOOSE:

  • A streamlined build system

  • An API aimed at extensibility

  • Straightforward APIs providing sensible default information

  • Integrated, automatic, and rigorous testing

  • Rapid, continuous integration development cycle

  • Codified, rigorous path for contributing

  • Applications are modular and composable

Each of these characteristics is meant to build trust in the framework by those attempting to use it. For instance, the build system is the first thing potential framework users come into contact with when they download a new software framework. Onerous dependency issues, complicated, hard to follow instructions or build failure can all result in a user passing on the platform. Ultimately, the decision to utilize a framework comes down to whether or not you trust the code in the framework and those developing it to be able to support your desired use-case. No matter the technical capabilities of a framework, without trust users will look elsewhere. This is especially true of those not trained in software development or computational science.

Developing trust in a framework goes beyond utilizing "best practices" for the code developed, it is equally important that the framework itself is built upon tools that are trusted. For this reason, MOOSE relies on a well-established code base of libMesh and PETSc. The libMesh library provides foundational capability for the finite element method and provides interfaces to leading-edge numerical solution packages such as PETSc.

With these principles in mind, an open source, massively parallel, finite element, multiphysics framework has been conceived. MOOSE is an on-going project started in 2008 aimed toward a common platform for creation of new multiphysics tools. This document provides design details pertinent to application developers as well as framework developers.

Use Cases

The MOOSE Framework is targeted at two main groups of actors: Developers and Users. Developers are the main use case. These are typically students and professionals trained in science and engineering fields with some level of experience with coding but typically very little formal software development training. The other user group is Users. Those who intend to use an application built upon the framework without writing any computer code themselves. Instead they may modify or create input files for driving a simulation, run the application, and analyze the results. All interactions through MOOSE are primarily through the command-line interface and through a customizable block-based input file.

System Purpose

The Software Design Description provided here is description of each object in the system. The pluggable architecture of the framework makes MOOSE and MOOSE-based applications straightforward to develop as each piece of end-user (developer) code that goes into the system follows a well-defined interface for the underlying systems that those object plug into. These descriptions are provided through developer-supplied "markdown" files that are required for all new objects that are developed as part of the framework, modules and derivative applications. More information about the design documentation can be found in Documenting MOOSE.

System Scope

The purpose of this software is to provide several libraries that can be used to build an application based upon the framework. Additionally, several utilities are provided for assisting developers and users in end-to-end FEM analysis. A brief overview of the major components are listed here:

ComponentDescription
framework libraryThe base system from which all MOOSE-based applications are created
module librariesOptional "physics" libraries that may be used in an application to provide capability
build systemThe system responsible for creating applications for a series of libraries and applications
test harnessThe extendable testing system for finding, scheduling, running, and reporting regression tests
"peacock"The GUI for building input files, executing applications, and displaying results
MooseDocsThe extendable markdown system for MOOSE providing common documentation and requirements enforcement
"stork"The script and templates for generating a new MOOSE-based application ready for building and testing
examplesA set of complete applications demonstrating the use of MOOSE's pluggable systems
tutorialsStep by step guides to building up an application using MOOSE's pluggable systems
unitAn application for unit testing individual classes or methods of C++ code

Dependencies and Limitations

The MOOSE platform has several dependencies on other software packages and has scope that is constantly evolving based upon funding, resources, priorities, and lab direction. However, the software is open-source and many features and even bugs can be offloaded to developers with appropriate levels of knowledge and direction from the main design team. The primary list of software dependencies is listed below. This list is not meant to be exhaustive. Individual operating systems may require specific packages to be installed prior to using MOOSE, which can be found on the Install MOOSE pages.

Software DependencyDescription
libMeshFinite Element Library and I/O routines
PETScSolver Package
hypreMultigrid Preconditioner
MPIA distributed parallel processing library (MPICH)

Figure 1: A diagram of the MOOSE code platform.

Definitions and Acronyms

This section defines, or provides the definition of, all terms and acronyms required to properly understand this specification.

Definitions

  • Pull (Merge) Request: A proposed change to the software (e.g. usually a code change, but may also include documentation, requirements, design, and/or testing).

  • Baseline: A specification or product (e.g., project plan, maintenance and operations (M&O) plan, requirements, or design) that has been formally reviewed and agreed upon, that thereafter serves as the basis for use and further development, and that can be changed only by using an approved change control process (NQA-1, 2009).

  • Validation: Confirmation, through the provision of objective evidence (e.g., acceptance test), that the requirements for a specific intended use or application have been fulfilled (24765:2010(E), 2010).

  • Verification: (1) The process of: evaluating a system or component to determine whether the products of a given development phase satisfy the conditions imposed at the start of that phase. (2) Formal proof of program correctness (e.g., requirements, design, implementation reviews, system tests) (24765:2010(E), 2010).

Acronyms

AcronymDescription
APIApplication Programming Interface
DOE-NEDepartment of Energy, Nuclear Energy
FEfinite element
FEMFinite Element Method
GUIgraphical user interface
HITHierarchical Input Text
HPCHigh Performance Computing
I/OInput/Output
INLIdaho National Laboratory
MOOSEMultiphysics Object Oriented Simulation Environment
MPIMessage Passing Interface
PDEspartial differential equations

Design Stakeholders and Concerns

Design Stakeholders

Stakeholders for MOOSE include several of the funding sources including DOE-NE and the INL. However, Since MOOSE is an open-source project, several universities, companies, and foreign governments have an interest in the development and maintenance of the MOOSE project.

Stakeholder Design Concerns

Concerns from many of the stakeholders are similar. These concerns include correctness, stability, and performance. The mitigation plan for each of these can be addressed. For correctness, MOOSE development requires either regression or unit testing for all new code added to the repository. The project contains several comparisons against analytical solutions where possible and also other verification methods such as MMS. For stability, MOOSE maintains multiple branches to incorporate several layers of testing both internally and for dependent applications. Finally, performance tests are also performed as part of the the normal testing suite to monitor code change impacts to performance.

System Design

The MOOSE framework itself is composed of a wide range of pluggable systems. Each system is generally composed of a single or small set of C++ objects intended to be specialized by a Developer to solve a specific problem. To accomplish this design goal, MOOSE uses several modern object-oriented design patterns. The primary overarching pattern is the "Factory Pattern". Users needing to extend MOOSE may inherit from one of MOOSE's systems to providing an implementation meeting their needs. The design of each of these systems is documented on the MOOSE homepage. Additionally, up-to-date documentation extracted from the source is maintained on the same documentation site after every successful merge to MOOSE's stable branch. After these objects are created, they can be registered with the framework and used immediately in a MOOSE input file.

System Structure

The MOOSE framework architecture consists of a core and several pluggable systems. The core of MOOSE consists of a number of key objects responsible for setting up and managing the user-defined objects of a finite element simulation. This core set of objects has limited extendability and exist for every simulation configuration that the framework is capable of running.

Adaptivity

Adaptivity/Indicators

Adaptivity/Markers

Application

AuxKernels

AuxKernels/MatVecRealGradAuxKernel

AuxKernels/MaterialVectorAuxKernel

AuxKernels/MaterialVectorGradAuxKernel

AuxScalarKernels

AuxVariables

AuxVariables/MultiAuxVariables

BCs

BCs/CavityPressure

BCs/CoupledPressure

BCs/InclinedNoDisplacementBC

BCs/Periodic

BCs/Pressure

Bounds

ChemicalComposition

Closures

Components

Constraints

Contact

ControlLogic

Controls

CoupledHeatTransfers

Covariance

DGKernels

Dampers

Debug

Debug/MaterialDerivativeTest

DeprecatedBlock

DiracKernels

Distributions

DomainIntegral

Executioner

Executioner/Adaptivity

Executioner/Predictor

Executioner/Quadrature

Executioner/TimeIntegrator

Executioner/TimeStepper

Executioner/TimeSteppers

Executors

ExplicitDynamicsContact

FVBCs

FVICs

FVInterfaceKernels

FVKernels

FluidProperties

FluidPropertiesInterrogator

Functions

FunctorMaterials

GeochemicalModelInterrogator

GlobalParams

GrayDiffuseRadiation

HeatStructureMaterials

ICs

ICs/PolycrystalICs

ICs/PolycrystalICs/BicrystalBoundingBoxIC

ICs/PolycrystalICs/BicrystalCircleGrainIC

ICs/PolycrystalICs/PolycrystalColoringIC

ICs/PolycrystalICs/PolycrystalRandomIC

ICs/PolycrystalICs/PolycrystalVoronoiVoidIC

ICs/PolycrystalICs/Tricrystal2CircleGrainsIC

InterfaceKernels

Kernels

Kernels/CHPFCRFFSplitKernel

Kernels/DynamicSolidMechanics

Kernels/DynamicTensorMechanics

Kernels/HHPFCRFFSplitKernel

Kernels/PFCRFFKernel

Kernels/PolycrystalElasticDrivingForce

Kernels/PolycrystalKernel

Kernels/PolycrystalStoredEnergy

Kernels/PoroMechanics

Kernels/RigidBodyMultiKernel

Kernels/SolidMechanics

Kernels/TensorMechanics

Likelihood

Materials

Mesh

Mesh/Partitioner

MeshDivisions

Modules

Modules/CompressibleNavierStokes

Modules/FluidProperties

Modules/HeatTransfer

Modules/HeatTransfer/ThermalContact

Modules/HeatTransfer/ThermalContact/BC

Modules/IncompressibleNavierStokes

Modules/NavierStokesFV

Modules/Peridynamics

Modules/Peridynamics/Mechanics

Modules/Peridynamics/Mechanics/GeneralizedPlaneStrain
Modules/Peridynamics/Mechanics/Master

Modules/PhaseField

Modules/PhaseField/Conserved

Modules/PhaseField/DisplacementGradients

Modules/PhaseField/EulerAngles2RGB

Modules/PhaseField/GrainGrowth

Modules/PhaseField/GrainGrowthLinearizedInterface

Modules/PhaseField/GrandPotential

Modules/PhaseField/Nonconserved

Modules/PorousFlow

Modules/PorousFlow/BCs

Modules/SolidProperties

Modules/TensorMechanics

Modules/TensorMechanics/CohesiveZoneMaster

Modules/TensorMechanics/DynamicMaster

Modules/TensorMechanics/GeneralizedPlaneStrain

Modules/TensorMechanics/GlobalStrain

Modules/TensorMechanics/LineElementMaster

Modules/TensorMechanics/Master

Modules/TensorMechanics/MaterialVectorBodyForce

MortarGapHeatTransfer

MultiApps

NEML2

NodalKernels

NodalNormals

Optimization

OptimizationReporter

Outputs

ParameterStudy

Physics

Physics/Diffusion

Physics/Diffusion/ContinuousGalerkin

Physics/Diffusion/FiniteVolume

Physics/HeatConduction

Physics/HeatConduction/FiniteElement

Physics/SolidMechanics

Physics/SolidMechanics/CohesiveZone

Physics/SolidMechanics/Dynamic

Physics/SolidMechanics/GeneralizedPlaneStrain

Physics/SolidMechanics/GlobalStrain

Physics/SolidMechanics/LineElement

Physics/SolidMechanics/LineElement/QuasiStatic

Physics/SolidMechanics/MaterialVectorBodyForce

Physics/SolidMechanics/QuasiStatic

PorousFlowBasicTHM

PorousFlowFullySaturated

PorousFlowUnsaturated

Positions

Postprocessors

Preconditioning

Problem

ProjectedStatefulMaterialStorage

RayBCs

RayKernels

ReactionNetwork

ReactionNetwork/AqueousEquilibriumReactions

ReactionNetwork/SolidKineticReactions

Reporters

Samplers

ScalarKernels

SolidProperties

SpatialReactionSolver

StochasticTools

Surrogates

ThermalContact

TimeDependentReactionSolver

TimeIndependentReactionSolver

Times

Trainers

Transfers

UserObjects

VariableMappings

Variables

Variables/CHPFCRFFSplitVariables

Variables/HHPFCRFFSplitVariables

Variables/PFCRFFVariables

Variables/PolycrystalVariables

VectorPostprocessors

XFEM

The MooseApp is the top-level object used to hold all of the other objects in a simulation. In a normal simulation a single MooseApp object is created and "run()". This object uses its Factory objects to build user defined objects which are stored in a series of Warehouse objects and executed. The Finite Element data is stored in the Systems and Assembly object while the domain information (the Mesh) is stored in the Mesh object. A series of threaded loops are used to run parallel calculations on the objects created and stored within the warehouses.

MOOSE's pluggable systems are documented on https://mooseframework.inl.gov. Each of these systems has a set of defined polymorphic interfaces and are designed to accomplish a specific task within the simulation. The design of these systems is fluid and is managed through agile methods and ticket request system on the MOOSE repository website.

Data Design and Control

At a high level, the system is designed to process HIT input files to construct several objects that will constitute an FE simulation. Some of the objects in the simulation may in turn load other file-based resources to complete the simulation. Examples include meshes or data files. The system will then assemble systems of equations and solve them using the libraries of the Code Platform. The system can then output the solution in one or more supported output formats commonly used for visualization.

Human-Machine Interface Design

MOOSE is a command-line driven program. All interaction with MOOSE and MOOSE-based codes is ultimately done through the command line. This is typical for HPC applications that use the MPI interface for running on super computing clusters. Optional GUIs may be used to assist in creating input files and launching executables on the command line.

System Design Interface

All external system interaction is performed either through file I/O or through local API calls. Neither the framework, nor the modules are designed to interact with any external system directly through remote procedure calls. Any code to code coupling performed using the framework are done directly through API calls either in a static binary or after loading shared libraries.

Security Structure

The framework does not require any elevated privileges to operate and does not run any stateful services, daemons or other network programs. Distributed runs rely on the MPI library.

Requirements Cross-Reference

  • framework: Reporter System
  • 1.1.6The 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

  • 1.41.125The 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

  • 1.41.179The 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

  • 1.54.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

  • 1.54.3The system shall report an error if an invalid name is provided when retrieving aggregate value.

    Specification(s): error

    Design: Reporter System

    Issue(s): #11323

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.54.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.54.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

  • 1.54.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

  • 1.54.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

  • framework: Markers System
  • 1.2.3The 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

  • 1.2.4The 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

  • 1.2.5The 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

  • 1.2.7The 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

  • 1.31.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

  • 1.31.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#24645

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.31.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#24645

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.31.4The adaptivity system shall create an auxiliary field variable that marks elements for refinement adjacent to any of a given set of boundaries.

    Specification(s): multiple

    Design: Markers SystemBoundaryMarker

    Issue(s): #1275#24645

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.31.5The 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

  • 1.31.6The 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

  • 1.31.14It 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.31.16The 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

  • 1.31.17The 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

  • 1.31.18The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.31.19The 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

  • 1.31.20The 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

  • framework: FunctionArrayAux
  • 1.3.3The system shall include the ability to set the value of an array variable using a function.

    Specification(s): test

    Design: FunctionArrayAux

    Issue(s): #15811

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: ArrayParsedAux
  • 1.3.4The system shall be able to evaluate a parsed expression dependent on an array of variable values.

    Specification(s): array_parsed_aux

    Design: ArrayParsedAux

    Issue(s): #20818

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.5The system shall issue an error when evaluating a parsed expression with array variable values if the number of components of the variable and coupled variables do not match.

    Specification(s): array_parsed_aux_error

    Design: ArrayParsedAux

    Issue(s): #20818

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: AuxKernel
  • 1.3.6The system shall provide a way to convert a component of an array variable to a standard variable.

    Specification(s): test

    Design: AuxKernel

    Issue(s): #6881

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.105The system shall resolve the dependency of auxiliary kernels on user objects including the objects that the aux kernels indirectly depend on.

    Specification(s): test

    Design: AuxKernel

    Issue(s): #14664

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: ArrayVarReductionAux
  • 1.3.7The system shall provide a way to reduce values in an array variable to a single variable using max/min/sum/average operations.

    Specification(s): test

    Design: ArrayVarReductionAux

    Issue(s): #22809

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: BuildArrayVariableAux
  • 1.3.10The system shall support the copy the values of standard variables into the component fields of an array variable.

    Specification(s): test

    Design: BuildArrayVariableAux

    Issue(s): #16402

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.11The system shall report a reasonable error when copying standard variables into the components of an array variable when
    1. the variables have inconsistent sizes or
    2. when the variables have inconsistent types.

    Specification(s): error/size, error/type

    Design: BuildArrayVariableAux

    Issue(s): #16402

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: ConstantScalarAux
  • 1.3.12The ConstantScalarAux object shall set the value of an scalar auxiliary variable to a constant value.

    Specification(s): test

    Design: ConstantScalarAux

    Issue(s): #1933

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: ContainsPointAux
  • 1.3.13The system shall be able to identify what element contains a point through visualization of an auxiliary variable.

    Specification(s): test

    Design: ContainsPointAux

    Issue(s): #22534

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: CopyValueAux
  • 1.3.14The system shall be able to copy from a variable to another of the same finite element family and order.

    Specification(s): copy

    Design: CopyValueAux

    Issue(s): #22373

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: Assembly
  • 1.3.15The system shall make current boundary id available in objects evaluated on boundaries.

    Specification(s): current_boundary_id

    Design: Assembly

    Issue(s): #13953

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.37.176We 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

  • 1.37.177We 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

  • 1.37.178We 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

  • 1.37.179If 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

  • 1.37.180A 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.37.181A 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.37.182If 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

  • 1.37.183If 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

  • 1.37.184A 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.37.185The 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

  • framework: DivergenceAux
  • 1.3.18The system shall be able to compute the divergence of a vector of finite element variables.

    Specification(s): finite_element

    Design: DivergenceAux

    Issue(s): #20955

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.3.19The system shall be able to compute the divergence of a vector of finite volume variables.

    Specification(s): finite_volume

    Design: DivergenceAux

    Issue(s): #20955

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: MaterialRealAux
  • 1.3.20The variable data created by a MaterialRealAux object shall support being limited to boundaries.

    Specification(s): test

    Design: MaterialRealAux

    Issue(s): #3114

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: ElementLengthAux
  • 1.3.29The system shall include an AuxKernel object for returning the element length.

    Specification(s): test

    Design: ElementLengthAux

    Issue(s): #7597

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: MooseVariableFE
  • 1.3.35The system shall include the ability to access the normal of a coupled variable within an AuxKernel object.

    Specification(s): test

    Design: AuxKernels SystemMooseVariableFE

    Issue(s): #3558

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.37.3We 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

  • 1.37.4Coupling 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

  • 1.37.5We 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

  • 1.37.6We 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

  • 1.48.65The system shall support retrieving solution values from neighboring elements for use in internal side calculations.

    Specification(s): test

    Design: MooseVariableFE

    Issue(s): #9390

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: FunctionScalarAux
  • 1.3.37The system shall include the ability to set the value of a scalar variable using a function.

    Specification(s): test

    Design: FunctionScalarAux

    Issue(s): #3499

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: GapValueAux
  • 1.3.39The system shall include the ability to report values on a boundary from a boundary across a mesh gap.

    Specification(s): test

    Design: GapValueAux

    Issue(s): #1630

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.40The system shall include the ability to report values on a boundary from a boundary across a mesh gap for a block restricted variable.

    Specification(s): test_restricted

    Design: GapValueAux

    Issue(s): #1630

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.55The system shall report an error in the penetration locator system if penetration is not detected.

    Specification(s): never_warning

    Design: GapValueAuxMesh System

    Issue(s): #3901

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.23.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

  • framework: RelationshipManager
  • 1.3.42The system shall utilize the minimum of ghosting necessary for the problem

    Specification(s): no_algebraic_ghosting

    Design: GhostingAuxRelationshipManager

    Issue(s): #12327

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.11.7When 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

  • 1.11.8When 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

  • 1.11.9If 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

  • 1.11.10This 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

  • 1.11.11This 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

  • 1.11.12This 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

  • 1.53.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

  • 1.53.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

  • 1.53.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

  • 1.53.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

  • 1.53.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

  • 1.53.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

  • 1.53.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

  • 1.53.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

  • 1.53.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

  • framework: VariableGradientComponent
  • 1.3.43The system shall include the ability to extract a component of a linear Lagrange variable gradient as an auxiliary variable.

    Specification(s): lagrange

    Design: VariableGradientComponent

    Issue(s): #3881

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.44The system shall include the ability to extract a component of a first order monomial variable gradient as an auxiliary variable.

    Specification(s): monomial

    Design: VariableGradientComponent

    Issue(s): #3881

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: HardwareIDAux
  • 1.3.45The system shall allow visualization of the MPI processes mapping to compute nodes

    Specification(s): test

    Design: HardwareIDAux

    Issue(s): #12629#12630

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: ParsedAux
  • 1.3.46The system shall include the ability to compute the linear combination of variables as an auxiliary variable.

    Specification(s): test

    Design: ParsedAux

    Issue(s): #4281#4871

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.72The system shall include an AuxKernel object capable of computing values from a functional expression.

    Specification(s): test

    Design: ParsedAux

    Issue(s): #4807

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.73The parsed expression AuxKernel in The system shall expose quadrature/nodal point coordinates and time if requested by the user.

    Specification(s): xyzt

    Design: ParsedAux

    Issue(s): #15877

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.74The system shall be able to compute a vector of values from a vector of functional expressions.

    Specification(s): test

    Design: ParsedAux

    Issue(s): #4807

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: Mesh System
  • 1.3.50The system shall include the ability to use extra element integers.

    Specification(s): mesh_integer

    Design: Mesh System

    Issue(s): #13764

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.51The system shall include the ability to use extra element integers on element faces.

    Specification(s): dg_mesh_integer

    Design: Mesh System

    Issue(s): #16005

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.5.75The 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

  • 1.5.76The 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

  • 1.9.5The system shall support cylindrical coordinates with a general axis.

    Specification(s): rz_general

    Design: Mesh System

    Issue(s): #24339

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.55The system shall report an error in the penetration locator system if penetration is not detected.

    Specification(s): never_warning

    Design: GapValueAuxMesh System

    Issue(s): #3901

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.23.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

  • 1.33.11The system shall get the correct mesh dimension for a list of subdomains.

    Specification(s): test

    Design: Mesh System

    Issue(s): #23794

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.33.13The 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

  • 1.33.22The system shall compute and store internal finite volume related element data on request for
    1. quadrilateral elements,
    2. quadrilateral elements in a cylindrical coordinate system, and
    3. triangular elements.

    Specification(s): elem_info/quad, elem_info/rz-quad, elem_info/tri

    Design: Mesh System

    Issue(s): #25824

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.33.23The 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

  • 1.33.26The 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

  • 1.33.27The 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

  • 1.33.28The 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

  • 1.33.29The 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

  • 1.33.30The 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

  • 1.33.31The system shall support refinement of TRI7 mesh elements.

    Specification(s): test_tri7_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.33.32The 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

  • 1.33.33The 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

  • 1.33.34The 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

  • 1.33.35The 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

  • 1.33.36The 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

  • 1.33.37The system shall support refinement of TET14 mesh elements.

    Specification(s): test_tet14_refine

    Design: Mesh System

    Issue(s): #4989#5021

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.33.38The 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

  • 1.33.39The 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

  • 1.33.40The 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

  • 1.33.41The 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

  • 1.33.42The 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

  • 1.33.43The 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

  • 1.33.58The 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

  • 1.33.59The 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

  • 1.33.60The 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

  • 1.33.61The 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

  • 1.33.62The 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

  • 1.33.63The system shall allow writing out the mesh with extra element ids without running a simulation.

    Specification(s): mesh_only_with_extra_elem_ids

    Design: Mesh System

    Issue(s): #23386

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.33.64The system shall allow writing out the mesh with extra element ids without running a simulation and user-provided id names.

    Specification(s): mesh_only_with_restricted_elem_ids

    Design: Mesh System

    Issue(s): #23386

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.33.65The system shall throw a warning if user-provided extra element id names do not exist on mesh.

    Specification(s): mesh_only_with_unrecognized_elem_ids

    Design: Mesh System

    Issue(s): #23386

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.33.66The 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

  • 1.33.67The 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

  • 1.33.68The 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

  • 1.33.69The 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

  • 1.33.70The 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

  • 1.33.71The 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

  • 1.33.72The 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

  • 1.33.73The 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

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

    Specification(s): nemesis_test

    Design: Mesh SystemNemesis

    Issue(s): #2520#23006

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.33.75The 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#23006

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.33.76The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.33.80The 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

  • 1.33.81The 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

  • 1.33.82The 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

  • 1.33.83The system shall ensure that the mesh is prepared at the time users execute their simulation.

    Specification(s): test

    Design: Mesh System

    Issue(s): #14329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.33.88The 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

  • 1.33.104The 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

  • 1.33.105The 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

  • 1.33.106The 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

  • 1.35.94The system shall be able to give a clear error message about a cyclic graph in mesh generation.

    Specification(s): error

    Design: Mesh System

    Issue(s): #21743

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.98The system shall support the generation of meshes for both reference and displaced mesh configurations.

    Specification(s): test

    Design: Mesh System

    Issue(s): #12712

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.121The system shall support assigning subdomain identifiers
    1. given a list of ids for each element; and
    2. given a list of elements and ids for quadrilateral and
    3. triangular elements.

    Specification(s): assign/quad_test, assign/quad_elementid_test, assign/tri_test

    Design: Mesh System

    Issue(s): #13814

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.153The system shall support using a directed acyclic graph of objects to generate a mesh where multiple possible end points may be explicitly selected:
    1. the first of two targets
    2. and the second of two targets.

    Specification(s): final_select/first, final_select/second

    Design: Mesh System

    Issue(s): #14058

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.154The system shall support selecting an earlier generation state of the mesh generator system used to generate the final mesh for a simulation.

    Specification(s): final_early_stop

    Design: Mesh System

    Issue(s): #14058

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.155The system shall generate an error when the objects used to generate a mesh results in an ambiguous end point
    1. due to a single graph with multiple end points, or
    2. due to multiple independent trees.

    Specification(s): ambigious/single_graph, ambigious/independent_graphs

    Design: Mesh System

    Issue(s): #14058

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.169The system shall support creating subdomains from
    1. 2D and
    2. 3D images.

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

    Design: Mesh System

    Issue(s): #13814

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.194The system shall support the modification of the mesh
    1. without restriction to the order of the supplied inputs with

    Specification(s): order/depend_order

    Design: Mesh System

    Issue(s): #13814

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.37.186The 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

  • 1.37.194The system shall report an error if the user provides inconsistent parameter values to the mesh and problem for the parameters related to
    1. subdomain blocks
    2. coordinate system types

    Specification(s): bad_params/block, bad_params/coord_type

    Design: Mesh System

    Issue(s): #21975

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.68If 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.48.14The system shall support running Postprocessors on the the mesh containing displacements:
    1. elemental and
    2. side.

    Specification(s): displaced_tests/elemental, displaced_tests/side

    Design: Mesh System

    Issue(s): #5750

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: Coupleable
  • 1.3.54The system shall include the ability to limit the execution of an AuxKernel object to initial setup.

    Specification(s): init_test

    Design: AuxKernels SystemCoupleable

    Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83#22563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.55The system shall include the ability to couple auxiliary variables.

    Specification(s): test

    Design: AuxKernels SystemCoupleable

    Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83#22563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.56The system shall be capable of resolving dependencies between AuxKernel objects regardless of input file order.

    Specification(s): sort_test

    Design: AuxKernels SystemCoupleable

    Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83#22563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.57Auxiliary kernel objects shall be capable of writing to multiple coupled variables.

    Specification(s): multi_update_test

    Design: AuxKernels SystemCoupleable

    Issue(s): #2099

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.58Writing to auxiliary variables shall be limited to use from AuxKernels, ElementUserObjects, or NodalUserObjects.

    Specification(s): multi_update_error

    Design: AuxKernels SystemCoupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.3.59Auxiliary kernel objects shall be capable of writing to to multiple coupled variables using the deprecated writeCoupledValue method.

    Specification(s): multi_update_deprecated_test

    Design: AuxKernels SystemCoupleable

    Issue(s): #2099

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.60Writing to auxiliary variables shall be limited to use from AuxKernels, ElementUserObjects, or NodalUserObjects using variable values.

    Specification(s): multi_update_deprecated_error

    Design: AuxKernels SystemCoupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.3.61The writing to auxiliary variables shall enforce nodal/elemental consistency between the kernel variable and the writable variables.

    Specification(s): multi_update_deprecated_error2

    Design: AuxKernels SystemCoupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.3.62The writableCoupledValue API can only act on AuxVariables.

    Specification(s): multi_update_deprecated_error3

    Design: AuxKernels SystemCoupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.3.63The writing to auxiliary variables shall error out if a constant value is passed in as variable name.

    Specification(s): multi_update_deprecated_error4

    Design: AuxKernels SystemCoupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.3.64Auxiliary kernel objects shall be capable of writing to finite volume coupled variables.

    Specification(s): multi_update_fv_test

    Design: AuxKernels SystemCoupleable

    Issue(s): #25661

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.65The MOOSE auxiliary system shall be capable of updating multiple elemental auxiliary variables within a single AuxKernel object, including the kernel variable itsef using the setNodalValue method.

    Specification(s): multi_update_elem_test

    Design: AuxKernels SystemCoupleable

    Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83#22563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.66The MOOSE auxiliary system shall be capable of updating multiple elemental auxiliary variables within a single AuxKernel object.

    Specification(s): multi_update_elem_test_coupled_value

    Design: AuxKernels SystemCoupleable

    Issue(s): #22563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.67The MOOSE auxiliary system shall check compatibility between primary and writable coupled variables.

    Specification(s): multi_update_elem_family_error

    Design: AuxKernels SystemCoupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.3.68The MOOSE auxiliary system shall be capable of coupling to nonlinear variables at the end of a timestep.

    Specification(s): ts_test

    Design: AuxKernels SystemCoupleable

    Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83#22563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.5.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

  • 1.5.15The system shall be able to compute the residual and Jacobian together when boundary conditions couple in variables defined on lower-dimensional blocks.

    Specification(s): resid_and_jac_together

    Design: Coupleable

    Issue(s): #19444

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.29.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

  • 1.29.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

  • 1.29.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

  • 1.29.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

  • 1.29.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

  • 1.29.17The 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

  • 1.29.18The 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

  • 1.29.19The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.29.42The 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

  • 1.29.43The 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

  • 1.29.44The 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

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

    Specification(s): test

    Design: Coupleable

    Issue(s): #13913

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.37.137The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.37.138The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.37.139The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.37.140The system shall report an error if an object tries to get the name of a coupled constant.

    Specification(s): coupled_constant_yet_needs_name

    Design: Coupleable

    Issue(s): #22597

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.48.9The system shall allow for the retrieval of raw elemental degree-of-freedom values directly for elemental evaluations.

    Specification(s): test

    Design: Coupleable

    Issue(s): #9690#9758

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.67.102The system shall allow nodal user objects to obtain writable references to nodal variables.

    Specification(s): nodal

    Design: Coupleable

    Issue(s): #22563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.103The system shall allow elemental user objects to obtain writable references to elemental variables.

    Specification(s): elemental

    Design: Coupleable

    Issue(s): #22563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.104The system shall prevent nodal user objects from obtaining writable references to elemental variables.

    Specification(s): nodal_error

    Design: Coupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.67.105The system shall prevent elemental user objects from obtaining writable references to nodal variables.

    Specification(s): elemental_error

    Design: Coupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.67.106The system shall allow block restricted user objects to obtain a writable reference to a variable with a block restriction that includes the user object's blocks

    Specification(s): block

    Design: Coupleable

    Issue(s): #22563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.107The system shall enforce that all variables an object obtains a writable reference to are defined on all of the object's blocks

    Specification(s): block_error

    Design: Coupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.67.108The system shall permit multiple objects to access a variable for writing if the objects have non-overlapping block restrictions

    Specification(s): block2

    Design: Coupleable

    Issue(s): #22563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.109The system shall report an error if multiple objects with overlapping block restrictions try to access a variable for writing

    Specification(s): block2_error

    Design: Coupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.67.110The system shall report an error if multiple objects, of which at least one is not block restricted, try to access a variable for writing

    Specification(s): block2_error2

    Design: Coupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.67.111The system shall permit writing to variables from boundary restricted nodal user objects.

    Specification(s): boundary

    Design: Coupleable

    Issue(s): #22563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.112The system shall make sure that variables written to by boundary restricted user objects are available along the entire boundary.

    Specification(s): boundary_error

    Design: Coupleable

    Issue(s): #22563

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.69.21Allow optional variable coupling where a default constant value is assumed when the user omits specifying a variable.

    Specification(s): use_default

    Design: Coupleable

    Issue(s): #2358

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.69.22Users are allowed to provide constant numeric values as input to an optionally coupled variable in addition to variable names that overrides the default constant value specified in code.

    Specification(s): use_real_input_param

    Design: Coupleable

    Issue(s): #2435

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.69.23Simulations with second derivative variable coupling shall not crash due to access to uninitialized data structures.

    Specification(s): optionally_coupled_system

    Design: Coupleable

    Issue(s): #4964

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.69.24Coupleable shall provide an interface that allows providing default values for a variables that operates
    1. with defaults or
    2. a vector of coupled variables.

    Specification(s): two_coupled/default_1, two_coupled/default_2

    Design: Coupleable

    Issue(s): #11920

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.69.25The system shall report an error when users couple constant values and variables together

    Specification(s): two_coupled_default_fail_mixed_input

    Design: Coupleable

    Issue(s): #11920

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.69.26The system shall report an error when requested default vector value is out of range and
    1. accessed by name or
    2. accessed by index.

    Specification(s): catch_out_of_bound_default_access/coupledValue, catch_out_of_bound_default_access/coupled

    Design: Coupleable

    Issue(s): #11920

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: QuotientAux
  • 1.3.79The system shall support the ability to compute the quotient of two variables.

    Specification(s): quotient_aux

    Design: QuotientAux

    Issue(s): #1394

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: VectorMagnitudeAux
  • 1.3.107The system shall include the ability to compute the Euclidean norm of three coupled variables.

    Specification(s): test

    Design: VectorMagnitudeAux

    Issue(s): #1894

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: VectorMaterialRealVectorValueAux
  • 1.3.108The system shall be able to output vector auxiliary variables based on the values of vector material properties, regardless of whether the material properties are computed using automatic differentiation or not.

    Specification(s): exo

    Design: VectorMaterialRealVectorValueAux

    Issue(s): #15495

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: VolumeAux
  • 1.3.112The system shall include the ability to sample
    1. elemental
    2. and side volumes

    Specification(s): test/element, test/side

    Design: VolumeAux

    Issue(s): #19307

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.3.113The system shall report a reasonable error when trying to sample element volumes into a non constant monomial variable

    Specification(s): incorrect_type

    Design: VolumeAux

    Issue(s): #19307

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: BatchMaterial
  • 1.4.1The batch material system shall provide the capability for gathering and serializing variable and material property values for batch property computation.

    Specification(s): test

    Design: BatchMaterial

    Issue(s): #21225

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • framework: NeumannBC
  • 1.5.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

  • 1.5.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

  • 1.29.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

  • framework: ADNeumannBC
  • 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

  • 1.29.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

  • framework: ADFunctionDirichletBC
  • 1.5.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

  • 1.5.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

  • 1.5.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

  • 1.5.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

  • 1.5.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

  • 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

  • framework: ADDirichletBC
  • 1.5.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

  • 1.5.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

  • 1.29.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

  • framework: ADDiffusion
  • 1.5.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

  • 1.5.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

  • 1.5.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

  • 1.29.37Jacobian 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

  • framework: ADFunctionNeumannBC
  • 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

  • framework: ADMatchedValueBC
  • 1.5.18The 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

  • 1.5.19The 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

  • framework: BCs System
  • 1.5.20The system shall be able to impose a nodal boundary condition constraint that involves nonlocal degrees of freedom and
    1. get the expected result in which the average value of the solution is zero, and
    2. exhibit a perfect Jacobian.

    Specification(s): test/residual, test/jacobian

    Design: BCs System

    Issue(s): #23940

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTesterExodiff

  • 1.5.26The 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

  • 1.5.27The 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

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

    Specification(s): test

    Design: BCs System

    Issue(s): #656

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.5.43The 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

  • 1.5.44The 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

  • 1.5.45The 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

  • 1.5.46The 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

  • 1.5.74The 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

  • 1.5.75The 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

  • 1.5.76The 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

  • 1.5.79BoundaryCondition objects shall support retrieval of VectorPostprocessor data.

    Specification(s): test

    Design: BCs System

    Issue(s): #9285

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: ArrayVacuumBC
  • 1.5.23The system shall provide array vacuum boundary condition.

    Specification(s): test

    Design: ArrayVacuumBC

    Issue(s): #6881

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: FunctionNeumannBC
  • 1.5.37The 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

  • framework: MatNeumannBC
  • 1.5.40The 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

  • 1.5.41The 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

  • framework: NodalNormals System
  • 1.5.47The 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

  • 1.5.48The 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

  • 1.5.49The 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

  • 1.5.50The 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

  • 1.5.51The 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

  • 1.5.52The 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

  • framework: Periodic System
  • 1.5.55The 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

  • 1.5.56The 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

  • 1.5.57The 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

  • 1.5.58The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.5.59The 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

  • 1.5.60The 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

  • 1.5.61The 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

  • 1.5.62The 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

  • 1.5.63The 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

  • 1.5.64The 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

  • 1.5.65The 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

  • 1.5.66The 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

  • 1.5.68The 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

  • 1.5.69The 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

  • 1.5.70The 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

  • framework: MooseMesh
  • 1.5.67The 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

  • 1.33.10The system shall allow specifying valid subdomain IDs that do not exist on the initial mesh.

    Specification(s): add_subdomain_ids

    Design: MooseMesh

    Issue(s): #23557

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.33.12The 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

  • 1.33.44The system shall be able to process boundary and subdomain names that start with digits but which have non-digits later in the name.

    Specification(s): test

    Design: MooseMesh

    Issue(s): #23776

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.33.77The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.33.86The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.33.87The 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

  • 1.35.69The system shall throw an error if the subdomains with different ID have duplicate names.

    Specification(s): check_duplicate_subdomain_names

    Design: MooseMesh

    Issue(s): #23735

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.56.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: NonlinearSystem
  • 1.5.73The system shall be able to compute the residual and the Jacobian of each nodal BC and integrated BC together.

    Specification(s): resid_jac_together

    Design: NonlinearSystem

    Issue(s): #23487

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.27.41The system shall be able to compute the residual and the Jacobian of each interface kernel together.

    Specification(s): resid_jac_together

    Design: NonlinearSystem

    Issue(s): #23487

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.29.114The system shall be able to compute the residual and the Jacobian of each Kernel together.

    Specification(s): resid_jac_together

    Design: NonlinearSystem

    Issue(s): #23487

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.37.142The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.40.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

  • 1.49.20Convergence matches previous version of MOOSE without the preconditioner reuse system

    Specification(s): without_reuse

    Design: NonlinearSystem

    Issue(s): #21868

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.49.21Preconditioner is reused until the linear iterations exceed the value of reuse_preconditioner_max_its upon which the system recalculates the preconditioner

    Specification(s): with_reuse

    Design: NonlinearSystem

    Issue(s): #21868

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.49.22A new preconditioner is formed if the system of equations changes for example here through mesh refinement

    Specification(s): mesh_refinement

    Design: NonlinearSystem

    Issue(s): #21868

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.59.2The system shall ignore particular variable automatic scaling factors

    Specification(s): ignore

    Design: NonlinearSystem

    Issue(s): #19573

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.59.3The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.59.9The 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

  • 1.59.10The 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

  • 1.59.12The 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

  • framework: ConstantBounds
  • 1.6.1The system shall include the ability to compute a nodal field variable with a constant upper and lower bounds.

    Specification(s): constant_bounds

    Design: ConstantBounds

    Issue(s): #951#14946

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.6.2The system shall include the ability to compute a field variable with a lower bound given by variable's old value.

    Specification(s): old_value_bounds

    Design: ConstantBounds

    Issue(s): #951#14946

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.6.3The system shall include the ability to compute a constant monomial field variable with constant upper and lower bounds.

    Specification(s): constant_bounds_elem

    Design: ConstantBounds

    Issue(s): #951#14946

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.6.4The system shall be able to impose constant upper and lower bounds on a finite volume variable.

    Specification(s): constant_bounds_fv

    Design: ConstantBounds

    Issue(s): #951#14946

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.6.5The system shall
    1. emit a warning if a variational inequalities (VI) solver is not found when the bounds system is used.
    2. error if an unsupported variable type is provided to the constant bounds kernel
    3. error if the type of the dummy auxiliary variable does not match the bounded variable.

    Specification(s): exceptions/solver, exceptions/bounded_variable_type, exceptions/mismatch_dummy

    Design: ConstantBounds

    Issue(s): #14946

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunAppRunException

  • 1.40.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: ConstantBounds

    Issue(s): #2999

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.40.6The system shall show violation of bounds when a non-variational-inequality solver is used

    Specification(s): unbounded

    Design: ConstantBounds

    Issue(s): #2999

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: Constraints System
  • 1.7.6The system shall support the ability to constrain nodal values.

    Specification(s): test

    Design: Constraints System

    Issue(s): #665

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.7.7The system shall support the ability to constrain nodal values using a displaced mesh.

    Specification(s): displaced_test

    Design: Constraints System

    Issue(s): #665

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.7.8The system shall support the ability to linearly constrain nodal values.

    Specification(s): linear_nodal

    Design: Constraints System

    Issue(s): #665

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.7.9The system shall support the ability to constrain nodal values of different variables.

    Specification(s): linear_nodal_constraint_different_variables

    Design: Constraints System

    Issue(s): #665

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.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

  • 1.38.11The system shall be able to construct a mortar mesh when coincident nodes exist on one or more mortar boundaries.

    Specification(s): coincident

    Design: Constraints System

    Issue(s): #21680

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.38.12We 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

  • 1.38.13We 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

  • 1.38.14We 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

  • 1.38.15We 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

  • 1.38.16We 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

  • 1.38.17We 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

  • 1.38.18We 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

  • 1.38.19We 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

  • 1.38.20The 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

  • 1.38.21We shall be able to produce the expected result for a solution continuity test case using the Petrov-Galerkin approach for mortar.

    Specification(s): soln-continuity-pg

    Design: Constraints System

    Issue(s): #13080#15215

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.22The 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

  • 1.38.23We 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

  • 1.38.24We 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

  • 1.38.25The 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 SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.26The 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 SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.27The 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 SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.28The 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 SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.29The 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 SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.30The 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 SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.31The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a TET14 conforming mesh, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): continuity_tet14

    Design: Constraints SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.32The 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 SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.33The 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 SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.34The system shall be able to produce the expected result for a solution continuity test case using the penalty-based mortar method on a TET4 conforming mesh, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): continuity_penalty_tet4

    Design: Constraints SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.35The system shall be able to produce the expected result for a solution continuity test case using the penalty-based mortar method on a TET10 conforming mesh, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): continuity_penalty_tet10

    Design: Constraints SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.36The system shall be able to produce the expected result for a solution continuity test case using the penalty-based mortar method on a TET14 conforming mesh, e.g. the primal variable values across the mortar interface shall be the same.

    Specification(s): continuity_penalty_tet14

    Design: Constraints SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.37The system shall be able to produce the expected result for a solution continuity test case using the penalty-based 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_penalty_sphere_hex8

    Design: Constraints SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.38The system shall be able to produce the expected result for a solution continuity test case using the penalty-based 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_penalty_sphere_hex20

    Design: Constraints SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.39The system shall be able to produce the same result using the penalty-based mortar method with and without automatic differentiation.

    Specification(s): continuity_penalty_sphere_hex20_ad

    Design: Constraints SystemEqualValueConstraintPenaltyEqualValueConstraint

    Issue(s): #13080#21329

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.40The 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

  • 1.38.41The 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

  • 1.38.42The 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

  • 1.38.43The 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

  • 1.38.44The 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

  • 1.38.45The 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

  • 1.38.46The system shall be able to perform gap heat transfer to couple conduction equations, on either side of the mortar interface, discretized with the finite volume method with
    1. first order accuracy
    2. second order accuracy

    Specification(s): fv/first_order, fv/second_order

    Design: Constraints System

    Issue(s): #21599

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 1.38.47The 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

  • 1.38.48The 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

  • 1.38.49The 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

  • 1.38.50The 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

  • 1.38.51The 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

  • 1.38.52The 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

  • 1.38.53The 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

  • 1.38.54The 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

  • 1.38.55The 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

  • 1.38.56The 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

  • 1.38.57We 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

  • 1.38.58We 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

  • 1.38.59We shall be able to do gap conductance on a dynamic mesh using auxiliary displacements, computing the residual and Jacobian
    1. separately
    2. together

    Specification(s): dynamic_mortar_gap_conductance/separate, dynamic_mortar_gap_conductance/together

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.38.60The Jacobian for the dynamic aux displacement gap conductance test case shall be perfect when computing the residual and Jacobian
    1. separately
    2. together

    Specification(s): dynamic_gap_jacobian/separate, dynamic_gap_jacobian/together

    Design: Constraints System

    Issue(s): #13080

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 1.38.61We 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

  • 1.38.62We 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

  • 1.38.63We 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

  • 1.38.64The 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

  • 1.38.65We 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

  • 1.38.66The 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

  • 1.38.67The 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

  • 1.38.68We 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

  • 1.38.69The 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

  • framework: NonlinearSystemBase
  • 1.7.10The system shall be able to allow overwriting of solution variables in node-face constraint objects.

    Specification(s): test_balance

    Design: NonlinearSystemBase

    Issue(s): #25666

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.22.78The 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

  • 1.22.79The 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

  • 1.22.80The 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

  • 1.22.81The 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

  • 1.37.159The system shall add ghost entries to residual vectors when needed

    Specification(s): ghosted

    Design: NonlinearSystemBase

    Issue(s): #20654

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.37.160The system shall not add ghost entries to residual vectors when not needed

    Specification(s): not_ghosted

    Design: NonlinearSystemBase

    Issue(s): #20654

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.39.3The system shall allow use of automatic differentiation and automatic scaling in sub-applications.

    Specification(s): test

    Design: NonlinearSystemBase

    Issue(s): #17078

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.59.1The system shall be able to include array variables in automatic scaling calculations.

    Specification(s): test

    Design: Systems overviewNonlinearSystemBase

    Issue(s): #26616

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.59.4The 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

  • 1.59.5The system shall be able to produce the same results without automatic scaling as with automatic scaling.

    Specification(s): not_scaled

    Design: NonlinearSystemBase

    Issue(s): #16212

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.59.6The 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

  • 1.59.7The 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

  • 1.59.11The system shall be able to include scalar variables in automatic scaling grouping calculations.

    Specification(s): test

    Design: Systems overviewNonlinearSystemBase

    Issue(s): #22042

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: TiedValueConstraint
  • 1.7.11The system shall include the ability to force the value of a variable to be the same on both sides of an interface.

    Specification(s): test

    Design: TiedValueConstraint

    Issue(s): #665

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: Controls System
  • 1.8.1The Control system shall include a means to control input parameters added by MOOSE action systems.

    Specification(s): test

    Design: Controls System

    Issue(s): #22068

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.8.2The 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

  • 1.8.3The 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

  • 1.8.4The 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

  • 1.8.5The 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

  • 1.8.7The Control system shall support explicitly defined dependencies.

    Specification(s): test

    Design: Controls System

    Issue(s): #9483#5676

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.8.8The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.8.9The 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

  • 1.8.10The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.8.11The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.8.12The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.8.13The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.8.18The 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

  • 1.8.19The 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

  • 1.8.20The 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

  • 1.8.21The 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

  • 1.8.22The 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

  • 1.8.23The 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

  • 1.8.24The 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. allowing the Proportional Integral Derivative control to have limits for its maximum and minimum output,
    3. using a input postprocessor in lieu of an input parameter,
    4. with integral windup control, resetting the integral term if the error crosses zero,
    5. keeping the PID process within a single timestep,
    6. and resetting the PID process correctly if the solver fails during a Picard/coupling iteration.

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

    Design: Controls SystemPIDTransientControl

    Issue(s): #17271

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.8.25The 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

  • 1.8.26The 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

  • 1.8.27The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.8.28The 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

  • 1.8.29The 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

  • 1.8.30The 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

  • 1.8.31The 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

  • 1.8.32The 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

  • 1.8.33The 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

  • 1.8.34The 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

  • 1.8.35The 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

  • 1.8.36The 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

  • 1.8.37The 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

  • 1.8.38The 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

  • 1.8.39The 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

  • 1.8.40The 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

  • 1.8.41The 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

  • 1.8.42The 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

  • 1.8.43The 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

  • 1.8.44The 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

  • 1.8.45The 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

  • 1.8.51The 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

  • 1.8.53The 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

  • 1.8.54The 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

  • 1.8.55The 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

  • 1.8.56The 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

  • 1.8.57The 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

  • framework: ControlOutput
  • 1.8.20The 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

  • 1.8.21The 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

  • 1.8.22The 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

  • 1.8.23The 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

  • framework: TimePeriod
  • 1.8.36The 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

  • 1.8.37The 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

  • 1.8.38The 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

  • 1.8.39The 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

  • 1.8.40The 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

  • 1.8.41The 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

  • 1.8.42The 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

  • 1.8.43The 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

  • 1.8.44The 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

  • 1.8.45The 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

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

    Specification(s): steady_error

    Design: TimePeriod

    Issue(s): #5676

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.8.47The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.8.48The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.8.49The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.8.50The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.8.51The 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

  • 1.8.52The 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

  • 1.8.53The 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

  • 1.8.54The 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

  • 1.8.55The 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

  • 1.8.56The 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

  • 1.8.57The 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

  • 1.13.39The system shall support controlling what objects are executing based on start and end times.

    Specification(s): test

    Design: TimePeriod

    Issue(s): #5560

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: DGKernels System
  • 1.11.5DGKernels shall coexist with stateful material properties

    Specification(s): stateful_props

    Design: DGKernels System

    Issue(s): #11766

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.11.17Adaptivity 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

  • 1.11.18The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.11.19The 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

  • 1.11.20The 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

  • 1.11.21The 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

  • 1.11.22The 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

  • 1.11.23The DGKernel system shall operate with displaced meshes.

    Specification(s): test

    Design: DGKernels System

    Issue(s): #3536

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.11.25The DGCoupledDiffusion object shall compute the correct Jacobian.

    Specification(s): jacobian_test

    Design: DGKernels System

    Issue(s): #629

    Collection(s): FUNCTIONAL

    Type(s): AnalyzeJacobian

  • 1.29.78The 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

  • 1.29.79The 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

  • 1.29.80The 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

  • 1.29.81The 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

  • 1.29.82The 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

  • 1.29.83The 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

  • 1.29.84The 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

  • 1.29.85The 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

  • 1.29.86The 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

  • 1.29.87The 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

  • 1.29.88The 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

  • 1.29.89The 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

  • 1.29.90The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.29.91The 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

  • 1.29.92The 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

  • framework: ADDGKernel
  • 1.11.15We shall be able to use constant monomials with AD

    Specification(s): exo

    Design: ADDGKernel

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 1.11.16MOOSE should support AD in DG Kernels

    Specification(s): test

    Design: ADDGKernel

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: Executioner System
  • 1.13.1The Executioner system shall support the ability to create custom objects with custom execution callbacks.

    Specification(s): test

    Design: Executioner System

    Issue(s): #1491

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.2The Executioner system shall support the creation of custom objects with arbitrary execution flags.

    Specification(s): test

    Design: Executioner System

    Issue(s): #7489

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.13.11The system shall support the use of material properties during an Eigen problem solve.

    Specification(s): test_nonlinear_eigen_material

    Design: Executioner System

    Issue(s): #2350

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.13The system shall be capable of solving a nonlinear diffusion problem using an Eigen value solver.

    Specification(s): test_another_nonlinear_eigen

    Design: Executioner System

    Issue(s): #2350

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.14The system shall be capable of solving a coupled nonlinear diffusion problem using an Eigen value solver.

    Specification(s): test_coupled_nonlinear_eigen

    Design: Executioner System

    Issue(s): #2350

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.15The system shall be capable of using coupled variables in the EigenKernel object.

    Specification(s): test_deficient_B_eigen

    Design: Executioner System

    Issue(s): #2350

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.16The system shall support adaptive solves for steady-state execution.

    Specification(s): test_steady_adapt

    Design: Executioner System

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.17The system shall be able to detect steady state conditions during execution.

    Specification(s): test_steady_state_check

    Design: Executioner System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.18The system shall be capable of solving a steady state diffusion problem.

    Specification(s): test_steady

    Design: Executioner System

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.19The system shall be capable of solving a transient diffusion problem.

    Specification(s): test_transient

    Design: Executioner System

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.20The system shall print automatic scaling factors if specified.

    Specification(s): test_print_automatic_scaling_factors_true

    Design: Executioner System

    Issue(s): #13795

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.13.21The system shall not print automatic scaling factors if not specified.

    Specification(s): test_print_automatic_scaling_factors_false

    Design: Executioner System

    Issue(s): #13795

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.13.24The system shall correctly compute Jacobians when boundary conditions are disabled.

    Specification(s): full_jacobian_thread_active_bcs

    Design: Executioner System

    Issue(s): #12627

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 1.13.25The Executioner system shall support the PETSc non-linear divergence tolerance.

    Specification(s): test

    Design: Executioner System

    Issue(s): #13991

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.32The system shall compute the solution of rank-deficient linear equations if the right hand side is within the range of the linear operator.

    Specification(s): test_singular

    Design: Executioner System

    Issue(s): #7866#7790

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.13.33The system shall compute the solution of rank-deficient linear equations if the right hand side has components that are orthogonal to the range of the linear operator.

    Specification(s): test_singular_contaminated

    Design: Executioner System

    Issue(s): #7866#7790

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.13.34Executioner objects shall be capable of coupling to Postprocessor values.

    Specification(s): pp_binding

    Design: Executioner System

    Issue(s): #10603

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.13.35The system shall allow executioners to do setups before initializing the problem.

    Specification(s): test

    Design: Executioner System

    Issue(s): #18004

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.13.36The system shall correctly evaluate Jacobians with coupled problems and the LINEAR solve type

    Specification(s): linear_with_full_smp

    Design: Executioner System

    Issue(s): #14065

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.37The system shall not change the system time during steady-state execution.

    Specification(s): test_steady_time

    Design: Executioner System

    Issue(s): #12772

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.38The system shall be able to set the system time for steady-state execution.

    Specification(s): test_steady_set_time

    Design: Executioner System

    Issue(s): #12772

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.40The system shall support explicit definition of execution times.

    Specification(s): testsynctimes

    Design: Executioner System

    Issue(s): #1781

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.13.41The system shall support output using a time interval.

    Specification(s): test_time_out_interval

    Design: Executioner System

    Issue(s): #1781

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.37.23The system shall report an error when the system solver is unable to find a converged solution.

    Specification(s): steady_no_converge

    Design: Executioner System

    Issue(s): #5144#5153

    Collection(s): FAILURE_ANALYSIS

    Type(s): RunApp

  • 1.37.141The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.80The system shall provide an ability to perform iterative solves with sub-applications.

    Specification(s): standard

    Design: Executioner System

    Issue(s): #9115

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.81The system shall provide an ability to relax solutions with iterative solves with sub-applications.

    Specification(s): parent_relaxed

    Design: Executioner System

    Issue(s): #9115

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.82The system shall provide an ability to relax sub-applications solutions along with the parent solution for during iterative solves.

    Specification(s): sub_relaxed

    Design: Executioner System

    Issue(s): #9115

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.83The system shall provide an ability to relax solutions of array variables with iterative solves with sub-applications.

    Specification(s): array_relaxed

    Design: Executioner System

    Issue(s): #9115

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.84The system shall report an error if provided relaxation factor that is less than or equal to 0 or greater than or equal to 2.

    Specification(s): bad_relax_factor

    Design: Executioner System

    Issue(s): #9115

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.68.15The 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

  • framework: Transient
  • 1.13.3The system shall be able to detect steady-states using the auxiliary system solution.

    Specification(s): aux-ss

    Design: Transient

    Issue(s): #19955

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.29.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

  • 1.62.1The system shall include an option that aborts the solve immediately if a solve fails.

    Specification(s): test

    Design: Transient

    Issue(s): 02ae277ceb83dcd5

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: EigenProblem
  • 1.13.4The system shall be able to solve an eigenvalue problem using something other than the L2 norm of Bx for normalization and a native eigenvalue solver.

    Specification(s): testb

    Design: EigenProblem

    Issue(s): #20095

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.13.5The system shall be able to solve an eigenvalue problem using the L2 norm of Bx and the sign of its first nonzero entry for normalization with a SLEPc eigenvalue solver.

    Specification(s): test11

    Design: EigenProblem

    Issue(s): #20095

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.13.6The system shall be able to solve an eigenvalue problem using the sign of the first nonzero entry of Bx combined with something other than the L2 norm of Bx for normalization with a SLEPc eigenvalue solver.

    Specification(s): test7

    Design: EigenProblem

    Issue(s): #20095

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.13.7The system shall be able to solve an eigenvalue problem using something other than the L2 norm of Bx for normalization and a SLEPc eigenvalue solver.

    Specification(s): test4

    Design: EigenProblem

    Issue(s): #20095

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: Executor
  • 1.14.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

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

    Specification(s): cycle

    Design: Executor

    Issue(s): #5229#18180

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

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

    Specification(s): multi_root

    Design: Executor

    Issue(s): #5229#18180

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.14.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

  • framework: ImageFunction
  • 1.16.13The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.16.14The 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

  • 1.16.15The 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

  • 1.16.16The 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

  • 1.16.17The 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

  • 1.16.18The 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

  • 1.16.19The 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

  • 1.16.20The 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

  • 1.16.21The 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

  • 1.16.22The 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

  • 1.16.23The 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

  • 1.16.24The 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

  • 1.16.25The 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

  • 1.16.26The 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

  • 1.16.27The 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

  • 1.16.28The 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

  • 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

  • framework: ImageMesh
  • 1.16.13The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.16.29The 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

  • 1.16.30The 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

  • framework: LinearCombinationFunction
  • 1.16.32The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.16.33The 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

  • 1.16.34The 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

  • 1.16.35The 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

  • framework: ParsedFunction
  • 1.16.36The 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

  • 1.16.37The 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

  • 1.16.38The 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

  • 1.16.39The 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

  • 1.16.40The 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

  • 1.16.41The ParsedFunction object shall support the use of functions, scalar expressions and postprocessor expressions 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

  • 1.16.42The 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

  • 1.16.43The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.16.44The system should error if a field variable is passed into a parsed function object, as this capability is currently not supported.

    Specification(s): nl_vars

    Design: ParsedFunction

    Issue(s): #15523

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: PeriodicFunction
  • 1.16.45The Function system shall provide the ability to take a base function and periodically repeat that function according to a user-defined period in time or in the x, y, or z direction, or a combination of those

    Specification(s): periodic_function

    Design: PeriodicFunction

    Issue(s): #23202

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: PiecewiseConstant
  • 1.16.46The 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#25058

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.16.47The 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#25058

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.16.48The system shall be able to compute a piecewise constant function based on x- and y-data loaded from a JSON file.

    Specification(s): piecewise_constant_from_json

    Design: PiecewiseConstant

    Issue(s): #2272#25058

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.16.49The system shall report an error if
    1. parameters meant for loading data from file are passed for a function loading data differently,
    2. or if parameters meant for loading data from JSON are passed for a function loading data differently.

    Specification(s): errors/param_meant_for_file, errors/param_meant_for_json

    Design: PiecewiseConstant

    Issue(s): #2272#25058

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.32.22The system shall be able to use automatic differentiation instantiations of piecewise linear functions.

    Specification(s): ad_piecewise_linear

    Design: PiecewiseConstant

    Issue(s): #20644

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: PiecewiseMultilinear
  • 1.16.57The PiecewiseMultilinear object will error if the supplied file fails to open.

    Specification(s): except1

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

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

    Specification(s): except2

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.16.59The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

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

    Specification(s): except4

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

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

    Specification(s): except5

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

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

    Specification(s): oneDa

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.16.63The 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

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

    Specification(s): time

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

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

    Specification(s): twoDa

    Design: PiecewiseMultilinear

    Issue(s): #2476

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.16.66The 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

  • 1.16.67The 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

  • 1.16.68The 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

  • framework: FunctorMaterials
  • 1.17.1The system shall support the output of functor material data as field variables including
    1. outputting a functor property, defined within a functor material;
    2. outputting a functor property with automatic differentiation, defined within a functor material.

    Specification(s): types/regular, types/ad

    Design: FunctorMaterialsOutput System

    Issue(s): #19382

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: Output System
  • 1.17.1The system shall support the output of functor material data as field variables including
    1. outputting a functor property, defined within a functor material;
    2. outputting a functor property with automatic differentiation, defined within a functor material.

    Specification(s): types/regular, types/ad

    Design: FunctorMaterialsOutput System

    Issue(s): #19382

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.32.104The system shall support the output of material data as field variables including
    1. outputting all properties within a material definition;
    2. outputting all properties from the output definition;
    3. outputting certain properties within a material definition;
    4. outputting certain properties within the output definition on a subdomain;
    5. outputting certain properties within the material definition on a subdomain;
    6. outputting certain properties within the material definition on a subdomain with a displaced configuration;
    7. outputting certain properties within the material definition on a boundary;
    8. outputting certain properties within the material definition to different files; and
    9. outputting properties for steady-state simulations.

    Specification(s): group/all, group/all_via_outputs, group/limit_via_outputs, group/block_via_outputs, group/block, group/block_displaced, group/boundary, group/multiple_files, group/steady

    Design: Materials SystemOutput System

    Issue(s): #1189#3538

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.32.105The system shall support the output as auxiliary field variables of
    1. automatic differentiation vector material properties

    Specification(s): data_types/ad_vector

    Design: Materials SystemOutput System

    Issue(s): #1189#3538

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.32.106The system shall report an error if an existing variable shares the same name as an auxiliary variable used for material output

    Specification(s): duplicate_variable_name

    Design: Materials SystemOutput System

    Issue(s): #1189#3538

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.32.107The system shall report an error if the supplied output options for material data output are not consistent with the list of available outputs.

    Specification(s): invalid_outputs

    Design: Materials SystemOutput System

    Issue(s): #1189#3538

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.32.108The system shall issue warnings if material data added by materials cannot be outputted as field variables.

    Specification(s): warn_unsupported_types

    Design: Materials SystemOutput System

    Issue(s): #1189#3538

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.32.109The system shall show the field variable names for outputting material data added by materials.

    Specification(s): show_added_aux_vars

    Design: Materials SystemOutput System

    Issue(s): #1189#3538

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.41.6The 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

  • 1.41.7The 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

  • 1.41.39The 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

  • 1.41.40The 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

  • 1.41.41The 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

  • 1.41.42The 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

  • 1.41.43The 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

  • 1.41.44The 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

  • 1.41.45The 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

  • 1.41.46The system shall support CSV output to files on linear iterations, generating unique filenames containing the time step, current nonlinear and linear iteration numbers.

    Specification(s): csv_transient_vpp_linear

    Design: Output SystemCSV

    Issue(s): #24705

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.47The system shall support CSV output to files on nonlinear iterations, generating unique filenames containing the time step and current nonlinear iteration number.

    Specification(s): csv_transient_vpp_nonlinear

    Design: Output SystemCSV

    Issue(s): #24705

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.48The system shall report an error if post-processors and scalar variables have different CSV output frequency.

    Specification(s): pp_scalar_execute_on_mismatch

    Design: Output SystemCSV

    Issue(s): #25211

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.49The system shall report an error if post-processors and reporters have different CSV output frequency.

    Specification(s): pp_reporter_execute_on_mismatch

    Design: Output SystemCSV

    Issue(s): #25211

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.66The 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

  • 1.41.67If 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.69The 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

  • 1.41.70The 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

  • 1.41.71The 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

  • 1.41.73The system shall report an error when two outputs with the same name are created.

    Specification(s): duplicate_objects

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.74The system shall report an error when two outputs produce a file with the same name.

    Specification(s): duplicate_output_files

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.75The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.99The system shall warn the user if a postprocessor utilizes the "outputs" parameter but postprocessor output is disabled for the console object.

    Specification(s): pps_screen_out_warn_test

    Design: Output System

    Issue(s): #1426

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.41.126The system shall support specifying an output interval for an output input file block.

    Specification(s): time_step

    Design: Output System

    Issue(s): #1927#23212

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.127The system shall support specifying an output interval for all outputs.

    Specification(s): common_time_step

    Design: Output System

    Issue(s): #1927#23212

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.128The system shall support limiting output to the final timestep of a simulation.

    Specification(s): output_final

    Design: Output System

    Issue(s): #1927#23212

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.129The system shall support output at specific simulation times.

    Specification(s): sync_times

    Design: Output System

    Issue(s): #1927#23212

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.130The system shall support output at times defined by the function.

    Specification(s): output_limiting_function

    Design: Output System

    Issue(s): #1927#23212

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.131The system shall support multiple output objects that have different simulation synchronization times specified.

    Specification(s): multiple_sync_times

    Design: Output System

    Issue(s): #1927#23212

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.132The system shall support specifying an minimum time difference between successive outputs.

    Specification(s): minimum_time_interval

    Design: Output System

    Issue(s): #1927#23212

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.41.133The system shall support the disabling of an output object by restricting the execution settings.

    Specification(s): no_output

    Design: Output System

    Issue(s): #1927#23212

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.134The 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#23212

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.135The 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#23212

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.136The 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

  • 1.41.137The 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

  • 1.41.138The 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

  • 1.41.139The 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

  • 1.41.140The 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

  • 1.41.149The 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

  • 1.41.150The 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

  • 1.41.151The 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

  • 1.41.152The 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

  • 1.41.153The 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

  • 1.41.155The system shall support the ability to limit output to certain sub-applications based on name.

    Specification(s): dt_from_parent

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.159The 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

  • 1.41.160The 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

  • 1.41.165The 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

  • 1.41.166The 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

  • 1.41.167The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.168The system shall support limiting postprocessor output to the screen.

    Specification(s): console

    Design: Output SystemOutputInterface

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.41.169The 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

  • 1.41.170The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.171The 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

  • 1.41.182The system shall not output linear residuals when requested.

    Specification(s): no_linear_residuals

    Design: Output System

    Issue(s): #22056

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.41.183The system shall not output non-linear residuals when requested.

    Specification(s): no_nonlinear_residuals

    Design: Output System

    Issue(s): #22056

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.41.184The system shall support writing file to sub-directories.

    Specification(s): test

    Design: Output System

    Issue(s): #3249

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.185The system shall allow output to occur at times provided by a times object.

    Specification(s): sync_times_object

    Design: Output System

    Issue(s): #25368

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.41.186The system shall report an error if output is specified to use a times object with changing times.

    Specification(s): sync_times_object_changing_times

    Design: Output System

    Issue(s): #25368

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.187The 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

  • 1.41.188The 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

  • 1.41.189The 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

  • 1.41.190The 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

  • 1.41.195The 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

  • 1.41.196The system shall report an error if a variable is marked for output and output suppression.

    Specification(s): test_hidden_shown

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.197The system shall report an error if a variable is perscribed for output but does not exist.

    Specification(s): test_nonexistent

    Design: Output System

    Issue(s): #1927

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.198The 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

  • 1.41.199The 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

  • 1.41.200The 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

  • 1.41.201The 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

  • 1.48.38Postprocessor objects shall be able to execute and output after the simulation is complete.

    Specification(s): execute_on_final

    Design: VectorPostprocessors SystemOutput System

    Issue(s): #9923

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.104The system shall support outputting the scalar Postprocessor values at specific intervals
    1. to a file and
    2. to the console.

    Specification(s): interval_output/test_interval, interval_output/test_interval_verify

    Design: Output System

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): RunAppExodiff

  • 1.48.105The system shall support outputting the scalar Postprocessor values to multiple locations with different intervals.

    Specification(s): test_interval_mismatch

    Design: Output System

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: FunctorSmoother
  • 1.17.3The system shall be able to
    1. use the average of the values of a functor on an element's face to compute the element value, which can be smoother, and
    2. use the average of the values of a functor at an element's neighbors to compute the element value, which can be smoother, and
    3. use a heuristic based on a functor's value on an element and the maximum values on the element's neighbors to compute a new element value that removes a checkerboard pattern.

    Specification(s): smoother/face, smoother/neighbors, smoother/checkerboard

    Design: FunctorSmoother

    Issue(s): #25452

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: Functor system
  • 1.18.1The system shall be able to accurately evaluate a finite element variable through the functor system in a finite volume Dirichlet boundary condition.

    Specification(s): exo

    Design: Functor system

    Issue(s): #19420

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.18.2The system shall compute the correct Jacobian when evaluating a finite element variable through the functor system in a finite volume Dirichlet boundary condition.

    Specification(s): jac

    Design: Functor system

    Issue(s): #19420

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 1.18.3The system shall be able to use a variable, function, functor material property, and a post-processor in a functor parameter.

    Specification(s): test

    Design: Functor system

    Issue(s): #25012

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.18.4The system shall be able to evaluate functors at nodes, element centers, and quadrature points, and match an expected analytic solution.

    Specification(s): analytic

    Design: Functor system

    Issue(s): #16809#19420

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: FVFunctorNeumannBC
  • 1.19.3The system shall provide a boundary condition to satisfy neumann boundary conditions with a functor

    Specification(s): test

    Design: FVFunctorNeumannBC

    Issue(s): #21632

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: FVNeumannBC
  • 1.19.4The 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

  • 1.19.5The system shall report an error 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.19.6The system shall report an error 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: FVICs System
  • 1.20.1The system shall support setting initial conditions of finite volume field variables to a constant value.

    Specification(s): one-domain

    Design: FVICs System

    Issue(s): #25824

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

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

    Specification(s): multiple-domains

    Design: FVICs System

    Issue(s): #25824

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.20.3The system shall support the initialization of a finite volume variable from an exodus file.

    Specification(s): parsed_function

    Design: FVICs System

    Issue(s): #25824

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.20.4The system shall support the definition of a function initial condition for a finite volume variable.

    Specification(s): parsed_function

    Design: FVICs System

    Issue(s): #25824

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: FVDiffusionInterface
  • 1.21.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

  • 1.21.3The system shall be able to solve a diffusion problem with the domain split in half and two finite volume variables living on each side and interpolating the diffusivities using a harmonic mean.

    Specification(s): diffusion-harmonic

    Design: FVDiffusionInterface

    Issue(s): #21923

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.21.4The system shall be able to solve a block-restricted diffusion problem where the variables live on different nonlinear systems.

    Specification(s): diffusion-multisystem

    Design: FVDiffusionInterfaceProblem system overview

    Issue(s): #25599

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: FVInterfaceKernels System
  • 1.21.5The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.21.6The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.21.7The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.22.53The system shall display second order convergence when applying weakly enforced matching Dirichlet and flux conditions.

    Specification(s): broken-domain

    Design: FVInterfaceKernels SystemFVBCs System

    Issue(s): #16756

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • framework: GradientJumpIndicator
  • 1.22.41The 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

  • 1.26.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

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

    Specification(s): fv

    Design: GradientJumpIndicator

    Issue(s): #1275

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: FVDiffusion
  • 1.22.62The system shall display first order convergence,
    1. when using a simple arithmetic average to determine the face values of discontinuous diffusion coefficients on a regular tri mesh.
    2. when using a simple arithmetic average to determine the face values of discontinuous diffusion coefficients on a quad mesh.

    Specification(s): average/tris, average/quads

    Design: FVDiffusion

    Issue(s): #21923

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 1.22.63The system shall display
    1. close to second order convergence, when using a simple harmonic average to determine the face values of discontinuous diffusion coefficients on a regular tri mesh.
    2. second order convergence, when using a simple harmonic average to determine the face values of discontinuous diffusion coefficients on a quad mesh.

    Specification(s): harmonic/tris, harmonic/quads

    Design: FVDiffusion

    Issue(s): #21923

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • framework: FVKernels System
  • 1.22.64The system shall be able to solve a coupled mass and momentum-type two equation system, which includes advection and diffusion.

    Specification(s): exo

    Design: FVKernels System

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.22.65The system shall exhibit second order convergence for the unknown in a coupled mass and momentum-type two equation system.

    Specification(s): mms

    Design: FVKernels System

    Issue(s): #14549

    Collection(s): FUNCTIONAL

    Type(s): PythonUnitTest

  • 1.22.73The 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

  • 1.22.74The 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

  • 1.22.75The 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

  • 1.22.76The 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

  • framework: PenetrationAux
  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • framework: NearestNodeDistanceAux
  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • 1.23.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

  • framework: FEProblemBase
  • 1.23.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

  • 1.25.48The 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

  • 1.37.206The 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

  • 1.65.74The system shall include an interface for retrieving objects that pertain to transferring data between applications.

    Specification(s): success

    Design: FEProblemBase

    Issue(s): #8608

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.67.84The system shall provide means to detect unresolved dependency in evaluations of user objects and auxiliary kernels

    Specification(s): state_detection

    Design: FEProblemBase

    Issue(s): #22802

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: Parser
  • 1.24.1The system shall include an input file syntax that supports defining global options.

    Specification(s): global_param_test

    Design: Parser

    Issue(s): #437#8761

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.24.2The system shall report an error if a private / suppressed parameter is set in the input file.

    Specification(s): test_suppress_ignore

    Design: Parser

    Issue(s): #437#8761

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.24.3The system shall not apply global parameter options onto suppressed parameters.

    Specification(s): test_ignore

    Design: Parser

    Issue(s): #437#8761

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.37.201The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.42.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

  • 1.42.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.42.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.42.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.42.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.42.14The system shall support including other input files in an input file

    Specification(s): include

    Design: Parser

    Issue(s): #9755#20125

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.42.15The 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

  • 1.42.16The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.42.17The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.42.18The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunAppRunExceptionExodiff

  • 1.42.19The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.42.20The system shall support parameter duplication check for multiple input files, which are later merged into one.

    Specification(s): dup_check

    Design: Parser

    Issue(s): #25994

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.42.21The 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

  • 1.42.22The 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

  • 1.42.23The 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

  • 1.42.24The system shall report the unit conversions performed at parse time when running in debug mode.

    Specification(s): debug_units

    Design: Parser

    Issue(s): #25362

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.42.25The 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

  • 1.42.26The system shall support reading in jagged triple-indexed arrays from the input file using two delimiters for columns and rows respectively.

    Specification(s): parse_triple_index

    Design: Parser

    Issue(s): #21930

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.42.27The system shall support reading in a vector of size-3 vectors.

    Specification(s): parse_vector_value

    Design: Parser

    Issue(s): #24337

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.42.28The system shall throw an exception if the given input cannot be parsed into a vector of size-3 vectors.

    Specification(s): parse_vector_value_error

    Design: Parser

    Issue(s): #24337

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: ArrayConstantIC
  • 1.25.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

  • 1.25.2The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: ArrayFunctionIC
  • 1.25.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

  • 1.25.4The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: ICs System
  • 1.25.5The system shall support setting initial conditions on boundaries.

    Specification(s): test

    Design: ICs System

    Issue(s): #534

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.25.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.25.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.25.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.25.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.25.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

  • 1.37.174The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: RandomIC
  • 1.25.36The system shall generate parallel agnostic random initial conditions

    Specification(s): test

    Design: RandomIC

    Issue(s): #5567#11901

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.25.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

  • framework: VectorConstantIC
  • 1.25.41The 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

  • 1.25.42The 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

  • 1.25.43The system shall allow vector-valued initial conditions be set using a vector function for the following element families:
    1. vector Lagrange,
    2. Nedelec,
    3. and Raviart-Thomas.

    Specification(s): vector_function_ic/lagrange, vector_function_ic/nedelec, vector_function_ic/raviart

    Design: VectorConstantIC

    Issue(s): #13309

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.25.44The 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

  • 1.25.45The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.25.46The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.25.47The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: AnalyticalIndicator
  • 1.26.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

  • 1.26.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

  • framework: ValueJumpIndicator
  • 1.26.6The 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

  • 1.26.7The 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

  • framework: FDP
  • 1.27.20The finite difference preconditioner shall work in parallel.

    Specification(s): parallel_fdp_test

    Design: FDP

    Issue(s): #10375

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.49.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

  • 1.49.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

  • 1.49.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

  • framework: Automatic Differentiation
  • 1.27.26The system shall be able to solve a simple interfacial source problem using automatic differentiation in which the source term depends on the gradient jump of a coupled variable.

    Specification(s): exo

    Design: Automatic Differentiation

    Issue(s): #15307

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.27.27The system shall be able to couple variable gradients 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

  • 1.27.28The 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

  • 1.27.29The 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

  • 1.27.30The 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

  • 1.27.31The 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

  • framework: RandomInterface
  • 1.28.9The system shall produce parallel-agnostic random number fields on a single processor.

    Specification(s): test

    Design: RandomInterface

    Issue(s): #2088#5476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.28.10The system shall produce parallel-agnostic random number fields on two or more processors.

    Specification(s): parallel_verification

    Design: RandomInterface

    Issue(s): #2088#5476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.28.11The system shall produce parallel-agnostic random number fields on two or more threads.

    Specification(s): threads_verification

    Design: RandomInterface

    Issue(s): #2088#5476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.28.12The system shall produce a parallel field without repeating patterns on distributed meshes.

    Specification(s): test_par_mesh

    Design: RandomInterface

    Issue(s): #2088#5476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.28.13The system shall produce parallel-agnostic random number fields via the user defined (UserObject) system.

    Specification(s): test_uo

    Design: RandomInterface

    Issue(s): #2088#5476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.28.14The system shall produce parallel-agnostic random number fields via the user defined (UserObject) system on two or more processors.

    Specification(s): parallel_verification_uo

    Design: RandomInterface

    Issue(s): #2088#5476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.28.15The system shall produce parallel-agnostic random number fields via the user defined (UserObject) system on two or more threads.

    Specification(s): threads_verification_uo

    Design: RandomInterface

    Issue(s): #2088#5476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.28.16The system shall produce a parallel field without repeating patterns via the user defined (UserObject) system.

    Specification(s): test_uo_par_mesh

    Design: RandomInterface

    Issue(s): #2088#5476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.28.17The system shall produce a parallel-agnostic random number via the material system.

    Specification(s): material_serial

    Design: RandomInterface

    Issue(s): #2088#5476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.28.18The system shall produce a parallel-agnostic random number via the material system on two or more processors.

    Specification(s): material_parallel

    Design: RandomInterface

    Issue(s): #2088#5476

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.48.112The system shall compute parallel-agnostic random numbers in the Postprocessor system
    1. when running a complete simulation, or
    2. when running the first half of the simulation and
    3. running the second half of the simulation with recovery and receiving the same values.

    Specification(s): random_pps/full_sim, random_pps/half_transient, random_pps/recover

    Design: RandomInterface

    Issue(s): #8225

    Collection(s): FUNCTIONAL

    Type(s): RunAppCSVDiff

  • framework: BodyForce
  • 1.29.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

  • 1.29.21The 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

  • framework: FEProblem
  • 1.29.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

  • 1.37.200The system shall use the default PETSc option database in the parent app to handle system-level PETSc parameters

    Specification(s): test_options_not_left

    Design: FEProblem

    Issue(s): #15129

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • framework: ADBodyForce
  • 1.29.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

  • framework: ADMatCoupledForce
  • 1.29.22The system shall provide a source term proportional to the value of a coupled variable with a material property prefactor.

    Specification(s): fe_result

    Design: ADMatCoupledForce

    Issue(s): #13744

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

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

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

    Design: ADMatCoupledForce

    Issue(s): #13744

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • framework: ADMatReaction
  • 1.29.26The system shall provide an ability to solve a steady-state diffusion-reaction problem, where the reaction term has a material property reaction rate.

    Specification(s): ad_mat_reaction

    Design: ADMatReaction

    Issue(s): #13484#13744

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.29.27The system shall calculate the correct Jacobian of ADMatReaction using automatic differentiation.

    Specification(s): ad_mat_reaction_jac

    Design: ADMatReaction

    Issue(s): #13484#13744

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • framework: Reaction / ADReaction
  • 1.29.28The 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

  • 1.29.29The 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

  • framework: AnisotropicDiffusion
  • 1.29.46The 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

  • framework: ArrayCoupledTimeDerivative
  • 1.29.47The system shall be able to reproduce the exact Jacobian for a 1d grid for a coupled array time derivative kernel.

    Specification(s): jac_1d

    Design: ArrayCoupledTimeDerivative

    Issue(s): #25833

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 1.29.48The system shall be able to reproduce the exact Jacobian for a 2d grid for a coupled array time derivative kernel.

    Specification(s): jac_2d

    Design: ArrayCoupledTimeDerivative

    Issue(s): #25833

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 1.29.49The system shall be able to reproduce the exact Jacobian for a 3d grid for a coupled array time derivative kernel.

    Specification(s): jac_3d

    Design: ArrayCoupledTimeDerivative

    Issue(s): #25833

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • framework: Diffusion
  • 1.29.69The 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

  • 1.29.70The 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

  • 1.29.71The 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

  • 1.29.72A 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

  • 1.29.73The 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

  • 1.29.74The 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

  • 1.29.122The 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

  • framework: FunctionDiffusion
  • 1.29.77The system shall run a simple 2D linear diffusion problem with Dirichlet boundary conditions on a regular mesh, where the laplace operator uses a function coefficient.

    Specification(s): test

    Design: FunctionDiffusion

    Issue(s): #13744

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: DisplacedProblem
  • 1.29.93We 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

  • 1.29.94We 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

  • 1.29.95We 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

  • 1.29.96We 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

  • 1.29.97We 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

  • 1.29.98We 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

  • 1.37.9The system shall be able to run a kernel on the displaced mesh with blocks that are a superset of the displacement variable blocks.

    Specification(s): run

    Design: DisplacedProblem

    Issue(s): #25804

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • framework: Kernel
  • 1.29.99The 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

  • 1.29.100The 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

  • 1.29.101The 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

  • framework: MaterialPropertyValue
  • 1.29.106The 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

  • framework: ScalarKernels System
  • 1.29.107The 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

  • 1.29.108The 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

  • 1.29.111The 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

  • 1.29.115The 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

  • 1.29.116The 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

  • 1.29.117The 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

  • 1.58.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

  • 1.58.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

  • 1.58.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

  • framework: ParsedODEKernel
  • 1.29.109The system shall support solving ODEs specified within the input file through parsed expression syntax.

    Specification(s): test_parsed_sys_impl

    Design: ParsedODEKernel

    Issue(s): #726

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.29.110The system support coupling of postprocessor values in the parsed expression ODE kernel.

    Specification(s): test_parsed_pp

    Design: ParsedODEKernel

    Issue(s): #14034

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: SystemBase
  • 1.29.112The 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

  • 1.29.113The 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

  • 1.37.207The 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

  • 1.37.208The 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

  • 1.37.209The 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

  • framework: ScalarLMKernel
  • 1.29.118The system shall solve a constrained Neumann problem and volume averaging using the Lagrange multiplier approach derived from a scalar augmentation class.

    Specification(s): kernel

    Design: ScalarLMKernel

    Issue(s): #22174

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.29.119The system shall support the ability to include the scalar wrapper but not actually use a scalar variable.

    Specification(s): bipass

    Design: ScalarLMKernel

    Issue(s): #22174

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.29.120The system shall report an error if a derived object uses scalars and computes scalar residuals but does not override the quadrature point residual calculation routine.

    Specification(s): override

    Design: ScalarLMKernel

    Issue(s): #22174

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: TimeDerivative
  • 1.29.123The system shall be able to run a transient diffusion problem

    Specification(s): test

    Design: TimeDerivative

    Issue(s): #000

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.29.124The 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

  • 1.35.184The system shall support the ability for mesh generators to save attributes to a stateful data store available for use when recovering a simulation.

    Specification(s): meta_data_store

    Design: TimeDerivative

    Issue(s): #000

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: VectorBodyForce
  • 1.29.151The 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

  • 1.29.152The 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

  • 1.29.154The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: BoundaryMarker
  • 1.31.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#24645

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.31.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#24645

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.31.4The adaptivity system shall create an auxiliary field variable that marks elements for refinement adjacent to any of a given set of boundaries.

    Specification(s): multiple

    Design: Markers SystemBoundaryMarker

    Issue(s): #1275#24645

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: BoxMarker
  • 1.31.5The 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

  • 1.31.6The 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

  • 1.31.8The 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

  • framework: ComboMarker
  • 1.31.7The 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

  • framework: Errorfractionmarker
  • 1.31.9The 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

  • 1.31.10The 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

  • 1.31.11The 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

  • framework: OrientedBoxMarker
  • 1.31.15The 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

  • framework: UniformMarker
  • 1.31.21The 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

  • framework: ValueRangeMarker
  • 1.31.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 within a specific range.

    Specification(s): test

    Design: ValueRangeMarker

    Issue(s): #1815

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: ValueThresholdMarker
  • 1.31.23The 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

  • framework: MaterialFunctorConverter
  • 1.32.56The system shall be able to convert functors to regular (using automatic differentiation or not) material properties.

    Specification(s): scalar

    Design: MaterialFunctorConverter

    Issue(s): #19420

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.32.57The system shall be able to convert functors to regular (using automatic differentiation or not) boundary material properties.

    Specification(s): face

    Design: MaterialFunctorConverter

    Issue(s): #19420

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.32.58The system shall be able to convert vector functors to regular vector material properties.

    Specification(s): vector

    Design: MaterialFunctorConverter

    Issue(s): #19420

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.32.59The system shall report an error
    1. if the user requests conversions to both AD and regular material properties, as this is not supported,
    2. if the user inputs a different number of functors and material properties, as the conversion match one to one.

    Specification(s): exception_checks/ad_and_regular, exception_checks/wrong_size

    Design: MaterialFunctorConverter

    Issue(s): #19420

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: FunctorADConverter
  • 1.32.60The system shall be able to convert functors from AD to regular and vice versa.

    Specification(s): exo

    Design: FunctorADConverter

    Issue(s): #19420

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.32.61The system shall report an error with a clear parameter error if
    1. the names for the regular functors to be converted are going to overlap with the new automatic differentiation functors
    2. the names for the regular functors to be converted are going to overlap with the other new regular functors
    3. the names for the automatic differentiation functors to be converted are going to overlap with the new regular functors
    4. the names for the automatic differentiation functors to be converted are going to overlap with the other new automatic differentiation functors
    5. the number of automatic differentiation functors to convert does not match the number of names for the converted functors
    6. the number of regular functors to convert does not match the number of names for the converted functors

    Specification(s): errors/reg_in_ad_out, errors/reg_in_reg_out, errors/ad_in_reg_out, errors/ad_in_ad_out, errors/size_ad_in, errors/size_reg_in

    Design: FunctorADConverter

    Issue(s): #19420

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: Mesh Splitting
  • 1.33.14The 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

  • 1.33.15The 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

  • 1.33.16The 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

  • 1.33.17The 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

  • 1.33.18The 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

  • 1.33.19The 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

  • 1.33.88The 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

  • 1.33.89A 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

  • 1.33.90A mesh can be pre-split properly and used to generate equivalent results to running a simulation with the unsplit mesh when
    1. set by command line
    2. set by an input parameter

    Specification(s): use_split/from_cli, use_split/from_input

    Design: Mesh Splitting

    Issue(s): #10623#17318

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.33.91Console 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

  • 1.33.92The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.33.93The 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

  • 1.33.94Meshes 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

  • 1.33.95Splitting 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

  • 1.33.96Splitting 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

  • 1.33.97The system should be able to load a pre-split mesh and perform additional mesh generation on it.

    Specification(s): meshgenerators_acting_on_split

    Design: Mesh SplittingFileMeshGenerator

    Issue(s): #18635

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: GeneratedMesh
  • 1.33.45The system shall generate a structured mesh on a Cartesian domain.

    Specification(s): test

    Design: GeneratedMesh

    Issue(s): #760

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.33.46The 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

  • 1.33.47The 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

  • framework: RinglebMesh
  • 1.33.51The 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

  • framework: PatternedMesh
  • 1.33.78The 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

  • 1.33.79The 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

  • framework: StitchedMesh
  • 1.33.98The 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

  • 1.33.99The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: TiledMesh
  • 1.33.103The 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

  • framework: FlipSidesetGenerator
  • 1.35.156The system shall support switching the normal orientation of a sideset in a two-dimensional mesh

    Specification(s): flux_2D

    Design: FlipSidesetGenerator

    Issue(s): #25528

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.35.157The system shall support switching the normal orientation of a sideset in a three-dimensional mesh

    Specification(s): flux_3D

    Design: FlipSidesetGenerator

    Issue(s): #25528

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.35.158The system shall produce a reasonable error when switching the normal orientation of a sideset if the sideset does not exist

    Specification(s): no_sideset_exception

    Design: FlipSidesetGenerator

    Issue(s): #25528

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.159The system shall produce a reasonable error when switching the normal orientation of a sideset if the sideset cannot be flipped

    Specification(s): no_neighbor_exception

    Design: FlipSidesetGenerator

    Issue(s): #25528

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: GeneratedMeshGenerator
  • 1.35.160The system shall be able to use libmesh mesh generation tools.

    Specification(s): test

    Design: GeneratedMeshGenerator

    Issue(s): #11640

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.161The system shall be able to use libmesh mesh generation tools and shift node/sideset ids by a constant offset.

    Specification(s): offset

    Design: GeneratedMeshGenerator

    Issue(s): #11640

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.162The system shall include mesh generation tools and allow adding a name prefix to the node/sideset names and maintain the
    1. id and
    2. include the added name.

    Specification(s): prefix/id, prefix/name

    Design: GeneratedMeshGenerator

    Issue(s): #11640

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.163The system shall include mesh generation tools and shift node/sideset ids by a constant offset while also adding a name prefix to them and maintain the
    1. the shifted id and
    2. include the added name.

    Specification(s): both/id, both/name

    Design: GeneratedMeshGenerator

    Issue(s): #11640

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.164The system shall generate a warning if Mesh Generators are used with a mesh type that does not accept them

    Specification(s): type_test

    Design: GeneratedMeshGenerator

    Issue(s): #13959

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.165The system shall be able to assign subdomain IDs for the (cartesian) generated mesh generator.

    Specification(s): with_subdomain_ids_test

    Design: GeneratedMeshGenerator

    Issue(s): #19297

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: ParsedCurveGenerator
  • 1.35.198The system shall generate a 2D open curve mesh.

    Specification(s): open_curve

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.199The system shall generate a 3D open curve mesh.

    Specification(s): open_curve_3d

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.200The system shall generate a 2D open curve mesh with nodesets on both ends.

    Specification(s): open_curve_with_ends

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.201The system shall generate a closed loop curve mesh with starting and ending points coincident.

    Specification(s): closed_curve

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.202The system shall generate a closed loop curve mesh with starting and ending points separated.

    Specification(s): forced_closed_curve

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.203The system shall generate a closed loop curve mesh with starting and ending points separated using a section that contains multiple elements.

    Specification(s): forced_closed_curve_multi_segments

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.204The system shall generate closed 2D curve meshes that can be used as inputs to Delaunay triangulation mesh generators.

    Specification(s): xy_delaunay_curve

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.205The system shall throw an error if the starting and ending points of a section are overlapped while the section is supposed to be open.

    Specification(s): err_crossed_curve

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.206The system shall throw an error if the oversampling algorithm exceeds its designated maximum sampling number.

    Specification(s): err_max_oversample

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.207The system shall throw an error if there are repeated elements in the user-specified curve abscissas.

    Specification(s): err_repeated_t_series

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.208The system shall throw an error if the user specifies to force closing a parsed curve, but it is already closed as the starting and ending points of the curve are overlapped.

    Specification(s): err_unneeded_forced_closed_num_segments_1

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.209The system shall throw an error if the user specifies to force closing a parsed curve but the curve to be generated is also specified to be open.

    Specification(s): err_unneeded_forced_closed_num_segments_2

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.210The system shall throw an error if the abscissa used to generate the curve is specified non-monotonically.

    Specification(s): err_unsorted_t_series

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.211The system shall throw an error if the number of curve segments is not consistent with the number of abscissa ranges.

    Specification(s): err_bad_nums_segments

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.212The system shall throw an error if the parsed expression for the x coordinate cannot be parsed as a function.

    Specification(s): err_failed_parsing_x

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.213The system shall throw an error if the parsed expression for the y coordinate cannot be parsed as a function.

    Specification(s): err_failed_parsing_y

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.214The system shall throw an error if the parsed expression for the z coordinate cannot be parsed as a function.

    Specification(s): err_failed_parsing_z

    Design: ParsedCurveGenerator

    Issue(s): #22848

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: StackGenerator
  • 1.35.269The system shall be able to generate meshes by stacking up existing meshes in
    1. two and
    2. three dimensions and
    3. error if the dimensions of the meshes to be stacked are not consistent.

    Specification(s): stack/2d, stack/3d, stack/error_dims

    Design: StackGenerator

    Issue(s): #11640

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunExceptionExodiff

  • framework: XYMeshLineCutter
  • 1.35.291The system shall be able to cut a simple one-subdomain mesh using the triangle element cutting method.

    Specification(s): simple_cut_elem

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.292The system shall be able to cut a simple one-subdomain mesh using the node moving method.

    Specification(s): simple_cut_node

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.293The system shall be able to cut a multi-subdomain mesh using the triangle element cutting method.

    Specification(s): multi_block_cut_elem

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.294The system shall be able to cut a multi-subdomain mesh using the element cutting method and improve the quality of triangular elements on the boundary.

    Specification(s): multi_block_cut_elem_improve

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.295The system shall be able to cut a multi-subdomain mesh using the node moving method.

    Specification(s): multi_block_cut_node

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.296The system shall be able to cut a multi-subdomain mesh using the node moving method with interface boundaries that need to conform.

    Specification(s): multi_block_cut_node_other_boundaries

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.35.297The system shall throw an error if the input mesh is not 2D.

    Specification(s): err_non_2d_mesh

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.298The system shall throw an error if the given name of the triangle element block, created during mesh line cutting, already exists in the input mesh, in the element cutting mode.

    Specification(s): err_pre_exist_block_name_elem

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.299The system shall throw an error if the given name of the triangular element block, created during mesh line cutting, already exists in the input mesh in the node moving mode.

    Specification(s): err_pre_exist_block_name_node

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.300The system shall throw an error if the size of the cut line parameters is not three.

    Specification(s): err_wrong_line_params_size

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.301The system shall throw an error if the cut line parameters is not valid to define a line.

    Specification(s): err_wrong_line_params_value

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.302The system shall throw an error if the external boundary id is not provided when the node moving method is used.

    Specification(s): err_no_external_boundary_id

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.35.303The system shall throw an error if the triangle element improvement is enabled under the node moving mode.

    Specification(s): err_tri_improve_for_node_moving

    Design: XYMeshLineCutter

    Issue(s): #23844

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: UserObject System
  • 1.37.20The system shall report an error if a boundary restricted object depends on a variable that is not defined on any portion of the boundary. These boundary restricted objects include
    1. nodal auxiliary kernels
    2. nodal user objects
    3. nodal boundary conditions
    4. integrated boundary conditions
    5. side user objects
    6. elemental auxiliary kernels

    Specification(s): error/nodal_aux, error/nodal_uo, error/nodal_bc, error/integrated_bc, error/side_uo, error/elemental_aux

    Design: AuxKernels SystemUserObject System

    Issue(s): #9734

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.37.21The system shall report an error if a variable is coupled into a boundary restricted object, along whose boundary the variable is only partially defined.

    Specification(s): partial_coverage

    Design: AuxKernels SystemUserObject System

    Issue(s): #9734

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.37.22The system shall report an error if an object restricted on an internal boundarydepends on a variable that is not defined on any portion of the boundary.

    Specification(s): error

    Design: AuxKernels SystemUserObject System

    Issue(s): #9734

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.67.9The system shall support the use of data produced by a custom user object calculations within a kernel object.

    Specification(s): kernel_coupling

    Design: UserObject System

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.10The system shall be able to execute user objects that perform operations on elements, boundaries, and internal sides.

    Specification(s): domain_uo

    Design: UserObject System

    Issue(s): #19995

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.67.11The system shall be able to execute user objects that perform operations on elements, boundaries, and interfaces.

    Specification(s): domain_uo_interface

    Design: UserObject System

    Issue(s): #19995

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.67.21The system shall execute user objects in the same group in the order given in the design documentation.

    Specification(s): simultaneous

    Design: UserObject System

    Issue(s): #23470

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.67.22The system shall permit adding one new execution order group.

    Specification(s): two_groups

    Design: UserObject System

    Issue(s): #23470

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.67.23The system shall correctly resolve dependencies within an execution order group.

    Specification(s): inter_group_dependence

    Design: UserObject System

    Issue(s): #23470

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.67.24The system shall permit adding multiple new execution order groups.

    Specification(s): three_groups

    Design: UserObject System

    Issue(s): #23470

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.67.25The system shall permit adding a new execution order group with a negative priority.

    Specification(s): negative_group

    Design: UserObject System

    Issue(s): #23470

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.67.60The system shall be able to execute a user object on a mortar interface and obtain gap computations that are equivalent to an auxiliary kernel evaluation
    1. on a reference, undisplaced mesh, and
    2. on a displaced mesh.

    Specification(s): test/reference, test/displaced

    Design: UserObject System

    Issue(s): #21329

    Collection(s): FUNCTIONAL

    Type(s): CSVDiffExodiff

  • 1.67.92The system shall be able to use algebraic information associated with lower-dimensional elements in side user objects.

    Specification(s): test

    Design: UserObject System

    Issue(s): #21687

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • framework: MooseObject
  • 1.37.146The 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

  • 1.37.147The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: MaxVarNDofsPerElem
  • 1.37.187The 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): CSVDiff

  • 1.37.188The 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): CSVDiff

  • 1.37.189The 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): CSVDiff

  • 1.37.190The 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): CSVDiff

  • 1.37.191The maximum number of degrees of freedom for a single variable on a 2D TRI6 elem shall be 6

    Specification(s): triangles_second_order

    Design: MaxVarNDofsPerElem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.37.192The maximum number of degrees of freedom for a single variable on a 2D TRI7 elem shall be 7

    Specification(s): triangles_third_order

    Design: MaxVarNDofsPerElem

    Issue(s): #5658

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.37.193The 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): CSVDiff

  • framework: WeightedGapAux
  • 1.38.9The 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

  • 1.38.10The 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

  • framework: CentroidMultiApp
  • 1.39.5The system shall include the ability to execute a sub-application at the centroid of every element within the finite element mesh.

    Specification(s): test

    Design: CentroidMultiApp

    Issue(s): #10483#24264

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.6The system shall optionally allow the first sub-app to fully initialize before initializing all the remaining child apps in parallel.

    Specification(s): test_quiet

    Design: CentroidMultiApp

    Issue(s): #10483#24264

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: MultiApp System
  • 1.39.7The system shall detect input file problems with sub app input files.

    Specification(s): input_file

    Design: MultiApp System

    Issue(s): #4101#4113

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.8The system shall CLI argument problems related to sub app input files.

    Specification(s): unused_subapp_param

    Design: MultiApp System

    Issue(s): #4101#4113

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.9The system show error when the number of input files is great than one and doesn't match the number of provided sub app positions.

    Specification(s): positions

    Design: MultiApp System

    Issue(s): #1845#3556#5784

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.10The system show error when the number of input files is great than one and doesn't match the number of provided sub app positions when using CLI overrides.

    Specification(s): not_enough_positions

    Design: MultiApp System

    Issue(s): #1845#3556#5784

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.11The system shall report an error when the number of sub app input files doesn't match the number of provided positions files.

    Specification(s): not_enough_position_files

    Design: MultiApp System

    Issue(s): #1845#3556#5784

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.12The system shall report an error when both positions are provided in the input file along with a separate file of positions.

    Specification(s): both_positions

    Design: MultiApp System

    Issue(s): #1845#3556#5784

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.13The system shall report an error when the multiapp positions file is malformed.

    Specification(s): bad_positions

    Design: MultiApp System

    Issue(s): #1845#3556#5784

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.14The system shall report an error when the Multiapp parameter sub_cycling and catch_up are both set to true.

    Specification(s): sub_cycling_and_catch_up

    Design: MultiApp System

    Issue(s): #6127

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.15The system shall support reading command-line arguments from a file with multiple lines

    Specification(s): multiline_file

    Design: MultiApp System

    Issue(s): #18596

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.16The system shall support reading command-line arguments from a file with a single line

    Specification(s): one_line_file

    Design: MultiApp System

    Issue(s): #18596

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.17The system shall support reading command-line arguments from multiple files

    Specification(s): two_files

    Design: MultiApp System

    Issue(s): #18596

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.18The system shall support reading command-line arguments from a file with multiple parameters separated semicolon

    Specification(s): multiple_parameters

    Design: MultiApp System

    Issue(s): #18596

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.19The system shall not support commandLine arguments from a file and an input at the same time

    Specification(s): input_and_from_file

    Design: MultiApp System

    Issue(s): #18596

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.20The system shall make sure the number of commandLine argument files either be only one or match the number of input files

    Specification(s): input_and_file

    Design: MultiApp System

    Issue(s): #18596

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.21The system shall provide at least one commandLine argument file when use parameter 'cli_args_files'

    Specification(s): no_cliarg_file

    Design: MultiApp System

    Issue(s): #18596

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.22The system shall not use an empty commandLine argument file

    Specification(s): empty_cliarg_file

    Design: MultiApp System

    Issue(s): #18596

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.23The system shall the total number of commandLine argument strings be only one or match the total number of sub apps

    Specification(s): inconsistent_cliargs_from_file

    Design: MultiApp System

    Issue(s): #18596

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.24The system shall the total number of commandLine argument strings from a file be only one or match the total number of positions

    Specification(s): positions_and_cliargs

    Design: MultiApp System

    Issue(s): #18596

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.25The system shall be able to clone the mesh created in parent application into its sub-application(s) for geometries in
    1. XY-cartesian coordinates,
    2. RZ-cylindrical coordinates, and
    3. R-spherical coordinates.

    Specification(s): clone/XY, clone/RZ, clone/RSpherical

    Design: MultiApp System

    Issue(s): #24345

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.39.26The MultiApp system shall include the ability to set command line parameters for each sub application from the input file.

    Specification(s): parent

    Design: MultiApp System

    Issue(s): #12576

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.27The MultiApp system shall include the ability to set common command line parameters for all sub applications from the input file.

    Specification(s): parent_common

    Design: MultiApp System

    Issue(s): #12576

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.28The MultiApp system shall include the ability to set common command line vector parameters, using double quotes, for all sub applications from the input file.

    Specification(s): common_vector

    Design: MultiApp System

    Issue(s): #12576

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.29The MultiApp system shall include the ability to set common command line vector parameters, using single quotes, for all sub applications from the input file.

    Specification(s): common_vector_single

    Design: MultiApp System

    Issue(s): #12576

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.30The MultiApp system shall include the ability to set command line vector parameters, using double quotes, distributed among all sub applications from the input file.

    Specification(s): split_with_vector_single

    Design: MultiApp System

    Issue(s): #12576

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.31The MultiApp system shall include the ability to set command line vector parameters, using single quotes, distributed among all sub applications from the input file.

    Specification(s): split_with_vector_double

    Design: MultiApp System

    Issue(s): #12576

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.32The MultiApp system shall error when the number of command line arguments supplied in the input file differs from the number if sub apps.

    Specification(s): wrong_size

    Design: MultiApp System

    Issue(s): #12576

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.33The system shall include the ability to halt the execution of sub-applications when steady-state is detected.

    Specification(s): test

    Design: MultiApp System

    Issue(s): #1893

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.39The system shall report an error if the execution of a sub-application fails during the initial execution.

    Specification(s): initial_multiapp_failure

    Design: MultiApp System

    Issue(s): #7213

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.42The system shall support the ability for a sub-application to adaptive modify the time step of the parent application when the sub-application operates at the
    1. beginning and
    2. end of a timestep.

    Specification(s): group/begin, group/end

    Design: MultiApp System

    Issue(s): #7842

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.43The system shall support limiting the number of processors for sub-applications.

    Specification(s): test

    Design: MultiApp System

    Issue(s): #1873

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.44The system shall support the ability to re-position sub-applications at a specified time
    1. for single and
    2. multi-level sub-applications.

    Specification(s): group/test, group/multilevel

    Design: MultiApp System

    Issue(s): #1971

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.45The system shall support the ability to re-position and reset sub-applications at a specified time
    1. for single and
    2. multi-level sub-applications.

    Specification(s): group/test, group/multilevel

    Design: MultiApp System

    Issue(s): #1971

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.46The system shall support evaluating multi-level sub-applications:
    1. where the parent application controls the time step for all sub-applications;
    2. where the parent application controls the time step via a function for all sub-applications; and
    3. where the sub-application controls the time step for the parent application,

    Specification(s): group/dt_from_parent, group/time_dt_from_parent, group/dt_from_sub

    Design: MultiApp System

    Issue(s): #1832

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.47The system shall support writing screen output from multi-level sub-applications to a file.

    Specification(s): console_to_file

    Design: MultiApp System

    Issue(s): #1832

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.39.48The system shall be capable of running multiple sub-applications that are defined by input and position file pairs.

    Specification(s): test

    Design: MultiApp System

    Issue(s): #5784

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.49The system shall support outputting sub-application data in a specified position
    1. for single and
    2. multi-level sub-applications.

    Specification(s): group/test, group/multilevel

    Design: MultiApp System

    Issue(s): #1888

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.50The MultiApp system shall allow overriding the cliArgs function to provide parameters to the subapp programmatically.

    Specification(s): override_cli_args

    Design: MultiApp System

    Issue(s): #20443

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.51The system shall support the the ability to set solver options within sub-applications.

    Specification(s): test

    Design: MultiApp System

    Issue(s): #1872

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.64The system shall support performing iterative solves of sub-applications that perform additional time steps to maintain time step consistency with the parent application
    1. resetting the initial condition for every coupling
    2. or re-using the previous solution as the initial condition for subsequent iterations.

    Specification(s): catch_up/test, catch_up/keep_solution

    Design: MultiApp System

    Issue(s): #10337

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.65Multiapps shall be able to be restored when a subapp encounters a solve failure.

    Specification(s): test

    Design: MultiApp System

    Issue(s): #5126

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.66CSV file writing should remain unaffected when a subapp encounters a solve failure.

    Specification(s): test_csv

    Design: MultiApp System

    Issue(s): #11178

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.39.67Multiapps shall be able to cut the parent app time step when any subapp encounters a solve failure.

    Specification(s): test_2subapps

    Design: MultiApp System

    Issue(s): #12477

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.77The system shall support performing iterative solves of sub-applications that used smaller time steps than parent application.

    Specification(s): test

    Design: MultiApp System

    Issue(s): #5126

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.78The system shall support evaluating sub-applications at spatial positions specified in a file.

    Specification(s): dt_from_multi

    Design: MultiApp System

    Issue(s): #1845

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.85The system shall support the ability to reset a sub-application at a specified time during the simultation
    1. for single and
    2. multi-level sub-applications.

    Specification(s): group/test, group/multilevel

    Design: MultiApp System

    Issue(s): #1970

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.86The system shall support the ability to reset a sub-application at multiple specified times during the simultation

    Specification(s): multiple_times

    Design: MultiApp System

    Issue(s): #1970

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.87The system shall report an error if the reset times specified for a multiapp are not sorted, as this likely indicates a user error in their input

    Specification(s): not_sorted_times

    Design: MultiApp System

    Issue(s): #1970

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.88The system shall support simulations that
    1. that execute sub-applications, which
    2. are capable of being restarted from a previous simulation.

    Specification(s): group/first, group/second

    Design: MultiApp System

    Issue(s): #5695

    Collection(s): FUNCTIONAL

    Type(s): RunAppExodiff

  • 1.39.89The system shall support simulations that
    1. that execute with multi-level sub-applications, which
    2. are capable of being restarted from a previous simulation.

    Specification(s): group/first, group/second

    Design: MultiApp System

    Issue(s): #5695

    Collection(s): FUNCTIONAL

    Type(s): RunAppExodiff

  • 1.39.90The system shall support simulations that
    1. that executes sub-applications, which
    2. can restart from a previous simulation and project the initial condition from the previous solution to the current, restarted simulation.

    Specification(s): group/first, group/second

    Design: MultiApp System

    Issue(s): #6087

    Collection(s): FUNCTIONAL

    Type(s): RunAppExodiff

  • 1.39.91The system shall support executing sub-applications in a specified position and/or with the specified frame of reference transformation
    1. with a scaled, rotated, translated child application
    2. with a scaled, rotated, translated parent application exchanging information with a translated child application

    Specification(s): group/multi-app, group/transform-main-multi-app

    Design: MultiApp System

    Issue(s): #19121

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.92The system shall report an error if
    1. both outputting in position and displacing applications are requested at the same time, as displaced apps are already output in position
    2. a translation is requested on a spherical or cylindrical coordinate mesh, as this is not expected to be a valid transformation
    3. displacing applications and moving applications at a certain time are both requested as this combination of features is not implemented

    Specification(s): errors/output_and_run_in_position, errors/invalid_frame_for_translation, errors/move_apps_not_supported

    Design: MultiApp System

    Issue(s): #19121

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.39.97The system shall support executing sub-applications that operate with smaller time steps then the parent application that include material properties that are based on previous time steps.

    Specification(s): test_stateful_subcycle

    Design: MultiApp System

    Issue(s): #8286

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.39.101The system shall support the execution of sub-applications that operate with smaller time steps then the parent application:
    1. with a sub-application that continues to the end time of the parent application and
    2. with a sub-application that specifies and completion time prior to the parent application.

    Specification(s): group/test, group/test_short_subapp

    Design: MultiApp System

    Issue(s): #1880

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.102The system shall support the output of sub-application data that operate with smaller time steps then the parent application.

    Specification(s): test_sub_cycle_output

    Design: MultiApp System

    Issue(s): #1880

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.103The system shall support the execution of sub-application that operate with adaptive time steps that differ from the parent application.

    Specification(s): test_it_adapt

    Design: MultiApp System

    Issue(s): #1880

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.104The system shall support sub-cycling with negative times by particularly ensuring that the sub-app does not advance further than the main app.

    Specification(s): test_negative_time

    Design: MultiApp System

    Issue(s): #15766

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.39.105The system shall support the failure of sub-application that operates with differing time steps than the parent application.
    1. The simulation shall continue by reducing the time step and
    2. support the failure and the ability to limit the number of processors for the sub-application.

    Specification(s): group/test_failure, group/test_failure_max_procs

    Design: MultiApp System

    Issue(s): #1880

    Collection(s): FUNCTIONAL

    Type(s): RunAppExodiff

  • 1.65.186The system shall support the transfer of data between a parent application and sub-applications after a sub-application as been reset.

    Specification(s): test

    Design: MultiApp SystemTransfers System

    Issue(s): #1970

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: UserObject
  • 1.39.41The system shall allow forcibly evaluating general user objects on the initial timestep before applying initial conditions.

    Specification(s): test

    Design: UserObject

    Issue(s): #14676

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.67.26The system shall support overriding the inter-system dependency resolution to allow for developers to decide when specific calculations should be forced into a specific order,
    1. by forcing a user object to execute before auxiliary kernels
    2. by forcing a user object to execute after auxiliary kernels

    Specification(s): test_force/preaux, test_force/postaux

    Design: UserObject

    Issue(s): #10360#18593#18594

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: FunctionDT
  • 1.39.57The system shall allow function-defined time stepping for transient multiapps

    Specification(s): function_dt

    Design: FunctionDT

    Issue(s): #5800

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: QuadraturePointMultiApp
  • 1.39.79The system shall include the ability to execute a sub-application at the quadrature points on every element within the finite element mesh.

    Specification(s): test

    Design: QuadraturePointMultiApp

    Issue(s): #22490

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: PerfGraph
  • 1.39.96MultiApps shall be properly identified in the PerfGraph

    Specification(s): slow_sub

    Design: PerfGraph

    Issue(s): #19662

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.48.106The system shall have the ability to output performance data to a file.

    Specification(s): csv_log

    Design: PerfGraph

    Issue(s): #1771

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.48.107The system shall calculate performance time when the data is only used by a Postprocessor.

    Specification(s): use_log_data_no_print

    Design: PerfGraph

    Issue(s): #7951

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.48.108The system shall calculate performance time even when the performance graph isn't printed to any output format.

    Specification(s): check_more_values

    Design: PerfGraph

    Issue(s): #10196

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.68.17The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.68.18The system shall allow for timing sections of code and having automated print-outs when they take too long.

    Specification(s): time_test

    Design: PerfGraph

    Issue(s): #15444

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • framework: NodalKernels System
  • 1.40.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

  • 1.40.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

  • 1.40.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

  • 1.40.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

  • framework: FileOutput
  • 1.41.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

  • framework: Console
  • 1.41.12The 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

  • 1.41.13The system shall support outputting table based Postprocessor data.

    Specification(s): postprocessors

    Design: Console

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.41.14The 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

  • 1.41.15The 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

  • 1.41.16The 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

  • 1.41.17The system shall support outputting head processor console information to a file when run in parallel.

    Specification(s): file_system_information_2procs_head

    Design: Console

    Issue(s): #26174

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.18The system shall support outputting all processors' console information to separate files when run in parallel with the –keep-cout command line option.

    Specification(s): file_system_information_2procs_all

    Design: Console

    Issue(s): #26174

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.19The 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

  • 1.41.20The 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

  • 1.41.21The 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

  • 1.41.22The 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

  • 1.41.23The 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

  • 1.41.24The 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

  • 1.41.25The 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

  • 1.41.26The system shall support writing time information in DTIME format in the console.

    Specification(s): console_dtime_format

    Design: Console

    Issue(s): #24813

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.41.27The system shall support writing time information in minutes in the console.

    Specification(s): console_minute_format

    Design: Console

    Issue(s): #24944

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.41.28The system shall support writing time information in hours in the console.

    Specification(s): console_hour_format

    Design: Console

    Issue(s): #24944

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.41.29The system shall support writing time information in days in the console.

    Specification(s): console_day_format

    Design: Console

    Issue(s): #24944

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.41.30The 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

  • 1.41.31The 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

  • 1.41.32The 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

  • 1.41.33The 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

  • 1.41.34The 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

  • 1.41.35The 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

  • 1.41.36The 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

  • 1.41.37The 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

  • 1.41.38The system shall report an error when specifying an invalid table fit width option.

    Specification(s): console_fit_width_error

    Design: Console

    Issue(s): #1927

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.157The 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

  • 1.41.158The 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

  • 1.41.187The 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

  • 1.41.188The 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

  • 1.41.189The 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

  • 1.41.190The 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

  • framework: CSV
  • 1.41.39The 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

  • 1.41.40The 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

  • 1.41.41The 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

  • 1.41.42The 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

  • 1.41.43The 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

  • 1.41.44The 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

  • 1.41.45The 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

  • 1.41.46The system shall support CSV output to files on linear iterations, generating unique filenames containing the time step, current nonlinear and linear iteration numbers.

    Specification(s): csv_transient_vpp_linear

    Design: Output SystemCSV

    Issue(s): #24705

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.47The system shall support CSV output to files on nonlinear iterations, generating unique filenames containing the time step and current nonlinear iteration number.

    Specification(s): csv_transient_vpp_nonlinear

    Design: Output SystemCSV

    Issue(s): #24705

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.48The system shall report an error if post-processors and scalar variables have different CSV output frequency.

    Specification(s): pp_scalar_execute_on_mismatch

    Design: Output SystemCSV

    Issue(s): #25211

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.49The system shall report an error if post-processors and reporters have different CSV output frequency.

    Specification(s): pp_reporter_execute_on_mismatch

    Design: Output SystemCSV

    Issue(s): #25211

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.50The CSV output object shall create a symlink to the final output 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

  • 1.41.51The CSV output object shall create a symlink to the final output 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

  • 1.41.52The 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

  • 1.41.53The CSV output object shall create a symlink to the most recent output with a '_LATEST' suffix for VectorPostprocessor data.

    Specification(s): latest

    Design: VectorPostprocessors SystemCSV

    Issue(s): #11087

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.41.54The 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

  • framework: Exodus
  • 1.41.76The system shall support ExodusII output.

    Specification(s): basic

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.77The system ExodusII output shall not use HDF5 unless requested.

    Specification(s): hdf5

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): RunCommand

  • 1.41.78The 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

  • 1.41.79The 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

  • 1.41.80The 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

  • 1.41.81The 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

  • 1.41.82The 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

  • 1.41.83The 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

  • 1.41.84The system shall support outputting side-discontinuous edge element data with the ExodusII format.

    Specification(s): side_discontinuous_edge2

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.85The system shall support outputting side-discontinuous quad element data with the ExodusII format.

    Specification(s): side_discontinuous

    Design: Exodus

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.86The system shall support outputting extra element id data defined on the input mesh with the ExodusII format.

    Specification(s): output_elem_id

    Design: Exodus

    Issue(s): #23386

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.87The system shall support restricting which extra element id data defined on the input mesh are outputted with the ExodusII format.

    Specification(s): output_elem_id_restrict

    Design: Exodus

    Issue(s): #23386

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.41.88The system shall report an error if
    1. the supplied names for including or excluding variables is invalid.
    2. a file base is supplied for a child app when there are multiple instances.

    Specification(s): errors/invalid_hide, errors/file_base_in_child_apps

    Design: Exodus

    Issue(s): #23743

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.154The 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

  • 1.41.161The 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

  • framework: GMV
  • 1.41.90The system shall support GMV output.

    Specification(s): gmv_out_test

    Design: GMV

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.123The 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

  • framework: Tecplot
  • 1.41.93The system shall support Tecplot output.

    Specification(s): tecplot_out_test

    Design: Tecplot

    Issue(s): #920

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.94The system shall support Tecplot output given in Tecplot binary format if the Tecplot API is available.

    Specification(s): tecplot_bin_test

    Design: Tecplot

    Issue(s): #3403

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.95The system shall support Tecplot output given in ASCII format if the Tecplot API is not available.

    Specification(s): tecplot_bin_test_override

    Design: Tecplot

    Issue(s): #3403

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.191The system shall support writing ASCII Tecplot output.

    Specification(s): test

    Design: Tecplot

    Issue(s): #440#1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.192The system shall support appending Tecplot output files.

    Specification(s): test_append

    Design: Tecplot

    Issue(s): #440#1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.193The system shall optionally support writing binary Tecplot files.

    Specification(s): test_binary

    Design: Tecplot

    Issue(s): #440#1927

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • framework: Gnuplot
  • 1.41.96The 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

  • 1.41.97The 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

  • 1.41.98The 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

  • framework: XDA/XDR
  • 1.41.102The system shall support XDR output.

    Specification(s): xdr_output

    Design: XDA/XDR

    Issue(s): #2243

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.204The 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

  • 1.41.205The 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

  • framework: OutputInterface
  • 1.41.124The 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

  • 1.41.156The 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

  • 1.41.166The 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

  • 1.41.167The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.168The system shall support limiting postprocessor output to the screen.

    Specification(s): console

    Design: Output SystemOutputInterface

    Issue(s): #1927

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.41.169The 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

  • 1.41.170The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: JSON
  • 1.41.141The system shall support JSON output for data.

    Specification(s): basic

    Design: JSON

    Issue(s): #11323

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.142The 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

  • 1.41.143The system shall support creating unique JSON output files per timestep.

    Specification(s): basic

    Design: JSON

    Issue(s): #18133

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 1.41.172The 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

  • 1.41.202The 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

  • 1.54.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

  • 1.54.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

  • framework: OutputWarehouse
  • 1.41.144The system shall provide an API for retrieving an output object by type and name.

    Specification(s): getOutput

    Design: OutputWarehouse

    Issue(s): #2885

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.145The system shall provide an API for retrieving all output objects of a type.

    Specification(s): getOutputs

    Design: OutputWarehouse

    Issue(s): #2885

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.146The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.147The system shall provide an API for retrieving all output object names of a type.

    Specification(s): getOutputNames

    Design: OutputWarehouse

    Issue(s): #2885

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.41.148The 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

  • 1.41.194The 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

  • framework: Progress
  • 1.41.173The system shall support printing a progress bar that indicates the fraction of total simulation time passed.

    Specification(s): full

    Design: Progress

    Issue(s): #22906

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.41.174The system shall support using a shortcut to set up a progress bar output.

    Specification(s): common

    Design: Progress

    Issue(s): #22906

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • framework: Restartable
  • 1.41.175Correctly set up initial recover files for the part2 test.

    Specification(s): part1

    Design: RestartableDataIO

    Issue(s): #2661

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.176A 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

  • 1.41.177Correctly 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

  • 1.41.178A 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

  • 1.55.3The system shall support reading and writing solutions on meshes containing duplicate or overlapping mesh nodes.

    Specification(s): test

    Design: DataIORestartable

    Issue(s): #2306

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.4The system shall support the ability to
    1. perform residual calculations that accumulate state and
    2. restart the calculation using the accumulated state.

    Specification(s): kernel/test, kernel/test2

    Design: DataIORestartable

    Issue(s): #2306

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.5The system shall support the ability to
    1. to name problem objects in a simulation and
    2. restart the calculation using the defined name.

    Specification(s): custom/custom_name, custom/custom_name2

    Design: DataIORestartable

    Issue(s): #2306

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.6The system shall report an error when
    1. a simulation is started with multiple processors but
    2. restarted with a different number processors.

    Specification(s): parallel_error/error1, parallel_error/error2

    Design: DataIORestartable

    Issue(s): #2306

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunExceptionExodiff

  • 1.55.7The system shall report an error when
    1. a simulation is started with multiple threads but
    2. restarted with a different number threads.

    Specification(s): thread_error/with_threads, thread_error/threads_error

    Design: DataIORestartable

    Issue(s): #2306

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunExceptionExodiff

  • 1.55.8The system shall support running a transient test for the purposed of changing a restart time step size.

    Specification(s): test_part1

    Design: DataIORestartable

    Issue(s): #2304

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.55.9The system shall support changing the time step size during a recover operation.

    Specification(s): test_restart

    Design: DataIORestartable

    Issue(s): #2304

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.10The system shall produce an error when an attempt is made to serialize a type without a serialization (dataStore) routine when that data is declared as restartable.

    Specification(s): pointer_store_error

    Design: DataIORestartable

    Issue(s): #1169

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.55.11The system shall store a custom type that contains a data serialization routine that is declared as restartable.

    Specification(s): pointer_load_error

    Design: DataIORestartable

    Issue(s): #1169

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.55.12The system shall produce an error when an attempt is made to deserialize a type without a deserialization (dataLoad) routine when that data is declared as restartable during a restart or recover operation.

    Specification(s): pointer_load_error2

    Design: DataIORestartable

    Issue(s): #1169

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.55.13The system shall support the checkpointed output of postprocessors.

    Specification(s): checkpoint

    Design: RestartableReceiver

    Issue(s): #25414

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.55.14The system shall support loading a postprocessor into another postprocessor during restart.

    Specification(s): restart

    Design: RestartableReceiver

    Issue(s): #25414

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.55.15The systen shall support running and saving off a transient solution with stateful material properties for a restart test.

    Specification(s): transient_with_stateful

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.16The systen shall support restart with a solution containing only a subset of the variables in the restart simulation.

    Specification(s): add_variable_restart

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.17The system shall support outputting a mesh from a simulation
    1. with uniform refinement to ExodusII format,
    2. start a new simulation that adds additional refinement,
    3. which can be used in an third simulation.

    Specification(s): uniform_refine/test_1, uniform_refine/test_2, uniform_refine/test_3

    Design: RestartableDataIO

    Issue(s): #563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.18The system shall support outputting a mesh to checkpoint format for restart testing.

    Specification(s): steady_1

    Design: RestartableDataIO

    Issue(s): #563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.19The system shall support starting a transient simulation from a steady simulation result.

    Specification(s): trans_from_steady

    Design: RestartableDataIO

    Issue(s): #563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.20The system shall support renaming a variable read from a solution file upon restart.

    Specification(s): restart_with_variable_rename

    Design: RestartableDataIO

    Issue(s): #4965

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.21The system shall support writing out several timesteps to a solution file to test reading from a specific point.

    Specification(s): restart_use_end_part1

    Design: RestartableDataIO

    Issue(s): #5748

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.55.22The system shall support restarting from the last timestep using the keyword "LATEST".

    Specification(s): restart_use_end_part2

    Design: RestartableDataIO

    Issue(s): #5748

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.23The system shall issue a useful error message stating the valid options when a user requests an invalid time step number or keyword.

    Specification(s): restart_use_end_error_check

    Design: RestartableDataIO

    Issue(s): #5748

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.55.24The system shall issue a useful error message stating that initial conditions should not be used when restarting.

    Specification(s): restart_error_with_ics

    Design: RestartableDataIO

    Issue(s): #21423

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.55.25The system shall support running and saving off a transient solution for using in a steady state restart.

    Specification(s): transient_solve

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.26The system shall support restarting a steady state solve from a transient simulation solution.

    Specification(s): steady_from_transient_restart

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.27The system shall support solving a transient problem as a reference solution for a two part multiapp solve.

    Specification(s): complete_solve_no_subapp

    Design: DataIORestartable

    Issue(s): #6297

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.28The system shall support writing out checkpoint directly from a subapp, a subtree of the multiapp tree of the parent solve.

    Specification(s): two_step_solve_parent

    Design: DataIORestartable

    Issue(s): #6297

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.29The system shall support restarting a subapp, a subtree of the multiapp tree of a parent solve without restarting the parent application.

    Specification(s): two_step_solve_parent_restart

    Design: DataIORestartable

    Issue(s): #6297

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.30The system shall support storing the solution of an eigenvalue solve such that it can be restarted later into a non-eigenvalue solve.

    Specification(s): eigen_store_solution

    Design: Restartable

    Issue(s): #21011

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.31The system shall support loading the restarted solution from an eigenvalue solve into a transient solve.

    Specification(s): transient_from_eigen_solution

    Design: Restartable

    Issue(s): #21011

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.32The system shall support executing a
    1. a steady-state problem
    2. and restarting a transient simulation from the previous solution.

    Specification(s): tests/steady, tests/restart_trans_from_steady

    Design: RestartableDataIO

    Issue(s): #563#13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.33The system shall support generating checkpoint files for restart testing with sub apps.

    Specification(s): steady_with_sub

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.34The system shall support restarting a transient simulation from a steady solution file with sub apps.

    Specification(s): restart_trans_from_steady_with_sub

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.35The system shall support generating checkpoint files for restart testing with multiple sub apps.

    Specification(s): steady_with_2subs

    Design: RestartableDataIO

    Issue(s): #15287

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.36The system shall support restarting a transient simulation from a steady solution file with multiple sub apps.

    Specification(s): restart_trans_from_steady_with_2subs

    Design: RestartableDataIO

    Issue(s): #15287

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.37The system shall support generating checkpoint files for transient to transient restart testing with multiple sub apps.

    Specification(s): pseudo_trans_with_2subs

    Design: RestartableDataIO

    Issue(s): #15287

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.38The system shall support restarting a transient simulation from a pseudo-transient solution file with multiple sub apps.

    Specification(s): restart_trans_from_pseudo_trans_with_2subs

    Design: RestartableDataIO

    Issue(s): #15287

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.39The system shall be capable, on a single process, of
    1. writing data to a restart file
    2. and restarting the simulation from the restart file.

    Specification(s): serial/first, serial/second

    Design: Restartable

    Issue(s): #1169#2218

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.55.40The system shall be capable, in parallel, of
    1. writing data to a restart file
    2. and restarting the simulation from the restart file.

    Specification(s): parallel/first, parallel/second

    Design: Restartable

    Issue(s): #1169#2218

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.55.42The system shall support outputting a mesh to checkpoint format for restart testing with "start_time".

    Specification(s): steady

    Design: RestartableDataIO

    Issue(s): #563

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.55.43The system shall use the the final time as the "start_time" from the restart file.

    Specification(s): default_start_timestart

    Design: RestartableDataIO

    Issue(s): #13182

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.55.44The system shall support resetting "start_time" when restarting from a checkpoint mesh format.

    Specification(s): start_time_override_zero

    Design: RestartableDataIO

    Issue(s): #13182

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.55.45The system shall support overriding "start_time" when restarting from a checkpoint mesh format to an arbitrary time.

    Specification(s): start_time_override_non_zero

    Design: RestartableDataIO

    Issue(s): #13182

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: DataIO
  • 1.41.175Correctly set up initial recover files for the part2 test.

    Specification(s): part1

    Design: RestartableDataIO

    Issue(s): #2661

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.41.176A 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

  • 1.41.177Correctly 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

  • 1.41.178A 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

  • 1.55.3The system shall support reading and writing solutions on meshes containing duplicate or overlapping mesh nodes.

    Specification(s): test

    Design: DataIORestartable

    Issue(s): #2306

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.4The system shall support the ability to
    1. perform residual calculations that accumulate state and
    2. restart the calculation using the accumulated state.

    Specification(s): kernel/test, kernel/test2

    Design: DataIORestartable

    Issue(s): #2306

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.5The system shall support the ability to
    1. to name problem objects in a simulation and
    2. restart the calculation using the defined name.

    Specification(s): custom/custom_name, custom/custom_name2

    Design: DataIORestartable

    Issue(s): #2306

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.6The system shall report an error when
    1. a simulation is started with multiple processors but
    2. restarted with a different number processors.

    Specification(s): parallel_error/error1, parallel_error/error2

    Design: DataIORestartable

    Issue(s): #2306

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunExceptionExodiff

  • 1.55.7The system shall report an error when
    1. a simulation is started with multiple threads but
    2. restarted with a different number threads.

    Specification(s): thread_error/with_threads, thread_error/threads_error

    Design: DataIORestartable

    Issue(s): #2306

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunExceptionExodiff

  • 1.55.8The system shall support running a transient test for the purposed of changing a restart time step size.

    Specification(s): test_part1

    Design: DataIORestartable

    Issue(s): #2304

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.55.9The system shall support changing the time step size during a recover operation.

    Specification(s): test_restart

    Design: DataIORestartable

    Issue(s): #2304

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.10The system shall produce an error when an attempt is made to serialize a type without a serialization (dataStore) routine when that data is declared as restartable.

    Specification(s): pointer_store_error

    Design: DataIORestartable

    Issue(s): #1169

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.55.11The system shall store a custom type that contains a data serialization routine that is declared as restartable.

    Specification(s): pointer_load_error

    Design: DataIORestartable

    Issue(s): #1169

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.55.12The system shall produce an error when an attempt is made to deserialize a type without a deserialization (dataLoad) routine when that data is declared as restartable during a restart or recover operation.

    Specification(s): pointer_load_error2

    Design: DataIORestartable

    Issue(s): #1169

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.55.15The systen shall support running and saving off a transient solution with stateful material properties for a restart test.

    Specification(s): transient_with_stateful

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.16The systen shall support restart with a solution containing only a subset of the variables in the restart simulation.

    Specification(s): add_variable_restart

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.17The system shall support outputting a mesh from a simulation
    1. with uniform refinement to ExodusII format,
    2. start a new simulation that adds additional refinement,
    3. which can be used in an third simulation.

    Specification(s): uniform_refine/test_1, uniform_refine/test_2, uniform_refine/test_3

    Design: RestartableDataIO

    Issue(s): #563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.18The system shall support outputting a mesh to checkpoint format for restart testing.

    Specification(s): steady_1

    Design: RestartableDataIO

    Issue(s): #563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.19The system shall support starting a transient simulation from a steady simulation result.

    Specification(s): trans_from_steady

    Design: RestartableDataIO

    Issue(s): #563

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.20The system shall support renaming a variable read from a solution file upon restart.

    Specification(s): restart_with_variable_rename

    Design: RestartableDataIO

    Issue(s): #4965

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.21The system shall support writing out several timesteps to a solution file to test reading from a specific point.

    Specification(s): restart_use_end_part1

    Design: RestartableDataIO

    Issue(s): #5748

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.55.22The system shall support restarting from the last timestep using the keyword "LATEST".

    Specification(s): restart_use_end_part2

    Design: RestartableDataIO

    Issue(s): #5748

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.23The system shall issue a useful error message stating the valid options when a user requests an invalid time step number or keyword.

    Specification(s): restart_use_end_error_check

    Design: RestartableDataIO

    Issue(s): #5748

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.55.24The system shall issue a useful error message stating that initial conditions should not be used when restarting.

    Specification(s): restart_error_with_ics

    Design: RestartableDataIO

    Issue(s): #21423

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.55.25The system shall support running and saving off a transient solution for using in a steady state restart.

    Specification(s): transient_solve

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.26The system shall support restarting a steady state solve from a transient simulation solution.

    Specification(s): steady_from_transient_restart

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.27The system shall support solving a transient problem as a reference solution for a two part multiapp solve.

    Specification(s): complete_solve_no_subapp

    Design: DataIORestartable

    Issue(s): #6297

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.28The system shall support writing out checkpoint directly from a subapp, a subtree of the multiapp tree of the parent solve.

    Specification(s): two_step_solve_parent

    Design: DataIORestartable

    Issue(s): #6297

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.29The system shall support restarting a subapp, a subtree of the multiapp tree of a parent solve without restarting the parent application.

    Specification(s): two_step_solve_parent_restart

    Design: DataIORestartable

    Issue(s): #6297

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.32The system shall support executing a
    1. a steady-state problem
    2. and restarting a transient simulation from the previous solution.

    Specification(s): tests/steady, tests/restart_trans_from_steady

    Design: RestartableDataIO

    Issue(s): #563#13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.33The system shall support generating checkpoint files for restart testing with sub apps.

    Specification(s): steady_with_sub

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.34The system shall support restarting a transient simulation from a steady solution file with sub apps.

    Specification(s): restart_trans_from_steady_with_sub

    Design: RestartableDataIO

    Issue(s): #13438

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.35The system shall support generating checkpoint files for restart testing with multiple sub apps.

    Specification(s): steady_with_2subs

    Design: RestartableDataIO

    Issue(s): #15287

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.36The system shall support restarting a transient simulation from a steady solution file with multiple sub apps.

    Specification(s): restart_trans_from_steady_with_2subs

    Design: RestartableDataIO

    Issue(s): #15287

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.37The system shall support generating checkpoint files for transient to transient restart testing with multiple sub apps.

    Specification(s): pseudo_trans_with_2subs

    Design: RestartableDataIO

    Issue(s): #15287

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.38The system shall support restarting a transient simulation from a pseudo-transient solution file with multiple sub apps.

    Specification(s): restart_trans_from_pseudo_trans_with_2subs

    Design: RestartableDataIO

    Issue(s): #15287

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.42The system shall support outputting a mesh to checkpoint format for restart testing with "start_time".

    Specification(s): steady

    Design: RestartableDataIO

    Issue(s): #563

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.55.43The system shall use the the final time as the "start_time" from the restart file.

    Specification(s): default_start_timestart

    Design: RestartableDataIO

    Issue(s): #13182

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.55.44The system shall support resetting "start_time" when restarting from a checkpoint mesh format.

    Specification(s): start_time_override_zero

    Design: RestartableDataIO

    Issue(s): #13182

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.55.45The system shall support overriding "start_time" when restarting from a checkpoint mesh format to an arbitrary time.

    Specification(s): start_time_override_non_zero

    Design: RestartableDataIO

    Issue(s): #13182

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: VTK
  • 1.41.203The 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

  • framework: CommandLine
  • 1.42.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

  • 1.42.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

  • 1.42.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

  • 1.42.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

  • 1.42.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: PhiZero
  • 1.45.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

  • 1.45.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

  • framework: DiffusionCG
  • 1.46.1The system shall be able to solve a source-less diffusion equation with a continuous Galerkin discretization with a shorthand syntax.

    Specification(s): cg

    Design: DiffusionCG

    Issue(s): #25642

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.46.2The system shall be able to solve a source-less diffusion equation with a continuous Galerkin discretization with automatic differentiation with a shorthand syntax.

    Specification(s): cg_ad

    Design: DiffusionCG

    Issue(s): #25642

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: DiffusionFV
  • 1.46.3The system shall be able to solve a source-less diffusion equation with a cell-centered finite volume discretization with a shorthand syntax.

    Specification(s): fv

    Design: DiffusionFV

    Issue(s): #25642

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: Positions
  • 1.47.1The system shall be able to create multiapps from positions objects.

    Specification(s): test

    Design: Positions

    Issue(s): #23587

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 1.47.2The system shall be able to create multiapps from positions objects using their initial positions.

    Specification(s): initial_positions

    Design: Positions

    Issue(s): #23587

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 1.47.3The system shall report an error if
    1. the positions objects to use for creating multiapps are not initialized, or
    2. the size of the current positions does not match the number of initial positions.

    Specification(s): error/not_init, error/size_changed

    Design: Positions

    Issue(s): #23587

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.47.4The system shall be able to load positions from
    1. a parameter in the input file,
    2. a text file,
    3. element centroids from a mesh, with or without block restriction,
    4. centroids of groups of elements in the mesh,
    5. a reporter with data in the expected vector of points format,
    6. triplets on functors that are evaluated to obtain positions,
    7. one or more multiapp positions,
    8. and one or more multiapp mesh centroids.

    Specification(s): test/input, test/file, test/mesh_elements, test/blocks_and_extra_ids, test/reporter, test/functors, test/multiapps, test/multiapps_centroids

    Design: Positions

    Issue(s): #23587

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 1.47.5The system shall be able to perform
    1. simple linear operations such as scaling, translation and rotation to positions, and
    2. a distribution, through translations, of positions from one set of positions onto another.

    Specification(s): operations/transform, operations/distribution

    Design: Positions

    Issue(s): #23587

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • framework: AreaPostprocessor
  • 1.48.1The AreaPostprocessor shall compute the "area" or dimension - 1 "volume" of sides.

    Specification(s): test

    Design: AreaPostprocessor

    Issue(s): #1901

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.55The system shall be able to correctly compute the volume of blocks and the area of sidesets in 3D.

    Specification(s): 3d

    Design: AreaPostprocessorVolumePostprocessor

    Issue(s): #15542

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.56The system shall be able to correctly compute the area of blocks and the perimeterof sidesets in 2D and appropriately handle boundary conditions applied to sidesetscreated with respect to different bodies.

    Specification(s): 2d

    Design: AreaPostprocessorVolumePostprocessor

    Issue(s): #15542

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: ElementH1Error
  • 1.48.24The system shall compute the H1-seminorm between a field variable and a analytical function.

    Specification(s): test

    Design: ElementH1Error

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: ElementL1Error
  • 1.48.29The system shall compute the L1 error between an elemental field variable and an analytical function.

    Specification(s): test

    Design: ElementL1Error

    Issue(s): #15857

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: ElementL2Error
  • 1.48.31The system shall compute the L2-error (Euclidean) between a field variable and a analytical function.

    Specification(s): test

    Design: ElementL2Error

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.70The system shall verify calculations using the method of manufactured solutions using a higher order polynomial function for linear elements.

    Specification(s): test

    Design: ElementL2Error

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.48.71The system shall verify calculations using the method of manufactured solutions using sine functions for linear elements:
    1. on a 3D mesh
    2. verified with an analytical 3D solution and
    3. on a 2D mesh
    4. verified with an analytical 2D solution.

    Specification(s): mms_tests/3D_mesh, mms_tests/3D_pps, mms_tests/2D_mesh, mms_tests/2D_pps

    Design: ElementL2Error

    Issue(s): #1410

    Collection(s): FUNCTIONAL

    Type(s): CSVDiffExodiff

  • 1.48.72The system shall verify calculations using the method of manufactured solutions using a functional form of an equation outside of the shape function space.

    Specification(s): test

    Design: ElementL2Error

    Issue(s): #1410

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: FindValueOnLine
  • 1.48.40The system shall be capable of find a value on a monotonically changing line.

    Specification(s): find_value_on_line

    Design: FindValueOnLine

    Issue(s): #6389#7864

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.41The system shall report and error when the target value is lower than one of the sampled endpoints.

    Specification(s): below_min

    Design: FindValueOnLine

    Issue(s): #6389#7864

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.48.42The system shall report and error when the target value is greater than one of the sampled endpoints.

    Specification(s): above_max

    Design: FindValueOnLine

    Issue(s): #6389#7864

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.48.43The system shall return the default flag value when the target value is lower than one of the sampled endpoints and error_if_not_found is false.

    Specification(s): below_min_default_continue

    Design: FindValueOnLine

    Issue(s): #6389#7864

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.44The system shall return the default flag value when the target value is greater than one of the sampled endpoints and error_if_not_found is false.

    Specification(s): above_max_default_continue

    Design: FindValueOnLine

    Issue(s): #6389#7864

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.45The system shall return user specified flag value when the target value is lower than one of the sampled endpoints and error_if_not_found is false.

    Specification(s): below_min_user_continue

    Design: FindValueOnLine

    Issue(s): #6389#7864

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.46The system shall return user specified flag value when the target value is greater than one of the sampled endpoints and error_if_not_found is false.

    Specification(s): above_max_user_continue

    Design: FindValueOnLine

    Issue(s): #6389#7864

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.47The system shall report and error when the sampling line extends beyond the mesh bounding box.

    Specification(s): line_out_of_bounds

    Design: FindValueOnLine

    Issue(s): #6389#7864

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.48.48The system shall report and error when the line sampling algorithm fails to converge within the desired depth.

    Specification(s): depth_exceeded

    Design: FindValueOnLine

    Issue(s): #6389#7864

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: VolumePostprocessor
  • 1.48.55The system shall be able to correctly compute the volume of blocks and the area of sidesets in 3D.

    Specification(s): 3d

    Design: AreaPostprocessorVolumePostprocessor

    Issue(s): #15542

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.56The system shall be able to correctly compute the area of blocks and the perimeterof sidesets in 2D and appropriately handle boundary conditions applied to sidesetscreated with respect to different bodies.

    Specification(s): 2d

    Design: AreaPostprocessorVolumePostprocessor

    Issue(s): #15542

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.144The system shall have the capability of computing the volume of the mesh domain.

    Specification(s): test

    Design: VolumePostprocessor

    Issue(s): #1609

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: InterfaceAverageVariableValuePostprocessor
  • 1.48.59Testing the implementation of the InterfaceAverageVariableValuePostprocessor By design at the end of the first step we should observe: an average material property of 7, an average material property absolute jump to 6,a signed material property jump (primary minus secondary) of 6, a signed material propertyjump (secondary minus primary) of -6, a material property value on the primary side of 10, a material property value on the primary side of 4

    Specification(s): interface_average_variable_value_postprocessor_test

    Design: InterfaceAverageVariableValuePostprocessor

    Issue(s): #11647

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.48.61Testing the implementation of the InterfaceAverageVariableValuePostprocessor for finite volume variables.By design at the end of the first step we should observe: an average material property of 7, an average material property absolute jump to 6,a signed material property jump (primary minus secondary) of 6, a signed material propertyjump (secondary minus primary) of -6, a material property value on the primary side of 10, a material property value on the primary side of 4

    Specification(s): interface_average_variable_value_postprocessor_fv_test

    Design: InterfaceAverageVariableValuePostprocessor

    Issue(s): #11647#16099

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: InterfaceIntegralVariableValuePostprocessor
  • 1.48.60Testing the implementation of the InterfaceIntegralVariableValuePostprocessor By design at the end of the first step we should observe: an integral material property of 21, an integral material property absolute jump to 18,a signed integral material property jump (primary minus secondary) of 18, a signed integral material propertyjump (secondary minus primary) of -18, a material integral property value on the primary side of 30, a material integral property value on the primary side of 12

    Specification(s): interface_integral_variable_value_postprocessor_test

    Design: InterfaceIntegralVariableValuePostprocessor

    Issue(s): #11647

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.48.62Testing the implementation of the InterfaceIntegralVariableValuePostprocessor for finite volume variables.By design at the end of the first step we should observe: an integral material property of 21, an integral material property absolute jump to 18,a signed integral material property jump (primary minus secondary) of 18, a signed integral material propertyjump (secondary minus primary) of -18, a material integral property value on the primary side of 30, a material integral property value on the primary side of 12

    Specification(s): interface_integral_variable_value_postprocessor_fv_test

    Design: InterfaceIntegralVariableValuePostprocessor

    Issue(s): #11647#16099

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: MemoryUsage
  • 1.48.68The system shall provide a postprocessor to measure physical and virtual memory usage and the major page fault count, depending on the operating system's ability to make those values available

    Specification(s): print_memory_usage

    Design: MemoryUsage

    Issue(s): #8619

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • framework: VectorMemoryUsage
  • 1.48.69The system shall provide a vectorpostprocessor to, on each rank, measure physical and virtual memory usage, major page fault count, and total available ram available, depending on the operating system's ability to make those values available

    Specification(s): vector_memory_usage

    Design: VectorMemoryUsage

    Issue(s): #12333

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • framework: NumDOFs
  • 1.48.85The NumDOFs Postprocessor shall report the number of degrees of freedom (DOFS) from one or more equations systems in the simulation.

    Specification(s): test

    Design: NumDOFs

    Issue(s): #2094#6872

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: NumElems
  • 1.48.86The NumElems Postprocessor shall report the number of elements (active or total) in the simulation.

    Specification(s): test

    Design: NumElems

    Issue(s): #2094#8421

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.87The NumElems Postprocessor shall report the number of elements (active or total) in the simulation when using distributed (pre-split) mesh.

    Specification(s): test_split

    Design: NumElems

    Issue(s): #2094#8421

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: NumNodes
  • 1.48.90The NumNodes Postprocessor shall report the number of nodes (replicated or distributed) in the simulation.

    Specification(s): test

    Design: NumNodes

    Issue(s): #2094

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.91The NumNodes Postprocessor shall report the number of nodes in the simulation when using distributed (pre-split) mesh.

    Specification(s): test_split

    Design: NumNodes

    Issue(s): #2094#8421

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: NumVars
  • 1.48.93The NumVars Postprocessor shall report the number of variables from one or more equation systems in the simulation.

    Specification(s): test

    Design: NumVars

    Issue(s): #2094

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: PerfGraphData
  • 1.48.98The system shall have the abililty to pull information from the PerfGraph into a Postprocessor

    Specification(s): test

    Design: PerfGraphData

    Issue(s): #11551

    Collection(s): FUNCTIONAL

    Type(s): CheckFiles

  • 1.48.99The system shall report a reasonable error when trying to obtain information from the PerfGraph for a section that does not exist

    Specification(s): missing

    Design: PerfGraphData

    Issue(s): #11551

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: PointValue
  • 1.48.100The system shall support the ability to sample a field variable value anywhere within the domain.

    Specification(s): test

    Design: PointValue

    Issue(s): #1776

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.48.101The system shall report an error when a field variable sample location is outside of the domain.

    Specification(s): error

    Design: PointValue

    Issue(s): #3475

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: Receiver
  • 1.48.115The system shall support the ability to report a scalar value set by arbitrary objects in the simulation
    1. with an initial default value and
    2. with a default previous (older) value.

    Specification(s): defaults/no_old_initialize, defaults/initial_only

    Design: Receiver

    Issue(s): #5106

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.55.13The system shall support the checkpointed output of postprocessors.

    Specification(s): checkpoint

    Design: RestartableReceiver

    Issue(s): #25414

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.55.14The system shall support loading a postprocessor into another postprocessor during restart.

    Specification(s): restart

    Design: RestartableReceiver

    Issue(s): #25414

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: ScalarVariable
  • 1.48.119The system shall support reporting scalar variables as Postprocessor (scalar output) values.

    Specification(s): scalar_pps

    Design: ScalarVariable

    Issue(s): #726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: ScalePostprocessor
  • 1.48.120The system shall support the scaling of a post processor quantity by another post processor quantity.

    Specification(s): test

    Design: ScalePostprocessor

    Issue(s): #5954

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: SideAverageValue
  • 1.48.122The system shall compute the area-weighted average of the integral of a variable over a side.

    Specification(s): test

    Design: SideAverageValue

    Issue(s): #1405

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.93The system shall report an error if the boundary is not specified when computing the average value of a variable on a boundary.

    Specification(s): test

    Design: SideAverageValue

    Issue(s): #9103#21566

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.67.94The system shall check if the lower-d variable is properly defined on a boundary.

    Specification(s): lower_d_test

    Design: SideAverageValue

    Issue(s): #9103#21566

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.67.95The system shall report an error if the lower-d variable is not properly defined on a boundary.

    Specification(s): lower_d_test_error

    Design: SideAverageValue

    Issue(s): #9103#21566

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.67.96The system shall report an error if the side average value of a variable is requested on a boundary that is the centerline of an axisymmetric model.

    Specification(s): rz_centerline_side

    Design: SideAverageValue

    Issue(s): #9103#21566

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: SideDiffusiveFluxAverage
  • 1.48.124The system shall be capable of computing the average diffusive flux through a specified boundary on the mesh.

    Specification(s): test

    Design: SideDiffusiveFluxAverage

    Issue(s): #2201

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.48.125The system shall be capable of computing the average of the diffusive flux integral of a finite volume variable through a specified boundary on the mesh.

    Specification(s): test_fv

    Design: SideDiffusiveFluxAverage

    Issue(s): #2201#16099

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: TableOutput
  • 1.48.135The TableOutput object shall allow the user to override tolerance checks when determining whether new rows should be added (independent variable delta)

    Specification(s): test

    Design: TableOutput

    Issue(s): #11171

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: FSP
  • 1.49.7The system shall support the use of field split preconditioner on
    1. a single subdomain and
    2. multiple subdomains.
    3. vector variables
    4. array variables

    Specification(s): group/test, group/fsp_image, group/vector, group/array

    Design: FSP

    Issue(s): #1851#22359

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.49.8The system shall report an error if a user has forgotten a variable in their field splits.

    Specification(s): missing_var_in_split

    Design: FSP

    Issue(s): #1851#22359

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.49.9The system shall support nested field splits.

    Specification(s): nested

    Design: FSP

    Issue(s): #1851#22359

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.49.10The system shall error if there is an inconsistent covering of degrees of freedom in a nested field split.

    Specification(s): nested_error

    Design: FSP

    Issue(s): #1851#22359

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.49.11The system shall be able to selectively remove degrees of freedom from a field spit by variable by boundary.

    Specification(s): unside_by_var

    Design: FSP

    Issue(s): #1851#22359

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: HMG
  • 1.49.12The system shall support the use of HMG (high performance MG)

    Specification(s): hmg

    Design: HMG

    Issue(s): #16210

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.49.13The 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

  • 1.49.14The 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

  • framework: Preconditioning System
  • 1.49.15The 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

  • 1.49.19The 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

  • framework: PBP
  • 1.49.16The 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

  • 1.49.17The 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

  • 1.49.18The 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

  • framework: SMP
  • 1.49.23The 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

  • 1.49.24The 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

  • framework: VCP
  • 1.49.25The 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

  • 1.49.26The 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

  • 1.49.27The 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

  • framework: Eigenvalue
  • 1.51.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

  • 1.51.8Eigenvalue system should support standard eigenvalue problems

    Specification(s): test

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.9Eigenvalue system should support generalized eigenvalue problems

    Specification(s): gipm_test

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.10Eigenvalue system should support IntegratedBC

    Specification(s): gipm_ibc

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.51.12Eigenvalue system should use homogeneous boundary conditions only

    Specification(s): wrong_NodalBC_type_eigen

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.51.13Eigenvalue system requires SLEPc installed

    Specification(s): no_slepc

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.20Eigenvalue system should be able to handle DG kernels

    Specification(s): dg_krylovschur

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.21Eigenvalue system shall support Picard iteration using eigenvalue executioner as a parent.

    Specification(s): eigen_as_parent

    Design: Eigenvalue

    Issue(s): #15513

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.22Eigenvalue system shall support Picard iteration using eigenvalue executioner as a parent and output eigen vectors as an exodus file.

    Specification(s): eigen_as_parent_exodus

    Design: Eigenvalue

    Issue(s): #15513

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.42Eigen solver should work with a physics-based preconditioner

    Specification(s): newton_pbp

    Design: Eigenvalue

    Issue(s): #7398

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • 1.51.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

  • framework: ReferenceResidualProblem
  • 1.51.57The 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

  • 1.51.58The 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

  • 1.51.59The 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

  • 1.51.60The 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

  • 1.51.61The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.51.62The 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

  • 1.51.63The system shall have the ability to base convergence on the comparison of L2 normalization of the residual for individual variables to the sum of the L2 normalization of the absolute value of the residual contributions of those variables.

    Specification(s): abs_ref

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.64The system shall have the ability to base convergence on the comparison of L2 normalization of the residual for individual variables to the sum of the L2 normalization of the absolute value of the residual contributions of those variables using an acceptable tolerance past a given number of nonlinear iterations.

    Specification(s): abs_ref_acceptable

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.51.65The system shall have the ability to base convergence on the comparison of L2 normalization of the residual for individual variables locally divided by the absolute value of the residual contributions of those variables.

    Specification(s): local_normalization

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.66The system shall have the ability to base convergence on the comparison of Linf normalization of the residual for individual variables locally divided by the absolute value of the residual contributions of those variables.

    Specification(s): local_linf_normalization

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.67The system shall have the ability to base convergence on the comparison of Linf normalization of the residual for individual variables to the sum of the Linf normalization of the absolute value of the residual contributions of those variables.

    Specification(s): linf_normalization

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.68The system shall have the ability to base convergence on the comparison of L2 normalization of the residual for individual variables to the sum of the L2 normalization of the absolute value of the residual contributions of those variables using AD.

    Specification(s): ad_abs_ref

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.69The system shall have the ability to default to the traditional convergence checks if no reference vector is provided in ReferenceResidualProblem.

    Specification(s): no_ref

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.70The system shall treat convergence with a zero reference residual value as requiring zero residual value for convergence.

    Specification(s): zero_tolerance_ref

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.51.71The system shall treat convergence with a zero reference residual value as converged if the residual is below the relative tolerance.

    Specification(s): zero_rel_tolerance_ref

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.51.72When using ReferenceResidualProblem the system shall throw an error
    1. if the reference tag is not a residual vector tag.
    2. if the reference tag does not exist.
    3. if the reference vector is not provided when using local normalization.
    4. if the reference vector is provided is not a residual vector tag.

    Specification(s): error/wrong_vector_tag_type, error/no_tag, error/no_reference_vector, error/not_residual_tag

    Design: ReferenceResidualProblem

    Issue(s): #9151

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: Quadrature System
  • 1.52.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

  • 1.52.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

  • 1.52.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

  • 1.52.4The system shall ensure that for per-block specified quadrature orders exactly one order is given per specified block.

    Specification(s): per-block-order-error

    Design: Quadrature System

    Issue(s): #24820

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.52.5The 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

  • 1.52.6The 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

  • 1.52.7The 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

  • framework: IterationInfo
  • 1.54.12The 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

  • framework: PerfGraphReporter
  • 1.54.16The 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): RunAppRunCommand

  • 1.54.17The 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

  • 1.54.18The 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): RunAppRunCommand

  • framework: RestartableDataReporter
  • 1.54.19The system shall support the output of restartable data in a human-readable form.

    Specification(s): test

    Design: RestartableDataReporter

    Issue(s): #26304

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 1.54.20The system shall support excluding names when outputting restartable data in a human-readable form.

    Specification(s): exclude

    Design: RestartableDataReporter

    Issue(s): #26304

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 1.54.21The system shall support omitting data values for data that is missing an output method when outputting restartable data in human-readable form.

    Specification(s): allow_unimplemented

    Design: RestartableDataReporter

    Issue(s): #26304

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 1.54.22The system shall support reporting a reasonable error when trying to output restartable data in human-readable form for a data type that does not have an output specialization

    Specification(s): unimplemented_error

    Design: RestartableDataReporter

    Issue(s): #26304

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.54.23The system shall support a detailed output including state flags when outputting restartable data in a human-readable form.

    Specification(s): detailed

    Design: RestartableDataReporter

    Issue(s): #26304

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • 1.54.24The system shall support the output of restartable meta data in a human-readable form.

    Specification(s): map

    Design: RestartableDataReporter

    Issue(s): #26304

    Collection(s): FUNCTIONAL

    Type(s): JSONDiff

  • framework: ADScalarTimeDerivative
  • 1.58.4The system shall provide the ability to compute the time derivative of a scalar variable and have its Jacobian computed using automatic differentiation, and
    1. applied using standard kernel variable interfaces, or
    2. applied using coupling interfaces.

    Specification(s): dot/test, dot/test_coupled

    Design: ADScalarTimeDerivative

    Issue(s): #18535

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: BDF2
  • 1.62.7The system shall support the second-order backward difference method for time integration
    1. with and
    2. without mesh adaptivity.

    Specification(s): group/test, group/adapt

    Design: BDF2

    Issue(s): #1953

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: ExplicitEuler
  • 1.62.21The system shall support the use of quasi-explicit Euler solver with
    1. 1D elements with first order shape functions and Dirichlet boundary conditions;
    2. 1D elements with second order shape functions and Dirichlet boundary conditions;
    3. 1D elements with second order shape functions and Neumann boundary conditions;
    4. 2D elements with first order shape functions and Dirichlet boundary conditions;
    5. 2D elements with second order shape functions and Dirichlet boundary conditions; and
    6. 2D elements with second order shape functions and Neumann boundary conditions.

    Specification(s): group/1d-linear, group/1d-quadratic, group/1d-quadratic-neumann, group/2d-linear, group/2d-linear-adapt, group/2d-quadratic

    Design: ExplicitEuler

    Issue(s): #1953

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: ImplicitEuler
  • 1.62.24The system shall support the use of an implicit Euler solver with
    1. with and
    2. without mesh adaptivity.

    Specification(s): group/test, group/adapt

    Design: ImplicitEuler

    Issue(s): #1953

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.62.25The system shall support the use of an implicit Euler solver with discontinuous (first-order Monomial) shape functions.

    Specification(s): monomials

    Design: ImplicitEuler

    Issue(s): #1953

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • framework: NewmarkBeta
  • 1.62.27The NewmarkBeta time integrator shall correctly compute the first and second time derivatives of a variable using the default beta and gamma parameters.

    Specification(s): newmark_beta_default

    Design: NewmarkBeta

    Issue(s): #12185#18178#18233

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.62.28The NewmarkBeta time integrator shall correctly compute the first and second time derivatives of a variable using user provided beta and gamma parameters.

    Specification(s): newmark_beta_prescribed

    Design: NewmarkBeta

    Issue(s): #12185#18178#18233

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.62.29The NewmarkBeta time integrator shall correctly use the inactive_tsteps parameter.

    Specification(s): newmark_beta_inactive_steps

    Design: NewmarkBeta

    Issue(s): #12185#18178#18233

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.62.30A Newmark-beta method time integrator shall correctly compute the second time derivative of an automatic differentiation variable using the default beta and gamma parameters.

    Specification(s): ad_newmark_beta_dotdot

    Design: NewmarkBeta

    Issue(s): #12185#18178#18233

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: TimeStepper System
  • 1.63.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

  • 1.63.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

  • 1.63.3The system shall report an error if trying to take a negative time step.

    Specification(s): error_negative

    Design: TimeStepper System

    Issue(s): #1953

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.63.4The 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

  • 1.63.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 constant value.

    Specification(s): constant_dt_cutback

    Design: TimeStepper System

    Issue(s): #13874

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.63.6The 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

  • 1.63.7The 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

  • 1.63.8The 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

  • 1.63.30The 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

  • 1.63.38The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: LogConstantDT
  • 1.63.28The 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

  • framework: PostprocessorDT
  • 1.63.29The 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

  • framework: Transfers System
  • 1.65.1The system shall output a warning if a transfer that only matches node ids is used in combinated with a coordinate transformation.

    Specification(s): both-transformed

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.65.2The system shall be able to perform interpolation transfers between main and sub applications that both have non-identity transformations into the reference space.

    Specification(s): both-transformed

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.3The system shall be able to perform mesh function transfers between main and sub applications that both have non-identity transformations into the reference space.

    Specification(s): both-transformed

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.4The system shall be able to map nearest node transfers between main and sub applications that both have non-identity transformations into the reference space.

    Specification(s): both-transformed

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.5The system shall report a warning when transferring a variable (for main app) and postprocessor (for subapp) for applications that both have non-identity transformations into the reference space.

    Specification(s): both-transformed

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.65.6The system shall be able to perform projection transfers between main and sub applications that both have non-identity transformations into the reference space.

    Specification(s): both-transformed

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.7The system shall be able to transfer data computed by a user object to a field, in either the child or the main app, in the presence of non-unity frame of reference transformations between the two applications.

    Specification(s): both-transformed

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.8The system shall be able to transfer information between three-dimensional and two-dimensional axisymmetric simulations in which the cylinder axis lies along the z-axis in three-dimensional space.

    Specification(s): multi-app

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.9The system shall be able to solve a diffusion problem with a coupled force provided by another variable.

    Specification(s): single-app

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.10The system shall be able to transfer information from a scaled, rotated, translated application into another application and reproduce the results from an equivalent single-application simulation with the transforms applied in the sub application.

    Specification(s): multi-app

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.11The system shall be able to transfer information from a scaled, rotated, translated application into another application and reproduce the results from an equivalent single-application simulation with the transforms applied in the main application.

    Specification(s): transform-main-multi-app

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.12The system shall report an error if the user does not provide sufficient information to determine the originator and destination of transfer information.

    Specification(s): need_multi_app

    Design: Transfers System

    Issue(s): #19451

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.65.13The system shall report an error if the user provides a mix of non-deprecated and deprecated parameters.

    Specification(s): mixing_parameters

    Design: Transfers System

    Issue(s): #19451

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.65.14The system shall report an error if the user provides nonsensical direction parameters.

    Specification(s): bad_spelling

    Design: Transfers System

    Issue(s): #19451

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.65.18The system shall be able to map nearest location transfers between main and sub applications that both have non-identity transformations into the reference space.

    Specification(s): both-transformed

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.19The system shall be able to transfer information between three-dimensional and two-dimensional axisymmetric simulations in which the cylinder axis lies along the z-axis in three-dimensional space, using the general field version of the nearest-location transfers.

    Specification(s): multi-app

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.20The system shall be able to transfer information from a scaled, rotated, translated application into another application and reproduce the results from an equivalent single-application simulation with the transforms applied in the sub application, using the general field version of the nearest-location transfers.

    Specification(s): multi-app

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.21The system shall be able to transfer information from a scaled, rotated, translated application into another application and reproduce the results from an equivalent single-application simulation with the transforms applied in the main application, using the general field version of the nearest-location transfers.

    Specification(s): transform-main-multi-app

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.48The system shall be able to perform transfers by evaluating the local shape function of variables between main and sub applications that both have non-identity transformations into the reference space.

    Specification(s): both-transformed

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.59The system shall be able to transfer data computed by a user object to a field, in either the child or the main app, in the presence of non-unity frame of reference transformations between the two applications, using the general field formulation of the transfer.

    Specification(s): both-transformed

    Design: Transfers System

    Issue(s): #12293

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.181The Transfer system shall support execution with the EXEC_FINAL flag.

    Specification(s): transfer_on_final

    Design: Transfers System

    Issue(s): #9923

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.182The system shall support transferring data between applications at the beginning of the fixed point iterations.

    Specification(s): transfer_on_fp_begin

    Design: Transfers System

    Issue(s): #22143

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.65.183The system shall support transferring data between applications at the end of the fixed point iterations.

    Specification(s): transfer_on_fp_end

    Design: Transfers System

    Issue(s): #22143

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.65.184The system shall be able to transfer data to and from an application executed at the beginning of the fixed point iterations.

    Specification(s): multiapp_on_fp_begin

    Design: Transfers System

    Issue(s): #22143

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.65.185The system shall be able to transfer data to and from an application executed at the end of the fixed point iterations.

    Specification(s): multiapp_on_fp_end

    Design: Transfers System

    Issue(s): #22143

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.65.186The system shall support the transfer of data between a parent application and sub-applications after a sub-application as been reset.

    Specification(s): test

    Design: MultiApp SystemTransfers System

    Issue(s): #1970

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: MultiAppCopyTransfer
  • 1.65.86The system shall support direct copy of array variables from a sub-application to the main application.

    Specification(s): test

    Design: MultiAppCopyTransfer

    Issue(s): #14391

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.87The system shall support the transfer of auxiliary field variables between identical meshes:
    1. from a sub-application and
    2. to a sub-application.

    Specification(s): transfer/from_sub_to_parent, transfer/to_sub_to_parent

    Design: MultiAppCopyTransfer

    Issue(s): #13754

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.88The system shall report an error if a variable, during a direct copy of auxiliary field variables, does not exist
    1. in the sub-application when transferring form it and
    2. in the parent application when transferring for it.

    Specification(s): errors/error_from_sub_to_parent, errors/error_to_sub_to_parent

    Design: MultiAppCopyTransfer

    Issue(s): #13754

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.65.89The system shall support the transfer of an auxiliary field variable to a primary variable between identical meshes:
    1. from a sub-application and
    2. to a sub-application.

    Specification(s): transfer/from_sub_to_parent, transfer/to_sub_to_parent

    Design: MultiAppCopyTransfer

    Issue(s): #13754#21487

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.90The system shall support the transfer of auxiliary field variables between identical meshes:
    1. between two subapps

    Specification(s): transfer/from_sub_to_sub

    Design: MultiAppCopyTransfer

    Issue(s): #13754#19451

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.91The system shall support the transfer of elemental field variables between identical meshes:
    1. with a block-restriction on the origin mesh
    2. with a block-restriction on the target mesh

    Specification(s): restricted/from_sub_to_parent, restricted/to_restricted

    Design: MultiAppCopyTransfer

    Issue(s): #13754#22817

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.92The system shall report an error if a nodal variable is requested to be transfered
    1. with block-restriction on the origin mesh.
    2. with block restriction on the target mesh.

    Specification(s): errors/error_from_nodal, errors/error_to_nodal

    Design: MultiAppCopyTransfer

    Issue(s): #13754#22817

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.65.93The system shall report an error if a variable is required to be transferred
    1. with an invalid source block for the to_multiapp direction.
    2. with an invalid source block for the from_multiapp direction.
    3. with an invalid target block for the to_multiapp direction.
    4. with an invalid target block for the from_multiapp direction.

    Specification(s): block_ids/invalid_from_block_to_app, block_ids/invalid_from_block_from_app, block_ids/invalid_to_block_to_app, block_ids/invalid_to_block_from_app

    Design: MultiAppCopyTransfer

    Issue(s): #13754#22817

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.65.94The system shall support direct copy of a constant monomial auxiliary variable from a sub-application to a constant monomial nonlinear variable in the main application.

    Specification(s): test

    Design: MultiAppCopyTransfer

    Issue(s): #7757

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.95The system shall support direct copy of a constant monomial auxiliary variable from a the main application to a constant monomial nonlinear variable in the sub-application.

    Specification(s): test

    Design: MultiAppCopyTransfer

    Issue(s): #7757

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.96The system shall report an error when the MultiAppCopyTransfer object is used on non-identical meshes.

    Specification(s): different_mesh

    Design: MultiAppCopyTransfer

    Issue(s): #7757

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.65.97The system shall report an error when the MultiAppCopyTransfer object is used on meshes with different variable types.

    Specification(s): different_variable_type

    Design: MultiAppCopyTransfer

    Issue(s): #7757

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.65.98The system shall support direct copy of a linear Lagrange nonlinear variable from a sub-application to the main application.

    Specification(s): test

    Design: MultiAppCopyTransfer

    Issue(s): #7757

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.99The system shall support direct copy of a linear Lagrange nonlinear variable to a sub-application from the main application.

    Specification(s): test

    Design: MultiAppCopyTransfer

    Issue(s): #7757

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.100The system shall support direct copy of multiple nonlinear variables from a sub-application to the main application.

    Specification(s): test

    Design: MultiAppCopyTransfer

    Issue(s): #14391

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.101The system shall support direct copy of a second-order Lagrange nonlinear variable from a sub-application to the main application.

    Specification(s): test

    Design: MultiAppCopyTransfer

    Issue(s): #7757

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.102The system shall support direct copy of a second-order Lagrange nonlinear variable to a sub-application from the main application.

    Specification(s): test

    Design: MultiAppCopyTransfer

    Issue(s): #7757

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.103The system shall support the transfer of field variables with solution vectors indicated by tags.

    Specification(s): transfer

    Design: MultiAppCopyTransfer

    Issue(s): #17586

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.104The system shall support direct copy of a third-order monomial auxiliary variable from a sub-application to a third-order monomial nonlinear variable in the main application.

    Specification(s): test

    Design: MultiAppCopyTransfer

    Issue(s): #7757

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.105The system shall support direct copy of a third-order auxiliary variable from a the main application to a third-order monomial nonlinear variable in the sub-application.

    Specification(s): test

    Design: MultiAppCopyTransfer

    Issue(s): #7757

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.65.106The system shall be able to transfer vector variables between identical meshes using a direct copy transfer.

    Specification(s): copy_vector

    Design: MultiAppCopyTransfer

    Issue(s): #26045

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: Terminator
  • 1.67.1The system shall terminate the execution of a solve based on post-processing calculations performed within the simulation.

    Specification(s): terminator

    Design: Terminator

    Issue(s): #3735

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.2The system shall abort the current step in a solve based on post-processing calculations performed within the simulation to cut the timestep.

    Specification(s): terminator_soft_step_fail

    Design: Terminator

    Issue(s): #16452

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.67.3The system shall abort the current nonlinear or linear solve in a simulation based on post-processing calculations performed within the simulation to cut the timestep.

    Specification(s): terminator_soft_solve_fail

    Design: Terminator

    Issue(s): #16452#24479

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.67.4The terminator system shall output a custom info, warning, or error message.

    Specification(s): terminator_message_1

    Design: Terminator

    Issue(s): #17000

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.67.5The terminator system shall check the compatibility of the suplied parameters.

    Specification(s): terminator_message_2

    Design: Terminator

    Issue(s): #17000

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.67.6The terminator system shall check that if a message is supplied, an appropriate error level for reporting that message is also used.

    Specification(s): terminator_message_3

    Design: Terminator

    Issue(s): #17000

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.67.7The system shall check a criterion for early termination of the run, but continue with the regular simulation when that criterion is not met.

    Specification(s): terminator_pass

    Design: Terminator

    Issue(s): #16452

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 1.67.8The system shall check that postprocessors providing data for a terminator meant to force a failure in a solve or a time step are executed often enough to be able to update the criterion.

    Specification(s): check_execution

    Design: Terminator

    Issue(s): #24479

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: GeometrySphere
  • 1.67.28The system shall support 'snapping' or moving new nodes in sidesets created by mesh adaptivity to the surface of a geometric sphere to capture high fidelity features on curved geometries.

    Specification(s): geometrysphere

    Design: GeometrySphere

    Issue(s): #9578

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.29The system shall support 'snapping' or moving new nodes in lower dimensional subdomains created by mesh adaptivity to the surface of a geometric sphere to capture high fidelity features on curved geometries.

    Specification(s): block

    Design: GeometrySphere

    Issue(s): #24645

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: InterfaceQpValueUserObject
  • 1.67.30Testing the implementation of the InterfaceQpValueUserObject. This test also shows the use of InterfaceValueUserObjectAux AuxKernel. InterfaceValueUserObjectAux use interface values computed and stored at each qp from the InterfaceQpValueUserObject and output them into an auxvaraible.Values on the interface are then computed via SideAverageValue PP.By design at the end of the first step we should observe: an average material property of 7, an average material property absolute jump fo 6, a singed material property jump (primary-secondary) of 6 a singed material propertyjump (secondary-primary) of -6 a material property value on the primary side of 10 a material property value on the primary side of 4

    Specification(s): interface_UO_QP_test

    Design: InterfaceQpValueUserObjectInterfaceValueUserObjectAux

    Issue(s): #11647

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.31The InterfaceUserObject system shall be able to get updated bulk, boundary and interface material property values.This test uses two specific test materials (e.g. LinearNonLinearIterationMaterial and LinearNonLinearIterationInterfaceMaterial) and one test userobject (e.g. InterfaceUserObjectTestGetMaterialProperty).This test will produce an error if the computed an retrived material property are not the same.

    Specification(s): interface_UO_get_material_test

    Design: InterfaceQpValueUserObjectInterfaceValueUserObjectAux

    Issue(s): #14680

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.67.32Testing the implementation of the InterfaceQpValueUserObject when computing the variable rate or increment.

    Specification(s): interface_Qp_rate_incremement_test

    Design: InterfaceQpValueUserObjectInterfaceValueUserObjectAux

    Issue(s): #14680

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.33Testing the implementation of the InterfaceQpMaterialPropertyRealUO.

    Specification(s): interface_Qp_real_material

    Design: InterfaceQpValueUserObjectInterfaceValueUserObjectAux

    Issue(s): #14680

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: InterfaceValueUserObjectAux
  • 1.67.30Testing the implementation of the InterfaceQpValueUserObject. This test also shows the use of InterfaceValueUserObjectAux AuxKernel. InterfaceValueUserObjectAux use interface values computed and stored at each qp from the InterfaceQpValueUserObject and output them into an auxvaraible.Values on the interface are then computed via SideAverageValue PP.By design at the end of the first step we should observe: an average material property of 7, an average material property absolute jump fo 6, a singed material property jump (primary-secondary) of 6 a singed material propertyjump (secondary-primary) of -6 a material property value on the primary side of 10 a material property value on the primary side of 4

    Specification(s): interface_UO_QP_test

    Design: InterfaceQpValueUserObjectInterfaceValueUserObjectAux

    Issue(s): #11647

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.31The InterfaceUserObject system shall be able to get updated bulk, boundary and interface material property values.This test uses two specific test materials (e.g. LinearNonLinearIterationMaterial and LinearNonLinearIterationInterfaceMaterial) and one test userobject (e.g. InterfaceUserObjectTestGetMaterialProperty).This test will produce an error if the computed an retrived material property are not the same.

    Specification(s): interface_UO_get_material_test

    Design: InterfaceQpValueUserObjectInterfaceValueUserObjectAux

    Issue(s): #14680

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.67.32Testing the implementation of the InterfaceQpValueUserObject when computing the variable rate or increment.

    Specification(s): interface_Qp_rate_incremement_test

    Design: InterfaceQpValueUserObjectInterfaceValueUserObjectAux

    Issue(s): #14680

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.33Testing the implementation of the InterfaceQpMaterialPropertyRealUO.

    Specification(s): interface_Qp_real_material

    Design: InterfaceQpValueUserObjectInterfaceValueUserObjectAux

    Issue(s): #14680

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: LayeredBase
  • 1.67.44The system shall have the ability to maintain persistent generic user data stored in "layers" that may persist across invocations in the form of file data.

    Specification(s): test

    Design: LayeredBase

    Issue(s): #7570#11711

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • framework: NearestRadiusLayeredAverage
  • 1.67.67The system shall compute layered averages for concentric cylindrical rings with equal thickness for a list of points that correspond to the average radius of each ring

    Specification(s): nearest_radius

    Design: NearestRadiusLayeredAverage

    Issue(s): #16829

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.69The system shall compute radial layered averages computed from the closest values for a list of points and output to a spatial vector postprocessor with one point per unique nearest point and layer

    Specification(s): radius_points_from_uo

    Design: NearestRadiusLayeredAverage

    Issue(s): #18931

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: NearestPointLayeredIntegral
  • 1.67.74The system shall compute layered integrals that computed from the closest values for a list of points that are specified in an external file

    Specification(s): from_file

    Design: NearestPointLayeredIntegral

    Issue(s): #14717

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 1.67.75The system shall compute layered integrals computed from the closest values for a list of points and output to a spatial vector postprocessor with one point per unique nearest point and layer

    Specification(s): points_from_uo

    Design: NearestPointLayeredIntegral

    Issue(s): #18931

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • framework: BilinearInterpolation
  • 1.68.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

  • 1.68.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

  • 1.68.3The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.68.4The system shall report an 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • 1.68.5The system shall report an error when there are insufficient parameters supplied for the PiecewiseBilinear object.

    Specification(s): xyz_error

    Design: BilinearInterpolation

    Issue(s): #5991

    Collection(s): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: MathUtils Namespace
  • 1.68.12The 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

  • 1.68.13The 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

  • 1.68.14The 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

  • framework: PerfGraphLivePrint
  • 1.68.19The system shall allow for nested code timing sections and having automated print-outs of the code section names when they are taking a long time.

    Specification(s): nested_sections

    Design: PerfGraphLivePrint

    Issue(s): #15444

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.68.20The system shall be able to display the automatic print-out of a timed section even when an external print happened before the threshold for the automatic print-out was met.

    Specification(s): section_interrupted_by_regular_print

    Design: PerfGraphLivePrint

    Issue(s): #23746

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.68.21The system shall allow for automatic print-outs of timing sections within multiapps.

    Specification(s): multiapps

    Design: PerfGraphLivePrint

    Issue(s): #19114

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.68.22The system shall allow for automatic print-outs of nested timing sections within multiapps.

    Specification(s): multiapps_and_nested

    Design: PerfGraphLivePrint

    Issue(s): #19114

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 1.68.23The system shall allow for automatic print-outs of timing sections within nested multiapps.

    Specification(s): nested_multiapps

    Design: PerfGraphLivePrint

    Issue(s): #19114

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • framework: Samplers System
  • 1.68.24The 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

  • 1.68.25The 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

  • 1.68.26The 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

  • framework: LineValueSampler
  • 1.70.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

  • 1.70.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

  • 1.70.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

  • 1.70.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

  • 1.70.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

  • 1.70.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

  • 1.70.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

  • framework: ElementsAlongLine
  • 1.70.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

  • 1.70.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

  • 1.70.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

  • framework: ElementsAlongPlane
  • 1.70.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

  • 1.70.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

  • 1.70.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

  • framework: LineFunctionSampler
  • 1.70.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

  • framework: NodalValueSampler
  • 1.70.51The 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

  • 1.70.52The 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): FUNCTIONALFAILURE_ANALYSIS

    Type(s): RunException

  • framework: SideValueSampler
  • 1.70.62The 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

  • 1.70.63The 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

  • framework: SphericalAverage
  • 1.70.67The 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

  • framework: VectorOfPostprocessors
  • 1.70.70The 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

References

  1. ISO/IEC/IEEE 24765:2010(E). Systems and software engineering—Vocabulary. first edition, December 15 2010.[BibTeX]
  2. 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]
  3. ASME NQA-1. ASME NQA-1-2008 with the NQA-1a-2009 addenda: Quality Assurance Requirements for Nuclear Facility Applications. first edition, August 31 2009.[BibTeX]