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

Figure 1: A diagram of the MOOSE code platform.
References
- ISO/IEC/IEEE 24765:2010(E).
Systems and software engineering—Vocabulary.
first edition, December 15 2010.[BibTeX]
- 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]
- 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]
Definitions and Acronyms
This section defines, or provides the definition of, all terms and acronyms required to properly understand this specification.
Definitions
- Pull (Merge) Request: A proposed change to the software (e.g. usually a code change, but may also include documentation, requirements, design, and/or testing). - Baseline: A specification or product (e.g., project plan, maintenance and operations (M&O) plan, requirements, or design) that has been formally reviewed and agreed upon, that thereafter serves as the basis for use and further development, and that can be changed only by using an approved change control process (NQA-1, 2009). - Validation: Confirmation, through the provision of objective evidence (e.g., acceptance test), that the requirements for a specific intended use or application have been fulfilled (24765:2010(E), 2010). - Verification: (1) The process of: evaluating a system or component to determine whether the products of a given development phase satisfy the conditions imposed at the start of that phase. (2) Formal proof of program correctness (e.g., requirements, design, implementation reviews, system tests) (24765:2010(E), 2010).
Acronyms
Acronym | Description |
---|---|
API | Application Programming Interface |
DOE-NE | Department of Energy, Nuclear Energy |
FE | finite element |
FEM | Finite Element Method |
GUI | graphical user interface |
HIT | Hierarchical Input Text |
HPC | High Performance Computing |
I/O | Input/Output |
INL | Idaho National Laboratory |
MOOSE | Multiphysics Object Oriented Simulation Environment |
MPI | Message Passing Interface |
PDEs | partial differential equations |
Design Stakeholders and Concerns
Design Stakeholders
Stakeholders for MOOSE include several of the funding sources including Department of Energy, Nuclear Energy (DOE-NE) and the INL. However, Since MOOSE is an open-source project, several universities, companies, and foreign governments have an interest in the development and maintenance of the MOOSE project.
Stakeholder Design Concerns
Concerns from many of the stakeholders are similar. These concerns include correctness, stability, and performance. The mitigation plan for each of these can be addressed. For correctness, MOOSE development requires either regression or unit testing for all new code added to the repository. The project contains several comparisons against analytical solutions where possible and also other verification methods such as MMS. For stability, MOOSE maintains multiple branches to incorporate several layers of testing both internally and for dependent applications. Finally, performance tests are also performed as part of the the normal testing suite to monitor code change impacts to performance.
System Design
The MOOSE framework itself is composed of a wide range of pluggable systems. Each system is generally composed of a single or small set of C++ objects intended to be specialized by a Developer to solve a specific problem. To accomplish this design goal, MOOSE uses several modern object-oriented design patterns. The primary overarching pattern is the "Factory Pattern". Users needing to extend MOOSE may inherit from one of MOOSE's systems to providing an implementation meeting his or her needs. The design of each of these systems is documented on the mooseframework.org wiki in the Tutorial section. Additionally, up-to-date documentation extracted from the source is maintained on the the mooseframework.org documentation site after every successful merge to MOOSE's stable branch. After these objects are created, the can be registered with the framework and used immediately in a MOOSE input file.
System Structure
The MOOSE framework architecture consists of a core and several pluggable systems. The core of MOOSE consists of a number of key objects responsible for setting up and managing the user-defined objects of a finite element simulation. This core set of objects has limited extendability and exist for every simulation configuration that the framework is capable of running.
Adaptivity
Adaptivity/Indicators
Adaptivity/Markers
AuxKernels
AuxKernels/MatVecRealGradAuxKernel
AuxKernels/MaterialVectorAuxKernel
AuxKernels/MaterialVectorGradAuxKernel
AuxScalarKernels
AuxVariables
AuxVariables/MultiAuxVariables
BCs
BCs/CavityPressure
BCs/CoupledPressure
BCs/InclinedNoDisplacementBC
BCs/Periodic
BCs/Pressure
Bounds
Closures
Components
Constraints
Contact
ControlLogic
Controls
CoupledHeatTransfers
Covariance
DGKernels
Dampers
Debug
Debug/MaterialDerivativeTest
DeprecatedBlock
DiracKernels
Distributions
DomainIntegral
Executioner
Executioner/Adaptivity
Executioner/Predictor
Executioner/Quadrature
Executioner/TimeIntegrator
Executioner/TimeStepper
Executors
FVBCs
FVInterfaceKernels
FVKernels
FluidPropertiesInterrogator
Functions
GeochemicalModelInterrogator
GlobalParams
GrayDiffuseRadiation
HeatStructureMaterials
ICs
ICs/PolycrystalICs
ICs/PolycrystalICs/BicrystalBoundingBoxIC
ICs/PolycrystalICs/BicrystalCircleGrainIC
ICs/PolycrystalICs/PolycrystalColoringIC
ICs/PolycrystalICs/PolycrystalRandomIC
ICs/PolycrystalICs/PolycrystalVoronoiVoidIC
ICs/PolycrystalICs/Tricrystal2CircleGrainsIC
InterfaceKernels
Kernels
Kernels/CHPFCRFFSplitKernel
Kernels/DynamicTensorMechanics
Kernels/HHPFCRFFSplitKernel
Kernels/PFCRFFKernel
Kernels/PolycrystalElasticDrivingForce
Kernels/PolycrystalKernel
Kernels/PolycrystalStoredEnergy
Kernels/PoroMechanics
Kernels/RigidBodyMultiKernel
Kernels/TensorMechanics
Materials
Mesh
Mesh/Partitioner
Modules
Modules/CompressibleNavierStokes
Modules/FluidProperties
Modules/HeatConduction
Modules/HeatConduction/ThermalContact
Modules/HeatConduction/ThermalContact/BC
Modules/IncompressibleNavierStokes
Modules/NavierStokesFV
Modules/Peridynamics
Modules/Peridynamics/Mechanics
Modules/Peridynamics/Mechanics/GeneralizedPlaneStrain
Modules/Peridynamics/Mechanics/Master
Modules/PhaseField
Modules/PhaseField/Conserved
Modules/PhaseField/DisplacementGradients
Modules/PhaseField/EulerAngles2RGB
Modules/PhaseField/GrainGrowth
Modules/PhaseField/GrandPotential
Modules/PhaseField/Nonconserved
Modules/PorousFlow
Modules/PorousFlow/BCs
Modules/TensorMechanics
Modules/TensorMechanics/CohesiveZoneMaster
Modules/TensorMechanics/DynamicMaster
Modules/TensorMechanics/GeneralizedPlaneStrain
Modules/TensorMechanics/GlobalStrain
Modules/TensorMechanics/LineElementMaster
Modules/TensorMechanics/Master
Modules/TensorMechanics/MaterialVectorBodyForce
MortarGapHeatTransfer
MultiApps
NodalKernels
NodalNormals
Outputs
PorousFlowBasicTHM
PorousFlowFullySaturated
PorousFlowUnsaturated
Postprocessors
Preconditioning
Problem
RayBCs
RayKernels
ReactionNetwork
ReactionNetwork/AqueousEquilibriumReactions
ReactionNetwork/SolidKineticReactions
Reporters
Samplers
ScalarKernels
SpatialReactionSolver
StochasticTools
Surrogates
ThermalContact
TimeDependentReactionSolver
TimeIndependentReactionSolver
Trainers
Transfers
UserObjects
Variables
Variables/CHPFCRFFSplitVariables
Variables/HHPFCRFFSplitVariables
Variables/PFCRFFVariables
Variables/PolycrystalVariables
VectorPostprocessors
XFEM
The MooseApp is the top-level object used to hold all of the other objects in a simulation. In a normal simulation a single MooseApp object is created and "run()". This object uses it's Factory objects to build user defined objects which are stored in a series of Warehouse objects and executed. The Finite Element data is stored in the Systems and Assembly object while the domain information (the Mesh) is stored in the Mesh object. A series of threaded loops are used to run parallel calculations on the objects created and stored within the warehouses.
MOOSE's pluggable systems are documented on the mooseframework.org wiki. Each of these systems has set of defined polymorphic interfaces and are designed to accomplish a specific task within the simulation. The design of these systems is fluid and is managed through agile methods and ticket request system on the Github.org website.
Data Design and Control
At a high level, the system is designed to process Hierarchical Input Text (HIT) input files to construct several objects that will constitute an finite element (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 Input/Output (I/O) or through local Application Programming Interface (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: AddAuxKernelAction
- 1.1.1The system shall allow the shortcut syntax specifying an AuxKernel
- nested under an AuxVariable, and
- it shall produce the same output as with the standard syntax.
Specification(s): syntax/nested, syntax/standard
Design: AddAuxKernelAction
Issue(s): #20753
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: AuxVariables System
- 1.1.2The system shall error if the supplied order of scalar auxiliary variable is of an unknown order.
Specification(s): invalid_order_high
Design: AuxVariables System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.1.3The system shall support calculations with an auxiliary scalar variable represented with a 21st order monomial function.
Specification(s): high_order_scalar
Design: AuxVariables System
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.10.1The system shall support the coupling of scalar aux variables for the purpose of sharing data and reporting values.
Specification(s): test
Design: AuxVariables System
Issue(s): #2318
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.5The system shall support direct calculation of field variables on multiple mesh subdomains.
Specification(s): block_aux_kernel_test
Design: AuxVariables System
Issue(s): 76ddaa1961753020e57d62d2b8f29e0638e40c28
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: CheckLegacyParamsAction
- 1.1.4The system shall report an informative error when object parameters are constructed using legacy methods
Specification(s): test
Design: CheckLegacyParamsAction
Issue(s): #19439
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: MOOSE Action System
- 1.1.5The system shall be capable of reporting
Action
object dependencies.Specification(s): test_show_actions_dependency
Design: MOOSE Action System
Issue(s): #11971
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.1.6The system shall be capable of reporting
Action
object task information.Specification(s): test_show_actions_tasks
Design: MOOSE Action System
Issue(s): #11971
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.1.8The system shall be able to retrieve other
Action
objects from within anotherAction
object.Specification(s): get_actions
Design: MOOSE Action System
Issue(s): #7905
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.1.9The Action system shall allow
Action
objects to create otherAction
objects.Specification(s): test_meta_action
Design: MOOSE Action System
Issue(s): #1478
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.1.10The Action system shall allow the creation of
Action
objects with multiple tasks.Specification(s): circle_quads
Design: MOOSE Action System
Issue(s): #10619
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.10The system shall support the ability to add additional mesh generators from a user accessible programmatic interface.
Specification(s): append_mesh_generator_test
Design: MOOSE Action System
Issue(s): #15121
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Reporter System
- 1.1.7The system shall support the detailed on-screen output of all of the Reporters that were declared and requested, including type, producer, context, and consumers.
Specification(s): test
Design: Reporter System
Issue(s): #17605
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.108The system shall support the ability to control the output of an aggregate calculation via a parameter of the object itself.
Specification(s): test
Design: Reporter System
Issue(s): #16666
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.36.158The system shall automatically output values to a comma separated (CSV) file in
- root/replicated mode
- and distributed mode.
Specification(s): csv/root, csv/distributed
Design: Reporter System
Issue(s): #11323
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.47.2The system shall have a system for computing and retrieving aggregate values of arbitrary type.
Specification(s): base
Design: Reporter System
Issue(s): #11323
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.47.3The system shall error if an invalid name is provided when retrieving aggregate value.
Specification(s): error
Design: Reporter System
Issue(s): #11323
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.47.4The system shall report a reasonable error when declaring a Reporter value and
- the parameter that contains the name was not found,
- the parameter that contains the name is not of the correct type,
- a Reporter with the same name has already been declared, and
- a Reporter with the same name but a different type has been requested.
Specification(s): errors/missing_param, errors/bad_param, errors/already_declared, errors/requested_different_type
Design: Reporter System
Issue(s): #11323
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.47.5The system shall support the mixing of computing and retreiving aggregate values of arbitrary types with the Postprocessor and VectorPostprocessor system.
Specification(s): special_types
Design: Reporter System
Issue(s): #11323
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.47.8The system shall output aggregate simulation information to JSON format
- when the aggregate value is declared after object construction
- 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.47.9The system shall support getting a reference to an aggregate calculation before it is created.
Specification(s): decalareInitialSetup_with_get
Design: Reporter SystemJSON
Issue(s): #17468
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- framework: Adaptivity System
- 1.2.1The Adaptivity system shall allow for multiple mesh adaptivity steps per timestep.
Specification(s): test
Design: Adaptivity System
Issue(s): #830
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.2.2The Adaptivity system shall support mesh adaptivity during initial setup.
Specification(s): test
Design: Adaptivity SystemMarkers System
Issue(s): #1700
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.2.3The Adaptivity system shall support marking elements for refinement during initial setup using a different marker than used during execution.
Specification(s): test
Design: Adaptivity SystemMarkers System
Issue(s): #1700
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.2.4The Adaptivity system shall support execution at every n timestep.
Specification(s): test
Design: Adaptivity SystemMarkers System
Issue(s): #13561
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.2.5The Adaptivity system shall be capable of restricting the element refinement level.
Specification(s): test
Design: Adaptivity System
Issue(s): #1699
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.2.6The Adaptivity system shall allow for
Marker
objects to be recomputed with each adaptivity cycle.Specification(s): test
Design: Adaptivity SystemMarkers System
Issue(s): #6663
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.2.7The system shall support initial uniform mesh refinement within a subdomain for a steady-state calculation.
Specification(s): steady
Design: Adaptivity System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.7The system shall include the ability to mark elements within a subdomain to be unchanged for mesh adaptivity.
Specification(s): test
Design: Adaptivity SystemBoxMarker
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.2The system shall perform identical adaptivity patterns on both the reference mesh and the displaced mesh when it exists.
Specification(s): displaced_test
Design: Adaptivity System
Issue(s): #443
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.3The system shall support toggling adaptivity on/off during a simulation.
Specification(s): test_time
Design: Adaptivity System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.4The system shall perform one or more adaptivity steps on the mesh before the simulation begins.
Specification(s): initial_adaptivity_test
Design: Adaptivity System
Issue(s): #920
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.5The system shall support patch-based error estimation among a stencil of elements.
Specification(s): patch_test
Design: Adaptivity System
Issue(s): #833
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.6The system shall support multiple adaptive steps per solve.
Specification(s): adapt_cycles_test
Design: Adaptivity System
Issue(s): #830
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.7The system shall perform adaptivity on systems containing multiple independent field variables.
Specification(s): test
Design: Adaptivity System
Issue(s): #920
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.8The system shall support running adaptivity on an interval basis (every several time steps).
Specification(s): interval
Design: Adaptivity System
Issue(s): #6888
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.9The system shall support weighted error estimation when considering multiple field variables for adaptivity.
Specification(s): test
Design: Adaptivity System
Issue(s): #447
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.53The system shall be able to output the
displacedmesh 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.75The system shall be capable of running multiple adaptivity cycles in a single solve step.
Specification(s): num_adaptivity_cycles
Design: Adaptivity System
Issue(s): #7646
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.76They system shall be capable of toggling adaptivity at the start of the simulation.
Specification(s): num_adaptivity_cycles_toggle_adaptivity
Design: Adaptivity System
Issue(s): #9746
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.77They system shall be capable of toggling adaptivity during the simulation.
Specification(s): num_adaptivity_cycles_toggle_adaptivity_wait
Design: Adaptivity System
Issue(s): #9746
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.59.66The system shall support the ability to toggle mesh adaptivity:
- off when it has been turned on in the input file,
- off when we are using initial adaptivity in the input file,
- off after a specific time, or
- off after some number of steps.
Specification(s): toggle_mesh_adaptivity/toggle_mesh_adaptivity, toggle_mesh_adaptivity/toggle_mesh_adaptivity_gaussian_ic, toggle_mesh_adaptivity/toggle_mesh_adaptivity_gaussian_ic_stop_time, toggle_mesh_adaptivity/toggle_mesh_adaptivity_wait
Design: Adaptivity System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Markers System
- 1.2.2The Adaptivity system shall support mesh adaptivity during initial setup.
Specification(s): test
Design: Adaptivity SystemMarkers System
Issue(s): #1700
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.2.3The Adaptivity system shall support marking elements for refinement during initial setup using a different marker than used during execution.
Specification(s): test
Design: Adaptivity SystemMarkers System
Issue(s): #1700
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.2.4The Adaptivity system shall support execution at every n timestep.
Specification(s): test
Design: Adaptivity SystemMarkers System
Issue(s): #13561
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.2.6The Adaptivity system shall allow for
Marker
objects to be recomputed with each adaptivity cycle.Specification(s): test
Design: Adaptivity SystemMarkers System
Issue(s): #6663
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.1The system shall include the ability to mark a mesh subdomain for uniform refinement.
Specification(s): test
Design: Markers System
Issue(s): #6665
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.2The adaptivity system shall create an auxiliary field variable that marks elements for refinement adjacent to a boundary.
Specification(s): adjacent
Design: Markers SystemBoundaryMarker
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.3The adaptivity system shall create an auxiliary field variable that marks elements for refinement within a given distance of a boundary.
Specification(s): distance
Design: Markers SystemBoundaryMarker
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.4The adaptivity system shall create an auxiliary field variable that marks elements for refinement within a rectangular region.
Specification(s): mark_only
Design: Markers SystemBoxMarker
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.5The adaptivity system shall adapt the mesh within a rectangular region.
Specification(s): mark_and_adapt
Design: Markers SystemBoxMarker
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.13It shall not be possible to specify Markers to run on the displaced mesh.
Specification(s): displaced_error
Design: Markers System
Issue(s): #11430
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.26.15The system shall support access to finite element quadrature point locations during the calculation of refinement marker flags.
Specification(s): test
Design: Markers System
Issue(s): #3279
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.16The adaptivity system shall create an auxiliary field variable that marks elements containing the points from the reporter for refinement.
Specification(s): mark_only
Design: Markers SystemReporterPointMarker
Issue(s): #18886
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.17The marker shall create an error if the coordinate vectors are not all the same size
Specification(s): wrong_size_error
Design: Markers SystemReporterPointMarker
Issue(s): #18886
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.26.18The marker shall be used for adaptivity for a moving point, being able to coarsen elements the point moves out of but not coarsen elements if it contains point.
Specification(s): adaptivity
Design: Markers SystemReporterPointMarker
Issue(s): #18886
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.26.19The system shall support the capability of creating a tool for marking finite elements for mesh refinement, for example:
- adding elements within the intersection of two circles;
- adding elements within the intersection of two circles and removing elements outside the circles; and
- 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.1The 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: AuxKernel
- 1.3.2The 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.82The 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: AuxScalarKernels System
- 1.3.3The system shall support auxiliary calculations for scalar variables at nodes.
Specification(s): test
Design: AuxScalarKernels System
Issue(s): #1896
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.4The AuxScalarKernel system shall automatically resolve dependencies between objects.
Specification(s): test
Design: AuxScalarKernels System
Issue(s): #1896
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ConstantBoundsAux
- 1.3.5The system shall include the ability to compute a field variable with a constant upper and lower bounds.
Specification(s): constant_bounds
Design: ConstantBoundsAux
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.6The system shall error if a variational inequalities (VI) solver is not found when BoundsAux is provided.
Specification(s): constant_bounds_warning
Design: ConstantBoundsAux
Issue(s): #14946
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.3.7The 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: ConstantBoundsAux
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.35.5The system shall be able to enforce an upper and lower bound on a variable using a variational inequality
- reduced space active set solver, which
- is compatible with algebraic multigrid, and
- a semi-smooth solver, which
- is also compatible with algebraic multigrid
- The reduced space active set method shall work with a matrix-free approximation of the Jacobian, and the function evaluations corresponding to the nonlinear residual and the base for finite-differencing shall be equivalent.
Specification(s): vi/rsls, vi/rsls_amg, vi/ssls, vi/ssls_amg, vi/rsls_pjfnk
Design: ConstantBoundsAux
Issue(s): #2999
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.35.6The system shall show violation of bounds when a non-variational-inequality solver is used
Specification(s): unbounded
Design: ConstantBoundsAux
Issue(s): #2999
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: BuildArrayVariableAux
- 1.3.8The 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.9The system shall report a reasonable error when copying standard variables into the components of an array variable when
- the variables have inconsistent sizes or
- when the variables have inconsistent types.
Specification(s): error/size, error/type
Design: BuildArrayVariableAux
Issue(s): #16402
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ConstantScalarAux
- 1.3.10The
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: Assembly
- 1.3.11The 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.32.158We shall be able the scrape the DOFMapOutput and determine when the Jacobian is slightly off
Specification(s): simple
Design: Assembly
Issue(s): #4182
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 1.32.159We shall be able the scrape the DOFMapOutput and determine when the Jacobian is questionable
Specification(s): med
Design: Assembly
Issue(s): #4182
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 1.32.160We shall throw no errors if the off-diagonal Jacobian is wrong if we are only testing the on-diagonal Jacobian
Specification(s): offdiag
Design: Assembly
Issue(s): #6624
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 1.32.161If use_displaced_mesh = false then MOOSE will not throw an exception if elements are inverted to produce a negative element Jacobian, in 3D simulations
Specification(s): no_negative_jacobian
Design: Assembly
Issue(s): #9740
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.162A 3D simulation shall throw an exception if there is a zero element Jacobian, when use_displaced_mesh = true
Specification(s): jacobian_zero
Design: Assembly
Issue(s): #9740
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.163A 3D simulation shall throw an exception if there is a negative element Jacobian, when use_displaced_mesh = true
Specification(s): jacobian_negative
Design: Assembly
Issue(s): #9740
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.164If use_displaced_mesh = false then MOOSE will not throw an exception if elements are inverted to produce a negative element Jacobian, in 2D simulations
Specification(s): no_negative_jacobian_2D
Design: Assembly
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.165If use_displaced_mesh = false then MOOSE will not throw an exception if elements are distored to produce a zero element Jacobian, in 2D simulations
Specification(s): zero_jacobian_2D_ok
Design: Assembly
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.166A 2D simulation shall throw an exception if there is a zero element Jacobian, when use_displaced_mesh = true
Specification(s): jacobian_zero_2D
Design: Assembly
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.167The PETSc Jacobian test shall reveal nans if there are nans in the matrix
Specification(s): inf_nan
Design: Assembly
Issue(s): #10788
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: DiffusionFluxAux
- 1.3.12The system shall be able to output the components of the flux vector for diffusion problems
- with a non-AD diffusion material property
- and with an AD diffusion material property
Specification(s): test/non_ad, test/ad
Design: DiffusionFluxAux
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.13The system shall be able to output the normal component of the flux vector for diffusion problems
Specification(s): normal_diffusion_flux
Design: DiffusionFluxAux
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MaterialRealAux
- 1.3.14The 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: AuxKernels System
- 1.3.15The system shall support boundary restricted auxiliary elemental variables with high order shape functions.
Specification(s): ho_boundary_restricted_test
Design: AuxKernels System
Issue(s): #16895
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.16The system shall error if a boundary restricted elemental auxiliary kernel is evaluated on an element with multiple boundary sides
Specification(s): boundary_restricted_error_test
Design: AuxKernels System
Issue(s): #5061
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.3.17The system shall allow a boundary restricted elemental auxiliary kernel to be evaluated on an element with multiple boundary sides by setting an input parameter.
Specification(s): boundary_unrestricted_error_test
Design: AuxKernels System
Issue(s): #17424
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.3.18Kernel objects shall be capable of coupling to an auxiliary variable.
Specification(s): test
Design: AuxKernels System
Issue(s): #502
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.19AuxKernel object dependencies shall be resolved automatically.
Specification(s): sort_test
Design: AuxKernels System
Issue(s): #1200
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.20AuxKernel objects shall operate on higher-order monomial basis functions.
Specification(s): high_order_test
Design: AuxKernels System
Issue(s): #2294
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.21AuxKernel objects shall operate on first-order L2 basis functions.
Specification(s): high_order_l2_test
Design: AuxKernels System
Issue(s): #2294
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.22AuxKernel object dependencies shall be resolved between block and non-block restricted variables.
Specification(s): block_global_depend_resolve
Design: AuxKernels System
Issue(s): #2723
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.25The system shall support the computation of a single value per element within the auxiliary system.
Specification(s): test
Design: AuxKernels System
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83#238
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.29The 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.3.43The system shall have the ability to restrict AuxKernel objects with coupled variables to a boundary.
Specification(s): test
Design: AuxKernels System
Issue(s): #3114
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.44The system shall include the ability to limit the execution of an AuxKernel object to initial setup.
Specification(s): init_test
Design: AuxKernels System
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.45The system shall include the ability to couple auxiliary variables.
Specification(s): test
Design: AuxKernels System
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.46The system shall be capable of resolving dependencies between AuxKernel objects regardless of input file order.
Specification(s): sort_test
Design: AuxKernels System
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.47The AuxKernel objects shall be capable of coupling to multiple variables.
Specification(s): multi_update_test
Design: AuxKernels System
Issue(s): #2099
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.48The MOOSE auxiliary system shall be capable of updating multiple auxiliary variables within a single AuxKernel object.
Specification(s): multi_update_elem_test
Design: AuxKernels System
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.49The MOOSE auxiliary system shall be capable of coupling to nonlinear variables at the end of a timestep.
Specification(s): ts_test
Design: AuxKernels System
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.52AuxKernel objects shall support the use of material properties from the previous two timesteps.
Specification(s): test
Design: AuxKernels System
Issue(s): #5539
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.55Execution of a UserObject shall occur after the execution of the AuxKernel objects if the former depends on the latter.
Specification(s): test
Design: AuxKernels SystemPostprocessor System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.56Execution of a FunctionValuePostprocessor that depends on a Function which depends on a second PostProcessor is construction order dependent.
Specification(s): pp_depend_indirect_wrong
Design: AuxKernels SystemPostprocessor System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.3.57Implicit dependencies of FunctionValuePostprocessors may be declared to resolve execution order independently of construction order.
Specification(s): pp_depend_indirect_correct
Design: AuxKernels SystemPostprocessor System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.3.74Kernel objects shall be able to couple to the time derivative of an auxiliary variable.
Specification(s): implicit_euler
Design: AuxKernels SystemKernels SystemAuxVariable
Issue(s): #442
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.75AuxKernel objects shall be able to couple to the time derivative of a nonlinear variable.
Specification(s): time_derivative_nl
Design: AuxKernels SystemKernels SystemAuxVariable
Issue(s): #442
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.76Error an AuxKernel object attemps to couple to the time derivative of an auxiliary variable.
Specification(s): coupled_aux_time_derivative
Design: AuxKernels SystemKernels SystemAuxVariable
Issue(s): #442
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.3.77The system shall be able to compute the time derivative of a non linear variable.
Specification(s): variable
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.78The system shall be able to compute the time derivative of functors for which the capability to obtain time derivatives on the fly is implemented.
Specification(s): functors
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.79The system shall be able to compute the time derivative of finite volume variables.
Specification(s): fv_variable
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.80The system shall error if
- a time derivative is requested from a functor material property for which the functor time derivative not implemented
- a time derivative is requested but the variable is a nodal variable which is currently unsupported
- a time derivative for a finite element variable is to be saved in a finite volume variable
- a time derivative for a finite volume variable is to be saved in a finite element variable
Specification(s): errors/not_implemented_functor_matprop, errors/not_a_nodal_kernel, errors/implicit_fe_fv_conversion, errors/implicit_fv_fe_conversion
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.3.88AuxKernel objects shall be capable of coupling to VectorPostprocessor objects.
Specification(s): test
Design: AuxKernels SystemVectorPostprocessors System
Issue(s): #7427
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ElementLengthAux
- 1.3.23The 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: ElementQualityAux
- 1.3.24The system shall be able to compute and visualize element quality metrics
Specification(s): test
Design: ElementQualityAux
Issue(s): #12131
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ElementLpNormAux
- 1.3.26The system shall include the ability to compute the Lp, L2, and H1 error norms for each element.
Specification(s): error_function_aux
Design: ElementLpNormAuxElementL2ErrorFunctionAuxElementH1ErrorFunctionAux
Issue(s): #7656
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ElementL2ErrorFunctionAux
- 1.3.26The system shall include the ability to compute the Lp, L2, and H1 error norms for each element.
Specification(s): error_function_aux
Design: ElementLpNormAuxElementL2ErrorFunctionAuxElementH1ErrorFunctionAux
Issue(s): #7656
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ElementH1ErrorFunctionAux
- 1.3.26The system shall include the ability to compute the Lp, L2, and H1 error norms for each element.
Specification(s): error_function_aux
Design: ElementLpNormAuxElementL2ErrorFunctionAuxElementH1ErrorFunctionAux
Issue(s): #7656
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: DependencyResolverInterface
- 1.3.27The system shall allow objects that depend on each other but have differing execution flags to run without error.
Specification(s): run
Design: DependencyResolverInterface
Issue(s): #7626
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.41.95The system shall support evaluating Postprocessors (UserObjects) in the following order: Elemental, Side, Internal Side, Nodal, and General.
Specification(s): element_side_test
Design: DependencyResolverInterface
Issue(s): #5972
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ExtraElementIDAux
- 1.3.28The system shall have the capability of visualizing element integers in an auxiliary variable.
Specification(s): element_extra_integer_aux_test
Design: ExtraElementIDAux
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MooseVariableFE
- 1.3.29The 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.32.1We shall be able to call AD variable methods on an auxiliary variable in a transient simulation and not hit assertions for both regular and neighbor calculations
Specification(s): guard_time_deriv_for_ad_aux
Design: MooseVariableFE
Issue(s): #13171
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.2Coupling an auxiliary variable into a DGKernel shall not destroy the Jacobian
Specification(s): neighbor_ad_with_aux_jac
Design: MooseVariableFE
Issue(s): #13171
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.32.3We shall be able to do NL variable coupling into a DGKernel
Specification(s): neighbor_ad_with_nl
Design: MooseVariableFE
Issue(s): #13171
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.4We shall be able to do NL variable coupling into a DGKernel and have a good Jacobian
Specification(s): neighbor_ad_with_nl_jac
Design: MooseVariableFE
Issue(s): #13171
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.41.58The 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: ForcingFunctionAux
- 1.3.30The system shall include the ability to increase the value of an AuxVariable from the previous time step using a forcing function.
Specification(s): forcing_function_aux
Design: ForcingFunctionAux
Issue(s): #20065
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FunctionScalarAux
- 1.3.31The 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.32The 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.33The 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.18.2The system shall be capable of computing the distance as well as transfer data between interior boundaries on a 2D domain.
Specification(s): test
Design: PenetrationAuxGapValueAux
Issue(s): #2713
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.51The system shall support a means for updating the geometric search patch dynamically that may be disabled.
Specification(s): never
Design: GapValueAuxMesh System
Issue(s): #3901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.52The system shall support a means for updating the geometric search patch dynamically that automatically determines when an update to the patch shall occur.
Specification(s): auto
Design: GapValueAuxMesh System
Issue(s): #3901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.53The system shall support a means for updating the geometric search patch dynamically that updates the patch prior to each solve.
Specification(s): always
Design: GapValueAuxMesh System
Issue(s): #3901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.54The system shall support a means for updating the geometric search patch dynamically that updates the patch prior to each iteration.
Specification(s): nonlinear_iter
Design: GapValueAuxMesh System
Issue(s): #3901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.55The system shall error in the penetration locator system if penetration is not detected.
Specification(s): never_warning
Design: GapValueAuxMesh System
Issue(s): #3901
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.18.56The system shall be able to perform patch updates on every non-linear iteration while performing uniform coarsening and refinement from grid sequencing.
Specification(s): always-grid-sequencing
Design: Mesh SystemGapValueAuxFEProblemBase
Issue(s): #14166
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: GhostingAux
- 1.3.34The system shall support viewing the elements that would be ghosted
- to specific processors and
- include local elements.
Specification(s): ghosting/show, ghosting/show_with_local
Design: GhostingAux
Issue(s): #12298
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.35The 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
- framework: RelationshipManager
- 1.3.35The 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.9.5When objects that need one layer of coupling (like DGKernels) are added via action, we shall ensure that we have added a proper relationship manager and thus incur no mallocs during calls to MatSetValues. We will not apply algebraic ghosting nor reinitialize system vectors in serial, but we will reinitialize the matrix sparsity
Specification(s): proper_ghosting_with_action_serial
Design: RelationshipManager
Issue(s): #13736
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.6When objects that need one layer of coupling (like DGKernels) are added via action, we shall ensure that we have added a proper relationship manager and thus incur no mallocs during calls to MatSetValues. We will also apply algebraic ghosting in parallel which will require reinitializing the system; the sparsity pattern will also have to be reinitialized
Specification(s): proper_ghosting_with_action_parallel
Design: RelationshipManager
Issue(s): #13736
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.7If a RelationshipManager with sufficient coverage has already been added through a MooseObjectAction, then the CouplingFunctorCheck action shall not add any relationship managers, avoiding reinitialization of system vectors and the system matrix
Specification(s): no_additional_rms
Design: RelationshipManager
Issue(s): #13736
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.8This test shall have one more rm than its replicated counter part because of the geometric-only GhostPointNeighbors rm, also demonstrating no mallocs. Sparsity will be reinitialized but not vectors
Specification(s): proper_ghosting_with_action_serial_distributed
Design: RelationshipManager
Issue(s): #13736
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.9This test shall have one more rm than its replicated counter part because of the geometric-only GhostPointNeighbors rm, also demonstrating no mallocs. Sparsity and vectors will both be reinitialized
Specification(s): proper_ghosting_with_action_parallel_distributed
Design: RelationshipManager
Issue(s): #13736
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.10This test shall have one more rm than its replicated counter part because of the geometric-only GhostPointNeighbors rm, also demonstrating no addition of rms by the CouplingFunctorCheckAction
Specification(s): no_additional_rms_distributed
Design: RelationshipManager
Issue(s): #13736
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.46.1The CouplingFunctorCheckAction shall add a default coupling functor if it's needed and hasn't already been added by another Action
Specification(s): run
Design: RelationshipManager
Issue(s): #13736
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.46.2The system shall be able to indicate when libMesh Ghosting Functors are in use.
Specification(s): test
Design: RelationshipManager
Issue(s): #13206
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.46.3The system shall ghost additional solution information when running in parallel with an active RelationshipManager
Specification(s): evaluable_neighbors_replicated
Design: RelationshipManager
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.46.4The system shall ghost additional neighboring elements surrounding a partition when running in parallel with DistributedMesh
Specification(s): edge_neighbor
Design: RelationshipManager
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.46.5The system shall ghost additional neighboring elements surrounding a partition when running in parallel with DistributedMesh with 3D
Specification(s): edge_neighbor_3D
Design: RelationshipManager
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.46.6The system shall be able to ghost elements for algebraic relationships.
Specification(s): all_systems_evaluable
Design: RelationshipManager
Issue(s): #14536
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.46.7The system shall ghost additional neighboring elements without also supplying solution information when a developer registers a RelationshipManager with an optional second argument to restrict functionality
Specification(s): geometric_edge_neighbor
Design: RelationshipManager
Issue(s): #10455
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.46.8The system shall ghost additional neighboring elements without also supplying solution information when a developer registers a RelationshipManager with an optional second argument to restrict functionality in 3D
Specification(s): geometric_edge_neighbor_3D
Design: RelationshipManager
Issue(s): #10455
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.46.9The system shall allow multiple active objectsto manage ghosting for the same object using
- replicated and
- distributed parallelism of the mesh.
Specification(s): evaluable_neighbors/replicated, evaluable_neighbors/distributed
Design: RelationshipManager
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VariableGradientComponent
- 1.3.36The 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.37The 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.38The system shall allow visualization of the MPI processes mapping to compute nodes
Specification(s): test
Design: HardwareIDAux
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ParsedAux
- 1.3.39The system shall include the ability to compute the linear combination of variables as an auxiliary variable.
Specification(s): test
Design: ParsedAux
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.53The 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.54The 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
- framework: Mesh System
- 1.3.40The 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.41The 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.4.69The system shall support creating sidesets from nodesets for hexahedron elements to use with Boundary Condition objects.
Specification(s): test_hex
Design: Mesh SystemBCs System
Issue(s): #687
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.70The system shall support creating sidesets from nodesets for tetrahedron elements to use with Boundary Condition objects.
Specification(s): test_tet
Design: Mesh SystemBCs System
Issue(s): #687
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.51The system shall support a means for updating the geometric search patch dynamically that may be disabled.
Specification(s): never
Design: GapValueAuxMesh System
Issue(s): #3901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.52The system shall support a means for updating the geometric search patch dynamically that automatically determines when an update to the patch shall occur.
Specification(s): auto
Design: GapValueAuxMesh System
Issue(s): #3901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.53The system shall support a means for updating the geometric search patch dynamically that updates the patch prior to each solve.
Specification(s): always
Design: GapValueAuxMesh System
Issue(s): #3901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.54The system shall support a means for updating the geometric search patch dynamically that updates the patch prior to each iteration.
Specification(s): nonlinear_iter
Design: GapValueAuxMesh System
Issue(s): #3901
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.55The system shall error in the penetration locator system if penetration is not detected.
Specification(s): never_warning
Design: GapValueAuxMesh System
Issue(s): #3901
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.18.56The system shall be able to perform patch updates on every non-linear iteration while performing uniform coarsening and refinement from grid sequencing.
Specification(s): always-grid-sequencing
Design: Mesh SystemGapValueAuxFEProblemBase
Issue(s): #14166
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.11The system shall support the use of a centroid-based parallel partitioning scheme.
Specification(s): centroid_partitioner_test
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.20The system shall compute and store internal face data on request for
- quadrilateral elements,
- triangular elements, and
- 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.28.23The system shall support refinement of QUAD4 mesh elements.
Specification(s): test_quad4_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.24The system shall support refinement of QUAD8 mesh elements.
Specification(s): test_quad8_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.25The system shall support refinement of QUAD9 mesh elements.
Specification(s): test_quad9_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.26The system shall support refinement of TRI3 mesh elements.
Specification(s): test_tri3_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.27The system shall support refinement of TRI6 mesh elements.
Specification(s): test_tri6_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.28The system shall support refinement of HEX8 mesh elements.
Specification(s): test_hex8_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.29The system shall support refinement of HEX20 mesh elements.
Specification(s): test_hex20_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.30The system shall support refinement of HEX27 mesh elements.
Specification(s): test_hex27_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.31The system shall support refinement of TET4 mesh elements.
Specification(s): test_tet4_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.32The system shall support refinement of TET10 mesh elements.
Specification(s): test_tet10_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.33The system shall support refinement of PRISM6 mesh elements.
Specification(s): test_prism6_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.34The system shall support refinement of PRISM15 mesh elements.
Specification(s): test_prism15_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.35The system shall support refinement of PRISM18 mesh elements.
Specification(s): test_prism18_refine
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.36The system shall support refinement of PYRAMID5 mesh elements.
Specification(s): test_pyramid5
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.37The system shall support refinement of PYRAMID13 mesh elements.
Specification(s): test_pyramid13
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.38The system shall support refinement of PYRAMID14 mesh elements.
Specification(s): test_pyramid14
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.52The system shall allow writing out the mesh without running a simulation.
Specification(s): mesh_only_test
Design: Mesh System
Issue(s): #1568
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.53The system shall print out information about the mesh when writing out the mesh.
Specification(s): mesh_info
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.28.54The system shall warn when using –mesh-only and there is no clear filename to use
Specification(s): mesh_only_warning
Design: Mesh System
Issue(s): #1568
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.28.55The system shall support overriding output dimension when necessary to store coordinates in higher planes
Specification(s): output_dimension_override
Design: Mesh System
Issue(s): #12757
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.56The system shall support writing parallel checkpoint files with –mesh-only
Specification(s): mesh_only_checkpoint
Design: Mesh System
Issue(s): #14312
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.28.57The system shall support simulations on meshes containing both 1D and 2D element types.
Specification(s): oned_twod_test
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.58The system shall support proper material evaluations on meshes containing both 1D and 2D element types.
Specification(s): oned_twod_w_matl_test
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.59The system shall support simulations on meshes containing both 1D and 3D element types.
Specification(s): oned_threed_test
Design: Mesh System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.60The system shall generate meshes with different sets of element integers and properly stitch them.
Specification(s): mesh_integer
Design: Mesh System
Issue(s): #13764
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.61The system shall support interchangeable use of integer and string identifiers for mesh entities.
Specification(s): test_names
Design: Mesh System
Issue(s): #979
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.62The system shall support interchangeable use of integer and string identifiers for mesh entities read from the XDA format.
Specification(s): test_names_xda
Design: Mesh System
Issue(s): #1055
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.63The system shall support interchangeable use of integer and string identifiers within the BCs/Periodic block.
Specification(s): test_periodic_names
Design: Mesh System
Issue(s): #979
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.64The system shall support the ability to assign and use string names to mesh entities during the simulation startup.
Specification(s): on_the_fly_test
Design: Mesh System
Issue(s): #979
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.65The system shall support writing solution data in the Nemesis parallel file format.
Specification(s): nemesis_test
Design: Mesh SystemNemesis
Issue(s): #2520
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.66The system shall support the re-partitioning of mesh files input using the Nemesis format.
Specification(s): nemesis_repartitioning_test
Design: Mesh SystemNemesis
Issue(s): #2520
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.28.67The system shall issue an error if no Mesh block is provided.
Specification(s): no_mesh_block_err
Design: Mesh System
Issue(s): #2408
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.28.71The system shall produce a valid periodic node map with only one periodic constraint direction.
Specification(s): 1D
Design: Mesh System
Issue(s): #11891
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.28.72The system shall produce a valid periodic node map with two periodic constraint directions.
Specification(s): 2D
Design: Mesh System
Issue(s): #11891
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.28.73The system shall produce a valid periodic node map with three periodic constraint directions.
Specification(s): 3D
Design: Mesh System
Issue(s): #11891
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.28.76The system shall support optionally allowing uniform refinements when using a pre-split mesh
Specification(s): square
Design: Mesh SystemMesh Splitting
Issue(s): #18575
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.91The system shall support avoiding repartitioning the mesh and deleting remote elements after uniform refinements
Specification(s): square
Design: Mesh System
Issue(s): #18571
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.92The system shall support having a truly unique_id (never recycled) for all mesh elements and nodes when using replicated mesh.
Specification(s): replicated_mesh
Design: Mesh System
Issue(s): #2142
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.28.93The system shall support having a truly unique_id (never recycled) for all mesh elements and nodes when using distributed mes.
Specification(s): distributed_mesh
Design: Mesh System
Issue(s): #2142
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.29.1The system shall support assigning boundary identifiers base on normal vectors of an element face for
- a rectangular cuboid and
- non regular geometry.
Specification(s): normal/simple, normal/less_simple
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.2The system shall support assigning boundary identifiers based on
- a nodal id,
- a spatial coordinate, and
- if the supplied location is outside of the domain.
Specification(s): extra/test, extra/test_coord, extra/test_bad_coord
Design: Mesh System
Issue(s): #13814
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- 1.29.3The system shall support assigning boundary identifiers based on the normal of a element face for
- specified points and
- specified directions with
- fixed normal application.
Specification(s): cylinder/points, cylinder/normal, cylinder/points_fixed
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.4The system shall support assigning boundary identifiers based the bounding box
- for all subdomain sides as well as
- for all subdomain sides including those with multiple existing identifiers in 2D and
- 3D.
Specification(s): bounding/test_add_side_sets_from_bounding_box, bounding/test_multiple_boundary_ids, bounding/test_multiple_boundary_ids_3d
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.5The system shall support assigning boundary identifiers based the bounding box of a subdomain and error if
- if no elements are located in the given bounding box;
- if no sides are located in the given bounding box;
- if no nodes are located in the given bounding box; and
- if the incorrect boundary inputs are supplied.
Specification(s): error/error_no_elements_in_bounding_box, error/error_no_side_sets_found, error/error_no_nodes_found, error/error_boundary_number
Design: Mesh System
Issue(s): #13814
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.29.6The system shall support assigning boundary identifiers based the bounding box of a subdomain
- if existing boundaries overlap and
- error if no nodes are located in the given bounding box.
Specification(s): overlap/test_overlapping, overlap/test_overlapping_sidesets_error
Design: Mesh System
Issue(s): #13814
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- 1.29.7The system shall support assigning subdomain identifiers
- given a list of ids for each element; and
- given a list of elements and ids for quadrilateral and
- 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.29.8The system shall support assigning subdomain identifiers for the entire domain.
Specification(s): test
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.9The system shall support removing elements including
- a 2D concave subdomain;
- a 3D concave subdomain;
- a 2D interior subdomain;
- a 3D interior subdomain;
- a 2D non-concave subdomain;
- a 3D non-concave subdomain;
- a 2D removal of a union of disjoint pieces;
- a 2D removal of a subdomain containing a nodeset;
- a 2D removal of a subdomain that eliminates sideset;
- a 2D removal of a subdomain containing a sideset;
- a 2D concave subdomain with a cut across elements.
Specification(s): delete/BlockDeleterTest1, delete/BlockDeleterTest2, delete/BlockDeleterTest3, delete/BlockDeleterTest4, delete/BlockDeleterTest5, delete/BlockDeleterTest6, delete/BlockDeleterTest7, delete/BlockDeleterTest8, delete/BlockDeleterTest9, delete/BlockDeleterTest10, delete/BlockDeleterTest12
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.10The system shall be capable of adding nodeset identifiers given a bounding box for
- an area inside the box;
- an area outside the box;
Specification(s): nodeset/test_inside_boundingbox, nodeset/test_outside_boundingbox
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.11The system shall error when adding nodeset identifiers given a bounding box and
- the supplied location is invalid and
- when multiple ids are provided for assignment.
Specification(s): error/test_bad_coord, error/test_bad_boundaryid
Design: Mesh System
Issue(s): #13814
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.29.12The system shall support separation of boundary identifiers for
- all boundaries and
- specific boundaries across a subdomain.
Specification(s): break/all, break/bottom
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.13The system shall support separation of boundary identifiers
- for 2D subdomains;
- across an interface; and
- an unstructured mesh.
Specification(s): break/2D4ElementJunctionBreakMeshAuto_test, break/2D4ElementJunctionBreakMeshAutoSplitInterface_test, break/2DPolyCrystalBreakMesh_test
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.14The system shall support separation of boundary identifiers
- for 3D subdomains;
- across an interface; and
- an unstructured mesh.
Specification(s): break/3D3BlocksBreakMeshAuto_test, break/3D3BlocksBreakMeshAutoSplitInterface_test, break/3DPolyCrystalBreakMesh_test
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.15The system shall support creating subdomains from
- 2D and
- 3D images.
Specification(s): image/2d, image/3d
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.16The system shall support the creation of lower dimensional elements on an existing sideset for
- first-order and
- second-order elements.
Specification(s): lower/first_order, lower/second_order
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.17The system shall support creating of 3D meshes from extrusion of
- 2D quadrilateral elements;
- 2D triangular elements;
- 2D quadrilateral elements at an angle; and
- 2D quadrilateral elements from generated mesh
Specification(s): extrude/quad_test, extrude/tri_test, extrude/angle_test, extrude/gen_extrude
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.18The system shall support creating of 3D meshes from extrusion of with the ability to remap subdomain identifiers
- for each layer individually or
- for all layers
Specification(s): remap/layer1, remap/layer2
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.19The system shall support the creation of lower dimensional elements along the faces contained in a side.
Specification(s): test
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.20The system shall support the modification of the mesh
- without restriction to the order of the supplied inputs with
- a forced mesh preparation step.
Specification(s): order/depend_order, order/depend_with_force_prepare
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.21The system shall support the creation of side identifiers based on a function provided in the input file.
Specification(s): parsed_sideset
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.22The system shall support the creation of subdomain identifiers based on a function provided in the input file.
Specification(s): parsed_subdomain_mm
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.23The system shall support the creating of side identifiers surrounding
- a subdomain;
- a subdomain given a direction;
- a generated subdomain; and
- a multiple generated subdomains
Specification(s): subdomains/around, subdomains/around_normals, subdomains/around_created_subdomain, subdomains/around_multi_created_subdomain
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.24The system shall support the creating of side identifiers between
- subdomains;
- multiple subdomains; and
- generated subdomains.
Specification(s): subdomains/test, subdomains/vector_test, subdomains/between_created_subdomain
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.25The system shall support the ability to apply smoothing to a mesh.
Specification(s): test
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.26The system shall be capable of adding subdomain identifiers given a bounding box for
- an area inside the box;
- an area outside the box;
- an area inside an oriented box; and
- an area outside an oriented box.
Specification(s): subdomain/inside, subdomain/outside, subdomain/oriented_inside, subdomain/oriented_outside
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.29.27The system shall be capable of transforming an existing mesh.
Specification(s): test
Design: Mesh System
Issue(s): #13814
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.27The 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.30.80The system shall support using a directed acyclic graph of objects to generate a mesh where multiple possible end points may be explicitly selected:
- the first of two targets
- 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.30.81The 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.30.82The system shall generate an error when the objects used to generate a mesh results in an ambiguous end point
- due to a single graph with multiple end points, or
- due to multiple independent trees.
Specification(s): ambigious/single_graph, ambigious/independent_graphs
Design: Mesh System
Issue(s): #14058
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.168The system shall support embedding a 1D block inside of a 3D block.
Specification(s): test
Design: Mesh System
Issue(s): #3990
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.55If the user asks for no displaced mesh to be created, even though displacements are provided in the mesh block, the system shall not create a displaced mesh
Specification(s): mesh_use_displaced_mesh_false
Design: Mesh System
Issue(s): #12580
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.41.13The system shall support running Postprocessors on the the mesh containing displacements:
- elemental and
- side.
Specification(s): displaced_tests/elemental, displaced_tests/side
Design: Mesh System
Issue(s): #5750
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: NearestNodeValueAux
- 1.3.42The system shall include the ability to compute the shortest distance from a nodes across boundaries.
Specification(s): test
Design: NearestNodeValueAux
Issue(s): #1634
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: NormalizationAux
- 1.3.50The system shall include the ability to normalize a variable based on a Postprocessor value.
Specification(s): normalization_aux
Design: NormalizationAux
Issue(s): #4281
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.51The system shall include the ability to normalize and shift a variable based on a Postprocessor value.
Specification(s): normalization_aux_shift
Design: NormalizationAux
Issue(s): #12401
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Postprocessor System
- 1.3.55Execution of a UserObject shall occur after the execution of the AuxKernel objects if the former depends on the latter.
Specification(s): test
Design: AuxKernels SystemPostprocessor System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.56Execution of a FunctionValuePostprocessor that depends on a Function which depends on a second PostProcessor is construction order dependent.
Specification(s): pp_depend_indirect_wrong
Design: AuxKernels SystemPostprocessor System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.3.57Implicit dependencies of FunctionValuePostprocessors may be declared to resolve execution order independently of construction order.
Specification(s): pp_depend_indirect_correct
Design: AuxKernels SystemPostprocessor System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.14.62The Function object shall support the ability to couple Postprocessor values.
Specification(s): test_pp_function_test
Design: Postprocessor System
Issue(s): #1199
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.25The system shall compute the average integral quantity over an element of a scalar material property.
Specification(s): test
Design: Postprocessor System
Issue(s): #2201
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.30The system shall compute the volumetric L2 norm of a variable over the mesh.
Specification(s): test
Design: Postprocessor System
Issue(s): #2201
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.86The system shall support the ability to retrieve previously computed Postprocessor values within a Postprocessor calculation:
- old (one timestep back) and
- older (two timesteps back).
Specification(s): old_older/test_old, old_older/test_older
Design: Postprocessor System
Issue(s): #5117
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.102The system shall support the ability to report an input parameter on the screen or to an input file.
Specification(s): test
Design: Postprocessor System
Issue(s): #4604#5680#9087#6934
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.103The system shall report an error when a requested parameter for reporting does not exist
- with a wildcard in the name and
- a complete name/
Specification(s): error_report/bad_name_error, error_report/no_param_error
Design: Postprocessor System
Issue(s): #4604#5680#9087#6934
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.41.107The system shall support coupling in a scalar variable to the Postprocessing system for calculating values.
Specification(s): test
Design: Postprocessor System
Issue(s): #7198
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.121The system shall compute an aggregate scalar quantity when applied along multiple boundaries.
Specification(s): test_side_multi_bnd
Design: Postprocessor System
Issue(s): #828
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: QuotientAux
- 1.3.58The 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: SolutionAux
- 1.3.59The system shall be capable of initializing an auxiliary variable from an existing solution
- from data generated by a simulation
- and loaded using location,
- using a direct degree-of-freedom copy for identical meshes,
- with scaling the supplied data,
- and that errors if data for the supplied variable is not found.
Specification(s): aux/build, aux/test, aux/direct, aux/solution_aux_scale, aux/output_error
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- 1.3.60The SolutionAux object shall be capable of populating an auxiliary variable from an ExodusII file.
Specification(s): exodus
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.61The SolutionAux object shall be capable of populating an auxiliary variable from an ExodusII file with a custom extension (e.g., *.e-s003).
Specification(s): exodus_file_extension
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.62The SolutionAux object shall be capable of reading elemental data for the largest timestep.
Specification(s): exodus_elem_map
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.63The SolutionAux object shall be capable of reading elemental data for a specific timestep.
Specification(s): exodus_elemental
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.64The SolutionAux object shall be capable of restricting reading to a single elemental variable.
Specification(s): exodus_elemental_only
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.65The SolutionAux object shall be capable of initializing an auxiliary variable from an existing ExodusII file using a direct degree-of-freedom copy for identical meshes.
Specification(s): exodus_direct
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.66The SolutionAux object shall be capable of setting an auxiliary variable with temporal interpolation.
Specification(s): exodus_interp
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.67The system shall be capable of initializing an auxiliary variable from an existing solution that
- is created in a simulation and
- used to restart another.
Specification(s): exodus_interp_restart/part1, exodus_interp_restart/part2
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.68The SolutionAux object shall be capable of setting an auxiliary variable with temporal interpolation using a direct degree-of-freedom copy for identical meshes.
Specification(s): exodus_interp_direct
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.69The SolutionAux object shall be capable of accessing specific variables from a SolutionUserObject.
Specification(s): multiple_input
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.70The SolutionAux object shall produce an error if the 'from_variable' parameter is not set and the supplied UserObject has multiple variables.
Specification(s): multiple_input_error
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.3.71The systems object shall be capable of setting values using an auxiliary variable
- from a simulation using
- an ASCII file and
- a binary file.
Specification(s): aux_nonlinear_solution/build, aux_nonlinear_solution/from_xda, aux_nonlinear_solution/from_xdr
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.72The system shall be capable of setting values using an auxiliary variable
- create4d from a simulation with adaptivity
- from an ASCII file
- with multiple threads.
Specification(s): aux_nonlinear_solution_adapt/build, aux_nonlinear_solution_adapt/from_xda, aux_nonlinear_solution_adapt/thread_test
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): CSVDiffRunAppExodiff
- framework: SolutionUserObject
- 1.3.59The system shall be capable of initializing an auxiliary variable from an existing solution
- from data generated by a simulation
- and loaded using location,
- using a direct degree-of-freedom copy for identical meshes,
- with scaling the supplied data,
- and that errors if data for the supplied variable is not found.
Specification(s): aux/build, aux/test, aux/direct, aux/solution_aux_scale, aux/output_error
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- 1.3.60The SolutionAux object shall be capable of populating an auxiliary variable from an ExodusII file.
Specification(s): exodus
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.61The SolutionAux object shall be capable of populating an auxiliary variable from an ExodusII file with a custom extension (e.g., *.e-s003).
Specification(s): exodus_file_extension
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.62The SolutionAux object shall be capable of reading elemental data for the largest timestep.
Specification(s): exodus_elem_map
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.63The SolutionAux object shall be capable of reading elemental data for a specific timestep.
Specification(s): exodus_elemental
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.64The SolutionAux object shall be capable of restricting reading to a single elemental variable.
Specification(s): exodus_elemental_only
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.65The SolutionAux object shall be capable of initializing an auxiliary variable from an existing ExodusII file using a direct degree-of-freedom copy for identical meshes.
Specification(s): exodus_direct
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.66The SolutionAux object shall be capable of setting an auxiliary variable with temporal interpolation.
Specification(s): exodus_interp
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.67The system shall be capable of initializing an auxiliary variable from an existing solution that
- is created in a simulation and
- used to restart another.
Specification(s): exodus_interp_restart/part1, exodus_interp_restart/part2
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.68The SolutionAux object shall be capable of setting an auxiliary variable with temporal interpolation using a direct degree-of-freedom copy for identical meshes.
Specification(s): exodus_interp_direct
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.69The SolutionAux object shall be capable of accessing specific variables from a SolutionUserObject.
Specification(s): multiple_input
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.70The SolutionAux object shall produce an error if the 'from_variable' parameter is not set and the supplied UserObject has multiple variables.
Specification(s): multiple_input_error
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.3.71The systems object shall be capable of setting values using an auxiliary variable
- from a simulation using
- an ASCII file and
- a binary file.
Specification(s): aux_nonlinear_solution/build, aux_nonlinear_solution/from_xda, aux_nonlinear_solution/from_xdr
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.72The system shall be capable of setting values using an auxiliary variable
- create4d from a simulation with adaptivity
- from an ASCII file
- with multiple threads.
Specification(s): aux_nonlinear_solution_adapt/build, aux_nonlinear_solution_adapt/from_xda, aux_nonlinear_solution_adapt/thread_test
Design: SolutionAuxSolutionUserObject
Issue(s): #1891
Collection(s): FUNCTIONAL
Type(s): CSVDiffRunAppExodiff
- 1.59.63The system shall be capable of writing out a solution file with both continuous and discontinuous fields for the purpose of verifying that ability to read those solutions back into a new simulation.
Specification(s): discontinuous_value_solution_uo_p1
Design: SolutionUserObject
Issue(s): #7244
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.64The system shall be capable of reading in field information and producing gradient values from both continuous and discontinuous fields.
Specification(s): discontinuous_value_solution_uo_p2
Design: SolutionUserObject
Issue(s): #7244
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: SolutionScalarAux
- 1.3.73The system shall read a scalar variable from an Exodus file and use its value
- from data generated by simulation
- and loaded by another.
Specification(s): test/build, test/test
Design: SolutionScalarAux
Issue(s): #13356
Collection(s): FUNCTIONAL
Type(s): CSVDiffRunApp
- framework: Kernels System
- 1.3.74Kernel objects shall be able to couple to the time derivative of an auxiliary variable.
Specification(s): implicit_euler
Design: AuxKernels SystemKernels SystemAuxVariable
Issue(s): #442
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.75AuxKernel objects shall be able to couple to the time derivative of a nonlinear variable.
Specification(s): time_derivative_nl
Design: AuxKernels SystemKernels SystemAuxVariable
Issue(s): #442
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.76Error an AuxKernel object attemps to couple to the time derivative of an auxiliary variable.
Specification(s): coupled_aux_time_derivative
Design: AuxKernels SystemKernels SystemAuxVariable
Issue(s): #442
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.3.77The system shall be able to compute the time derivative of a non linear variable.
Specification(s): variable
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.78The system shall be able to compute the time derivative of functors for which the capability to obtain time derivatives on the fly is implemented.
Specification(s): functors
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.79The system shall be able to compute the time derivative of finite volume variables.
Specification(s): fv_variable
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.80The system shall error if
- a time derivative is requested from a functor material property for which the functor time derivative not implemented
- a time derivative is requested but the variable is a nodal variable which is currently unsupported
- a time derivative for a finite element variable is to be saved in a finite volume variable
- a time derivative for a finite volume variable is to be saved in a finite element variable
Specification(s): errors/not_implemented_functor_matprop, errors/not_a_nodal_kernel, errors/implicit_fe_fv_conversion, errors/implicit_fv_fe_conversion
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.24.33Jacobian entries generated with AD shall match hand-coded Jacobian entries as measured through save-in values
Specification(s): test
Design: Kernels System
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.34The system shall provide a generic kernel object that allows for easy switching between hand-coded and automatic computation of the Jacobian, and encourages maximum kernel code-reuse.
Specification(s): generic_test
Design: Kernels System
Issue(s): #15552
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.38The system shall run a coupled diffusion-advection problem with higher-order variables on a non-regular mesh domain:
- in a steady-state calculation, and
- in a transient calculation.
Specification(s): adv_diff_reaction/steady, adv_diff_reaction/transient
Design: Kernels System
Issue(s): #1410
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.64The system shall support applying a function of space-time as a forcing function to the mesh domain.
Specification(s): body_force
Design: Kernels System
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.65The system shall report an error when a parsed function expression contains quote characters.
Specification(s): parsed_func_error_check
Design: Kernels System
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.24.94The system shall have the ability to declare the derivatives of material properties.
Specification(s): test_jacobian
Design: Kernels System
Issue(s): #8377
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.106The system shall support retrieving a vector of values in a kernel object for the purpose of computing a residual statement.
Specification(s): test
Design: Kernels System
Issue(s): #7425
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.117The system shall error if the volumetric residual calculation is not assigned an associated vector within the numerical solving routine.
Specification(s): test
Design: Kernels System
Issue(s): #9669
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.178The system shall be capable of storing residual contributions as an auxiliary field variable for
- continuous Galerkin and
- discontinuous Galerkin methods.
Specification(s): save_in/cg, save_in/dg
Design: Kernels System
Issue(s): 4cb5e2a9f87973dba738584db39f7db935b65ce5
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.179The system shall error if the residual calculation contribution is assigned to the incorrect variable for
- on-diagonal and
- off-diagonal terms.
Specification(s): error/test_soln_var_err, error/test_diag_sol_var_err
Design: Kernels System
Issue(s): 4cb5e2a9f87973dba738584db39f7db935b65ce5
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.180The system shall be able to compute the same value for a block-restricted save-in variable regardless of the number of processes used to run a simulation.
Specification(s): block-restricted-save-in
Design: Kernels System
Issue(s): #12239
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: AuxVariable
- 1.3.74Kernel objects shall be able to couple to the time derivative of an auxiliary variable.
Specification(s): implicit_euler
Design: AuxKernels SystemKernels SystemAuxVariable
Issue(s): #442
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.75AuxKernel objects shall be able to couple to the time derivative of a nonlinear variable.
Specification(s): time_derivative_nl
Design: AuxKernels SystemKernels SystemAuxVariable
Issue(s): #442
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.76Error an AuxKernel object attemps to couple to the time derivative of an auxiliary variable.
Specification(s): coupled_aux_time_derivative
Design: AuxKernels SystemKernels SystemAuxVariable
Issue(s): #442
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.3.77The system shall be able to compute the time derivative of a non linear variable.
Specification(s): variable
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.78The system shall be able to compute the time derivative of functors for which the capability to obtain time derivatives on the fly is implemented.
Specification(s): functors
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.79The system shall be able to compute the time derivative of finite volume variables.
Specification(s): fv_variable
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.80The system shall error if
- a time derivative is requested from a functor material property for which the functor time derivative not implemented
- a time derivative is requested but the variable is a nodal variable which is currently unsupported
- a time derivative for a finite element variable is to be saved in a finite volume variable
- a time derivative for a finite volume variable is to be saved in a finite element variable
Specification(s): errors/not_implemented_functor_matprop, errors/not_a_nodal_kernel, errors/implicit_fe_fv_conversion, errors/implicit_fv_fe_conversion
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: Functions System
- 1.3.77The system shall be able to compute the time derivative of a non linear variable.
Specification(s): variable
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.78The system shall be able to compute the time derivative of functors for which the capability to obtain time derivatives on the fly is implemented.
Specification(s): functors
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.79The system shall be able to compute the time derivative of finite volume variables.
Specification(s): fv_variable
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.80The system shall error if
- a time derivative is requested from a functor material property for which the functor time derivative not implemented
- a time derivative is requested but the variable is a nodal variable which is currently unsupported
- a time derivative for a finite element variable is to be saved in a finite volume variable
- a time derivative for a finite volume variable is to be saved in a finite element variable
Specification(s): errors/not_implemented_functor_matprop, errors/not_a_nodal_kernel, errors/implicit_fe_fv_conversion, errors/implicit_fv_fe_conversion
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.14.4The Function system shall include the ability to set default values for input parameters expecting a function name.
Specification(s): test
Design: Functions System
Issue(s): #2880
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.5The Function system shall include the ability to read comma or space separated data and perform linear interpolation using the supplied data.
Specification(s): test
Design: Functions SystemPiecewiseLinear
Issue(s): cf61044773b14d5560e583867462fe9831dd1f3e
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.7The Function object shall include a callback executed during each timestep.
Specification(s): test
Design: Functions System
Issue(s): #1017
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Materials System
- 1.3.77The system shall be able to compute the time derivative of a non linear variable.
Specification(s): variable
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.78The system shall be able to compute the time derivative of functors for which the capability to obtain time derivatives on the fly is implemented.
Specification(s): functors
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.79The system shall be able to compute the time derivative of finite volume variables.
Specification(s): fv_variable
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.80The system shall error if
- a time derivative is requested from a functor material property for which the functor time derivative not implemented
- a time derivative is requested but the variable is a nodal variable which is currently unsupported
- a time derivative for a finite element variable is to be saved in a finite volume variable
- a time derivative for a finite volume variable is to be saved in a finite element variable
Specification(s): errors/not_implemented_functor_matprop, errors/not_a_nodal_kernel, errors/implicit_fe_fv_conversion, errors/implicit_fv_fe_conversion
Design: AuxKernels SystemKernels SystemAuxVariableFunctions SystemMaterials System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.9.22The system shall be able to use variables when initializing stateful material properties on neighbor materials used for the discontinuous Galerkin method.
Specification(s): run
Design: Materials System
Issue(s): #19735
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.13.1The Material objects provided on all subdomains shall satisfy requests for objects on all subdomains.
Specification(s): test
Design: Materials System
Issue(s): #8575
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.22.14The system shall ensure that interfacial materials are sorted such that consumers execute after producers.
Specification(s): sort_interface_materials
Design: Materials System
Issue(s): #17171
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.3The Jacobian from a material property declared as AD and gotten as AD shall be accurate
Specification(s): test_adad
Design: Materials System
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.4The Jacobian from a material property declared as regular and gotten as regular shall be inaccurate
Specification(s): test_regreg
Design: Materials System
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.5AD shall work with stateful material properties and the Jacobian shall be beautiful
Specification(s): stateful_jacobian
Design: Materials System
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.27.6The time evolution of the stateful diffusivity property shall show that AD works with stateful material properties
Specification(s): stateful_residual
Design: Materials System
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.7We shall be able to set default values for AD material properties
Specification(s): default_material_value
Design: Materials System
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.8We shall have a perfect Jacobian when using default values for an AD material property
Specification(s): default_material_value_jac
Design: Materials System
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.27.9For a given dual number, the system shall be able to construct a map from global degree of freedom index to the corresponding derivative
Specification(s): global_index_derivative_map
Design: Materials System
Issue(s): #15450
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.18The system shall provide material properties in boundary restricted objects acting on nodal variables.
Specification(s): bnd_coupling_vol
Design: Materials System
Issue(s): #3141
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.19The system shall provide material properties in boundary restricted objects acting on elemental variables.
Specification(s): elem_aux_bc_on_bnd
Design: Materials System
Issue(s): #3586
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.20The system shall provide location dependent boundary material property evaluations with finite volume variables.
Specification(s): fv_material_quadrature
Design: Materials System
Issue(s): #15194
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.27The system shall issue an error when multiple materials properties with the same name are declared on the same block.
Specification(s): error
Design: Materials System
Issue(s): #6533
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.46The system shall support the ability for materials to force immediate execution of other (discrete) materials:
- for a simple monomial expression, and
- for a simple polynomial expression.
Specification(s): newton_iteration/eq1, newton_iteration/eq2
Design: Materials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.47The system shall not calculate materials that are meant to be controlled by other materials (discrete) materials.
Specification(s): newton_no_calc
Design: Materials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.48The system shall issue a warning when a "discrete" material object is retrieved for use in a controlling material but it is set to auto-execute.
Specification(s): newton_warning
Design: Materials System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.49The system shall verify that a material being retrieved is defined everywhere that the retrieving material is defined:
- on compatible blocks, and
- on compatible boundaries.
Specification(s): coverage_check/block_incompatible, coverage_check/boundary_incompatible
Design: Materials System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.50The system shall issue a warning when a "discrete" material's "reset" method is not defined.
Specification(s): reset_warning
Design: Materials System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.53The system shall be able to execute functor material properties in integrated boundary conditions
- with some caching of the property evaluations
- with no caching of the property evaluations
Specification(s): functors_with_bcs/some_caching, functors_with_bcs/no_caching
Design: Materials System
Issue(s): #18395
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.60The system shall error if a functor material property is declared as returning one type and is retrieved as returning a different type.
Specification(s): inconsistent_types
Design: Materials System
Issue(s): #16809
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.61The system shall error if a functor material property is declared with the same name as another functor.
Specification(s): prop_name_issue
Design: Materials System
Issue(s): #16809
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.62The system shall error if a functor vector material property is declared with the same name as another functor.
Specification(s): vector_prop_name_issue
Design: Materials System
Issue(s): #16809
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.67The system shall be able to produce a valid Real material object on the fly for use in calculations requiring material properties
- computed at each quadrature point.
- with a single value per element for efficiency that is made available to all quadrature points in a coupled calculation.
Specification(s): real/all_qps, real/constant_on_elem
Design: Materials System
Issue(s): #8437
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.68The system shall shall be able to compute a RankTwoTensor material object
- with constant values.
- with constant values using automatic differentiation.
- with values determined by functions.
- with values determined by functions using automatic differentiation.
Specification(s): ranktwotensor/constant, ranktwotensor/ad_constant, ranktwotensor/function, ranktwotensor/ad_function
Design: Materials System
Issue(s): #8437
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.27.69The system shall report the retrieval of material properties by names:
- on boundaries,
- on blocks,
- on the all mesh boundaries, and
- on the all mesh blocks.
Specification(s): get_prop_names/boundary, get_prop_names/block, get_prop_names/any_boundary, get_prop_names/any_block
Design: Materials System
Issue(s): #4420
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.70The system shall support retrieving a single property (name) supplied by different materials on different mesh blocks.
Specification(s): property_on_all_blocks
Design: Materials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.71The system shall report an error if a material property is needed on the entire domain but is only supplied on a subset of the subdomains.
Specification(s): property_on_one_block
Design: Materials System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.72The system shall report that a material property is available when it is defined on a subdomain.
Specification(s): hasMaterialProperty
Design: Materials System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.73The system shall support retrieving a boundary restricted material property for performing a calculation on a boundary.
Specification(s): property_on_boundary
Design: Materials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.74The system shall report and error when a boundary restricted material is not defined on the same boundary as a boundary restricted object using that property in a calculation.
Specification(s): property_not_on_boundary
Design: Materials System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.75The system shall be able to grab face and neighboring face variable values and material properties in a single material object that lives on an interface
Specification(s): jump
Design: Materials System
Issue(s): #12066
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.76The system shall be able to grab face and neighboring face variable values and material properties in a single material object that lives on an interface when the mesh is split
Specification(s): jump_split
Design: Materials System
Issue(s): #12066
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.77The system shall be able to calculate stateful material properties in an interface material object
Specification(s): jump_split_stateful
Design: Materials System
Issue(s): #12066
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.78The system shall evaluate interface materials such that they can be used in boundary restricted elemental auxiliary kernels
Specification(s): boundary_elem_aux
Design: Materials System
Issue(s): #14387
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.79The system shall support material property calculations that depend on other material properties:
- with one level of dependencies,
- with two levels of dependencies,
- with three levels of dependencies, and
- with differing values across mesh subdomains.
Specification(s): depend/coupled_1, depend/coupled_2, depend/coupled_3, depend/coupled_block
Design: Materials System
Issue(s): 6683d503d6441165249f8d49c65b76722430019a
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.80The system shall support material property calculations for used with discontinuous Galerkin finite element method.
Specification(s): dg_test
Design: Materials System
Issue(s): 6683d503d6441165249f8d49c65b76722430019a
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.81The system shall support material property calculations that are restricted to boundaries on the mesh.
Specification(s): bnd_material_test
Design: Materials System
Issue(s): 6683d503d6441165249f8d49c65b76722430019a
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.82The system shall error if material property calculations result in a cyclic dependency.
Specification(s): mat_cyclic_dep_error_test
Design: Materials System
Issue(s): 6683d503d6441165249f8d49c65b76722430019a
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.83The system shall error is a material property is requested on a subdomain on which it is not defined.
Specification(s): mat_block_boundary_check
Design: Materials System
Issue(s): 6683d503d6441165249f8d49c65b76722430019a
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.84The system shall support material property calculations that operate on auxiliary systems and during volume and surface residual calculations.
Specification(s): test
Design: Materials System
Issue(s): 6683d503d6441165249f8d49c65b76722430019a
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.85The system shall error if material properties are not computed on all subdomains.
Specification(s): check_test
Design: Materials System
Issue(s): 6683d503d6441165249f8d49c65b76722430019a
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.86The system shall include that ability to handle C++ exceptions during material property calculation routines:
- on a single process,
- from processor 1 during a parallel calculation with 4 processes,
- from processor 0 during a parallel calculation with 4 processes.
Specification(s): exception/serial, exception/rank1, exception/rank0
Design: Materials System
Issue(s): 6683d503d6441165249f8d49c65b76722430019a
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.87The system shall support the calculation of material properties that vary at numerical integration quadrature points.
Specification(s): test_constant_on_elem
Design: Materials System
Issue(s): 6683d503d6441165249f8d49c65b76722430019a
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.88The system shall only compute material properties when they are needed (consumed by other objects).
Specification(s): dont_reinit_mat_for_aux
Design: Materials System
Issue(s): #8444
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.89The system shall support having multiple materials supplying multiple unique material properties on the same subdomains of the mesh.
Specification(s): test
Design: Materials System
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.90The system shall not create a dependency when old versions of material properties are retrieved and used in calculations.
Specification(s): test
Design: Materials System
Issue(s): #8496
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.27.91The system shall support optional material property coupling when the requesting object
- is a material that comes before the providing material
- is a material that comes after the providing material
- is an AuxKernel
- is a UserObject
Specification(s): order/material_before, order/material_after, order/auxkernel, order/userobject
Design: Materials System
Issue(s): #18999
Collection(s): FUNCTIONAL
Type(s): RunAppExodiff
- 1.27.92Optional material property objects that cannot be resolved shall evaluate to false
Specification(s): material_missing
Design: Materials System
Issue(s): #18999
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.27.93The optional material property system use from a material object shall return
- an accessible material for existing AD properties
- an accessible material for existing non-AD properties
- an inaccessible material for non-existing AD properties
- an inaccessible material for non-existing non-AD properties
Specification(s): material_error/ad_expected, material_error/non-ad_expected, material_error/ad_not_expected, material_error/non-ad_not_expected
Design: Materials System
Issue(s): #18999
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.94The system shall support the output of material data as field variables including
- outputting all properties within a material definition;
- outputting all properties from the output definition;
- outputting certain properties within a material definition;
- outputting certain properties within the output definition on a subdomain;
- outputting certain properties within the material definition on a subdomain;
- outputting certain properties within the material definition on a subdomain with a displaced configuration;
- outputting certain properties within the material definition on a boundary;
- outputting certain properties within the material definition to different files; and
- 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
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.95The system shall support the output as auxiliary field variables of
- automatic differentiation vector material properties
Specification(s): data_types/ad_vector
Design: Materials SystemOutput System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.96The system shall 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
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.97The system shall 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
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.98The 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
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.27.99The system shall show the field variable names for outputting material data added by materials.
Specification(s): show_added_aux_vars
Design: Materials SystemOutput System
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.27.104The system shall be able to produce stateful material properties that can be consumed by other objects in the system.
Specification(s): test
Design: Materials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.105The system shall support coupling in an auxiliary field variable for use in initializing stateful material properties.
Specification(s): aux_init_qp_props
Design: Materials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.106The system shall allow the retrieval of stateful material properties for calculations on internal sides within a mesh.
Specification(s): test
Design: Materials System
Issue(s): #2972
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.107The system shall be able to generate up to three states of material properties for use in other calculations: current, old and older
- where properties are stored in auxiliary spatial fields, and
- when those properties are averaged and output to a comma-separated value file.
Specification(s): stateful_old/exodiff_old, stateful_old/csvdiff_old
Design: Materials System
Issue(s): #1927#8278#4268#5658#3277#3414#808#8450#13972#15956
Collection(s): FUNCTIONAL
Type(s): CSVDiffExodiff
- 1.27.108The system shall verify that the oldest material property (older) can be coupled to other objects for use in another calculation:
- where properties are stored in auxiliary spatial fields, and
- when those properties are averaged and output to a comma-separated value file.
Specification(s): stateful_older/exodiff_older, stateful_older/csvdiff_older
Design: Materials System
Issue(s): #1927#8278#4268#5658#3277#3414#808#8450#13972#15956
Collection(s): FUNCTIONAL
Type(s): CSVDiffExodiff
- 1.27.109The system shall be able to promote normal material properties to stateful when old/older properties are requested.
Specification(s): implicit_stateful
Design: Materials System
Issue(s): #1927#8278#4268#5658#3277#3414#808#8450#13972#15956
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.110The system shall make material property calculations available during the computation of the initial Residual vector.
Specification(s): computing_initial_residual_test
Design: Materials System
Issue(s): #1927#8278#4268#5658#3277#3414#808#8450#13972#15956
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.111The system shall store stateful properties that vary at every calculation point (quadrature point) similarly to a normal field variable even though they are not interpolatory:
- on blocks, and
- on boundaries.
Specification(s): storage/spatial_test, storage/spatial_bnd_only
Design: Materials System
Issue(s): #1927#8278#4268#5658#3277#3414#808#8450#13972#15956
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.112The system shall support the ability to copy stored stateful data from one element to another element.
Specification(s): stateful_copy
Design: Materials System
Issue(s): #1927#8278#4268#5658#3277#3414#808#8450#13972#15956
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.113The system shall handle storing stateful properties related to elements on the mesh as the mesh is adapting:
- when properties are spatially constant, and
- when properties vary spatially.
Specification(s): adaptivity/spatially_const, adaptivity/spatially_varying
Design: Materials System
Issue(s): #1927#8278#4268#5658#3277#3414#808#8450#13972#15956
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.114The system shall not store any stateful material properties that are declared but never used.
Specification(s): many_stateful_props
Design: Materials System
Issue(s): #1927#8278#4268#5658#3277#3414#808#8450#13972#15956
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.115The system shall be able to correctly handle stateful materials
- when using a regular material property.
- when using an AD material property.
- when using a regular material property using templated methods.
- when using an AD material property using templated methods.
Specification(s): ad/reg, ad/ad, ad/template_reg, ad/template_ad
Design: Materials System
Issue(s): #1927#8278#4268#5658#3277#3414#808#8450#13972#15956
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.116The system shall be capable of outputting material properties through auxiliary field variables.
Specification(s): test
Design: Materials System
Issue(s): #4489
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.117The system shall report and error when invalid indices are requested when attempting to output material properties through auxiliary field variables.
Specification(s): except1
Design: Materials System
Issue(s): #4489
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.118The system shall only prepare or setup field variables on each element when they are used by a material object.
Specification(s): var_coupling
Design: Materials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.119The system shall support coupling in a nonlinear field variable for use in initializing stateful material properties.
Specification(s): var_stateful_coupling
Design: Materials System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.38The system shall support late binding of material properties to other objects so that those objects may be created first, or material property retrieval may be delayed until the system is initialized.
Specification(s): test
Design: Materials System
Issue(s): #1656
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VariableTimeIntegrationAux
- 1.3.81The system shall include the ability to compute the integral of a variable over time.
Specification(s): time_integration_aux
Design: VariableTimeIntegrationAux
Issue(s): #5737
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VectorFunctionAux
- 1.3.83The system shall include the ability to set the components of a vector auxiliary variable using a function defined within the input file.
Specification(s): VectorFunctionAux
Design: VectorFunctionAux
Issue(s): #12312
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VectorMagnitudeAux
- 1.3.84The 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.85The 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: VectorPostprocessorVisualizationAux
- 1.3.86The system shall be capable of populating an auxiliary variable from VectorPostprocessor data sized to the number of processors.
Specification(s): test
Design: VectorPostprocessorVisualizationAuxWorkBalance
Issue(s): #11272
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: WorkBalance
- 1.3.86The system shall be capable of populating an auxiliary variable from VectorPostprocessor data sized to the number of processors.
Specification(s): test
Design: VectorPostprocessorVisualizationAuxWorkBalance
Issue(s): #11272
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.62.65The system shall have the ability to compute several statistics related to the balance of the mesh partitioning
- on replicated meshes, and
- on distributed meshes.
Specification(s): work_balance/replicated, work_balance/distributed
Design: WorkBalance
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: VectorVariableMagnitudeAux
- 1.3.87The system shall include the ability to compute auxiliary quantities at the nodes of elements based on the values of a LAGRANGE_VEC variable.
Specification(s): test
Design: VectorVariableMagnitudeAux
Issue(s): #16076
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VectorPostprocessors System
- 1.3.88AuxKernel objects shall be capable of coupling to VectorPostprocessor objects.
Specification(s): test
Design: AuxKernels SystemVectorPostprocessors System
Issue(s): #7427
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.39The CSV output object shall create a symlink to the final output with with a '_FINAL' suffix for VectorPostprocessor data when there are execute flags in addition to FINAL.
Specification(s): final
Design: VectorPostprocessors SystemCSV
Issue(s): #11087
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.40The CSV output object shall create a symlink to the final output with with a '_FINAL' suffix for VectorPostprocessor data when the execute flag is set to FINAL.
Specification(s): final_only
Design: VectorPostprocessors SystemCSV
Issue(s): #11087
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.41The CSV output object 'create_final_symlink' parameter shall be able to disable the creation of the final symlink.
Specification(s): no_link
Design: VectorPostprocessors SystemCSV
Issue(s): #11087
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.42The CSV output object shall create a symlink to the most recent output with with a '_LATEST' suffix for VectorPostprocessor data.
Specification(s): latest
Design: VectorPostprocessors SystemCSV
Issue(s): #11087
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.43The CSV output object 'create_latest_symlink' parameter shall be able to disable the creation of the latest symlink.
Specification(s): no_latest
Design: VectorPostprocessors SystemCSV
Issue(s): #11087
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.41.36Postprocessor 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.41.87The VectorPostprocessor system shall provide a mechanism to retrieve references to old vectors.
Specification(s): old_no_history
Design: VectorPostprocessors System
Issue(s): #11300
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.88The VectorPostprocessor system shall provide a mechanism to retrieve references to old vectors while maintaining vector history.
Specification(s): old_with_history
Design: VectorPostprocessors System
Issue(s): #11300
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.2The system shall be able to produce arbitrary vectors of values for use in other calculations.
Specification(s): constant_vector_postprocessor
Design: VectorPostprocessors System
Issue(s): #3087
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.3The system shall be able to produce multiple arbitrary vectors of values for use in other calculations.
Specification(s): constant_vector_postprocessor_multcol
Design: VectorPostprocessors System
Issue(s): #14569
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.10The system shall support writing a vector of data
- that is completely stored on a single processor or
- distributed across many and
- allows for the creation of symbolic links to the the most recent and final files on each processor.
Specification(s): parallel_type/replicated, parallel_type/distributed, parallel_type/distributed_symlinks
Design: VectorPostprocessors System
Issue(s): #14480
Collection(s): FUNCTIONAL
Type(s): CSVDiffCheckFiles
- 1.62.30The system shall have late binding producers of vector quantities (VectorPostprocessors) that may be declared after system initialization.
Specification(s): test
Design: VectorPostprocessors System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.48The system shall provide VectorPostprocessor results to all processors as scattered data.
Specification(s): test
Design: VectorPostprocessors System
Issue(s): #11408
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.62.49The system shall provide VectorPostprocessor results to all processors as replicated data.
Specification(s): broadcast
Design: VectorPostprocessors System
Issue(s): #11408
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.62.55The VectorPostprocessor system takes a parameter "contains_complete_history" which guarentees the vector state is left alone between invocations resulting in a single CSV output file.
Specification(s): test
Design: VectorPostprocessors System
Issue(s): #11300
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.62The system shall support the ability to output a separate comma separated value file containing time and time time information corresponding to vector Postprocessor output.
Specification(s): test
Design: VectorPostprocessors System
Issue(s): #6618
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: VolumeAux
- 1.3.89The system shall include the ability to sample
- elemental
- and side volumes
Specification(s): test/element, test/side
Design: VolumeAux
Issue(s): #19307
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.3.90The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: NeumannBC
- 1.4.1The system shall support Neumann type boundary conditions for a 1D problem.
Specification(s): test
Design: NeumannBC
Issue(s): #1654
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.2The system shall support Neumann type boundary conditions for a 1D problem using an imported mesh.
Specification(s): from_cubit
Design: NeumannBC
Issue(s): #1654
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.2The system shall provide an ability to solve a 2D diffusion problem with Neumann boundary conditions.
Specification(s): testneumann
Design: NeumannBC
Issue(s): #1410
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ADNeumannBC
- 1.4.3The system shall support Neumann type boundary conditions using automatic differentiation for a 1D problem
- using a generated mesh.
- and shall be able to produce the exact Jacobian
- 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.24.9The system shall provide an ability to solve a 2D diffusion problem Neumann boundary conditions using
- automatic differentiation and
- 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.4.4The system shall support setting AD Dirichlet type boundary conditions, supplied as a function, directly to the solution vector prior to the solve.
Specification(s): bc_function_nodal_test
Design: ADFunctionDirichletBC
Issue(s): #13261
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.6The system shall support setting AD Dirichlet type boundary conditions, supplied as a function, directly to the solution vector prior to the solve and have perfect Jacobians.
Specification(s): bc_function_nodal_test-jac
Design: ADFunctionDirichletBC
Issue(s): #13261
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.4.8We shall be able to produce the expected result using ADKernel, ADNodalBC, and ADIntegratedBC
Specification(s): test
Design: ADFunctionDirichletBCADDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.9We shall be able to produce the exact Jacobian using ADKernel, ADNodalBC, and ADIntegratedBC with a first order variable
Specification(s): jac
Design: ADFunctionDirichletBCADDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.4.10We shall be able to produce the exact Jacobian using ADKernel, ADNodalBC, and ADIntegratedBC with a second order variable
Specification(s): 2nd_order_jac
Design: ADFunctionDirichletBCADDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.4.15The system shall support Dirichlet type boundary conditions defined by a function
- using automatic differentiation.
- 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.4.5The system shall support setting AD Dirichlet type boundary conditions directly to the solution vector prior to the solve.
Specification(s): bc_preset_nodal_test
Design: ADDirichletBC
Issue(s): #13261
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.7The system shall support setting AD Dirichlet type boundary conditions directly to the solution vector prior to the solve and have perfect Jacobians.
Specification(s): bc_preset_nodal_test-jac
Design: ADDirichletBC
Issue(s): #13261
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.8The system shall provide an ability to solve a 2D diffusion problem with Dirichlet boundary conditions using
- automatic differentiation and
- 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.4.8We shall be able to produce the expected result using ADKernel, ADNodalBC, and ADIntegratedBC
Specification(s): test
Design: ADFunctionDirichletBCADDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.9We shall be able to produce the exact Jacobian using ADKernel, ADNodalBC, and ADIntegratedBC with a first order variable
Specification(s): jac
Design: ADFunctionDirichletBCADDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.4.10We shall be able to produce the exact Jacobian using ADKernel, ADNodalBC, and ADIntegratedBC with a second order variable
Specification(s): 2nd_order_jac
Design: ADFunctionDirichletBCADDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.30Jacobian entries generated with AD for a simple diffusion problem shall be accurate
Specification(s): test
Design: ADDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ADVectorFunctionDirichletBC
- 1.4.11We shall be able to produce the expected result using ADVectorKernel, ADVectorNodalBC, and ADVectorIntegratedBC
Specification(s): vector_test
Design: ADVectorFunctionDirichletBCADVectorDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.12We shall be able to produce the exact Jacobian using ADVectorKernel, ADVectorNodalBC, and ADVectorIntegratedBC with a first order variable
Specification(s): vector_jac
Design: ADVectorFunctionDirichletBCADVectorDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.4.13We shall be able to produce the exact Jacobian using ADVectorKernel, ADVectorNodalBC, and ADVectorIntegratedBC with a second order variable
Specification(s): 2nd_order_vector_jac
Design: ADVectorFunctionDirichletBCADVectorDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.132The system shall be able to solve multi-d LAGRANGE_VEC problems with automatic differentiation and reproduce the hand-coded result.
Specification(s): ad_lagrange_vec
Design: ADVectorFunctionDirichletBC
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.133The system shall be able to solve multi-d LAGRANGE_VEC problems with automatic differentiation and have a perfect Jacobian.
Specification(s): ad_lagrange_vec_jacobian
Design: ADVectorFunctionDirichletBC
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.139The system shall error if the 'function' and 'function_x' parameters are both set within the ADVectorFunctionDirichletBC object.
Specification(s): ad_comp_error
Design: ADVectorFunctionDirichletBC
Issue(s): #13309
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ADVectorDiffusion
- 1.4.11We shall be able to produce the expected result using ADVectorKernel, ADVectorNodalBC, and ADVectorIntegratedBC
Specification(s): vector_test
Design: ADVectorFunctionDirichletBCADVectorDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.12We shall be able to produce the exact Jacobian using ADVectorKernel, ADVectorNodalBC, and ADVectorIntegratedBC with a first order variable
Specification(s): vector_jac
Design: ADVectorFunctionDirichletBCADVectorDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.4.13We shall be able to produce the exact Jacobian using ADVectorKernel, ADVectorNodalBC, and ADVectorIntegratedBC with a second order variable
Specification(s): 2nd_order_vector_jac
Design: ADVectorFunctionDirichletBCADVectorDiffusion
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: Coupleable
- 1.4.14The system shall be able to couple a lower-dimensional variable into a boundary condition for a higher-dimensional variable.
Specification(s): couple_lower
Design: Coupleable
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.11Coupled variable gradient Jacobian entries generated with AD shall be accurate
Specification(s): test
Design: Coupleable
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.13Coupled variable value Jacobian entries generated with AD shall be accurate
Specification(s): test
Design: Coupleable
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.14We shall be able to get aux variable values through adCoupledValue with the knowledge that the derivatives will always be zero
Specification(s): test_coupled_aux
Design: Coupleable
Issue(s): #12852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.15Getting a constant aux variable through adCoupledValue shall not destroy our Jacobian
Specification(s): test_coupled_aux_jac
Design: Coupleable
Issue(s): #12852
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.16We shall be able to get dot aux variable values through adCoupledValue with the knowledge that the time derivatives will always be zero
Specification(s): test_coupled_dot_aux
Design: Coupleable
Issue(s): #12996
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.18The system shall automatically generate a full coupling matrix when doing global AD indexing such that there are no new matrix memory allocations.
Specification(s): no_mallocs_pjfnk
Design: Coupleable
Issue(s): #16396
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.19The system shall automatically generate a full coupling matrix when doing global AD indexing, resulting in a perfect Jacobian even when the user has not requested full coupling.
Specification(s): perfect_jac_pjfnk_global_ad
Design: Coupleable
Issue(s): #16396
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.20The system shall allow the user to override the automated generation of a full coupling matrix when doing global AD indexing, which for this test results in a new nonzero allocation because there is off-diagonal coupling.
Specification(s): trust_user_and_then_error
Design: Coupleable
Issue(s): #16396
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.24.35The system shall support coupling of variables with automatic differentiation and vector values.
Specification(s): ad_vector_couple
Design: Coupleable
Issue(s): #12836
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.36The system shall support coupling to the gradient of variables with automatic differentiation and vector values.
Specification(s): ad_grad_vector_couple
Design: Coupleable
Issue(s): #12836
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.37The system shall support coupling of default values for variables with automatic differentiation and vector values.
Specification(s): ad_vector_couple_default
Design: Coupleable
Issue(s): #12836
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.123The system shall compute second-order time derivatives for vector variables
Specification(s): test
Design: Coupleable
Issue(s): #13913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.127The system shall report an error if users try to get nodal values of non-nodal variables.
Specification(s): coupled_nodal_for_non_nodal_variable
Design: Coupleable
Issue(s): #11623
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.128The system shall report an error if users try to get old nodal values of non-nodal variables.
Specification(s): coupled_nodal_for_non_nodal_variable_old
Design: Coupleable
Issue(s): #11623
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.129The system shall report an error if users try to get older nodal values of non-nodal variables.
Specification(s): coupled_nodal_for_non_nodal_variable_older
Design: Coupleable
Issue(s): #11623
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.41.8The system shall allow for the retrieval of raw elemental degree-of-freedom values directly for elemental evaluations.
Specification(s): test
Design: Coupleable
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.61.22Allow 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.61.23Users 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.61.24Simulations 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.61.25Coupleable shall provide an interface that allows providing default values for a variables that operates
- with defaults or
- 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.61.26The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.61.27The system shall report an error when requested default vector value is out of range and
- accessed by name or
- 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ADFunctionNeumannBC
- 1.4.16The system shall support Neumann type boundary conditions defined by a function
- using automatic differentiation.
- 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.4.17The system shall support matching variable values on a boundary using automatic differentiation
Specification(s): test
Design: ADMatchedValueBC
Issue(s): #18212
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.18The system shall produce the exact Jacobian for BC matching variable values on a boundary using automatic differentiation
Specification(s): jacobian
Design: ADMatchedValueBC
Issue(s): #18212
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: ADPenaltyDirichletBC
- 1.4.19The system shall support the application of Dirichlet type boundary conditions using the penalty method using the AD system
- with a constant value on the boundary.
- with a constant value on the boundary and shall be able to produce the exact Jacobian.
- with a value on the boundary set by a function.
- with a value on the boundary set by a function and shall be able to produce the exact Jacobian.
Specification(s): ad/penalty_dirichlet_bc_test, ad/penalty_dirichlet_bc_test-jac, ad/function_penalty_dirichlet_bc_test, ad/function_penalty_dirichlet_bc_test-jac
Design: ADPenaltyDirichletBCADFunctionPenaltyDirichletBC
Issue(s): #12903
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- framework: ADFunctionPenaltyDirichletBC
- 1.4.19The system shall support the application of Dirichlet type boundary conditions using the penalty method using the AD system
- with a constant value on the boundary.
- with a constant value on the boundary and shall be able to produce the exact Jacobian.
- with a value on the boundary set by a function.
- with a value on the boundary set by a function and shall be able to produce the exact Jacobian.
Specification(s): ad/penalty_dirichlet_bc_test, ad/penalty_dirichlet_bc_test-jac, ad/function_penalty_dirichlet_bc_test, ad/function_penalty_dirichlet_bc_test-jac
Design: ADPenaltyDirichletBCADFunctionPenaltyDirichletBC
Issue(s): #12903
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- framework: ArrayVacuumBC
- 1.4.20The system shall provide array vacuum boundary condition.
Specification(s): test
Design: ArrayVacuumBC
Issue(s): #6881
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FunctionDirichletBC
- 1.4.21The system shall support setting Dirichlet type boundary conditions, supplied as a function, directly to the solution vector prior to the solve.
Specification(s): bc_function_nodal_test
Design: FunctionDirichletBC
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.33The system shall support Dirichlet type boundary conditions defined by a function.
Specification(s): test
Design: FunctionDirichletBC
Issue(s): #1214
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: DirichletBC
- 1.4.22The system shall support setting Dirichlet type boundary conditions directly to the solution vector prior to the solve.
Specification(s): bc_preset_nodal_test
Design: DirichletBC
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.1The system shall provide an ability to solve a 2D diffusion problem with Dirichlet boundary conditions.
Specification(s): testdirichlet
Design: DirichletBC
Issue(s): #6397
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: BCs System
- 1.4.23The system shall support the creation of BoundaryCondition objects that support conditional activation.
Specification(s): test
Design: BCs System
Issue(s): #1771
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.24The system shall support the creation of BoundaryCondition objects that couple to nonlinear variables.
Specification(s): test
Design: BCs System
Issue(s): #656
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.37The system shall support matching variable values on a boundary.
Specification(s): test
Design: BCs System
Issue(s): #656
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.38The system shall support the ability to create convective flux boundary conditions.
Specification(s): convective_flux_bc_test
Design: BCs System
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.39The system shall support a vacuum boundary condition for neutron diffusion on the boundary.
Specification(s): vacuumbc_test
Design: BCs System
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.40The system shall support Neumann type boundary conditions where the specified value is defined as the value of a vector, , in the direction of the boundary outward facing normal, (i.e., ).
Specification(s): vector_neumann_test
Design: BCs System
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.41The system shall support the 'no boundary condition' type boundary condition (Griffiths, 1997).
Specification(s): weak_gradient_bc_test
Design: BCs System
Issue(s): 16769b212846275cd8b12e5a89b9e98f3ab7ca83
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.68The system shall properly compute second derivatives within BoundaryCondition objects.
Specification(s): test_lap_bc
Design: BCs System
Issue(s): #6327
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.69The system shall support creating sidesets from nodesets for hexahedron elements to use with Boundary Condition objects.
Specification(s): test_hex
Design: Mesh SystemBCs System
Issue(s): #687
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.70The system shall support creating sidesets from nodesets for tetrahedron elements to use with Boundary Condition objects.
Specification(s): test_tet
Design: Mesh SystemBCs System
Issue(s): #687
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.73BoundaryCondition objects shall support retrieval of VectorPostprocessor data.
Specification(s): test
Design: BCs System
Issue(s): #9285
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: CoupledVarNeumannBC
- 1.4.25The system shall support coupled Neumann type boundary conditions.
Specification(s): test
Design: CoupledVarNeumannBC
Issue(s): #13502
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.26The system shall enable scaling of the Neumann type boundary conditions.
Specification(s): on_off
Design: CoupledVarNeumannBC
Issue(s): #15421
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.27When coupling nonlinear variables into a Neumann type boundary condition, the system shall
- generate accurate results
- generate a perfect Jacobian
Specification(s): nonlinear/exo, nonlinear/jac
Design: CoupledVarNeumannBC
Issue(s): #13502
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- framework: AddPeriodicBCAction
- 1.4.28The system shall be able to determine if a non-scalable algorithm is being used for ghosting boundaries.
Specification(s): check
Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator
Issue(s): #15501
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.4.29The system shall make sure that boundaries are actually distributed.
Specification(s): check_one_step
Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator
Issue(s): #15501
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.4.30The system shall support periodic boundary conditions in a parallel generated 2D mesh.
Specification(s): 2d
Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator
Issue(s): #15501
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.31The system shall support periodic boundary conditions in a parallel generated 3D mesh.
Specification(s): 3d
Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator
Issue(s): #15501
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.32The system shall support periodic boundary conditions in a parallel generated 1D mesh.
Specification(s): 1d
Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator
Issue(s): #15501
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.66When using periodic boundary detection, the system shall not attempt to add periodic boundary conditions to scalar variables.
Specification(s): no_add_scalar
Design: AddPeriodicBCAction
Issue(s): #11417
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: DistributedRectilinearMeshGenerator
- 1.4.28The system shall be able to determine if a non-scalable algorithm is being used for ghosting boundaries.
Specification(s): check
Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator
Issue(s): #15501
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.4.29The system shall make sure that boundaries are actually distributed.
Specification(s): check_one_step
Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator
Issue(s): #15501
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.4.30The system shall support periodic boundary conditions in a parallel generated 2D mesh.
Specification(s): 2d
Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator
Issue(s): #15501
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.31The system shall support periodic boundary conditions in a parallel generated 3D mesh.
Specification(s): 3d
Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator
Issue(s): #15501
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.32The system shall support periodic boundary conditions in a parallel generated 1D mesh.
Specification(s): 1d
Design: AddPeriodicBCActionDistributedRectilinearMeshGenerator
Issue(s): #15501
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.28The system shall support mesh adaptivity on a distributed generated displaced mesh.
Specification(s): adaptivity
Design: DistributedRectilinearMeshGenerator
Issue(s): #15702
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.29The system shall support mesh adaptivity with periodic boundary conditions on a distributed generated displaced mesh.
Specification(s): pbc_adaptivity
Design: DistributedRectilinearMeshGenerator
Issue(s): #15702
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.30The system shall support a scalable mesh adaptivity with periodic boundary conditions on a distributed generated displaced mesh
- without and with
- automatic scaling.
Specification(s): pbc/adaptivity_nemesis, pbc/adaptivity_autoscaling
Design: DistributedRectilinearMeshGenerator
Issue(s): #15702
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.31The system shall be able to generate 2D Quad4 mesh in parallel.
Specification(s): mesh_generator
Design: DistributedRectilinearMeshGenerator
Issue(s): #11485
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.32The system shall be able to check if or not users ask for too many layers of ghosting elements.
Specification(s): check_nlayers
Design: DistributedRectilinearMeshGenerator
Issue(s): #11485
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.33The system shall be able to generate 1D EDGE2 mesh in parallel.
Specification(s): 1D
Design: DistributedRectilinearMeshGenerator
Issue(s): #11485
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.34The system shall be able to generate 3D HEX8 mesh in parallel.
Specification(s): 3D
Design: DistributedRectilinearMeshGenerator
Issue(s): #11485
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.35The system shall be able to generate 3D HEX8 mesh in parallel using ptscotch partitioner
Specification(s): 3D_ptscotch
Design: DistributedRectilinearMeshGenerator
Issue(s): #11485
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.36The system shall be able to generate 3D HEX8 mesh in parallel using hierarch partitioner
Specification(s): 3D_hierarch
Design: DistributedRectilinearMeshGenerator
Issue(s): #11485
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.37The system shall be able to generate a first-order hexahedral mesh in parallel using a small number of cores for the graph partitioner.
Specification(s): 3d_scomm_out
Design: DistributedRectilinearMeshGenerator
Issue(s): #15464
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.38The system shall error out if the number of cores for partition is larger than the total number of cores.
Specification(s): 3d_scomm_10_out
Design: DistributedRectilinearMeshGenerator
Issue(s): #15464
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.39The system shall be able to adapt a mesh generated in parallel.
Specification(s): mesh_adaptivity
Design: DistributedRectilinearMeshGenerator
Issue(s): #11485
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.40The system shall generate an arbitrary number of layers of side neighbors using DistributedRectilinearMeshGenerator.
Specification(s): num_layers
Design: DistributedRectilinearMeshGenerator
Issue(s): #16143
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.41The system shall be able to generate a squarish partition for a 2D distributed generated mesh using 3 processors.
Specification(s): 2D_3
Design: DistributedRectilinearMeshGenerator
Issue(s): #16729
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.42The system shall be able to generate a squarish partition for a 2D distributed generated mesh using 4 processors.
Specification(s): 2D_4
Design: DistributedRectilinearMeshGenerator
Issue(s): #16729
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.43The system shall be able to generate a squarish partition for a 2D distributed generated mesh using 6 processors.
Specification(s): 2D_6
Design: DistributedRectilinearMeshGenerator
Issue(s): #16729
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.44The system shall be able to generate a squarish partition for a 1D distributed generated mesh using 3 processors.
Specification(s): 1D_3
Design: DistributedRectilinearMeshGenerator
Issue(s): #16729
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.45The system shall be able to generate a squarish partition for a 1D distributed generated mesh using 4 processors.
Specification(s): 1D_4
Design: DistributedRectilinearMeshGenerator
Issue(s): #16729
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.46The system shall be able to generate a squarish partition for a 3D distributed generated mesh using 3 processors.
Specification(s): 3D_3
Design: DistributedRectilinearMeshGenerator
Issue(s): #16729
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.47The system shall be able to generate a squarish partition for a 3D distributed generated mesh using 4 processors.
Specification(s): 3D_4
Design: DistributedRectilinearMeshGenerator
Issue(s): #16729
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.48The system shall be able to generate a squarish partition for a 3D distributed generated mesh using 8 processors.
Specification(s): 3D_8
Design: DistributedRectilinearMeshGenerator
Issue(s): #16729
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FunctionNeumannBC
- 1.4.34The system shall support applying a function of space-time as a Neumann boundary condition.
Specification(s): test
Design: FunctionNeumannBC
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MatNeumannBC
- 1.4.35The system shall support applying a material property as a Neumann boundary condition.
Specification(s): test
Design: MatNeumannBC
Issue(s): #17791
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.36The system shall support applying a material property as a Neumann boundary condition using AD.
Specification(s): ad_test
Design: MatNeumannBC
Issue(s): #17791
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: NodalNormals System
- 1.4.42The system shall be capable of computing the nodal normals for triangle elements.
Specification(s): circle_tris
Design: NodalNormals System
Issue(s): #1871
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.43The system shall be capable of computing the nodal normals for quadrilateral elements.
Specification(s): circle_quads
Design: NodalNormals System
Issue(s): #1871
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.44The system shall be capable of computing the nodal normals for first order hexahedron elements.
Specification(s): cylinder_hexes
Design: NodalNormals System
Issue(s): #1871
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.45The system shall be capable of computing the nodal normals for second order hexahedron elements.
Specification(s): cylinder_hexes_2nd
Design: NodalNormals System
Issue(s): #1871
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.46The system shall be capable of computing the first order nodal normals for second order hexahedron elements.
Specification(s): cylinder_hexes_1st_2nd
Design: NodalNormals System
Issue(s): #1871
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.47The system shall be capable of computing the nodal normals for quadrilateral elements on a square domain.
Specification(s): small_sqaure
Design: NodalNormals System
Issue(s): #1871
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PenaltyDirichletBC
- 1.4.48The system shall support the application of Dirichlet type boundary conditions using the penalty method.
Specification(s): test_penalty_dirichlet_bc
Design: PenaltyDirichletBC
Issue(s): #5268
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.49The system shall support the application of Dirichlet type boundary conditions, defined by a function, using the penalty method.
Specification(s): test_function_penalty_dirichlet_bc
Design: PenaltyDirichletBC
Issue(s): #5268
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Periodic System
- 1.4.50The system shall support periodic boundary conditions with transforms defined as functions.
Specification(s): all_periodic_trans_test
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.51The system shall support periodic boundary conditions with transforms that are computed automatically in the 'x' and 'y' directions.
Specification(s): auto_wrap_2d_test
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.52The system shall support periodic boundary conditions with transforms that are computed automatically in the 'x' and 'y' directions using a non-generated mesh.
Specification(s): auto_wrap_2d_test_non_generated
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.53The system shall produce an error within the PeriodicDistanceAux object when a point is provided that is outside the mesh domain.
Specification(s): auto_wrap_2d_test_error_check
Design: Periodic System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.4.54The system shall support periodic boundary conditions with transforms that are computed automatically in the 'x', 'y', and 'z' directions.
Specification(s): auto_wrap_3d_test
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.55The system shall support periodic boundary conditions on orthogonal boundaries with transforms defined as functions.
Specification(s): orthogonal_pbc_on_square_test
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.56The system shall support periodic boundary conditions on parallel boundaries with transforms defined as functions.
Specification(s): parallel_pbc_using_trans_test
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.57The system shall support periodic boundary conditions with mesh adaptivity.
Specification(s): testlevel1
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.58The system shall support periodic boundary conditions with transforms prescribed as a translation.
Specification(s): testperiodic
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.59The system shall support periodic boundary conditions on vector variables with transforms prescribed as a translation.
Specification(s): testperiodic_vector
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.60The system shall support periodic boundary conditions with displacements.
Specification(s): testperiodic_dp
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.61The system shall support periodic boundary conditions on a trapezoid domain with transforms prescribed as functions.
Specification(s): testtrapezoid
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.63The system shall support periodic boundary conditions on a wedge domain with transforms prescribed as functions.
Specification(s): testwedge
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.64The system shall support periodic boundary conditions for a single variable on a wedge domain with transforms prescribed as functions.
Specification(s): testwedgesys
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.4.65The system shall support periodic boundary conditions for input meshes that have repeated element ids.
Specification(s): auto_dir_repeated_id
Design: Periodic System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MooseMesh
- 1.4.62The system shall support calls to periodic distance and bounds methods on the mesh when periodic boundary conditions are not used.
Specification(s): trapezoid_non_periodic
Design: MooseMesh
Issue(s): #11939
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.10The system shall output all boundary and subdomain connections.
Specification(s): boundary_subdomain_connections
Design: MooseMesh
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.28.68The system shall issue a diagnostic when a referenced node set does not exist in the mesh
Specification(s): test
Design: MooseMesh
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.28.74The system shall issue a diagnostic when a referenced side set does not exist in the mesh.
Specification(s): missing_side_set
Design: MooseMesh
Issue(s): #13509
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.28.75The system shall have the ability to construct a side set from a set of nodes.
Specification(s): construct_side_sets
Design: MooseMesh
Issue(s): #13509
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.49.11The system shall issue an error when a referenced subdomain does not exist in the mesh.
Specification(s): block
Design: MooseMesh
Issue(s): #2757
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.60.14The mesh system shall report a reasonable error when using a subdomain name that is reserved for internal use
Specification(s): get_subdomain_id_any
Design: MooseMesh
Issue(s): #17710
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: PostprocessorNeumannBC
- 1.4.67The system shall support the application of a Neumann boundary condition computed via Postprocessor object.
Specification(s): test
Design: PostprocessorNeumannBC
Issue(s): #5680
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SinNeumannBC
- 1.4.71The system shall include the ability to apply a Neumann boundary condition according to a sin function.
Specification(s): sinneumann_test
Design: SinNeumannBC
Issue(s): 0d86cfce0b83e2efaa0647d8e1f1ca5e755872fc
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SinDirichletBC
- 1.4.72The system shall include the ability to apply a Dirichlet boundary condition according to a sin function.
Specification(s): sindirichlet_test
Design: SinDirichletBC
Issue(s): 0d86cfce0b83e2efaa0647d8e1f1ca5e755872fc
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: CoupledTiedValueConstraint
- 1.5.1The system shall include ability to force the value of a variable to be the same on both sides of an interface using Lagrange multipliers.
Specification(s): test
Design: CoupledTiedValueConstraint
Issue(s): #1476
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: EqualValueBoundaryConstraint
- 1.5.2The system shall include the ability to constrain the values on a boundary to a value at a prescribed node.
Specification(s): test
Design: EqualValueBoundaryConstraint
Issue(s): #617
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.5.3The system shall be able to enforce the equal value boundary constraint in parallel with adaptivity.
Specification(s): adaptivity
Design: EqualValueBoundaryConstraint
Issue(s): #617
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: EqualValueEmbeddedConstraint
- 1.5.4The system shall support embedded constraints between using a kinematic formulation between
- 1D and 2D;
- 1D and 3D;
- 2D;
- 2D and 3D; and
- 3D subdomains.
Specification(s): kinematic/1D_2D, kinematic/1D_3D, kinematic/2D_2D, kinematic/2D_3D, kinematic/3D_3D
Design: EqualValueEmbeddedConstraint
Issue(s): #11722
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.5.5The system shall support embedded constraints between using a penalty formulation between
- 1D and 2D;
- 1D and 3D;
- 2D;
- 2D and 3D; and
- 3D subdomains.
Specification(s): penalty/1D_2D, penalty/1D_3D, penalty/2D_2D, penalty/2D_3D, penalty/3D_3D
Design: EqualValueEmbeddedConstraint
Issue(s): #11722
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Constraints System
- 1.5.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.5.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.33.2We shall be able to enforce periodic boundary conditions on 3d domains using mortar constraints.
Specification(s): 3d_periodic_mortar
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.5We shall be able to enforce solution continuity on a conforming mesh for one variable
Specification(s): conforming
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.6We shall be able to enforce solution gradient continuity on a conforming mesh for one variable
Specification(s): equalgradient
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.7We shall be able to enforce solution continuity on a conforming mesh for two variables
Specification(s): conforming_two_var
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.8We shall be able to enforce solution continuity on a conforming mesh for one variable using second order shape functions for both primal and lagrange variables. Note that this may be a relatively unstable discretization
Specification(s): conforming-2nd-order
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.9We shall be able to produce the expected result for a solution continuity test case using the mortar method, e.g. the primal variable values across the mortar interface shall be the same.
Specification(s): soln-continuity
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.10We shall be able to produce the expected result for a solution continuity test case using the first order dual basis.
Specification(s): dual-soln-continuity
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.11We shall be able to produce the expected result for a solution continuity test case using the second order dual basis.
Specification(s): dual-soln-continuity-2nd-order
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.12We shall be able to produce the expected result for a fine mesh solution continuity test case using the mortar method, e.g. the primal variable values across the mortar interface shall be the same.
Specification(s): soln-continuity-fine
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.13The Jacobian for the solution continuity test case shall be perfect
Specification(s): soln-continuity-jac
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.33.14The system shall be able to prolong and restrict stateful material properties because of mesh adaptivity in the presense of lower dimensional subdomains that do not have materials and when stateful properties are needed on boundaries (because of integrated boundary conditions)
Specification(s): sequencing-stateful-soln-continuity
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.15We shall be able to produce the expected result for a solution continuity test case with the first order dual basis using VCP.
Specification(s): vcp
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.16We shall be able to produce the expected result for a solution continuity test case with the second order dual basis using VCP.
Specification(s): vcp-2nd-order
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.17The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a HEX8 mesh with curved geometry, e.g. the primal variable values across the mortar interface shall be the same.
Specification(s): continuity_sphere_hex8
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.18The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a HEX27 mesh with curved geometry, e.g. the primal variable values across the mortar interface shall be the same.
Specification(s): continuity_sphere_hex27
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.19The system shall generate a debug mortar mesh the parameter debug_mesh is passed to a mortar constraint
Specification(s): continuity_sphere_hex27-debug-mesh
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.20The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a TET4 conforming mesh, e.g. the primal variable values across the mortar interface shall be the same.
Specification(s): continuity_tet4
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.21The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a TET10 conforming mesh, e.g. the primal variable values across the mortar interface shall be the same.
Specification(s): continuity_tet10
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.22The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a TET4 non-conforming mesh, e.g. the primal variable values across the mortar interface shall be the same.
Specification(s): continuity_nonconforming_tet
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.23The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a mesh with mixed element types, e.g. the primal variable values across the mortar interface shall be the same.
Specification(s): continuity_mixed
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.24The system shall be able to produce the expected result for a solution continuity test case using the mortar method on a HEX20 mesh with curved geometry, e.g. the primal variable values across the mortar interface shall be the same.
Specification(s): continuity_sphere_hex20
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.25The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1 for a mortar solution continuity problem with conforming and non-conforming (HEX8) geometric discretization when using a first order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.
Specification(s): p1p0
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.26The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 2 for a mortar solution continuity problem with conforming and non-conforming (HEX8) geometric discretization when using a first order basis for the temperature variable and a first order basis for the Lagrange multiplier.
Specification(s): p1p1
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.27The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1.5 for a mortar solution continuity problem with conforming and non-conforming (HEX8) geometric discretization when using a first order basis for the temperature variable and a first order dual basis for the Lagrange multiplier.
Specification(s): p1p1dual
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.28The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 1 for a mortar solution continuity problem with conforming and non-conforming (HEX27) geometric discretization when using a second order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.
Specification(s): p2p0
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.29The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 2 for a mortar solution continuity problem with conforming and non-conforming (HEX27) geometric discretization when using a second order basis for the temperature variable and a first order basis for the Lagrange multiplier.
Specification(s): p2p1
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.30The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 3 for a mortar solution continuity problem with conforming and non-conforming (HEX27) geometric discretization when using a second order basis for the temperature variable and a second order basis for the Lagrange multiplier.
Specification(s): p2p2
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.31The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 3 for a mortar gap-conductance problem with equal, coarse-secondary, and coarse-primary geometric discretizations when using a second order basis for the temperature variable and a second order basis for the Lagrange multiplier.
Specification(s): p2p2
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.32The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 2 for a mortar gap-conductance problem with equal, coarse-secondary, and coarse-primary geometric discretizations when using a second order basis for the temperature variable and a first order basis for the Lagrange multiplier.
Specification(s): p2p1
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.33The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1 for a mortar gap-conductance problem with equal, coarse-secondary, and coarse-primary geometric discretizations when using a second order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.
Specification(s): p2p0
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.34The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 2 for a mortar gap-conductance problem with equal, coarse-secondary, and coarse-primary geometric discretizations when using a first order basis for the temperature variable and a first order basis for the Lagrange multiplier.
Specification(s): p1p1
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.35The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1 for a mortar gap-conductance problem with equal, coarse-secondary, and coarse-primary geometric discretizations when using a first order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.
Specification(s): p1p0
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.36The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 3 for a mortar solution continuity problem with an equal geometric discretization when using a second order basis for the temperature variable and a second order basis for the Lagrange multiplier.
Specification(s): p2p2
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.37The system shall be able to demonstrate asymptotically correct convergence rates of 3 and 2 for a mortar solution continuity problem with an equal geometric discretization when using a second order basis for the temperature variable and a first order basis for the Lagrange multiplier.
Specification(s): p2p1
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.38The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1 for a mortar solution continuity problem with an equal geometric discretization when using a second order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.
Specification(s): p2p0
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.39The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 2 for a mortar solution continuity problem with an equal geometric discretization when using a first order basis for the temperature variable and a first order basis for the Lagrange multiplier.
Specification(s): p1p1
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.40The system shall be able to demonstrate asymptotically correct convergence rates of 2 and 1 for a mortar solution continuity problem with an equal geometric discretization when using a first order basis for the temperature variable and a zeroth order basis for the Lagrange multiplier.
Specification(s): p1p0
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.33.41We shall be able to couple variables between boundary auxiliary kernels and mortar constraints.
Specification(s): gap-conductance-bnd-aux-kernel
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.42We shall be able to use boundary-restricted material properties in mortar constraints.
Specification(s): gap-conductance-bnd-material
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.43We shall be able to do gap conductance on a dynamic mesh using auxiliary displacements
Specification(s): dynnamic_mortar_gap_conductance
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.44The Jacobian for the dynamic aux displacement gap conductance test case shall be perfect
Specification(s): dynamic_gap_jacobian
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.33.45We shall be able to do gap conductance on a dynamic mesh using auxiliary displacements on a fine mesh
Specification(s): dynamic_gap_conductance_fine
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.46We shall generate the exact expected analytic solution for the gap conductance problem
Specification(s): linear_exact_verification
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.47We shall be able to produce the expected result for a gap conductance test case using the mortar method. Specifically, this test yields lagrange multipliers that are correctly proportional to the delta of temperature across the gap, e.g. the heat flux
Specification(s): real_mortar_gap_conductance
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.48The Jacobian for the gap conductance test case shall be perfect
Specification(s): gap_jacobian
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.33.49We shall be able to produce the expected result for a gap conductance test case using the mortar method on a fine mesh. Specifically, this test yields lagrange multipliers that are correctly proportional to the delta of temperature across the gap, e.g. the heat flux
Specification(s): gap_conductance_fine
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.50The system shall give access to the locations in physical space of mortar segment element quadrature points.
Specification(s): exo
Design: Constraints System
Issue(s): #16177
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.51The system shall compute an exact Jacobian for a simulation involving the physical space location of mortar quadrature points.
Specification(s): jac
Design: Constraints System
Issue(s): #16177
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.33.52We shall be able to enforce periodic boundary conditions on a non-uniform mesh using the mortar method
Specification(s): exo
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.33.53The Jacobian for mortar enforcement of periodic boundary conditions shall be perfect
Specification(s): jac
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: TiedValueConstraint
- 1.5.8The 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.6.1The Control system shall allow a boolean parameter to be controlled with a function.
Specification(s): single
Design: Controls SystemBoolFunctionControl
Issue(s): #15402
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.2The Control system shall be capable of activating or deactivating MOOSE objects using a conditional function.
Specification(s): test
Design: Controls SystemConditionalFunctionEnableControl
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.3The MOOSE control system shall allow parameters from differing objects, with differing names to be associated and changed together.
Specification(s): direct
Design: Controls System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.4The MOOSE control system shall allow parameters from objects to be assigned aliases for the purpose of changing the value.
Specification(s): alias
Design: Controls System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.6The Control system shall support explicitly defined dependencies.
Specification(s): test
Design: Controls System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.7The Control system shall error if an attempt to alter a non-controllable parameter is performed.
Specification(s): non_controllable_error
Design: Controls System
Issue(s): #5676
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.6.8The Control system shall error if multiple controllable parameters exists, but only a single parameter is expected to be controlled.
Specification(s): multiple_params_found_warning
Design: Controls System
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.9The Control system shall error if an unknown parameter is supplied for control.
Specification(s): no_param_found
Design: Controls System
Issue(s): #5676
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.6.10The Control system shall error if a thread id greater than the number of threads available is supplied when retrieving a Control object.
Specification(s): tid_warehouse_error
Design: Controls System
Issue(s): #5676
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.6.11The Control system shall error if an attempt is made to disable the Executioner.
Specification(s): disable_executioner
Design: Controls System
Issue(s): #5676
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.6.12The Control system shall error if an invalid control name is supplied to the Control dependency resolution procedure.
Specification(s): non_existing_dependency
Design: Controls System
Issue(s): #5676
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.6.13The Control system shall support the modification of a single parameter using the objects base class name, object name, and parameter name.
Specification(s): base_object_param
Design: Controls System
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.14The Control system shall support the modification of multiple parameters using the objects base class and the parameter name.
Specification(s): base_param
Design: Controls System
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.15The Control system shall include a means to output information regarding the controlled parameters.
Specification(s): test
Design: Controls SystemControlOutput
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.16The Control system shall include a means to output information regarding the controlled parameters, including only showing information regarding a parameter if it has changed since the last output.
Specification(s): clear
Design: Controls SystemControlOutput
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.17The system shall include a command line flag for displaying controllable parameter information.
Specification(s): cli_args
Design: Controls SystemControlOutput
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.18The Control system shall include a means to output information regarding the objects with controllable parameters.
Specification(s): active
Design: Controls SystemControlOutput
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.19The Control system shall be able to control an input parameter to make a postprocessor match a target value,
- using the principle of Proportional Integral Derivative control,
- using a input postprocessor in lieu of an input parameter,
- with integral windup control, resetting the integral term if the error crosses zero,
- keeping the PID process within a single timestep,
- and resetting the PID process correctly if the solver fails during a Picard/coupling iteration.
Specification(s): pid/basic, pid/basic_postprocessor, pid/windup, pid/picard, pid/resistance_to_solver_fails
Design: Controls SystemPIDTransientControl
Issue(s): #17271
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.20The Control system shall allow a scalar parameter to be controlled with a function.
Specification(s): single
Design: Controls SystemRealFunctionControl
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.21The Control system shall allow multiple scalar parameters to be controlled with a function.
Specification(s): multiple
Design: Controls SystemRealFunctionControl
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.22The MOOSE control system shall be capable of restricting parameters to be controlled for specific execution flags.
Specification(s): error
Design: Controls System
Issue(s): #12576
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.6.23The Control system shall allow multiple parameters to be changed by the parameter name alone using input syntax format.
Specification(s): param
Design: Controls System
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.24The Control system shall allow multiple parameters to be changed given the object and parameter names using input syntax format.
Specification(s): object_param
Design: Controls System
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.25The Control system shall allow for a single parameter to be changes given the input syntax, object name, and parameter name.
Specification(s): system_object_param
Design: Controls System
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.26The Control system shall allow for multiple parameters to be changed given input syntax and a parameter name.
Specification(s): system_asterisk_param
Design: Controls System
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.27The Control system shall allow multiple parameters to be changed by the parameter name alone using a tag.
Specification(s): param
Design: Controls System
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.28The Control system shall allow multiple parameters to be changed given a tag and parameter names, given a tag assigned across input blocks.
Specification(s): object_param
Design: Controls System
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.29The Control system shall allow for a single parameter to be changes given a tag and parameter name, given a tag assigned to a single object.
Specification(s): system_object_param
Design: Controls System
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.30The Control system shall allow for multiple parameters to be changed given a tag and a parameter name, given a tag assigned within a single input block on multiple objects.
Specification(s): system_asterisk_param
Design: Controls System
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.31The Control system shall be capable of activating or deactivating AuxKernel objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.32The Control system shall be capable of activating or deactivating AuxScalarKernel objects with time, given identical start end times.
Specification(s): multi_same_times
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.33The Control system shall be capable of activating or deactivating AuxScalarKernel objects with time, given differing start end times.
Specification(s): multi_different_times
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.34The system shall be capable of activating and/or deactivating boundary contributions to the residual with time
- for contributions from finite element nodes,
- for contributions integrated over a finite element side,
- for contributions from automatic differentiation, and
- 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.6.35The Control system shall be capable of activating or deactivating Constraint objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.36The system shall support disabling an object using an input parameter.
Specification(s): enable_false
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.37The system shall support enabling an object using an input parameter.
Specification(s): enable_true
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.38The system shall be capable of activating or deactivating Damper objects with time via the Control system.
Specification(s): control
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.39The Control system shall be capable of activating or deactivating DGKernel objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.40The Control system shall be capable of activating or deactivating DiracKernel objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.46The system shall be capable of activating or deactivating volume residual contributions with time:
- for non-automatic differentiation and
- automatic differentiation terms.
Specification(s): test/non_ad, test/ad
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.48The Control system shall be capable of activating or deactivating MultiApp objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.49The Control system shall be capable of activating or deactivating NodalKernel objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.50The Control system shall be capable of activating or deactivating ScalarKernel objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.51The Control system shall be capable of activating or deactivating Transfer objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.52The Control system shall be capable of activating or deactivating UserObject objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: BoolFunctionControl
- 1.6.1The Control system shall allow a boolean parameter to be controlled with a function.
Specification(s): single
Design: Controls SystemBoolFunctionControl
Issue(s): #15402
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ConditionalFunctionEnableControl
- 1.6.2The Control system shall be capable of activating or deactivating MOOSE objects using a conditional function.
Specification(s): test
Design: Controls SystemConditionalFunctionEnableControl
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: PiecewiseLinear
- 1.6.5The system shall allow controlling piecewise functions and material properties.
Specification(s): controlled_piecewise
Design: PiecewiseLinearPiecewiseLinearInterpolationMaterial
Issue(s): #15321
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.5The Function system shall include the ability to read comma or space separated data and perform linear interpolation using the supplied data.
Specification(s): test
Design: Functions SystemPiecewiseLinear
Issue(s): cf61044773b14d5560e583867462fe9831dd1f3e
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.11The system shall allow for piecewise functions to directly set the x and y data internally.
Specification(s): hardcoded_piecewise_linear
Design: PiecewiseLinear
Issue(s): #14220
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.14.48The Function system shall include an object that creates a function based on x- and y-data pairs and does not extrapolate.
Specification(s): no_extrap
Design: PiecewiseLinear
Issue(s): #20024
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.14.49The Function system shall include an object that creates a function based on x- and y-data pairs and does extrapolate.
Specification(s): extrap
Design: PiecewiseLinear
Issue(s): #20024
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: PiecewiseLinearInterpolationMaterial
- 1.6.5The system shall allow controlling piecewise functions and material properties.
Specification(s): controlled_piecewise
Design: PiecewiseLinearPiecewiseLinearInterpolationMaterial
Issue(s): #15321
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.102The system shall support the calculation of a material property with a
- linear interpolation of a variable,
- with a scaling factor, and
- extrapolation.
Specification(s): linear/interpolation, linear/scale_factor, linear/extrapolation
Design: PiecewiseLinearInterpolationMaterial
Issue(s): #13224
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.103The system shall support the calculation of a material property with a linear interpolation and error if
- x, y, and xy_data are all specified;
- x and xy_data are both specified;
- the x and y vectors are different lengths; and
- the xy_data vector length is not a multiple of two.
Specification(s): errors/err1, errors/err2, errors/err3, errors/err4
Design: PiecewiseLinearInterpolationMaterial
Issue(s): #13224
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ControlOutput
- 1.6.15The Control system shall include a means to output information regarding the controlled parameters.
Specification(s): test
Design: Controls SystemControlOutput
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.16The Control system shall include a means to output information regarding the controlled parameters, including only showing information regarding a parameter if it has changed since the last output.
Specification(s): clear
Design: Controls SystemControlOutput
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.17The system shall include a command line flag for displaying controllable parameter information.
Specification(s): cli_args
Design: Controls SystemControlOutput
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.18The Control system shall include a means to output information regarding the objects with controllable parameters.
Specification(s): active
Design: Controls SystemControlOutput
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: PIDTransientControl
- 1.6.19The Control system shall be able to control an input parameter to make a postprocessor match a target value,
- using the principle of Proportional Integral Derivative control,
- using a input postprocessor in lieu of an input parameter,
- with integral windup control, resetting the integral term if the error crosses zero,
- keeping the PID process within a single timestep,
- and resetting the PID process correctly if the solver fails during a Picard/coupling iteration.
Specification(s): pid/basic, pid/basic_postprocessor, pid/windup, pid/picard, pid/resistance_to_solver_fails
Design: Controls SystemPIDTransientControl
Issue(s): #17271
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: RealFunctionControl
- 1.6.20The Control system shall allow a scalar parameter to be controlled with a function.
Specification(s): single
Design: Controls SystemRealFunctionControl
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.21The Control system shall allow multiple scalar parameters to be controlled with a function.
Specification(s): multiple
Design: Controls SystemRealFunctionControl
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: TimePeriod
- 1.6.31The Control system shall be capable of activating or deactivating AuxKernel objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.32The Control system shall be capable of activating or deactivating AuxScalarKernel objects with time, given identical start end times.
Specification(s): multi_same_times
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.33The Control system shall be capable of activating or deactivating AuxScalarKernel objects with time, given differing start end times.
Specification(s): multi_different_times
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.34The system shall be capable of activating and/or deactivating boundary contributions to the residual with time
- for contributions from finite element nodes,
- for contributions integrated over a finite element side,
- for contributions from automatic differentiation, and
- 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.6.35The Control system shall be capable of activating or deactivating Constraint objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.36The system shall support disabling an object using an input parameter.
Specification(s): enable_false
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.37The system shall support enabling an object using an input parameter.
Specification(s): enable_true
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.6.38The system shall be capable of activating or deactivating Damper objects with time via the Control system.
Specification(s): control
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.39The Control system shall be capable of activating or deactivating DGKernel objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.40The Control system shall be capable of activating or deactivating DiracKernel objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.41The TimePeriod object shall error when used with a steady state problem.
Specification(s): steady_error
Design: TimePeriod
Issue(s): #5676
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.6.42The TimePeriod object shall error when the start and end time parameters are not the same length.
Specification(s): start_end_size_mismatch
Design: TimePeriod
Issue(s): #5676
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.6.43The TimePeriod object shall error when start and end time parameters differ in length than the supplied object list.
Specification(s): time_disable_size_mismatch
Design: TimePeriod
Issue(s): #5676
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.6.44The TimePeriod object shall error when a list of objects to control is omitted.
Specification(s): enable_disable_not_set
Design: TimePeriod
Issue(s): #5676
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.6.45The TimePeriod object shall error when start time is greater than the end time.
Specification(s): start_greater_than_end_error
Design: TimePeriod
Issue(s): #5676
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.6.46The system shall be capable of activating or deactivating volume residual contributions with time:
- for non-automatic differentiation and
- automatic differentiation terms.
Specification(s): test/non_ad, test/ad
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.47The system shall be capable of activating or deactivating materials in the input file depending on time.
Specification(s): test
Design: TimePeriod
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.48The Control system shall be capable of activating or deactivating MultiApp objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.49The Control system shall be capable of activating or deactivating NodalKernel objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.50The Control system shall be capable of activating or deactivating ScalarKernel objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.6.51The Control system shall be capable of activating or deactivating Transfer objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.6.52The Control system shall be capable of activating or deactivating UserObject objects with time.
Specification(s): test
Design: Controls SystemTimePeriod
Issue(s): #5676
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.11.35The 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: Problem system overview
- 1.7.1The system shall support cylindrical coordinates with the radial direction in the 'x' direction.
Specification(s): rz-y-rotation
Design: Problem system overview
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.7.2The system shall support cylindrical coordinates with the radial direction in the 'y' direction.
Specification(s): rz-x-rotation
Design: Problem system overview
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.7.3The system shall support cylindrical coordinates with the radial direction in the 'x' direction with discontinous Galkerin and integrated boundary conditions.
Specification(s): rz-integrated-y-rotation
Design: Problem system overview
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.7.4The system shall support cylindrical coordinates with the radial direction in the 'y' direction with discontinous Galkerin and integrated boundary conditions.
Specification(s): rz-integrated-x-rotation
Design: Problem system overview
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.7The system shall report an error when a material property is not defined on a boundary.
Specification(s): bc_check
Design: Problem system overview
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.8The system shall report an error when a material property requested by a UserObject is not defined on a boundary.
Specification(s): side_uo_check
Design: Problem system overview
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.9The system shall report an error when a material property requested by a DGKernel is not defined on a boundary.
Specification(s): dgkernel_check_boundary
Design: Problem system overview
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.10The system shall report an error when a material property requested by a DGKernel is not defined on a subdomain.
Specification(s): dgkernel_check_block
Design: Problem system overview
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.11The system shall verify that objects that use subdomain restricted variables are defined on a subset of the restricted domain area.
Specification(s): variable_interface_run
Design: Problem system overview
Issue(s): #9889
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.12The system shall produce an error when an object's discretization area is explicitly set to a value greater than the area of the underlying variable used by the object.
Specification(s): variable_interface_error_block_set
Design: Problem system overview
Issue(s): #9889
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.13The system shall produce an error when an object's discretization area is greater than the area of the underlying variable used by the object.
Specification(s): variable_interface_error_block_any
Design: Problem system overview
Issue(s): #9889
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.14The system shall produce an error when an object's discretization area is explicitly set to a different area than the area of a coupled variable used by the object.
Specification(s): coupleable_error_block_set
Design: Problem system overview
Issue(s): #9889
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.15The system shall produce an error when an object's discretization area is different than an explicitly set variable on only defined on a different portion of the mesh.
Specification(s): coupleable_error_block_set2
Design: Problem system overview
Issue(s): #9889
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.16The system shall produce an error when an object's discretization area is covers the whole mesh but a coupled variable only exists on a portion of the mesh.
Specification(s): coupleable_error_block_any
Design: Problem system overview
Issue(s): #9889
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.18The system shall report an error message when a range-checked parameter is out of range.
Specification(s): range_check_param
Design: Problem system overview
Issue(s): #2777
Collection(s): FAILURE_ANALYSIS
Type(s): RunException
- 1.32.19The system shall report an error when a null pointer-checked parameter is retrieved from the InputParameters object.
Specification(s): checked_pointer_param_test
Design: Problem system overview
Issue(s): #10356
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.20The system shall report an error when multiple AuxVariables are added to the system with conflicting types.
Specification(s): add_aux_variable_multiple_test
Design: Problem system overview
Issue(s): #1222
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.21The system shall report an error when multiple Scalar AuxVariables are added to the system with conflicting types.
Specification(s): add_aux_scalar_variable_multiple_test
Design: Problem system overview
Issue(s): #9313
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.22The system shall report an error when an attempt is made to instantiate a non-existent BoundaryCondition object.
Specification(s): bad_bc_test
Design: Problem system overview
Issue(s): #10486
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.23The system shall report an error when a non-existent nonlinear variable name is used by a MooseObject.
Specification(s): bad_bc_var_test
Design: Problem system overview
Issue(s): #11227
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.24The system shall report an error message when an invalid enumeration is supplied in any MooseEnum type.
Specification(s): bad_enum_test
Design: Problem system overview
Issue(s): #489
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.25The system shall report an error message when an invalid Executioner is specified.
Specification(s): bad_executioner_test
Design: Problem system overview
Issue(s): #12106
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.26The system shall report an error message when an invalid Kernel is specified.
Specification(s): bad_kernel_test
Design: Problem system overview
Issue(s): #12106
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.27The system shall report an error message when a Kernel object attempts to access a non-existent variable.
Specification(s): bad_kernel_var_test
Design: Problem system overview
Issue(s): #11227
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.28The system shall report an error when an invalid Material is specified.
Specification(s): bad_material_test
Design: Problem system overview
Issue(s): #12106
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.29The system shall report an error when a previously undeclared variable is used in a parsed function expression.
Specification(s): bad_parsed_function_vars_test
Design: Problem system overview
Issue(s): #4683
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.30The system shall report an error when a first order element is used with a second order discretization.
Specification(s): bad_second_order_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.31The system shall report an error message when a deprecated input file block is used.
Specification(s): deprecated_block_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.32The system shall report a warning when a deprecated parameter with a default value is explicitly set by the user.
Specification(s): deprecated_param_default
Design: Problem system overview
Issue(s): #1951
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.33The system shall report a warning when an optional deprecated parameter is explicitly set by the user.
Specification(s): deprecated_param_no_default
Design: Problem system overview
Issue(s): #1951
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.34The system shall report an error when conflicting domain restrictions are applied to a single object.
Specification(s): double_restrict_uo_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.35The system shall report an error when the number of ids and corresponding block names are mismatched.
Specification(s): dynamic_check_name_block_mismatch_test
Design: Problem system overview
Issue(s): #8596
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.36The system shall report an error when a duplicate name is provided for a set of unique block ids.
Specification(s): dynamic_check_name_block_test
Design: Problem system overview
Issue(s): #8596
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.37The system shall report an error when the number of ids and corresponding boundary names are mismatched.
Specification(s): dynamic_check_name_boundary_mismatch_test
Design: Problem system overview
Issue(s): #8596
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.38The system shall report an error when a duplicate name is provided for a set of unique boundary ids.
Specification(s): dynamic_check_name_boundary_test
Design: Problem system overview
Issue(s): #8596
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.39The system shall report an error when the linear interpolation utility is supplied with bad domain values.
Specification(s): linear_interp_material_check
Design: Problem system overview
Issue(s): #5886
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.40The system shall report an error when the Piecewise utility encounters an unexpected column data format.
Specification(s): function_file_test1
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.41The system shall report an error when the Piecewise utility encounters an unexpected row data format.
Specification(s): function_file_test2
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.42The system shall report an error when the Piecewise utility encounters inconsistent domain and range data.
Specification(s): function_file_test3
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.43The system shall report an error when an invalid enumeration is supplied in the Piecewise utility.
Specification(s): function_file_test4
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.44The system shall report an error when the Piecewise data is over-specified with the data file option.
Specification(s): function_file_test5
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.45The system shall report an error when the Piecewise data is over-specified with row/column data.
Specification(s): function_file_test6
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.46The system shall report an error when either the domain or range is missing when using the domain/range option in the Piecewise utility.
Specification(s): function_file_test7
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.47The system shall report and error if the supplied domain/range pairs are not even in the Piecewise utility.
Specification(s): function_file_test8
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.48The system shall report an error if no function is supplied in the Piecewise utility.
Specification(s): function_file_test9
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.49The system shall report an error if the xy_data is supplied but the function is missing in the Piecewise utility.
Specification(s): function_file_test10
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.50The system shall report an error when the number of columns appears incorrect in the Piecewise utility.
Specification(s): function_file_test11
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.51The system shall report an error when an out of range y-column index is supplied in the Piecewise utility.
Specification(s): function_file_test12
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.52The system shall report an error when an out of range x-column index is supplied in the Piecewise utility.
Specification(s): function_file_test13
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.53The system shall report an error if too many rows are supplied when the data is expected to contain row information.
Specification(s): function_file_test14
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.54The system shall report an error when an out of range x-row index is supplied in the Piecewise utility.
Specification(s): function_file_test15
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.55The system shall report an error when an out of range y-row index is supplied in the Piecewise utility.
Specification(s): function_file_test16
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.56The system shall report an error when the x and y index in file are equal in the Piecewise utility.
Specification(s): function_file_test17
Design: Problem system overview
Issue(s): #2421
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.57The system shall report an error if one or more domain blocks do not have any active Kernels objects assigned.
Specification(s): incomplete_kernel_block_coverage_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.58The system shall report an error if one or more variables do not have any active Kernel objects assigned.
Specification(s): incomplete_kernel_variable_coverage_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.59The system shall report an error if one or more domain blocks do not have any active FVKernels objects assigned.
Specification(s): incomplete_fvkernel_block_coverage_test
Design: Problem system overview
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.60The system shall report an error if one or more variables do not have any active FVKernel objects assigned.
Specification(s): incomplete_fvkernel_variable_coverage_test
Design: Problem system overview
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.61The system shall report an error when an elemental variable (no continuity) is coupled to a variable with continuity.
Specification(s): invalid_elemental_to_nodal_couple_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.62The system shall report an error when an active input block section is specified but missing.
Specification(s): missing_active_section_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.63The system shall report an error when a material property is requested but not supplied on a mesh block.
Specification(s): missing_coupled_mat_prop_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.64The system shall report an error when a coupled variable is supplied that was not added as a valid parameter.
Specification(s): coupled_grad_without_declare
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.65The system shall report an error when the data file is non-existent or not-readable in the Piecewise utility.
Specification(s): missing_function_file_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.66The system shall report an error when the coupled function does not exist or can not be parsedfor the Piecewise utility.
Specification(s): missing_function_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.67The system shall report an error when one or more material properties are missing from any mesh block.
Specification(s): missing_material_prop_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.68The system shall report an error when a material property is supplied on some blocks but missing on other blocks where it is requested.
Specification(s): missing_material_prop_test2
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.69The system shall report an error when only "old" properties are supplied but current properties are requested.
Specification(s): bad_stateful_material_only_old
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.70The system shall report an error when only "older" properties are supplied but current properties are requested.
Specification(s): bad_stateful_material_only_older
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.71The system shall report an error when the mesh file cannot be found.
Specification(s): missing_mesh_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.72The system shall report an error when a required parameter is not supplied in an Action.
Specification(s): missing_req_par_action_obj_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.73The system shall report an error when a specific mesh required parameter is not supplied.
Specification(s): missing_req_par_mesh_block_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.74The system shall report an error when the special "type" parameter is not supplied for a MooseObject.
Specification(s): missing_req_par_moose_obj_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.75The system shall report an error when a required parameter is not supplied in a MooseObject.
Specification(s): missing_var_in_kernel_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.76The system shall report an error when a required coupling parameter is missing.
Specification(s): missing_required_coupled_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.77The system shall report an error when more than one preconditioner block is supplied.
Specification(s): multi_precond_test
Design: Problem system overview
Issue(s): #1904
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.78The system shall abort the solve and report a floating point error when a NaN is produced during user computation with the Steady executioner.
Specification(s): nan_no_trap_fpe_test
Design: Problem system overview
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.79The system shall abort the solve and report a floating point error when a NaN is produced during user computation with the Transient executioner.
Specification(s): nan_no_trap_fpe_test_trans
Design: Problem system overview
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.80The system shall report an error when a nodal AuxKernel attempts to access a material property.
Specification(s): nodal_material_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.81The system shall report an error when the same named parameter appears multiple times in the same input file.
Specification(s): override_name_variable_test
Design: Problem system overview
Issue(s): #9617
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.82The system shall report an error when the coordinate transformation conflicts with the underlying element types.
Specification(s): rz_3d_error_check_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.83The system shall report an error when nonlinear and auxiliary variables are declared with the same name.
Specification(s): same_name_variable_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.84The system shall report an error when an AuxKernel is applied outside of the domain where a restricted variable exists.
Specification(s): subdomain_restricted_auxkernel_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.85The system shall report an error when a Kernel is applied outside of the domain where a restricted variable exists.
Specification(s): subdomain_restricted_kernel_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.86The system shall report a warning when an unused parameter is provided through the input file or an Action.
Specification(s): unused_param_test
Design: Problem system overview
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.87The system shall report a warning when an unused parameter is supplied on the command line.
Specification(s): unused_param_test_cli
Design: Problem system overview
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.88The system shall report an error when a UserObject and a Postprocessor are added with the same names.
Specification(s): uo_pps_name_collision_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.89The system shall report and error when a UserObject and a VectorPostprocessor are added with the same names.
Specification(s): uo_vector_pps_name_collision_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.90The system shall report an error when an input file block associated with on pluggable system is asked to build an object from a different system.
Specification(s): wrong_object_test
Design: Problem system overview
Issue(s): #1405
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.91The system shall report a standard Unix usage statement when an invalid command line switch is used.
Specification(s): wrong_input_switch
Design: Problem system overview
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.92The system shall report an error when a required variable is missing from the ICs input file block.
Specification(s): ics_missing_variable
Design: Problem system overview
Issue(s): #534
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.93The system shall report an error when a boundary restriction is applied to a non-nodal variable discretization.
Specification(s): ic_bnd_for_non_nodal
Design: Problem system overview
Issue(s): #534
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.94The system shall report an error when coupling to old temporal solution vectors in a Steady (no time) Executioner.
Specification(s): old_integrity_check
Design: Problem system overview
Issue(s): #380
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.95The system shall report an error when coupling to a time derivative solution vector in a Steady (no time) Executioner.
Specification(s): dot_integrity_check
Design: Problem system overview
Issue(s): #10810
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.96The system shall report an error when an older scalar solution variable is accessed in a Steady (no time) Executioner.
Specification(s): scalar_old_integrity_check
Design: Problem system overview
Issue(s): #10810
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.97The system shall report an error when an older time derivative scalar solution variable is accessed in a Steady (no time) Executioner.
Specification(s): scalar_dot_integrity_check
Design: Problem system overview
Issue(s): #10810
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.98The system shall report an error when a coupled variable is not defined in the same region as the variable performing the coupling.
Specification(s): node_value_off_block
Design: Problem system overview
Issue(s): #2849
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.99The system shall report the successful parsing and interpretation of input file syntax when using the "–check-input" command line flag.
Specification(s): check_syntax_ok
Design: Problem system overview
Issue(s): #4437
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.100The system shall report an error when performing nodal constraints when there is a mismatch in the number of constrained nodes.
Specification(s): check_syntax_error
Design: Problem system overview
Issue(s): #4437
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.101The system shall report an error when requested to check the syntax in an input file but no input file is supplied.
Specification(s): check_syntax_no_input
Design: Problem system overview
Issue(s): #4437
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.102The system shall report an error when multiple time schemes are specified in the same input file.
Specification(s): multiple_time_int_check
Design: Problem system overview
Issue(s): #5463
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.103The system shall report an error when there is a mismatch between the parameter for an object and the type of object are mismatched.
Specification(s): calling_wrong_feproblem_method
Design: Problem system overview
Issue(s): #6383
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.104The system shall report an error when the variables representing displacement are of a lower order than the mesh.
Specification(s): wrong_displacement_order
Design: Problem system overview
Issue(s): #6561
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.105The system shall report an error when the name of a function could be misinterpreted because it could also be evaluated (e.g. a function name of "x").
Specification(s): function_conflict
Design: Problem system overview
Issue(s): #8412
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.106The system shall report an error when floating point input parameter types fail to parse as floating point numbers.
Specification(s): bad_number
Design: Problem system overview
Issue(s): #10310
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.107The system shall report an error when a scalar variable is used where a spatial variable is expected.
Specification(s): coupling_field_into_scalar
Design: Problem system overview
Issue(s): #10398
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.108The system shall report an error when a field variable is used where a scalar variable is expected.
Specification(s): coupling_scalar_into_field
Design: Problem system overview
Issue(s): #10398
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.109The system shall report an error when an invalid coupled spatial variable is requested.
Specification(s): coupling_nonexistent_field
Design: Problem system overview
Issue(s): #10398
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.110The system shall report an error when an invalid coupled scalar variable is requested.
Specification(s): coupling_nonexistent_scalar
Design: Problem system overview
Issue(s): #10398
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.111The system shall report an error when an attempt is made to couple a variable with itself.
Specification(s): coupling_itself
Design: Problem system overview
Issue(s): #10398
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.112The system shall report an error when an attempt is made to couple a variable with itself in coupled force term using automated differentiation.
Specification(s): coupling_itself_ad
Design: Problem system overview
Issue(s): #18214
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.113The system shall report an error when an input file cannot be opened and read.
Specification(s): missing_input
Design: Problem system overview
Issue(s): #10909
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.114The system shall report an error when a Kernel attempts to use an auxiliary variable.
Specification(s): kernel_with_aux_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.115The system shall report an error when a boundary condition object attempts to use an auxiliary variable.
Specification(s): bc_with_aux_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.116The system shall report an error when an AuxKernel specifies a non-existent variable.
Specification(s): aux_kernel_with_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.117The system shall report an error when a scalar Kernel specifies a non-existent variable.
Specification(s): scalar_kernel_with_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.118The system shall report an error when a nodal Kernel attempts to use an auxiliary variable.
Specification(s): nodal_kernel_with_aux_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.119The system shall report an error when a constraint attempts to use an auxiliary variable.
Specification(s): constraint_with_aux_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.120The system shall report an error when a scalar auxiliary Kernel attempts to use a solution variable.
Specification(s): scalar_aux_kernel_with_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.121The system shall report an error when a DiracKernel attempts to use an auxiliary variable.
Specification(s): dirac_kernel_with_aux_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.122The system shall report an error when a discontinuous Galerkin Kernel attempts to use a solution variable.
Specification(s): dg_kernel_with_aux_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.123The system shall report an error when an interface Kernel attempts to use an auxiliary variable.
Specification(s): interface_kernel_with_aux_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.124The system shall report an error when a Kernel attempts to retrieve an empty string variable.
Specification(s): kernel_with_empty_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.125The system shall report an error when a vector Kernel attempts to use a scalar solution variable.
Specification(s): vector_kernel_with_standard_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.126The system shall report an error when a Kernel attempts to use a vector solution variable.
Specification(s): kernel_with_vector_var
Design: Problem system overview
Issue(s): #11039
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.44.1The system shall allow the creation of a custom problem through a user-defined Action.
Specification(s): no_problem_block
Design: Problem system overview
Issue(s): #12002
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.44.2The system shall support the creation of a custom problem with parameters in Problem block.
Specification(s): with_problem_block_without_type
Design: Problem system overview
Issue(s): #12002
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.44.3The system shall error out when Problem block type is not specified.
Specification(s): with_problem_block_with_wrong_type
Design: Problem system overview
Issue(s): #12002
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.44.4The system shall support the creation of a custom problem through Problem block with type specified.
Specification(s): with_problem_block_with_type
Design: Problem system overview
Issue(s): #12002
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.44.5The system shall support the ability to extend the basic "Problem" interface.
Specification(s): test
Design: Problem system overview
Issue(s): #12060
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.44.49The system shall support different coordinate systems on different subdomains within the mesh.
Specification(s): test
Design: Problem system overview
Issue(s): #1216
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.44.50The system shall support the ability to disable the check for PDE operators in all or some parts of the domain.
Specification(s): test
Design: Problem system overview
Issue(s): #2291
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.44.51The system shall support the ability to disable the check for active materials in all parts of the domain.
Specification(s): test
Design: Problem system overview
Issue(s): #5306
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.44.52The system shall support the ability to disable the check for the existence of all dependent properties within a domain.
Specification(s): test
Design: Problem system overview
Issue(s): #5306
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.44.53The system shall have the ability to disable the actual nonlinear system solve in a simulation.
Specification(s): test
Design: Problem system overview
Issue(s): #1978
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: BoundingValueElementDamper
- 1.8.1The system shall include the ability to reduce the change in nonlinear residual based on a maximum value on elements.
Specification(s): bounding_value_max
Design: BoundingValueElementDamper
Issue(s): #7856
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.8.2The system shall include the ability to reduce the change in nonlinear residual based on a minimum value on elements.
Specification(s): bounding_value_min
Design: BoundingValueElementDamper
Issue(s): #7856
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.8.6The Damper system shall use the minimum of NodalDamper and ElementDamper, when the later computes the minimum.
Specification(s): interacting_node_elem1
Design: BoundingValueElementDamper
Issue(s): #7856
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.8.7The Damper system shall use the minimum of NodalDamper and ElementDamper, when the former computes the minimum.
Specification(s): interacting_node_elem2
Design: BoundingValueElementDamper
Issue(s): #7856
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.8.12The BoundingValueElementDamper object shall report if the minimum value is greater than the maximum value.
Specification(s): min_elem_damping
Design: BoundingValueElementDamper
Issue(s): #7856
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: BoundingValueNodalDamper
- 1.8.3The system shall include the ability to reduce the change in nonlinear residual based on a maximum value on nodes.
Specification(s): bounding_value_max
Design: BoundingValueNodalDamper
Issue(s): #7856
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.8.4The system shall include the ability to reduce the change in nonlinear residual based on a minimum value on nodes.
Specification(s): bounding_value_min
Design: BoundingValueNodalDamper
Issue(s): #7856
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.8.11The BoundingValueNodalDamper object shall report if the minimum value is greater than the maximum value.
Specification(s): min_nodal_damping
Design: BoundingValueNodalDamper
Issue(s): #7856
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: ConstantDamper
- 1.8.5The system shall include the ability to reduce the change in nonlinear residual based on a constant value.
Specification(s): testdamper
Design: ConstantDamper
Issue(s): a36e89da9e8028ea068c330f516c7cc805d4cdeb
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MaxIncrement
- 1.8.8The Damper system shall be capable of reducing the change in non linear residual based on an allowable increment on elements using an absolute increment.
Specification(s): testverifydamping
Design: MaxIncrement
Issue(s): 5509fd360a4ca128a642b1c6603fa3f5205c05d8
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.8.9The Damper system shall be capable of reducing the change in non linear residual based on an allowable increment on elements using an fractional increment.
Specification(s): testverifydamping_percentage
Design: MaxIncrement
Issue(s): 5509fd360a4ca128a642b1c6603fa3f5205c05d8
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.8.10The system shall give an informative error if user code requests a variable from the warehouse with a bad key.
Specification(s): bad_key
Design: MaxIncrement
Issue(s): 5509fd360a4ca128a642b1c6603fa3f5205c05d8
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: Dampers System
- 1.8.13The Damper system shall error if the damping value is below a minimum.
Specification(s): min_general_damping
Design: Dampers System
Issue(s): #7856
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ConservativeAdvection
- 1.9.1The system shall support solving 1D advection using the discontinous Galerkin method.
Specification(s): test
Design: ConservativeAdvectionDGConvection
Issue(s): #869
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.53The system shall include the ability to compute the residual contribution from the conservative form of the advection operator
- without upwinding in 3D,
- with upwinding in 3D,
- without upwinding in 1D,
- with upwinding in 1D,
- without upwinding in 2D,
- with upwinding in 2D,
- with upwinding and an outflow boundary condition, and
- without any outflow boundary conditions.
Specification(s): upwinding/no_upwinding_jacobian, upwinding/full_upwinding_jacobian, upwinding/no_upwinding_1D, upwinding/full_upwinding_1D, upwinding/no_upwinding_2D, upwinding/full_upwinding_2D, upwinding/none_in_all_out, upwinding/none_in_none_out
Design: ConservativeAdvection
Issue(s): #11852
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterCSVDiffExodiff
- framework: DGConvection
- 1.9.1The system shall support solving 1D advection using the discontinous Galerkin method.
Specification(s): test
Design: ConservativeAdvectionDGConvection
Issue(s): #869
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: DGFunctionDiffusionDirichletBC
- 1.9.2The system shall support solving 2D diffusion using the discontinuous Galerkin method.
Specification(s): test
Design: DGFunctionDiffusionDirichletBCDGDiffusion
Issue(s): #869
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.11The system shall support solving 3D diffusion using the discontinuous Galerkin method.
Specification(s): test
Design: DGFunctionDiffusionDirichletBCDGDiffusion
Issue(s): #869
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: DGDiffusion
- 1.9.2The system shall support solving 2D diffusion using the discontinuous Galerkin method.
Specification(s): test
Design: DGFunctionDiffusionDirichletBCDGDiffusion
Issue(s): #869
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.11The system shall support solving 3D diffusion using the discontinuous Galerkin method.
Specification(s): test
Design: DGFunctionDiffusionDirichletBCDGDiffusion
Issue(s): #869
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: DGKernels System
- 1.9.3DGKernels shall coexist with stateful material properties
Specification(s): stateful_props
Design: DGKernels System
Issue(s): #11766
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.9.14Adaptivity shall work with dg kernels as long as stateful properties are not used.
Specification(s): dg_adaptivity
Design: DGKernels System
Issue(s): #10977
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.15The system shall error if the triad of dg kernels, adaptivity, and stateful properties are used together.
Specification(s): error_stateful_dg_adaptivity
Design: DGKernels System
Issue(s): #10977
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.9.16The system shall be able to solve the advection diffusion equation using the discontinuous Galerkin method.
Specification(s): resid
Design: DGKernels System
Issue(s): #8408
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.17The system shall compute the correct Jacobian for the advection diffusion equation using the discontinuous Galerkin method.
Specification(s): jac
Design: DGKernels System
Issue(s): #8408
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.9.18The DGKernel system shall support restriction to subdomains, in 1D.
Specification(s): 1D_test
Design: DGKernels System
Issue(s): #6042
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.19The DGKernel system shall support restriction to subdomains, in 2D.
Specification(s): 2D_test
Design: DGKernels System
Issue(s): #6042
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.20The DGKernel system shall operate with displaced meshes.
Specification(s): test
Design: DGKernels System
Issue(s): #3536
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.9.21The DGCoupledDiffusion object shall compute the correct Jacobian.
Specification(s): jacobian_test
Design: DGKernels System
Issue(s): #629
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 1.24.66The system shall support hybrid finite element method (HFEM) calculations with Dirichlet boundary conditions using standard variables.
Specification(s): dirichlet
Design: DGKernels System
Issue(s): #17447
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.67The system shall support hybrid finite element method (HFEM) calculations with Dirichlet boundary conditions using array variables.
Specification(s): array_dirichlet
Design: DGKernels System
Issue(s): #17447
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.68The system shall support hybrid finite element method (HFEM) calculations with preconditioner only using the block diagonal Jacobian.
Specification(s): array_dirichlet_pjfnk
Design: DGKernels System
Issue(s): #20029
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.69The system shall support hybrid finite element method (HFEM) calculations with coupling of components of array variables on internal sides.
Specification(s): array_dirichlet_transform
Design: DGKernels System
Issue(s): #20029
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.70The system shall support hybrid finite element method (HFEM) calculations with coupling of components of array variables on boundary sides.
Specification(s): array_dirichlet_transform_bc
Design: DGKernels System
Issue(s): #20029
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.71The system shall support hybrid finite element method (HFEM) calculations with Neumann boundary conditions using standard variables.
Specification(s): neumann
Design: DGKernels System
Issue(s): #17447
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.72The system shall support hybrid finite element method (HFEM) calculations with Neumann boundary conditions using array variables.
Specification(s): array_neumann
Design: DGKernels System
Issue(s): #17447
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.73The system shall support hybrid finite element method (HFEM) calculations with Robin boundary conditions using standard variables.
Specification(s): robin
Design: DGKernels System
Issue(s): #17447
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.74The system shall support hybrid finite element method (HFEM) calculations with Robin boundary conditions using array variables.
Specification(s): array_robin
Design: DGKernels System
Issue(s): #17447
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.75The system shall support hybrid finite element method (HFEM) calculations with high order shape functions.
Specification(s): high_order
Design: DGKernels System
Issue(s): #17447
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.76The system shall support hybrid finite element method (HFEM) calculations with Robin boundary conditions through Lagrange multipliers.
Specification(s): variable_robin
Design: DGKernels System
Issue(s): #17447
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.77The system shall support hybrid finite element method (HFEM) calculations with displaced meshes.
Specification(s): robin_displaced
Design: DGKernels System
Issue(s): #17447
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.78The system shall issue an error for unsupported mesh adaptation with hybrid finite element method (HFEM) calculations.
Specification(s): robin_adpatation
Design: DGKernels System
Issue(s): #17447
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.24.79The system shall support hybrid finite element method (HFEM) calculations with Dirichlet boundary conditions with boundary values specified by variables.
Specification(s): variable_dirichlet
Design: DGKernels System
Issue(s): #17447
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.80The system shall issue an error for not fully supported distributed mesh with hybrid finite element method (HFEM) calculations.
Specification(s): robin_distributed_mesh
Design: DGKernels System
Issue(s): #17447
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.24.81The system shall be able to compute lower dimensional element volumes using element Jacobian information computed earlier during finite element object reinitialization and when the highest dimension of the mesh is
- two
- 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: FEProblemSolve.md
- 1.9.4The system shall not perform memory allocation automatic scaling when computing values using discontinuous finite element methods.
Specification(s): no_mallocs_during_scaling
Design: FEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.11.22The system shall consider a nonlinear solve diverged if the nonlinear residual exceeds the absolute divergence tolerance while iterating
Specification(s): test_abs_divtol
Design: FEProblemSolve.md
Issue(s): #16474
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.11.23The system shall perform n non linear iterations before checking for non linear divergence
Specification(s): nl_forced_its
Design: FEProblemSolve.md
Issue(s): #16474
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.11.24The system shall force the prescribed number of non linear iterations even if convergence tolerance is already satisfied.
Specification(s): 2d_diffusion_test
Design: FEProblemSolve.md
Issue(s): #16474
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.11.25The system shall perform many non linear iterations before checking for non linear divergence
Specification(s): many_nl_forced_its
Design: FEProblemSolve.md
Issue(s): #19591
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.11.26The system shall perform many non linear iterations before checking for non linear divergence using reference residual
Specification(s): many_nl_forced_its_ref_res
Design: FEProblemSolve.md
Issue(s): #19591
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.11.27The system shall consider a nonlinear solve diverged if the nonlinear residual oscillates by a user-controlled number of times.
Specification(s): nl_pingpong
Design: FEProblemSolve.md
Issue(s): #16376
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.22.22The system shall not perform memory allocation for automatic scaling when computing values.
Specification(s): no_mallocs_during_scaling
Design: FEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.24.48We shall be able to show that without automatic scaling, this system is singular
Specification(s): poorly-conditioned-field-scalar-system
Design: ExecutionerFEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.24.49We shall be able to show that with automatic scaling, this system is non-singular
Specification(s): auto-scaled-field-scalar-system
Design: ExecutionerFEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.50We shall be able to show that with automatic scaling we can run this problem successfully in parallel
Specification(s): auto-scaled-field-scalar-system-parallel
Design: ExecutionerFEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.110We shall not be able to solve a problem where the physics Jacobians are very large compared to the jacobian from a Dirichlet BC (unity)
Specification(s): cant-solve-poorly-scaled
Design: FEProblemSolve.md
Issue(s): #12601
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.24.111We shall be able to solve an initially poorly scaled problem by using MOOSE's automatic scaling feature
Specification(s): automatic-scaling-done-once
Design: FEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.112We shall be able to solve an initially poorly scaled problem by using MOOSE's automatic scaling feature in parallel
Specification(s): automatic-scaling-done-once-parallel-preconditioner
Design: FEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.113We shall not be able to solve a problem where the physics has large changes over time if we only scale once
Specification(s): cant-solve-large-transient-changes
Design: FEProblemSolve.md
Issue(s): #12601
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.24.114We shall be able to solve a problem where the physics has large changes over time if we scale on every time step
Specification(s): automatic-scaling-done-per-time-step
Design: FEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.115We shall be able to solve a problem where the physics has large changes over time if we scale on every time step in parallel
Specification(s): automatic-scaling-done-per-time-step-parallel-preconditioner
Design: FEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ADDGKernel
- 1.9.12We shall be able to use constant monomials with AD
Specification(s): exo
Design: ADDGKernel
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.9.13MOOSE should support AD in DG Kernels
Specification(s): test
Design: ADDGKernel
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: DiracKernels System
- 1.10.2The system shall support block restricted dirac kernels.
Specification(s): skip
Design: DiracKernels System
Issue(s): #17561
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.10.3The system shall behave accordingly if the added point is not found, when point_not_found_behavior is set to
- ERROR or
- WARNING.
Specification(s): point_not_found/error, point_not_found/warning
Design: DiracKernels System
Issue(s): #17561
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionRunApp
- 1.10.4The system shall support a constant point source implemented as a Dirac function:
- in 1D,
- in 2D,
- in 3D,
- and with finite volume variables.
Specification(s): dim/1D, dim/2D, dim/3D, dim/1Dfv
Design: DiracKernels System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.10.5The system shall allow for source locations to be set by a user-defined object.
Specification(s): test
Design: DiracKernels System
Issue(s): #2357
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.10.7The system shall allow point sources originating from the evaluation of material properties.
Specification(s): material_point_source_test
Design: DiracKernels System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.10.8DiracKernel objects shall report an error if a material property from a previous time step is requested:
- one step back, and
- two steps back.
Specification(s): check_errors/old, check_errors/older
Design: DiracKernels System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.10.9The DiracKernel system shall allow for duplicate source locations to be defined.
Specification(s): multiplicity
Design: DiracKernels System
Issue(s): #7060
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.10.10The system shall support the computation of off diagonal Jacobian terms for residual terms defined with a Dirac delta function.
Specification(s): nonlinear_source
Design: DiracKernels System
Issue(s): #668
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.10.11The system shall support source location caching using element ids:
- on a static mesh with no adaptivity,
- with uniform mesh refinement,
- with adaptive mesh refinement, and
- with displaced mesh.
Specification(s): point_caching/basic, point_caching/uniform_refinement, point_caching/adaptive_refinement, point_caching/moving_mesh
Design: DiracKernels System
Issue(s): #2364
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.10.12The DiracKernel system shall report an error if a location does not correspond with the supplied element id.
Specification(s): point_caching_error
Design: DiracKernels System
Issue(s): #2364
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: FunctionDiracSource
- 1.10.6The system shall have the ability to set the value of point source from a function.
Specification(s): function_dirac_source
Design: FunctionDiracSource
Issue(s): #9552
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ReporterPointSource
- 1.10.13The system shall support point sources with locations and values given by a Reporter
- in a steady state 2D problem, reading data from a reporter and reproducing the constantPointSource.
- in a steady state 2D problem, reading data from a vectorPostProcessor and reproducing the constantPointSource.
- in steady state 3D problem, reproducing the constantPointSource.
- in a transient problem with the vpp source value changing as the vpp changes.
- and shall report an error if the input arrays are not the same size
Specification(s): reporterPointSource/2dConstantReporter, reporterPointSource/2dConstantVPP, reporterPointSource/3dConstant, reporterPointSource/2dTransient, reporterPointSource/wrong_size_error
Design: ReporterPointSource
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionCSVDiffExodiff
- framework: Executioner System
- 1.11.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.11.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.11.7The 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.11.9The 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.11.10The 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.11.11The 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.11.12The 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.11.13The 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.11.14The 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.11.15The 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.11.16The 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.11.17The 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.11.20The 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.11.21The 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.11.28The 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
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.11.29The 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
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.11.30Executioner 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.11.31The 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.11.32The 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.11.33The 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.11.34The 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.11.36The system shall support explicit definition of execution times.
Specification(s): testsynctimes
Design: Executioner System
Issue(s): #1781
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.11.37The 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.32.17The system shall report an error when the system solver is unable to find a converged solution.
Specification(s): steady_no_converge
Design: Executioner System
Collection(s): FAILURE_ANALYSIS
Type(s): RunApp
- 1.32.130The system shall have an integrity check that ensures an Executioner object exists in the system.
Specification(s): missing_executioner
Design: Executioner System
Issue(s): #11586
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.71The 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.34.72The system shall provide an ability to relax solutions with iterative solves with sub-applications.
Specification(s): master_relaxed
Design: Executioner System
Issue(s): #9115
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.73The system shall provide an ability to relax sub-applications solutions along with the master solution for during iterative solves.
Specification(s): sub_relaxed
Design: Executioner System
Issue(s): #9115
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.74The 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.34.75The system shall 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.60.13The system shall support the use of the Dennis-Schnabel method for computing the finite difference parameter for matrix free finite difference solver.
Specification(s): mffd_test
Design: Executioner System
Issue(s): #584
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: Transient
- 1.11.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.24.6The system shall force the solver to take at least one iteration regardless of the initial residual norm when the snes_force_iteration option is specified.
Specification(s): test_force_iteration
Design: Transient
Issue(s): #10594
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.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: InversePowerMethod
- 1.11.4The system shall support solving an Eigen value problem using the inverse power method.
Specification(s): test_inverse_power_method
Design: InversePowerMethod
Issue(s): #2350
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: NonlinearEigen
- 1.11.5The system shall support solving an Eigen value problem using Newton's method.
Specification(s): test_nonlinear_eigen
Design: NonlinearEigen
Issue(s): #2350
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.11.6The system shall support solving an Eigen value problem using Newton's method in parallel.
Specification(s): test_nonlinear_eigen_parallel
Design: NonlinearEigen
Issue(s): #2350
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MassEigenKernel
- 1.11.8The system shall be capable of solving a diffusion problem using an Eigen value solver.
Specification(s): test_normal_eigenkernel
Design: MassEigenKernel
Issue(s): #2350
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: TaggingInterface
- 1.11.18The system shall provide a capability to solve a problem iteratively with a tagged residual vector for
- linear and
- nonlinear problems.
Specification(s): tagged_residual/diffusion, tagged_residual/nonlinear
Design: TaggingInterface
Issue(s): #9669
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.11.19The system shall provide a capability to solve a problem iteratively with a tagged solution vector being coupled in
- kernels and/or
- materials.
Specification(s): tagged_solution_vector/var, tagged_solution_vector/material
Design: TaggingInterface
Issue(s): #17586
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.118Time kernel requires a transient executioner
Specification(s): bad_transient
Design: TaggingInterface
Issue(s): #9669
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.24.119The kernel can be only assigned to the existing vector tags in the system
Specification(s): bad_vector_tag
Design: TaggingInterface
Issue(s): #9669
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.24.120The kernel can be only assigned to the existing matrix tags in the system
Specification(s): bad_matrix_tag
Design: TaggingInterface
Issue(s): #9669
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.54.1The system shall support the ability for a specific calculation to fill a labeled or "tagged"
- numeric vector,
- numeric vector (without the variable scaling),
- numeric matrix,
- numeric matrix (without the variable scaling),
- multiple numeric vectors simultaneously, or
- multiple numeric matrices simultaneously.
Specification(s): general/tag_vector, general/tag_vector_no_scale, general/tag_matrix, general/tag_matrix_no_scale, general/tag_multiple_vectors, general/tag_multiple_matrices
Design: TaggingInterface
Issue(s): #9669
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.54.2The system shall throw an error when the variable orders and families for the tagged and the auxiliary output variables do not match.
Specification(s): tag_vector_error
Design: TaggingInterface
Issue(s): #9669
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.54.3The system shall support filling in labeled or "tagged" vectors or matrices from:
- the scalar kernel system,
- the scalar kernel system (without the variable scaling),
- the discontinous Galerkin system,
- integrated boundary conditions,
- the interface kernels system,
- the Dirac kernel system,
- the nodal kernel system, and
- the eigen system.
Specification(s): systems/test_tag_scalar_kernels, systems/test_tag_scalar_kernels_no_scale, systems/test_tag_DG_kernels, systems/test_tag_itegratedBCs, systems/test_tag_interface_kernels, systems/test_tag_dirac_kernels, systems/test_tag_nodal_kernels, systems/test_eigen
Design: TaggingInterface
Issue(s): #9669
Collection(s): FUNCTIONAL
Type(s): CSVDiffExodiff
- 1.54.4Cached Active object state will be maintained correctly even when objects' active state changes during runtime.
Specification(s): controls-tagging
Design: TaggingInterface
Issue(s): #15515
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Executor
- 1.12.1The system shall be able to utilize a modular/nested system of execution
Specification(s): test
Design: Executor
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.12.2The system shall error if the Executor system contains an infinite cycle
Specification(s): cycle
Design: Executor
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.12.3The system shall only have one root node in the Executor tree
Specification(s): multi_root
Design: Executor
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.12.4The system shall be able to experimentally use the executor system instead of an executioner.
Specification(s): test_executor_interface
Design: Executor
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: CoarsenedPiecewiseLinear
- 1.14.1Generate the fine tabulated function data for the coarsened_piecewise_linear test
Specification(s): prepare_data
Design: CoarsenedPiecewiseLinear
Issue(s): #2272
Collection(s): FUNCTIONAL
Type(s): RunCommand
- 1.14.2The Function system shall include an object that creates a function based on x- and y-data pairs, reduces the number of data points based on a user supplied cut-off and returns a linearly interpolated value from the coarsened data.
Specification(s): coarsened_piecewise_linear
Design: CoarsenedPiecewiseLinear
Issue(s): #2272
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ConstantFunction
- 1.14.3The Function system shall include a constant function.
Specification(s): test
Design: ConstantFunction
Issue(s): #1678
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FunctionIC
- 1.14.6The system shall be able to initialize a variable with values computed using a user-specified function
- using the function directly.
- with a scaling factor applied to the function.
Specification(s): test/basic, test/scaling
Design: FunctionIC
Issue(s): f792fc7ff9f8d8dfa8b3272117745fc422295ca1
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: GenericFunctionMaterial
- 1.14.8The Material system shall support defining properties within the input file that are associated with functions.
Specification(s): scalar
Design: GenericFunctionMaterial
Issue(s): #1335
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: GenericFunctionVectorMaterial
- 1.14.9The Material system shall support defining vector properties within the input file that are associated with functions.
Specification(s): vector
Design: GenericFunctionVectorMaterial
Issue(s): #18372
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.10The Material system shall error out if the number of functions supplied does not match the size of the vector function material properties.
Specification(s): vector_error
Design: GenericFunctionVectorMaterial
Issue(s): #18372
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ImageFunction
- 1.14.12The system shall include the ability to create functions from image files that errors if
- an unsupported file type is provided;
- if an invalid component value is supplied;
- if an invalid filename is provided; and
- the system is not configured with the correct dependencies.
Specification(s): errors/file_suffix, errors/component, errors/invalid_file, errors/no_vtk
Design: ImageFunctionImageMesh
Issue(s): #5927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.14.13The system shall include the ability to define a function based on a 2D image and initialize a nodal variable.
Specification(s): 2d
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.14The system shall include the ability to define a function based on a 2D image and initialize a elemental variable.
Specification(s): 2d_elemental
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.15The system shall include the ability to define a function based on a stack of images and initialize a nodal variable.
Specification(s): 3d
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.16The system shall include the ability to define a function based on a subset stack of images and initialize a nodal variable.
Specification(s): 3d_subset
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.17The system shall allow the image data within the ImageFunction object to be set as one of two values based on a threshold value.
Specification(s): threshold
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.18The system shall be capable of initializing a variable from image data and perform initial adaptivity based on the data.
Specification(s): threshold_adapt
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.19The system shall be capable of initializing a variable from image data and perform initial adaptivity based on the data, in parallel.
Specification(s): threshold_adapt_parallel
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.20The system shall be capable of initializing a variable from image data and perform initial adaptivity based on the data, in parallel and produce Nemesis output files.
Specification(s): threshold_adapt_parallel_check_files
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.14.21The system shall be capable of limiting the supplied data to the ImageFunction object to a single component of the RGB image data.
Specification(s): component
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.22The system shall be capable of shifting and scaling the supplied image data to the ImageFunction object.
Specification(s): shift_and_scale
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.23The system shall be capable of operating on domains that are larger than the image size in the ImageFunction object.
Specification(s): subset
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.24The system shall be capable of flipping image data along the vertical axis in the ImageFunction object.
Specification(s): flip
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.25The system shall be capable of flipping image data along vertical axis and shifting the origin using the ImageFunction object.
Specification(s): flip_dual
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.26The system shall be capable of flipping image data along vertical and horizontal axis within the ImageFunction object.
Specification(s): flip_quad
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.27The system shall be capable of operating on domains that are smaller than the image size within the ImageFunction object.
Specification(s): crop
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.30The system shall perform shift and scale options independently using the ImageFunction object.
Specification(s): moose_logo
Design: ImageFunction
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ImageMesh
- 1.14.12The system shall include the ability to create functions from image files that errors if
- an unsupported file type is provided;
- if an invalid component value is supplied;
- if an invalid filename is provided; and
- the system is not configured with the correct dependencies.
Specification(s): errors/file_suffix, errors/component, errors/invalid_file, errors/no_vtk
Design: ImageFunctionImageMesh
Issue(s): #5927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.14.28The system shall be capable of generating a 3D mesh based on a stack of 2D images using the ImageMesh object.
Specification(s): image_mesh_3d
Design: ImageMesh
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.29The system shall be capable of generating a 2D mesh based on an image using the ImageMesh object.
Specification(s): image_mesh_2d
Design: ImageMesh
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: LinearCombinationFunction
- 1.14.31The LinearCombinationFunction shall report an error if the parameters listing the functions differs in size than the list of coefficients.
Specification(s): except1
Design: LinearCombinationFunction
Issue(s): #4828
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.14.32The LinearCombinationFunction shall be capable of computing the sum of function values, each multiplied by a scale factor.
Specification(s): lcf1
Design: LinearCombinationFunction
Issue(s): #4828
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.14.33The LinearCombinationFunction shall be capable of computing the sum of function gradients, each multiplied by a scale factor.
Specification(s): lcf_grad
Design: LinearCombinationFunction
Issue(s): #4828
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.14.34The LinearCombinationFunction shall be capable of computing the sum of vector functions, each multiplied by a scale factor.
Specification(s): lcf_vector
Design: LinearCombinationFunction
Issue(s): #4828
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ParsedFunction
- 1.14.35The Function system shall support the creation of objects that execute a function defined within the input file.
Specification(s): steady
Design: ParsedFunction
Issue(s): #1902
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.36The ParsedFunction object shall be capable of defining function within the input file for use with the method of manufactured solutions.
Specification(s): transient
Design: ParsedFunction
Issue(s): #1902
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.37The Function system shall support the creation of objects that execute a vector function defined within the input file.
Specification(s): vector
Design: ParsedFunction
Issue(s): #2273
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.38The Function system shall support the creation of objects that execute a function defined within the input file that includes a scalar variable.
Specification(s): scalar
Design: ParsedFunction
Issue(s): #5041
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.39The ParsedFunction object shall support the use of other functions specified by their names in its expression.
Specification(s): function
Design: ParsedFunction
Issue(s): #12179
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.40The ParsedFunction object shall support the use of functions, scalar values and postprocessor values specified by their names in its expression at the same time.
Specification(s): combined
Design: ParsedFunction
Issue(s): #12179
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.41The Function system shall support the creation of objects that execute a curl of a vector function defined within the input file.
Specification(s): function_curl
Design: ParsedFunction
Issue(s): #13041
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.42The ParsedFunction object shall fail with a human readable error if a vals entry is supplied that is neither a valid postprocessor, scalar variable, function, or real number.
Specification(s): vals_error
Design: ParsedFunction
Issue(s): #14169
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: PiecewiseConstant
- 1.14.43The Function system shall include an object that creates a function based on x- and y-data pairs and returns an explicit value from the supplied data when queried (i.e., linear interpolation is not performed).
Specification(s): piecewise_constant
Design: PiecewiseConstant
Issue(s): #2272
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.44The Function system shall include an object that creates a function based on x- and y-data pairs and returns an explicit value from the supplied data when queried (i.e., linear interpolation is not performed) in a simple simulation, with both negative and positive values.
Specification(s): piecewise_constant_simple
Design: PiecewiseConstant
Issue(s): #2272
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.27.21The 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: PiecewiseConstantFromCSV
- 1.14.45The Function system shall include a function that can obtain data from a CSV file
- with data sorted by element ids
- with data sorted by node ids
- with data at given locations and using nearest neighbor interpolation between those data points
- using nearest neighbor interpolation with a random tesselation
- with data at given locations and using nearest neighbor interpolation between those data points, with periodic boundaries
- with data sorted by blocks and with constant values on each block.
Specification(s): csv_read/element, csv_read/node, csv_read/voronoi, csv_read/random_voronoi, csv_read/periodic_voronoi, csv_read/block
Design: PiecewiseConstantFromCSV
Issue(s): #19109
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.46The system shall error out if
- if the CSV reader object and the function expect the CSV data to be ordered differently
- if the desired column number in the CSV file is higher than the number of columns in the file
- if the data saught exceeds the row number in the CSV file
- if the number of blocks specified to a CSV reader reading block-data is 0
- if the number of nearest-neighbor regions specified to a CSV reader reading nearest-neighbor-region-data is 0
Specification(s): errors/read_type, errors/num_columns, errors/num_rows, errors/zero_blocks, errors/zero_voronoi
Design: PiecewiseConstantFromCSV
Issue(s): #19109
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.14.47The system shall issue a warning if
- if the desired column number in the CSV file is known to be a column holding point coordinates
- if the data file contains more points/rows than the reader needs
Specification(s): warnings/num_columns, warnings/too_much_data_in_file
Design: PiecewiseConstantFromCSV
Issue(s): #19109
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: PiecewiseMultilinear
- 1.14.50The PiecewiseMultilinear object will error if the supplied file fails to open.
Specification(s): except1
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.14.51The PiecewiseMultiInterpolation object shall error if the supplied data is not monotonically increasing.
Specification(s): except2
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.14.52The PiecewiseMultiInterpolation object shall error if the number of requested functions differ than the number available from the file.
Specification(s): except3
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.14.53The PiecewiseMultiInterpolation errors if the axes supplied are not independent.
Specification(s): except4
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.14.54The PiecewiseMultilinear shall error if the axis lines are not located in the supplied data.
Specification(s): except5
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.14.55The PiecewiseMultilinear object shall perform interpolation on a 1D domain.
Specification(s): oneDa
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.14.56The PiecewiseMultilinear object shall perform interpolation on a 1D domain that compares to an equivalent known function.
Specification(s): oneDb
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.14.57The PiecewiseMultilinear object shall perform interpolation of time-dependent data.
Specification(s): time
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.14.58The PiecewiseMultilinear object shall perform interpolation on a 2D domain.
Specification(s): twoDa
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.14.59The PiecewiseMultilinear object shall perform interpolation on a 2D domain that compares to an equivalent known function.
Specification(s): twoDb
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.60The PiecewiseMultilinear object shall perform constant interpolation on a 2D domain.
Specification(s): twoD_const
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.61The PiecewiseMultilinear object shall perform interpolation on a 3D domain with time-dependent data.
Specification(s): fourDa
Design: PiecewiseMultilinear
Issue(s): #2476
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SolutionFunction
- 1.14.63The SolutionFunction object shall be capable of evaluating a solution read from XDA mesh and solution files.
Specification(s): test
Design: SolutionFunction
Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.64The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file with temporal interpolation.
Specification(s): exodus_interp_test
Design: SolutionFunction
Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.65The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file.
Specification(s): exodus_test
Design: SolutionFunction
Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.66The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and rotated 45 degrees about the z-axis.
Specification(s): rot1
Design: SolutionFunction
Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.67The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and rotated 45 degrees about the y-axis.
Specification(s): rot2
Design: SolutionFunction
Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.68The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and rotated 90 degrees about the z-axis and 45 degress about the x-axis.
Specification(s): rot3
Design: SolutionFunction
Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.69The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and rotated 45 degrees about the z-axis for a 2D domain.
Specification(s): rot4
Design: SolutionFunction
Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.70The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and scaled by a factor in the x and y directions as well as translated in the x-direction.
Specification(s): scale_transl
Design: SolutionFunction
Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.71The SolutionFunction object shall be capable of evaluating a solution read from an Exodus file and scaled by a factor of two in the x and y directions.
Specification(s): scale_mult
Design: SolutionFunction
Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.72The SolutionFunction object shall error if a variable that does not exist is requested.
Specification(s): nonexistent_var_err
Design: SolutionFunction
Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.14.73The system shall be capable of evaluating the gradient of a solution
- created in a simulation
- and read from another.
Specification(s): solution_function/grad_p1, solution_function/grad_p2
Design: SolutionFunction
Issue(s): fc620eb2a4580a2320e03e6e89ad092dd2f4123b
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VectorPostprocessorFunction
- 1.14.74The VectorPostprocessorFunction shall be capable of linear interpolating data generated by a VectorPostprocessor object.
Specification(s): test_spatial_data
Design: VectorPostprocessorFunction
Issue(s): #8713
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.14.75The VectorPostprocessorFunction shall be capable of linear interpolating data generated by a VPP with respect to time.
Specification(s): test_time_data
Design: VectorPostprocessorFunction
Issue(s): #14700
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: FVNeumannBC
- 1.15.1The system shall run a simple 1D diffusion problem with a Neumann BC value.
Specification(s): fv_neumann
Design: FVNeumannBC
Issue(s): #16477
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.15.2The system shall error out if a finite volume flux boundary condition, in this case a finite volume Neumann boundary condition, is used inside the domain.
Specification(s): fvbcs_internal
Design: FVNeumannBC
Issue(s): #16882
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.15.3The system shall error out if a finite volume flux boundary condition is used on a mesh element face that is not connected to an element with the corresponding finite volume variable.
Specification(s): fvbcs_disconnected_from_variable
Design: FVNeumannBC
Issue(s): #16882
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: FVPostprocessorDirichletBC
- 1.15.4The system shall run a simple 1D diffusion problem with a Dirichlet BC value set by a postprocessor.
Specification(s): fv_pp_dirichlet
Design: FVPostprocessorDirichletBC
Issue(s): #16477
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FVTwoVarContinuityConstraint
- 1.16.1The system shall be able to solve a diffusion problem with finite volumes with the domain split in half and force the two variables living on each side of the domain to match on the interface.
Specification(s): continuity
Design: FVTwoVarContinuityConstraint
Issue(s): #17638
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FVDiffusionInterface
- 1.16.2The system shall be able to solve a diffusion problem with the domain split in half and two finite volume variables living on each side.
Specification(s): diffusion
Design: FVDiffusionInterface
Issue(s): #17638
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FVInterfaceKernels System
- 1.16.3The system shall error if a user specified variable on the 1st side of an interface does not actually exist on the 1st side.
Specification(s): run_except1
Design: FVInterfaceKernels System
Issue(s): #17087
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.16.4The system shall error if a user specified variable on the 2nd side of an interface does not actually exist on the 2nd side.
Specification(s): run_except2
Design: FVInterfaceKernels System
Issue(s): #17087
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.16.5The system shall error if a user does not specify a variable on the 2nd side of an interface, leading the system to assume that the variable on the 1st side of the interface should be used on the 2nd side, and the variable on the 1st side does not exist on the 2nd side.
Specification(s): run_except3
Design: FVInterfaceKernels System
Issue(s): #17087
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: FVOneVarDiffusionInterface
- 1.16.6The system shall be able to solve a diffusion problem with finite volumes with the domain split in half and show first order convergence due to its treatment of coefficient discontinuities both
- with an interfacing object
- without an interfacing object
Specification(s): first_order_convergence/with-ik, first_order_convergence/without-ik
Design: FVOneVarDiffusionInterface
Issue(s): #17087
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- framework: Finite Volume Design Decisions in MOOSE
- 1.17.1The system shall support block restriction of finite volume variables and kernels, and shall properly handle material evaluation in block-restricted settings, in a one-dimensional example.
Specification(s): 1d
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15894
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.2The system shall allow definition of a functor material property with the same name by different block-restricted materials on neighboring subdomains even when there are different sets of finite volume flux kernels on those same neighboring subdomains.
Specification(s): overlapping-mats
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.3The system shall support simultaneous block restriction of finite volume and finite element variables and have coupling of the finite volume variables into the finite element equations.
Specification(s): distinct-mats
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15894
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.4The system shall compute a perfect Jacobian when coupling block-restricted finite volume variables into block-restricted finite element calculations.
Specification(s): jac
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15894
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.17.5The system shall allow different materials to define the same material property name on different sides of an interface when the finite volume physics is the same on both sides of the interface.
Specification(s): just-mat-blk-restriction
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15894
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.6The system shall compute a perfect Jacobian when different materials define the same material property on different sides of a interface and the finite volume physics are the same on both sides of the interface.
Specification(s): just-mat-blk-restriction-jac
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15894
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.17.10The system shall be able to couple both finite element and finite volume variables, as functors, into functor material property calculations.
Specification(s): fe-and-fv-with-functors
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.11The system shall support coupling of a finite volume variable into a finite element calculation.
Specification(s): coupled-gold
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15894
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.12The system shall compute a perfect Jacobian when coupling a finite volume variable into a finite element calculation.
Specification(s): jac
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15894
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.17.13The system shall allow a finite volume object to consume a material property that depends on another material property that is computed in a material that couples in a finite element variable.
Specification(s): dep-in-same-mat-as-coupled-fe
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.14The system shall suggest that the user add a finite volume variable if a finite volume object cannot retrieve one
Specification(s): var_except
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.17.15The system shall be able to perform finite volume simulations with adaptivity and give correct results
Specification(s): adapt
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.16The system shall be able to combat a singular solve, resulting from two term boundary expansion during gradient computation, by reverting to a one term boundary expansion.
Specification(s): steady-coarse
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16822
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.17The system shall display second order convergence when there is some skewness due to mismatch between cell levels.
Specification(s): steady-mms
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.18The system shall be able to solve the Burgers equation in 1D using the FV method
Specification(s): fv_burgers
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.19The system shall run a 2D linear advection problems using the finite volume method a regular mesh.
Specification(s): fv_2D_constant_scalar_advection
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.20The system shall be able to produce correct mathematical results for a coupled-reaction problem
- using both finite element and finite volume discretizations with
- the correct Jacobian entries.
Specification(s): test/exo, test/jac
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- 1.17.21The system shall be able to compute the second time derivative of a variable when using the finite volume method and automatic differentiation.
Specification(s): csv
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #18178
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.17.22The system shall be able to couple variables at faces when using the finite volume method.
Specification(s): exo
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.23The system shall have an accurate Jacobian when coupling variables at faces and using the finite volume method.
Specification(s): jac
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.17.24The system shall support caching of functor evaluations performed with boundary face arguments.
Specification(s): ssf_caching
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #20470
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.25The system shall run a simple 2D linear diffusion problem using the finite volume method with Dirichlet boundary conditions on a regular mesh.
Specification(s): dirichlet
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.26The system shall run a simple 2D linear diffusion problem in RZ coordinates using the finite volume method with Dirichlet boundary conditions on a regular mesh.
Specification(s): dirichlet_rz
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.27The system shall be able to compute a full Jacobian matrix when performing finite volume computations
Specification(s): dirichlet_full_jac
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.28The system shall run a simple 2D linear diffusion problem using the finite volume method with Neumann and Dirichlet boundary conditions on a regular mesh.
Specification(s): neumann
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.29The system shall run a simple 2D transient linear diffusion problem using the finite volume method with Dirichlet boundary conditions on a regular mesh.
Specification(s): transient
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.30The system shall be able to solve a finite-volume-only problem
- on an unrefined mesh
- and on a mesh that has been refined to have the same amount of elements and achieve identical results
Specification(s): refinement/no_refinement, refinement/refinement
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.31The system shall be able solve a three-dimensional diffusion problem using the finite volume method.
Specification(s): 3d_dirichlet
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.32The system shall be able solve a one-dimensional diffusion problem using the finite volume method.
Specification(s): 1d_dirichlet
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.33The system shall correctly account for differences between gradient and divergence operators in cylindrical coordinates.
Specification(s): unstructured-rz
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15063
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.35The system shall be able to to solve an advection-diffusion equation with a dirichlet condition on the left boundary and a zero gradient condition on the right boundary and display second order convergence with the finite volume method.
Specification(s): test
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.36The system shall, while using an advective outflow boundary condition, demonstrate second order convergence if a two term Taylor series is used to approximate the face value and first order convergence if a one term Taylor series is used.
Specification(s): outflow
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.37The system shall be able to do one-term and two-term Taylor expansions for extrapolating finite volume solutions to boundary faces, and these extrapolations should be usable by flux kernels at inflow/outflow boundaries to produce first and second order accurate solutions respectively as measured by an L2 norm.
Specification(s): extrapolate
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16169
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.38The system shall display first order convergence with an upwind limiter.
Specification(s): UpwindLimiter
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.39The system shall display second order convergence with a central-differencing limiter.
Specification(s): CentralDifferenceLimiter
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.40The system shall display second order convergence with a Van-Leer limiter.
Specification(s): VanLeerLimiter
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.41The system shall display second order convergence with a min-mod limiter.
Specification(s): MinModLimiter
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.42The system shall display second order convergence with a second-order-upwind limiter.
Specification(s): SOULimiter
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.43The system shall display second order convergence with a QUICK limiter.
Specification(s): QUICKLimiter
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.44The system shall provide a Kurganov-Tadmor scheme for evaluating convective intercell fluxes
- with central difference interpolation of face values and resulting second order convergence
- with upwind interpolation of face values and resulting first order convergence
- with central difference interpolation with Van-Leer limiting of face values and resulting two and a half order convergence
Specification(s): kt/KTLimitedCD, kt/KTLimitedUpwind, kt/KTLimitedVanLeer
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.45The system shall be able to solve the diffusion equation in 2D axisymmetric coordinates using the finite volume method, and display a second order convergence rate.
Specification(s): diffusion
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.46The system shall be able to solve a pure advection problem in 1D cylindrical coordinates using the finite volume method, and display a second order convergence rate.
Specification(s): advection
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.47The system shall be able to solve a advection-reaction problem in 2D axisymmetric coordinates using the finite volume method, and display a second order convergence rate.
Specification(s): advection-reaction
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.48The system shall be able to solve a advection-diffusion-reaction problem in 2D axisymmetric coordinates using the finite volume method, and display a second order convergence rate.
Specification(s): advection-diffusion-reaction
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.49The system shall be able to implement advection through an element based kernel, that leverages the system's ability to reconstruct gradients, and demonstrate second order convergence on a cartesian coordinate system.
Specification(s): cartesian
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15066
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.50The system shall be able to retrieve and usefinite volume variable gradients in materials using a coupling interface and reproduce element-based advection results based on direct use of the variable gradient in a Cartesian coordinate system.
Specification(s): mat-cartesian
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16963
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.51The system shall be able to implement advection through an element based kernel, that leverages the system's ability to reconstruct gradients, and demonstrate second order convergence in an axisymmetric coordinate system.
Specification(s): rz
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15066
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.52The system shall be able to retrieve and usefinite volume variable gradients in materials using a coupling interface and reproduce element-based advection results based on direct use of the variable gradient in an axisymmetric coordinate system.
Specification(s): mat-rz
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16963
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.54The system shall display second order convergence, when using face side neighbors to compute face midpoint values during gradient reconstruction.
Specification(s): compact
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15063
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.55The system shall display 1.5 order convergence, when using face vertex neighbors to compute face midpoint values during gradient reconstruction.
Specification(s): extended
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #15063
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.56The system shall display first order convergence with regular face averaging in an advection diffusion problem.
Specification(s): average
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16239
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.57The system shall display second order convergence with skew-corrected face averaging for the diffusion term in an advection diffusion problem.
Specification(s): skewcorrected
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16239
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.58The system shall display second order convergence with skew-corrected face averaging for the diffusion and advection terms in an advection diffusion problem.
Specification(s): skewcorrected-advection
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16239
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.59The system shall display first order convergence, when averaging face side neighbors to compute face midpoint values during gradient reconstruction.
Specification(s): average
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16239
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.60The system shall display second order convergence, when skewness-corrected averaging to compute face midpoint values during gradient reconstruction.
Specification(s): skewcorrected
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16239
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.61The system shall display first order convergence when using a skew-corrected average-based face-interpolation together with extrapolated BCs.
Specification(s): skewcorrected
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #16239
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.17.75The system shall be able to run a flux boundary condition and a flux kernel for different variables on the same boundary and calculate correct function and Jacobian values.
Specification(s): jac
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.17.76The system shall be able to perform limiting schemes on Euclidean vector functors. These limiting schemes include
- first-order upwind
- central differencing
- vanLeer
Specification(s): limiting_schemes/upwind, limiting_schemes/central_difference, limiting_schemes/vanLeer
Design: Finite Volume Design Decisions in MOOSE
Issue(s): #20493
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FVIntegralValueConstraint
- 1.17.7The system shall be able to impose a constraint on the domain integral of a variable.
Specification(s): integral
Design: FVIntegralValueConstraint
Issue(s): #20607
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FVPointValueConstraint
- 1.17.8The system shall be able to impose a constraint on a single point value of a variable.
Specification(s): point_value
Design: FVPointValueConstraint
Issue(s): #20607
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FVBoundedValueConstraint
- 1.17.9The system shall be able to impose bounds for the values of a variable.
Specification(s): bound
Design: FVBoundedValueConstraint
Issue(s): #20607
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: GradientJumpIndicator
- 1.17.34The system shall be able to perform Laplacian-based adaptivity with finite volume variables.
Specification(s): gradient-jump
Design: GradientJumpIndicator
Issue(s): #20705
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.21.3The system shall include the ability to compute the square of the change in the gradient of a variable across element boundaries for the purpose of performing automatic mesh adaptivity.
Specification(s): test
Design: GradientJumpIndicator
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FVKernels System
- 1.17.53The system shall be able to solve a coupled mass and momentum-type two equation system, which includes advection and diffusion, using the finite volume method, and display second order convergence for both variables.
Specification(s): test
Design: FVKernels System
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.62The system shall be able to solve a diffusion problem with the finite volume method and display second order convergence.
Specification(s): diffusion
Design: FVKernels System
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.63The system shall be able to solve a advection-diffusion problem with the finite volume method and display second order convergence.
Specification(s): advection-diffusion
Design: FVKernels System
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.64The system shall be able to solve a advection-diffusion problem with the finite volume method, using a velocity supplied by a material, and display second order convergence.
Specification(s): mat-advection-diffusion
Design: FVKernels System
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.65The system shall be able to solve a advection problem with the finite volume method and display second order convergence.
Specification(s): advection
Design: FVKernels System
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.66The system shall be able to solve a advection problem with the finite volume method, using a velocity supplied by a material, and display second order convergence.
Specification(s): mat-advection
Design: FVKernels System
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.67The system shall be able to solve a advection-diffusion problem with the finite volume method and display first order convergence with an upwind scheme for the advection operator.
Specification(s): upwind-advection-diffusion
Design: FVKernels System
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.68The system shall be able to solve a advection problem with the finite volume method and display first order convergence with an upwind scheme.
Specification(s): upwind-advection
Design: FVKernels System
Issue(s): #14549
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FVOrthogonalDiffusion
- 1.17.69The system shall be able to solve diffusion on an orthogonal grid using a diffusion kernel which accounts only for orthogonal diffusion.
Specification(s): orthogonal-diffusion
Design: FVOrthogonalDiffusionFVOrthogonalBoundaryDiffusion
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FVOrthogonalBoundaryDiffusion
- 1.17.69The system shall be able to solve diffusion on an orthogonal grid using a diffusion kernel which accounts only for orthogonal diffusion.
Specification(s): orthogonal-diffusion
Design: FVOrthogonalDiffusionFVOrthogonalBoundaryDiffusion
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: NonlinearSystemBase
- 1.17.70The system shall be able to identify and show when a matrix is ill conditioned.
Specification(s): bad
Design: NonlinearSystemBase
Issue(s): #15732
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.17.71The system shall be able to condition a system automatically through variable scaling factors.
Specification(s): good
Design: NonlinearSystemBase
Issue(s): #15732
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.72The system shall be able to condition a system manually through variable scaling factors.
Specification(s): good_manual
Design: NonlinearSystemBase
Issue(s): #15732
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.17.73The system shall be able to sequentially apply manual and automatic scaling and in the case of poor manual scaling, restore the condition number automatically.
Specification(s): combined_manual_automatic
Design: NonlinearSystemBase
Issue(s): #15732
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.1The 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.52.3The system shall be able to automatically compute scaling factors based on Jacobian
- data solely along the diagonal
- 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.52.4The system shall be able to automatically scale variables and produce a good condition number from a naturally ill-conditioned system using
- automatic and
- manual prescribed settings.
Specification(s): scaling/automatic, scaling/manual
Design: NonlinearSystemBase
Issue(s): #15732
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.52.5The system shall display a very poor condition number for an ill-conditioned system.
Specification(s): bad
Design: NonlinearSystemBase
Issue(s): #15732
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: MooseVariableBase
- 1.17.74The system shall be able to evaluate functors with single sided face information arguments.
Specification(s): single_sided_face
Design: MooseVariableBase
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.116The system shall be able to do on the fly time derivative and gradient evaluations of variable functors.
Specification(s): dot_grad_test
Design: MooseVariableBase
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.48.34The system shall be able to restart a scalar variable in the presence of other variables with the standard sequence of:
- run initial input
- run restart input
Specification(s): restarting/part1, restarting/part2
Design: MooseVariableBase
Issue(s): #17471
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PenetrationAux
- 1.18.1The system shall be capable of computing the distance between two disjoint boundaries on a 1D domain.
Specification(s): test
Design: PenetrationAux
Issue(s): #1693
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.2The system shall be capable of computing the distance as well as transfer data between interior boundaries on a 2D domain.
Specification(s): test
Design: PenetrationAuxGapValueAux
Issue(s): #2713
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.3The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 2D.
Specification(s): pl_test1
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.4The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 2D using second order elements.
Specification(s): pl_test1q
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.5The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance.
Specification(s): pl_test1tt
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.6The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance and second order elements.
Specification(s): pl_test1qtt
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.7The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 2D.
Specification(s): pl_test2
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.8The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 2D with second order elements.
Specification(s): pl_test2q
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.9The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 2D using a tangential tolerance for the distance.
Specification(s): pl_test2tt
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.10The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 2D using a tangential tolerance for the distance and second order elements.
Specification(s): pl_test2qtt
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.11The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D.
Specification(s): pl_test3
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.12The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D and second order elements.
Specification(s): pl_test3q
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.13The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance.
Specification(s): pl_test3tt
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.14The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance and second order elements.
Specification(s): pl_test3qtt
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.15The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using normal smoothing for the distance.
Specification(s): pl_test3ns
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.16The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using normal smoothing for the distance and second order elements.
Specification(s): pl_test3qns
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.17The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using nodal normal based smoothing for the distance.
Specification(s): pl_test3nns
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.18The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 2D using nodal normal based smoothing for the distance and second order elements.
Specification(s): pl_test3qnns
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.19The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D.
Specification(s): pl_test4
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.20The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using second order elements.
Specification(s): pl_test4q
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.21The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance.
Specification(s): pl_test4tt
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.22The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using a tangential tolerance of for the distance and second order elements.
Specification(s): pl_test4qtt
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.23The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using normal smoothing for the distance.
Specification(s): pl_test4ns
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.24The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using normal smoothing for the distance and second order elements.
Specification(s): pl_test4qns
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.25The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using nodal normal based smoothing.
Specification(s): pl_test4nns
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.26The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 2D using nodal normal based smoothing and second order elements.
Specification(s): pl_test4qnns
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.27The systems shall be capable of performing simulations with geometric penetration
- computed within one simulation
- that are restarted from a another.
Specification(s): restart/part1, restart/part2
Design: PenetrationAux
Issue(s): #852
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.28The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces in 2D.
Specification(s): test
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.29The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces in 2D with triangular elements.
Specification(s): 2d_triangle
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.30The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 3D.
Specification(s): pl_test1
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.31The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 3D using second order elements.
Specification(s): pl_test1q
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.32The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 3D using a tangential tolerance of for the distance.
Specification(s): pl_test1tt
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.33The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces of a moving interface in 3D using a tangential tolerance of for the distance and second order elements.
Specification(s): pl_test1qtt
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.34The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 3D.
Specification(s): pl_test2
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.35The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 3D with second order elements.
Specification(s): pl_test2q
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.36The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 3D using a tangential tolerance for the distance.
Specification(s): pl_test2tt
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.37The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces of a moving interface in 3D using a tangential tolerance for the distance and second order elements.
Specification(s): pl_test2qtt
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.38The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 3D.
Specification(s): pl_test3
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.39The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 3D and second order elements.
Specification(s): pl_test3q
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.40The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and convex disjoint surfaces of a moving interface in 3D using a tangential tolerance of for the distance and second order elements.
Specification(s): pl_test3tt
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.41The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 3D.
Specification(s): pl_test4
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.42The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 3D using second order elements.
Specification(s): pl_test4q
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.43The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between a flat and concave disjoint surfaces of a moving interface in 3D using a tangential tolerance of for the distance.
Specification(s): pl_test4tt
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.44The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two disjoint surfaces:
- with nodal normal based smoothing;
- with nodal normal based smoothing and a specified tangential tolerance;
- with a specified normal smoothing distance;
- with a specified normal smoothing distance and a specified tangential tolerance;
- with second-order elements and third-order quadrature; and
- 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.18.45The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two overlapping surfaces:
- with nodal normal based smoothing;
- with nodal normal based smoothing and a specified tangential tolerance;
- with a specified normal smoothing distance;
- with a specified normal smoothing distance and a specified tangential tolerance;
- with second-order elements and third-order quadrature; and
- 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.18.46The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, overlapping surfaces in 3D.
Specification(s): test
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.47The PenetrationAux object shall be capable of computing the distance, tangential distance, normal, closest point, side id, and element id between two parallel, disjoint surfaces in 2D with tetrahedron elements.
Specification(s): 3d_tet
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.57The PenetrationAux object shall compute the distance between two boundaries in 3D that overlap.
Specification(s): test
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.58The PenetrationAux object shall compute, in parallel, the distance between two boundaries in 3D that overlap.
Specification(s): parallel_test
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.62The PenetrationAux object shall compute the distance between two overlapping boundaries using a constant monomial auxiliary variable.
Specification(s): qpl
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.63The PenetrationAux object shall compute the distance between two overlapping boundaries using a constant monomial auxiliary variable in 1D.
Specification(s): 1d_qpl
Design: PenetrationAux
Issue(s): 5478df0f0897ed7ac3dd3a3de1785a7948c75cfe
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: NearestNodeDistanceAux
- 1.18.48The NearestNodeDistanceAux object shall be capable of computing the shortest distance between a boundary and subdomain.
Specification(s): test
Design: NearestNodeDistanceAux
Issue(s): #3964
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.49The NearestNodeDistanceAux shall be capable of computing the shortest distance between two boundaries.
Specification(s): test
Design: NearestNodeDistanceAux
Issue(s): #1570
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.50The NearestNodeDistanceAux shall be capable of computing the shortest distance between two boundaries with adaptivity.
Specification(s): adapt
Design: NearestNodeDistanceAux
Issue(s): #1570
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.60The NearestNodeDistanceAux object shall compute the shortest distance between nodes on two overlapping boundaries using a constant monomial auxiliary variable.
Specification(s): qnnl
Design: NearestNodeDistanceAux
Issue(s): #1462
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.18.61Volumetric AD assembly data shall be properly sized when reinitializing faces
Specification(s): qnnl_ad
Design: NearestNodeDistanceAux
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FEProblemBase
- 1.18.56The system shall be able to perform patch updates on every non-linear iteration while performing uniform coarsening and refinement from grid sequencing.
Specification(s): always-grid-sequencing
Design: Mesh SystemGapValueAuxFEProblemBase
Issue(s): #14166
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.45The system should supply a special convenience "zero" variable that can be indexed like a normal coupled variable.
Specification(s): test
Design: FEProblemBase
Issue(s): #11202
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.32.181The system shall only reinitialize variables values that are consumed by other active objects in the system.
Specification(s): test
Design: FEProblemBase
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.4The 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
- framework: GeometricSearchData
- 1.18.59The nonlinear system shall be able to augment its sparsity based on constraints when we have a quadrature nearest-node locator.
Specification(s): quadrature_locator_plus_constraint
Design: GeometricSearchData
Issue(s): #5234
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: Parser
- 1.19.1The system shall include an input file syntax that supports defining global options.
Specification(s): global_param_test
Design: Parser
Issue(s): #437
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.177The system shall print an understandable message when a user-specified path/file does not exist.
Specification(s): except01
Design: Parser
Issue(s): #15718
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.1The system shall support active/inactive parameters to selectively enable/disable subblocks within all input file blocks.
Specification(s): inactive_active
Design: Parser
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.37.2The system shall produce an error when the active parameter refers to a non-exiseant block.
Specification(s): active_section_missing
Design: Parser
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.3The system shall produce an error when the inactive parameter refers to a non-existent block.
Specification(s): inactive_section_missing
Design: Parser
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.4The system shall produce an error when both the active and inactive parameters are present in the same block.
Specification(s): inactive_active_combo
Design: Parser
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.5The system shall honor the active or inactive parameters at the top (root) level.
Specification(s): top_level
Design: Parser
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.14The system shall be able to read input file syntax and write into map parameters.
Specification(s): test
Design: Parser
Issue(s): #14894
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.37.15The system shall error if a user supplies an odd number of entries, implying an unbalanced key-value set, to a map parameter.
Specification(s): odd_entries
Design: Parser
Issue(s): #14894
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.16The system shall error if a user supplies syntax in a map parameter that cannot be cast to the requested mapped type.
Specification(s): bad_value
Design: Parser
Issue(s): #14894
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.17The system shall support for multiple input files, which are merged into one input specification for a simulation
- where no parameters overlap
- where input files may override parameters in previous inputs
- while locating input errors in the correct file
- 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
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionRunAppExodiff
- 1.37.18The system shall raise an error if no input files were specified after the -i option
Specification(s): no_file
Design: Parser
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.19The system shall support parameter substitution in input files using command line variable expressions.
Specification(s): param_substitution_cli
Design: Parser
Issue(s): #5649
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.37.20The system shall support parameter substitution in input files using variable expressions from within the same input file.
Specification(s): param_substitution_in_file
Design: Parser
Issue(s): #5649
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.37.21The system shall support unit conversion in input files using variable expressions.
Specification(s): unit_conversion
Design: Parser
Issue(s): #14827
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.37.22The system shall support reading in jagged double-indexed arrays from the input file using two delimiters for columns and rows respectively.
Specification(s): parse_double_index
Design: Parser
Issue(s): #6442
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ArrayConstantIC
- 1.20.1The system shall allow to set constant initial conditions for an array variable.
Specification(s): array_constant_ic
Design: ArrayConstantIC
Issue(s): #6881
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.2The system shall error if the wrong number of components are provided in a constant initial condition for array variables.
Specification(s): size_error
Design: ArrayConstantIC
Issue(s): #6881
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ArrayFunctionIC
- 1.20.3The system shall allow to set initial conditions for an array variable based on functions.
Specification(s): array_constant_ic
Design: ArrayFunctionIC
Issue(s): #6881
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.4The system shall error if the wrong number of components are provided in a functionalized initial condition for array variables.
Specification(s): size_error
Design: ArrayFunctionIC
Issue(s): #6881
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ICs System
- 1.20.5The system shall support setting initial conditions on boundaries.
Specification(s): test
Design: ICs System
Issue(s): #534
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.8The system shall report an error when multiple initial conditions are applied to the same boundary.
Specification(s): ics_on_same_boundary
Design: ICs System
Issue(s): #6580
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.20.9The system shall report an error when multiple initial conditions are applied to the same subdomain.
Specification(s): ics_on_same_block
Design: ICs System
Issue(s): #6580
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.20.10The system shall report an error when a global initial conditions overlap on the same variable.
Specification(s): ics_on_same_block_both_global
Design: ICs System
Issue(s): #6580
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.20.11The system shall report an error when a global and subdomain restricted initial conditions overlap on the same variable.
Specification(s): ics_on_same_block_first_global
Design: ICs System
Issue(s): #6580
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.20.12The system shall support setting different values for each coefficient of higher-order scalar values.
Specification(s): test
Design: ICs System
Issue(s): #2085
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.13The system shall support setting initial conditions of field variables to a constant value.
Specification(s): test
Design: ICs System
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.14The system shall support setting initial conditions of subdomain restricted field variables to a constant value.
Specification(s): subdomain_test
Design: ICs System
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.15The system shall provide current node or element pointers when possible when evaluating initial conditions at a point in the domain.
Specification(s): test
Design: ICs System
Issue(s): #4953
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.18The system shall allow nodal initial condition objects to couple to other nodal variables for computing values for the current variable.
Specification(s): test
Design: ICs System
Issue(s): #534
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.19The system shall allow elemental initial condition objects to couple to other elemental variables for computing values for the current variable.
Specification(s): monomial
Design: ICs System
Issue(s): #534
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.20The system shall write output files containing nodal solutions in ExodusII format suitable for restart.
Specification(s): nodal_var_1
Design: ICs System
Issue(s): #13438
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.21The system shall be able to populate nodal initial conditions from a previous solution file in ExodusII format.
Specification(s): nodal_var_2
Design: ICs System
Issue(s): #13438
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.22The system shall write output files containing elemental solutions in ExodusII format suitable for restart.
Specification(s): elem_var_1
Design: ICs System
Issue(s): #13438
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.23The system shall be able to populate elemental initial conditions from a previous solution file in ExodusII format.
Specification(s): elem_var_2
Design: ICs System
Issue(s): #13438
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.24The system shall write output files containing elemental array variable solutions in ExodusII format suitable for restart.
Specification(s): array_elem_var_1
Design: ICs System
Issue(s): #13438
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.25The system shall be able to populate elemental array variable initial conditions from a previous solution file in ExodusII format.
Specification(s): array_elem_var_2
Design: ICs System
Issue(s): #13438
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.26The system shall write output files containing nodal array variable solutions in ExodusII format suitable for restart.
Specification(s): array_nodal_var_1
Design: ICs System
Issue(s): #13438
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.27The system shall be able to populate nodal array variable initial conditions from a previous solution file in ExodusII format.
Specification(s): array_nodal_var_2
Design: ICs System
Issue(s): #13438
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.28The system shall support setting gradient values for shape functions that support them.
Specification(s): parsed_function
Design: ICs System
Issue(s): #3312
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.29The system shall support using a spline function to set both value and gradient values in an initial condition.
Specification(s): spline_function
Design: ICs System
Issue(s): #3312
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.30The system shall support setting a scalar initial condition by evaluating a function.
Specification(s): test
Design: ICs System
Issue(s): #6309
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.20.31The system shall support setting initial conditions for the Hermite set of shape functions.
Specification(s): test
Design: ICs System
Issue(s): #1493
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.34The system shall support initial conditions on second order Lagrange variables in 3D space.
Specification(s): 3d_second_order
Design: ICs System
Issue(s): #1493
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.156The system shall verify equality among the current, old, and older solution vectors prior to running the simulation.
Specification(s): equal_solutions
Design: ICs System
Issue(s): #1396
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: BoundingBoxIC
- 1.20.6Generates a rectangular IC
Specification(s): test
Design: BoundingBoxIC
Issue(s): #11034
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.7BoundingBoxIC shall have a diffuse interface option.
Specification(s): diffuse
Design: BoundingBoxIC
Issue(s): #13331
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: InitialCondition
- 1.20.16The system shall allow setting field initial condition from an user object
Specification(s): ic_depend_on_uo
Design: InitialConditionUserObjectInterface
Issue(s): #8810
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.35The system shall allow initial conditions to retrieve post-processor values.
Specification(s): test
Design: InitialConditionPostprocessorInterface
Issue(s): #17692
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: UserObjectInterface
- 1.20.16The system shall allow setting field initial condition from an user object
Specification(s): ic_depend_on_uo
Design: InitialConditionUserObjectInterface
Issue(s): #8810
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.17The system shall allow setting scalar initial condition from an user object
Specification(s): scalar_ic_from_uo
Design: ScalarInitialConditionUserObjectInterface
Issue(s): #13357
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.23.20The system shall report a reasonable error when requesting a UserObject when
- getting the name from a parameter and the parameter is not found,
- getting the name from a parameter and the parameter does not represent a name,
- getting the name from a parameter and the user object is not found,
- getting the UserObject by name and the user object is not found,
- getting the name from a paremeter and the provided object is not of the correct type, and
- getting the UserObject by name and the provided object is not of the correct type.
Specification(s): errors/missing_parameter, errors/bad_parameter_type, errors/not_found_by_param, errors/not_found_by_name, errors/bad_cast, errors/bad_cast_by_name
Design: UserObjectInterface
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.23.21The system shall provide an interface that reports if a UserObject exists by
- parameter,
- name,
- parameter and type, and
- name and type.
Specification(s): has_uo/param, has_uo/name, has_uo/param_T, has_uo/name_T
Design: UserObjectInterface
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: ScalarInitialCondition
- 1.20.17The system shall allow setting scalar initial condition from an user object
Specification(s): scalar_ic_from_uo
Design: ScalarInitialConditionUserObjectInterface
Issue(s): #13357
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: IntegralPreservingFunctionIC
- 1.20.32The system shall error if
- the postprocessor does not have execute_on initial
- the postprocessor for normalization is zero
Specification(s): errors/missing_initial, errors/zero_integral
Design: IntegralPreservingFunctionIC
Issue(s): #19476
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.20.33The system shall be able to apply a normalized sinusoidal initial condition.
Specification(s): sinusoidal
Design: IntegralPreservingFunctionIC
Issue(s): #19476
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PostprocessorInterface
- 1.20.35The system shall allow initial conditions to retrieve post-processor values.
Specification(s): test
Design: InitialConditionPostprocessorInterface
Issue(s): #17692
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.23.2The system shall report a reasonable error when requesting a Postprocessor from a parameter when
- the parameter is not found,
- the parameter does not represent a Postprocessor,
- the parameter is a single Postprocessor value and a greater index than zero is requested,
- and the parameter is a single Postprocessor value and a greater index than zero is requested.
Specification(s): param_errors/missing_parameter, param_errors/bad_parameter_type, param_errors/out_of_range_single, param_errors/out_of_range_vector
Design: PostprocessorInterface
Issue(s): #17512
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.23.3The system shall report a reasonable error when requesting a Postprocessor name from a parameter in which the postprocessor is a default value and not a name.
Specification(s): name_for_default_error
Design: PostprocessorInterface
Issue(s): #17512
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.23.4The system shall report a reasonable error when it is too early to request if a postprocesor exists
- by parameter name and
- by Postprocessor name.
Specification(s): has_errors/param, has_errors/name
Design: PostprocessorInterface
Issue(s): #17512
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.23.5The system shall report a reasonable error when requesting a Postprocessor value
- by parameter and the Postprocessor does not exist and
- by Postprocessor name and the Postprocessor does not exist.
Specification(s): missing_errors/by_param, missing_errors/by_name
Design: PostprocessorInterface
Issue(s): #17512
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: RandomIC
- 1.20.36The system shall generate parallel agnostic random initial conditions
Specification(s): test
Design: RandomIC
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.37The system shall generate threaded agnostic random initial conditions
Specification(s): test_threaded
Design: RandomIC
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VectorConstantIC
- 1.20.38The system shall allow to set constant vector-valued initial conditions.
Specification(s): vector_constant_ic
Design: VectorConstantIC
Issue(s): #12311
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.39The system shall allow to set constant vector-valued initial conditions when adding vector variables.
Specification(s): vector_short_constant_ic
Design: VectorConstantIC
Issue(s): #12311
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.40The system shall allow vector-valued initial conditions be set using a vector function.
Specification(s): vector_function_ic
Design: VectorConstantIC
Issue(s): #13309
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.41The system shall allow vector-valued initial conditions be set using a function by components.
Specification(s): vector_function_ic_comp
Design: VectorConstantIC
Issue(s): #13309
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.20.42The system shall error if the 'function' and 'function_x' parameters are both set within the VectorFunctionIC object.
Specification(s): comp_x_error
Design: VectorConstantIC
Issue(s): #13309
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.20.43The system shall error if the 'function' and 'function_y' parameters are both set within the VectorFunctionIC object.
Specification(s): comp_y_error
Design: VectorConstantIC
Issue(s): #13309
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.20.44The system shall error if the 'function' and 'function_z' parameters are both set within the VectorFunctionIC object.
Specification(s): comp_z_error
Design: VectorConstantIC
Issue(s): #13309
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: AnalyticalIndicator
- 1.21.1The system shall include the ability to compute the square of the difference between a solution variable and an analytical function for the purpose of performing automatic mesh adaptivity.
Specification(s): analytical
Design: AnalyticalIndicator
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.21.2The system shall include the ability to compute the square of the difference between a FV solution variable and an analytical function for the purpose of performing automatic mesh adaptivity.
Specification(s): analytical_fv
Design: AnalyticalIndicator
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: LaplacianJumpIndicator
- 1.21.4The system shall include the ability to compute the square of the change in the Laplacian of a variable across element boundaries for the purpose of performing automatic mesh adaptivity:
- with a penalty based flux boundary condition;
- with a weakly imposed flux boundary condition; and
- for transient calculations.
Specification(s): group/test_biharmonic, group/test_biharmonic_weak_bc, group/test_biharmonic_transient
Design: LaplacianJumpIndicator
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ValueJumpIndicator
- 1.21.5The system shall include the ability to compute the square of the change in a variable across element boundaries for the purpose of performing automatic mesh adaptivity:
Specification(s): test
Design: ValueJumpIndicator
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.21.6The system shall include the ability to compute the square of the change in a FV variable across element boundaries for the purpose of performing automatic mesh adaptivity:
Specification(s): fv
Design: ValueJumpIndicator
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: InterfaceKernels System
- 1.22.1Interface kernels shall provide integrated conditions between subdomains, and shall work with boundary restricted materials with stateful properties.
Specification(s): interface_diffusion
Design: InterfaceKernels System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.2The interface diffusion penalty method should reproduce the analytic solution
Specification(s): interface_diffusion_penalty
Design: InterfaceKernels System
Issue(s): #11765
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.3The InterfaceKernel system shall use with interface material in 1D.
Specification(s): interface_diffusion_penalty_with_jump_material
Design: InterfaceKernels System
Issue(s): #12066
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.4The system shall support the evaluation of neighboring quantities on elements containing different shape functions.
Specification(s): mixed_shapes_test
Design: InterfaceKernels System
Issue(s): #13232
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.5The system shall produce correct Jacobians for coupled flux on an interface.
Specification(s): jacobian_test
Design: InterfaceKernels System
Issue(s): #13232
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 1.22.6The system shall support produce correct Jacobians when evaluating neighboring quantities on elements containing different shape functions.
Specification(s): mixed_shapes_jacobian_test
Design: InterfaceKernels System
Issue(s): #13232
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 1.22.7The system shall produce correct Jacobians for single variable coupled flux on an interface.
Specification(s): single_variable_jacobian_test
Design: InterfaceKernels System
Issue(s): #13232
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 1.22.8Save-in shall record the correct residuals and Jacobians representing the interface kernel. This applies the DirichletBC to side a (block 0) of the interface.
Specification(s): ik_save_in
Design: InterfaceKernels System
Issue(s): #9854
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.9Save-in shall record the correct residuals and Jacobians representing the interface kernel. This applies the DirichletBC to side b (block 1) of the interface.
Specification(s): ik_save_in_other_side
Design: InterfaceKernels System
Issue(s): #13232
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.15The system shall not try to reinit a displaced interface, leading to failed point inversions, if a displaced interface kernel has not been added to the simulation.
Specification(s): no_failed_point_inversions
Design: InterfaceKernels System
Issue(s): #18175
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.16The InterfaceKernel system shall operate with coupled variables in 2D. This uses a penalty implementation that is optimally convergent.
Specification(s): test
Design: InterfaceKernels System
Issue(s): #7885
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.17Allow the interface to impose the same time derivative on two neighboring variables. This uses a penalty implementation that is optimally convergent.
Specification(s): test_dot
Design: InterfaceKernels System
Issue(s): #12372
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.18The InterfaceKernel system shall use with interface material in 2D.
Specification(s): test_jump_material
Design: InterfaceKernels System
Issue(s): #12066
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.19The Jacobian evaluation for InterfaceKernel objects in 2D shall be analytically correct.
Specification(s): jacobian_test
Design: InterfaceKernels System
Issue(s): #7437
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 1.22.21The InterfaceKernel system shall support Vector Finite Elements in 2D.
Specification(s): vector_2d
Design: InterfaceKernels System
Issue(s): #13354
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.23The InterfaceKernel system shall operate with coupled variables in 3D. This uses a penalty implementation that is optimally convergent.
Specification(s): coupled_3d
Design: InterfaceKernels System
Issue(s): #7885
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.24The InterfaceKernel system shall support Vector Finite Elements in 3D.
Specification(s): vector_3d
Design: InterfaceKernels System
Issue(s): #13354
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.25The InterfaceKernel system shall use with interface material in 3D.
Specification(s): test_jump_material
Design: InterfaceKernels System
Issue(s): #12066
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.30Adaptivity shall work with interface kernels as long as stateful properties are not used.
Specification(s): ik_adaptivity
Design: InterfaceKernels System
Issue(s): #10977
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.31The system shall error if the triad of interface kernels, adaptivity, and stateful properties are used together.
Specification(s): error_stateful_ik_adaptivity
Design: InterfaceKernels System
Issue(s): #10977
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.22.32The system shall be able to execute interfacial conditions on sidesets generated by gmsh.
Specification(s): test
Design: InterfaceKernels System
Issue(s): #15203
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.33The system shall support Dirichlet and Neumann interface conditions.
Specification(s): matchedvalue
Design: InterfaceKernels System
Issue(s): #7437
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.34The system shall support penalty interface conditions.
Specification(s): penalty
Design: InterfaceKernels System
Issue(s): #7437
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.35The system shall support matched-value interface with different variable coefficients with automatic differentiation.
Specification(s): variable_coeffs_AD
Design: InterfaceKernels System
Issue(s): #7437
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.36The system shall support matched-value interface with different variable coefficients.
Specification(s): variable_coeffs
Design: InterfaceKernels System
Issue(s): #7437
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.37When computing residuals and jacobians on an interface, the system shall be able to use element information from the displaced mesh when requested
Specification(s): displaced
Design: InterfaceKernels System
Issue(s): #14876
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.38When computing residuals and jacobians on an interface, the system shall be able to use element information from the reference mesh
Specification(s): undisplaced
Design: InterfaceKernels System
Issue(s): #14876
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.39During mesh displacement, the system shall be able to compute different element Jacobians for different sides of an interface.
Specification(s): jxw_neighbor
Design: InterfaceKernels System
Issue(s): #14870
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: InterfaceReaction
- 1.22.10The interface reaction kernel should reproduce the analytic solution
Specification(s): reaction_1D_steady_CSVDiff
Design: InterfaceReaction
Issue(s): #13365
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.22.11The interface reaction kernel should work with interface diffusion kernel
Specification(s): reaction_1D_steady_ExoDiff
Design: InterfaceReaction
Issue(s): #13365
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.12The solution should be discontinued at the interface due to the reaction taking place
Specification(s): reaction_1D_transient
Design: InterfaceReaction
Issue(s): #13365
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.13The Jacobian from InterfaceReaction shall be perfect
Specification(s): reaction_1D_transient_Jac
Design: InterfaceReaction
Issue(s): #13365
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: FDP
- 1.22.20The finite difference preconditioner shall work in parallel.
Specification(s): parallel_fdp_test
Design: FDP
Issue(s): #10375
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.42.4The system shall produce a perfect coloring for the Jacobian when using the finite difference preconditioner.
Specification(s): jacobian_fdp_coloring_full_test
Design: FDP
Issue(s): #13232
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 1.42.5The system shall produce a perfect Jacobian when using the stadard finite difference preconditioner.
Specification(s): jacobian_fdp_standard_test
Design: FDP
Issue(s): #13232
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- 1.42.6The system shall detect missing off-diagonal Jacobian entries when using a full finite different preconditioner.
Specification(s): jacobian_fdp_coloring_diagonal_test_fail
Design: FDP
Issue(s): #13232
Collection(s): FUNCTIONAL
Type(s): AnalyzeJacobian
- framework: Automatic Differentiation
- 1.22.26The system shall be able to solve a simple interfacial source problem using automatic differentiation in which the slope on the left-hand side of the interface has a slope greater by two than the slope on the right-hand side.
Specification(s): exo
Design: Automatic Differentiation
Issue(s): #15307
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.27The system shall be able to couple variables at interfaces and have an accurate Jacobian provided through automatic differentiation.
Specification(s): jac
Design: Automatic Differentiation
Issue(s): #15307
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.22.28The system shall be able to solve a simple interfacial source problem using automatic differentiation and vector variables in which the slope on the left-hand side of the interface has a slope greater by two than the slope on the right-hand side.
Specification(s): exo
Design: Automatic Differentiation
Issue(s): #15307
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.22.29The system shall be able to couple vector variables at interfaces and have an accurate Jacobian provided through automatic differentiation.
Specification(s): jac
Design: Automatic Differentiation
Issue(s): #15307
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: JvarMapInterface
- 1.23.1The system shall build a bijective map between variable numbers and their couple variable indices.
Specification(s): parameter_map
Design: JvarMapInterface
Issue(s): #13951
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: RandomInterface
- 1.23.6The system shall produce parallel-agnostic random number fields on a single processor.
Specification(s): test
Design: RandomInterface
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.23.7The system shall produce parallel-agnostic random number fields on two or more processors.
Specification(s): parallel_verification
Design: RandomInterface
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.23.8The system shall produce parallel-agnostic random number fields on two or more threads.
Specification(s): threads_verification
Design: RandomInterface
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.23.9The system shall produce a parallel field without repeating patterns on distributed meshes.
Specification(s): test_par_mesh
Design: RandomInterface
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.23.10The system shall produce parallel-agnostic random number fields via the user defined (UserObject) system.
Specification(s): test_uo
Design: RandomInterface
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.23.11The 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
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.23.12The 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
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.23.13The system shall produce a parallel field without repeating patterns via the user defined (UserObject) system.
Specification(s): test_uo_par_mesh
Design: RandomInterface
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.23.14The system shall produce a parallel-agnostic random number via the material system.
Specification(s): material_serial
Design: RandomInterface
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.23.15The system shall produce a parallel-agnostic random number via the material system on two or more processors.
Specification(s): material_parallel
Design: RandomInterface
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.101The system shall compute parallel-agnostic random numbers in the Postprocessor system
- when running a complete simulation, or
- when running the first half of the simulation and
- 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): CSVDiffRunApp
- framework: ReporterInterface
- 1.23.16The system shall report a reasonable error when requesting a Reporter value from a parameter when
- the parameter is not found and
- the parameter does not represent a Reporter
Specification(s): param_errors/missing_parameter, param_errors/bad_parameter_type
Design: ReporterInterface
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.23.17The system shall report a reasonable error when requesting a Reporter value when a Reporter with the same name exists with a different type.
Specification(s): other_type_requested_error
Design: ReporterInterface
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.23.18The system shall report a reasonable error when requesting a Reporter value
- by parameter and the Reporter value does not exist and
- by Reporter name and the Reporter value does not exist.
Specification(s): missing_errors/param, missing_errors/name
Design: ReporterInterface
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.23.19The system shall report a reasonable error when it is too early to request if a Reporter value exists
- by parameter name and
- by Reporter name.
Specification(s): has_errors/param, has_errors/name
Design: ReporterInterface
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: VectorPostprocessorInterface
- 1.23.22The system shall report a reasonable error when requesting a VectorPostprocessor value from a parameter when
- the parameter is not found and
- the parameter does not represent a VectorPostprocessor.
Specification(s): param_errors/missing_parameter, param_errors/bad_parameter_type
Design: VectorPostprocessorInterface
Issue(s): #17512
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.23.23The system shall report a reasonable error when it is too early to request if a VectorPostprocessor exists
- by vector name and parameter name,
- by vector name and VectorPostprocessor name,
- by parameter name, and
- and by VectorPostprocessor name.
Specification(s): has_errors/value_param, has_errors/value_name, has_errors/param, has_errors/name
Design: VectorPostprocessorInterface
Issue(s): #17512
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.23.24The system shall report a reasonable error when requesting a VectorPostprocessor value
- by parameter and the VectorPostprocessor does not exist,
- by parameter and the VectorPostprocessor exists but the requested vector does not,
- by VectorPostprocessor name and the VectorPostprocessor does not exist, and
- by VectorPostprocessor name and the VectorPostprocessor exists but the requested vector does not.
Specification(s): missing_errors/by_param, missing_errors/by_param_vector, missing_errors/by_name, missing_errors/by_name_vector
Design: VectorPostprocessorInterface
Issue(s): #17512
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: MatDiffusion
- 1.24.3The system shall provide a diffusion kernel that obtains the diffusion coefficient from a material property
Specification(s): testmatdiffusion
Design: MatDiffusion
Issue(s): #12074
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: BodyForce
- 1.24.4The system shall provide an ability to solve a 2D diffusion problem including a volumetric source term.
Specification(s): testbodyforce
Design: BodyForce
Issue(s): #6136
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.22The Jacobian of ADBodyForce with a force function shall be perfect.
Specification(s): testbodyforce-adfunction-jac
Design: BodyForce
Issue(s): #13260
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: Framework Software Test Plan
- 1.24.5The system shall provide a tester that checks hand-coded Jacobian against finite difference Jacobian using -snes_type=test option.
Specification(s): test_jacobian
Design: Framework Software Test Plan
Issue(s): #2337
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.32.157The system shall support a testing mechanism that fails intermittently.
Specification(s): intermittent_failure
Design: Framework Software Test Plan
Issue(s): #13334
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.175The testing system shall support the ability to disable geometrical mapping of mesh elements for comparison purposes.
Specification(s): test
Design: Framework Software Test Plan
Issue(s): #6011
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.185The test system shall have the ability to execute a specific input file.
Specification(s): execute
Design: Framework Software Test Plan
Issue(s): #7215
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.186The test system shall have the ability to run a test that neither clears expected outputs or runs the expected executeable for multiple output testing.
Specification(s): dont
Design: Framework Software Test Plan
Issue(s): #7215
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FEProblem
- 1.24.7The system shall not compute an extra residual if the linear solver is used.
Specification(s): actual_linear_solver
Design: FEProblem
Issue(s): #11760
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.176The system shall use the default PETSc option database in the master app to handle system-level PETSc parameters
Specification(s): test_options_not_left
Design: FEProblem
Issue(s): #15129
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: ADBodyForce
- 1.24.10The system shall provide an ability to solve a 2D diffusion problem including a volumetric source term using
- automatic differentiation and
- compute the correct Jacobian matrix.
Specification(s): bodyforce/ad, bodyforce/ad-jac
Design: ADBodyForce
Issue(s): #13260
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- framework: CoupledForce / ADCoupledForce
- 1.24.12The system shall provide a source term proportional to the value of
- an aux variable and shall be able to produce the exact Jacobian
- an finite element primary variable and shall be able to produce the exact Jacobian
Specification(s): jacobians/aux, jacobians/fe
Design: CoupledForce / ADCoupledForce
Issue(s): #18214
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: DualReal
- 1.24.17The system will output the required number of derivative entries needed for automatic differentiation calculations
Specification(s): test_ad_output
Design: DualReal
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.24.25The system will error and tell the user if they use derivative storage that is too small
Specification(s): ad_max_dofs_per_elem_error
Design: DualReal
Issue(s): #5658
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ADTimeDerivative
- 1.24.21Jacobians calculated by ADTimeDerivative and ADBodyForce shall be perfect.
Specification(s): testbodyforce-jac
Design: ADTimeDerivative
Issue(s): #13260
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.31The system shall be able to solve a transient diffusion problem with
- automatic differentiation and
- compute the correct Jacobian matrix.
Specification(s): transient_diffusion/ad, transient_diffusion/jac_ad_transient_diffusion
Design: ADTimeDerivative
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- framework: ADMatDiffusion
- 1.24.23The system shall solve a one-dimensional Diffusion problem with a material property diffusivity and match a known solution.
- without and
- with automatic differentiation including
- the correct Jacobian matrix.
Specification(s): 1D/1D_transient, 1D/ad_1D_transient, 1D/ad_1D_transient_jacobian
Design: ADMatDiffusion
Issue(s): #2582#5658#12633#13632
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- 1.24.24The system shall solve a two-dimenional Diffusion problem with a material property diffusivity and match a known solution.
- without and
- with automatic differentiation including
- the correct Jacobian matrix.
Specification(s): 2D/2D_steady_state, 2D/ad_2D_steady_state, 2D/ad_2D_steady_state_jacobian
Design: ADMatDiffusion
Issue(s): #2582#5658#12633#13632
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- framework: Reaction / ADReaction
- 1.24.26The system shall contain a consuming reaction term object whose Jacobian is calculated via forward automatic differentiation.
Specification(s): ad_reaction
Design: Reaction / ADReaction
Issue(s): #21009
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.27The system shall produce a perfect Jacobian for a consuming reaction term object using forward automatic differentiation.
Specification(s): ad_reaction_jac
Design: Reaction / ADReaction
Issue(s): #21009
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: CoefReaction / ADCoefReaction
- 1.24.28The system shall contain a consuming reaction term object with a scalar coefficient whose Jacobian is calculated via forward automatic differentiation.
Specification(s): ad_coef_reaction
Design: CoefReaction / ADCoefReaction
Issue(s): #21009
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.29The system shall produce a perfect Jacobian for a consuming reaction term object with a scalar coefficient using forward automatic differentiation.
Specification(s): ad_coef_reaction_jac
Design: CoefReaction / ADCoefReaction
Issue(s): #21009
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: ADVectorTimeDerivative
- 1.24.32The system shall be able to solve a transient diffusion problem with vector variables
- automatic differentiation and
- compute the correct Jacobian matrix.
Specification(s): transient_vector_diffusion/ad, transient_vector_diffusion/jac_ad
Design: ADVectorTimeDerivative
Issue(s): #13017
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- framework: AnisotropicDiffusion
- 1.24.39The system shall support direct tensor-vector products and vector dot products to maintain dimension agnostic formulations where possible.
Specification(s): test_aniso
Design: AnisotropicDiffusion
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ArrayMooseVariable
- 1.24.40The system shall provide array diffusion kernels on an array variable.
Specification(s): test
Design: ArrayMooseVariable
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.41The system shall provide array reaction kernels on an array variable.
Specification(s): test_diffusion_reaction
Design: ArrayMooseVariable
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.42The system shall provide array DG diffusion kernels on an elemental array variable.
Specification(s): test_diffusion_reaction_dg
Design: ArrayMooseVariable
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.43The system shall provide coupling of standard variables in array kernels.
Specification(s): test_diffusion_reaction_coupling
Design: ArrayMooseVariable
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.44The system shall provide coupling of array variables in standard kernels.
Specification(s): test_diffusion_reaction_other_coupling
Design: ArrayMooseVariable
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.45The system shall provide residual save-in and Jacobian diagonal save-in for
- array and
- standard variables.
Specification(s): save_in/array, save_in/test_standard_save_in
Design: ArrayMooseVariable
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.46The system shall provide array time derivative kernels on an array variable.
Specification(s): test_diffusion_reaction_transient
Design: ArrayMooseVariable
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.47The system shall provide array body-force kernels on an array variable.
Specification(s): test_body_force
Design: ArrayMooseVariable
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.1The system shall provide an ability to add array variables with constant initial conditions.
Specification(s): block_aux_kernel_test
Design: ArrayMooseVariable
Issue(s): #19564
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.2The system shall be able to define an array variable with component size one.
Specification(s): size_one
Design: ArrayMooseVariable
Issue(s): #19564
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.3The system shall report a reasonable error when defining a variable with multiple components not as an array variable.
Specification(s): array_false_error
Design: ArrayMooseVariable
Issue(s): #19564
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.61.4The system shall support the automated creation of array variables.
Specification(s): action
Design: ArrayMooseVariable
Issue(s): #19564
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Executioner
- 1.24.48We shall be able to show that without automatic scaling, this system is singular
Specification(s): poorly-conditioned-field-scalar-system
Design: ExecutionerFEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.24.49We shall be able to show that with automatic scaling, this system is non-singular
Specification(s): auto-scaled-field-scalar-system
Design: ExecutionerFEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.50We shall be able to show that with automatic scaling we can run this problem successfully in parallel
Specification(s): auto-scaled-field-scalar-system-parallel
Design: ExecutionerFEProblemSolve.md
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.37The system shall support an attribute (scalar value) reporter through the "Execution" system.
Specification(s): reporting
Design: Executioner
Issue(s): #5037
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: BlockRestrictable Interface
- 1.24.51The system shall support the ability to apply a kernel to a subset of the domain
- through a subdomain restriction on the kernel, and
- through a subdomain restriction on the variable.
Specification(s): block_restriction/kernel, block_restriction/variable
Design: BlockRestrictable Interface
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.49.1The system shall include an interface to allow objects to be restricted to subdomains.
Specification(s): block_solution_working
Design: BlockRestrictable Interface
Issue(s): #2096
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.49.2The system shall error if an object is restricted to a set of subdomains that differs from a dependant object.
Specification(s): block_undefined_var_block
Design: BlockRestrictable Interface
Issue(s): #2096
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.49.3The system shall include an interface that provides a method for returning all associated subdomains:
- as a list of names or
- as a list of ids.
Specification(s): ids/blocks, ids/hasBlocks
Design: BlockRestrictable Interface
Issue(s): #2096
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.49.4The system shall include an interface that provides methods for indicating if the supplied subdomain identifier(s) exists on the object:
- if a single subdomain is supplied ant the object is not restricted;
- if a single subdoman is supplied and the object is restricted to a set of subdomains; and
- if multiple boundaries are supplied and the object is restricted to a set of subdomains.
Specification(s): has/hasBlocks_ANY_BLOCK_ID, has/blockIDs, has/isBlockSubset
Design: BlockRestrictable Interface
Issue(s): #2096
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.49.5The system shall include an interface that provides a method for indicating if the supplied material property exists on the same subdomains as the object:
- the method shall return true if the property subdomains match with the object subdomains and
- the method shall return false if the property subdomains dot not match with the object subdomains.
Specification(s): mat/hasBlockMaterialProperty_true, mat/hasBlockMaterialProperty_false
Design: BlockRestrictable Interface
Issue(s): #2096
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.49.9The system shall error if an object restricted to subdomains is created without valid data
- regarding the problem being solved or
- information regarding the finite element mesh.
Specification(s): errors/fe_problem_null, errors/mesh_null
Design: BlockRestrictable Interface
Issue(s): #2411
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.49.10The system shall support the ability to restrict user defined calculations to sides of a subdomain.
Specification(s): test
Design: BlockRestrictable Interface
Issue(s): #2411
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: CoefTimeDerivative
- 1.24.52The system shall support scaling the computed time derivative by a scalar coefficient.
Specification(s): test
Design: CoefTimeDerivative
Issue(s): #11047
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: CoupledTimeDerivative
- 1.24.54A coupled time derivative kernel shall be provided
Specification(s): testdirichlet
Design: CoupledTimeDerivative
Issue(s): #9786
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ADCoupledTimeDerivative
- 1.24.55A coupled time derivative kernel with forward mode automatic differentiation shall be provided
Specification(s): adtestdirichlet
Design: ADCoupledTimeDerivative
Issue(s): #13138
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VectorCoupledTimeDerivative
- 1.24.56A coupled time derivative kernel compatible with vector variables with hand-coded jacobians shall be provided
Specification(s): vectortestdirichlet
Design: VectorCoupledTimeDerivative
Issue(s): #13913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.57The Jacobian from VectorCoupledTimeDerivative shall be perfect
Specification(s): jac_vectortestdirichlet
Design: VectorCoupledTimeDerivative
Issue(s): #13913
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: Diffusion
- 1.24.58The SMP Jacobian for a problem with a hanging-node shall be non-singular
Specification(s): test_smp
Design: Diffusion
Issue(s): libmesh#1985
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.59The colored finite difference Jacobian for a problem with a hanging-node shall be non-singular
Specification(s): test_fd_coloring
Design: Diffusion
Issue(s): libmesh#1985
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.60The standard finite difference Jacobian for a problem with a hanging-node shall be non-singular
Specification(s): test_fd_standard
Design: Diffusion
Issue(s): libmesh#1985
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.61A matrix-free operator shall be able to solve the hanging-node problem, indicating it is non-singular
Specification(s): test_mf
Design: Diffusion
Issue(s): libmesh#1985
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.62The SMP Jacobian shall be perfect for the hanging-node problem
Specification(s): test_smp_jacobian
Design: Diffusion
Issue(s): libmesh#1985
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.63The system shall compute a perfect Jacobian via automatic differentiation for a hanging-node problem and simultaneously handle automatic differentiation objects that do not actually have nonlinear variable dependence.
Specification(s): test_ad_smp_jacobian
Design: Diffusion
Issue(s): libmesh#1985#15732
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.107The system shall run a simple 2D linear diffusion problem with Dirichlet boundary conditions on a regular mesh.
Specification(s): test
Design: Diffusion
Issue(s): #1493
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: DisplacedProblem
- 1.24.82We shall automatically capture the dependence of things like JxW and grad_test on (second order) displacements
Specification(s): jxw_jacobian
Design: DisplacedProblem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.83We shall automatically capture the dependence of things like JxW and grad_test on (first order) displacements
Specification(s): jxw_jacobian_2
Design: DisplacedProblem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.84We shall automatically capture the dependence of things like JxW and grad_test on (second order) displacements for a cylindrical geometry
Specification(s): jxw_jacobian_cylindrical
Design: DisplacedProblem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.85We shall automatically capture the dependence of things like JxW and grad_test on (first order) displacements for a cylindrical geometry
Specification(s): jxw_jacobian_2_cylindrical
Design: DisplacedProblem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.86We shall automatically capture the dependence of things like JxW and grad_test on (second order) displacements for a spherical geometry
Specification(s): jxw_jacobian_spherical
Design: DisplacedProblem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.87We shall automatically capture the dependence of things like JxW and grad_test on (first order) displacements for a spherical geometry
Specification(s): jxw_jacobian_2_spherical
Design: DisplacedProblem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: Kernel
- 1.24.88The system shall provide optimized kernels for residuals with the test function or its gradient factored out.
Specification(s): test
Design: Kernel
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.89The system shall provide optimized kernels for residuals with the test function or its gradient factored out in the automatic differentiation system.
Specification(s): adtest
Design: Kernel
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.90The system shall calculate perfect Jacobians for the automatic differentiation precompute problem.
Specification(s): adtest-jac
Design: Kernel
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: MassLumpedTimeDerivative
- 1.24.91The system shall support the ability to use mass lumping for time derivative terms.
Specification(s): mass_lumping
Design: MassLumpedTimeDerivative
Issue(s): #2689
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.92The system shall verify that the Jacobian terms when using mass lumping for time derivative terms are computed correctly.
Specification(s): mass_lumping_jacobian
Design: MassLumpedTimeDerivative
Issue(s): #2689
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: MatCoupledForce
- 1.24.93The system shall support a kernel for coupling the sum of several products of material properties with variables and constant coefficients
Specification(s): material_coupled_force
Design: MatCoupledForce
Issue(s): #14665
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MaterialPropertyValue
- 1.24.95The system shall have the ability to verify individual Jacobian contributions before they are scaled by other finite element factors in the system.
Specification(s): test
Design: MaterialPropertyValue
Issue(s): #14823
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ScalarKernels System
- 1.24.96The system shall support solving Ordinary Differential Equations in explicit form.
Specification(s): test_expl
Design: ScalarKernels System
Issue(s): #726
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.97The system shall support solving Ordinary Differential Equations in implicit form.
Specification(s): test_sys_impl
Design: ScalarKernels System
Issue(s): #726
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.100The system shall support solving Coupled Ordinary Differential Equations.
Specification(s): test_coupled_ode_td
Design: ScalarKernels System
Issue(s): #726
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.24.103The system shall solve the constrained Neumann problem using the Lagrange multiplier approach.
Specification(s): kernel
Design: ScalarKernels System
Issue(s): cbf6d2235379f6ad75908b0f9d4be792dbce6c3d
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.104The system shall solve the constrained Neumann problem using the Lagrange multiplier approach when displacements are active.
Specification(s): kernel_disp
Design: ScalarKernels System
Issue(s): #7699
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.105The system shall support the ability to set Dirichlet boundary conditions using the Lagrange multiplier approach.
Specification(s): bc
Design: ScalarKernels System
Issue(s): #1800
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.51.1We shall be able to couple a scalar variable into AD objects and do some meaningful physics: depleting boundary source diffusion problem
Specification(s): exo
Design: ScalarKernels System
Issue(s): #13703
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.51.2We shall be able to couple a scalar variable into AD objects and get the correct Jacobian
Specification(s): jac
Design: ScalarKernels System
Issue(s): #13703
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.51.3The system shall be able to correctly compute the Jacobian of an ADScalarKernel using automatic differentiation.
Specification(s): jacobian
Design: ScalarKernels System
Issue(s): #18535
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: ParsedODEKernel
- 1.24.98The system shall support solving ODEs specified within the input file through parsed function syntax.
Specification(s): test_parsed_sys_impl
Design: ParsedODEKernel
Issue(s): #726
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.99The system support coupling of postprocessor values in the parsed function ODE kernel.
Specification(s): test_parsed_pp
Design: ParsedODEKernel
Issue(s): #14034
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: SystemBase
- 1.24.101The system shall allow scalar variable initial condition to be loaded from a file mesh
Specification(s): test_coupled_ode_td_var_ic_from_mesh
Design: SystemBase
Issue(s): #13040
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.24.102The system shall allow auxscalar variable initial condition to be loaded from a file mesh
Specification(s): test_coupled_ode_td_auxvar_ic_from_mesh
Design: SystemBase
Issue(s): #13040
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.32.182The system shall make a serialized solution vector available when requested by objects in the system.
Specification(s): test
Design: SystemBase
Issue(s): #4490
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.183The system shall make a serialized solution vector available when requested by objects in the system when uniform refinement is active.
Specification(s): uniform_refine
Design: SystemBase
Issue(s): #4490
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.184The system shall make a serialized solution vector available when requested by objects in the system when adaptivity is active.
Specification(s): adapt
Design: SystemBase
Issue(s): #4490
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: TimeDerivative
- 1.24.108The system shall be able to run a transient diffusion problem
Specification(s): test
Design: TimeDerivative
Issue(s): #000
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.109The system shall not do any mallocs in MatSetValues for simple kernels
Specification(s): test_mallocs
Design: TimeDerivative
Issue(s): #13736
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.30.96The 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: VectorTimeDerivative
- 1.24.121The system shall be able to reproduce the simple_transient_diffusion test with VectorTimeDerivative (hand-coded Jacobian).
Specification(s): transient_vector_diffusion
Design: VectorTimeDerivative
Issue(s): #13913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.122The Jacobian from VectorTimeDerivative shall be perfect
Specification(s): jac_transient_vector_diffusion
Design: VectorTimeDerivative
Issue(s): #13913
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: Variables System
- 1.24.124The system shall be able to solve a curl-curl problem using NEDELEC_ONE elements.
Specification(s): vector_fe
Design: Variables System
Issue(s): #10049
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.125The system shall be able to couple a vector variable into a standard kernel.
Specification(s): coupled_scalar_vector
Design: Variables System
Issue(s): #10049
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.126The system shall be able to assign a default value for a vector variable from the source file.
Specification(s): coupled_scalar_default_vector_source
Design: Variables System
Issue(s): #10049
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.127The system shall warn when assigning a default value with number of components less than LIBMESH_DIM, and it shall be able to assign the default value from the input file.
Specification(s): coupled_scalar_default_vector_input_and_warn
Design: Variables System
Issue(s): #10049
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.128The system shall be able to assign a default value for a vector variable from the input file and still have the correct jacobian.
Specification(s): coupled_scalar_default_vector_jacobian
Design: Variables System
Issue(s): #10049
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.129The system shall be able to solve multi-dimensional problems with LAGRANGE_VEC variables.
Specification(s): lagrange_vec
Design: Variables System
Issue(s): #10049
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.130The system shall be able to solve one-dimensional problems with LAGRANGE_VEC variables.
Specification(s): lagrange_vec_1d
Design: Variables System
Issue(s): #10049
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.131The system shall be able to solve one-dimensional problems with LAGRANGE_VEC variables and produce the correct Jacobian.
Specification(s): lagrange_vec_1d_jac
Design: Variables System
Issue(s): #10049
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.134The system shall be able to couple a vector variable into a standard kernel and produced the correct Jacobian.
Specification(s): jacobian
Design: Variables System
Issue(s): #10049
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.135The system shall be able to couple a standard variable into a vector kernel. Additionally, The system shall be able to calculate time derivatives of variable gradients.
Specification(s): coupled_gradient_dot_em_gauge
Design: Variables SystemVectorBodyForce
Issue(s): #10861
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.136The system shall be able to compute the correct Jacobian when coupling a standard variable into a vector kernel and taking time derivatives of variable gradients.
Specification(s): coupled_gradient_dot_jacobian
Design: Variables SystemVectorBodyForce
Issue(s): #10861
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.137The system shall be able to assign dirichlet boundary conditions for LAGRANGE_VEC variables; obtain coupled vector variable gradients; and correctly initialize both volume and face curl shape functions when the curl of a variable is requested.
Specification(s): coupled_vector_gradient
Design: Variables SystemVectorDiffusionVectorDirichletBCVectorFunctionDirichletBC
Issue(s): #11150
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.10The system shall support the ability to couple a scalar auxiliary calculation for use in a field auxiliary calculation:
- using current scalar values,
- using previously calculated scalar values (old), and
- using values calculated from two steps back (older).
Specification(s): coupled_scalar/test, coupled_scalar/old, coupled_scalar/older
Design: Variables System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.11The system shall support the ability to use a default value when an optional scalar coupling is requested but not supplied.
Specification(s): test_default
Design: Variables System
Issue(s): #4762
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.12The system shall support the ability to use the initial value of a scalar auxiliary calculation when it is coupled into another object that executes at the beginning of the simulation.
Specification(s): from_ic
Design: Variables System
Issue(s): #11717
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.13The system shall support "curvilinear" elements (elements that contain curved edges.
Specification(s): test
Design: Variables System
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.61.14The system shall support the hierarchical family of shape functions on mesh
- in 1D,
- in 2D, and
- in 3D.
Specification(s): group/test_hermite_3_1d, group/test_hermite_3_2d, group/test_hermite_3_3d
Design: Variables System
Issue(s): #983
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.15The system shall produce the correct convergence rate for third-order Hermite shape function discretizations as mesh refinement is performed:
- when using periodic boundary conditions, and
- when using Dirichlet boundary conditions.
Specification(s): hermite_convergance/periodic, hermite_convergance/dirichlet
Design: Variables System
Issue(s): #2190
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.16The system shall support the hierarchical family of shape functions on mesh including:
- first-order on 1D elements,
- second-order on 1D elements,
- third-order on 1D elements,
- first-order on 2D elements,
- second-order on 2D elements,
- third-order on 2D elements,
- first-order on 3D elements,
- second-order on 3D elements, and
- third-order on 3D elements.
Specification(s): group/test_hier_1_1d, group/test_hier_2_1d, group/test_hier_3_1d, group/test_hier_1_2d, group/test_hier_2_2d, group/test_hier_3_2d, group/test_hier_1_3d, group/test_hier_3_3d, group/test_hier_2_3d
Design: Variables System
Issue(s): #1636
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.17The system shall support the constant Monomial family of shape functions on mesh elements:
- in one dimension,
- in two dimensions, and
- in three dimensions.
Specification(s): constant_monomial/test_monomial_constant_1d, constant_monomial/test_monomial_constant_3d, constant_monomial/test_monomial_constant_2d
Design: Variables System
Issue(s): #1636
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.18The system shall support the direct retrieval of "elemental solution" or "degree of freedom" values without the need to sample the finite element shape function:
- for current solution values,
- for previous solution values (old), and
- for solution values calculated two steps back (older).
Specification(s): get_elemental_val/current, get_elemental_val/old, get_elemental_val/older
Design: Variables System
Issue(s): #11451
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.61.19The system shall support second and third order Monomial family of shape functions.
Specification(s): test
Design: Variables System
Issue(s): #3293
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.20The system shall support the ability to have mixed field variable orders on the same mesh.
Specification(s): test
Design: Variables System
Issue(s): 76ddaa1961753020e57d62d2b8f29e0638e40c28
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.21The system shall support the ability to have multiple independent block restricted variables in a mesh contain multiple blocks.
Specification(s): test
Design: Variables System
Issue(s): 76ddaa1961753020e57d62d2b8f29e0638e40c28
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.28The system shall support the ability to couple to a previous field variable calculation to produce another field such that there is no Jacobian contribution due to the lagged coupling.
Specification(s): test
Design: Variables System
Issue(s): #6101
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.29The system shall ensure that coupled second derivative calculations are only performed when requested and are only performed on the minimum required fields.
Specification(s): interface_kernels
Design: Variables System
Issue(s): #10492
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.30The system shall initialize SIDE_HIERARCHIC variables as instructed
Specification(s): side_hierarchic
Design: Variables System
Issue(s): #20191
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VectorBodyForce
- 1.24.135The system shall be able to couple a standard variable into a vector kernel. Additionally, The system shall be able to calculate time derivatives of variable gradients.
Specification(s): coupled_gradient_dot_em_gauge
Design: Variables SystemVectorBodyForce
Issue(s): #10861
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.24.136The system shall be able to compute the correct Jacobian when coupling a standard variable into a vector kernel and taking time derivatives of variable gradients.
Specification(s): coupled_gradient_dot_jacobian
Design: Variables SystemVectorBodyForce
Issue(s): #10861
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.24.138The system shall error if the 'function' and 'function_x' parameters are both set when defining a vector function Dirichlet boundary condition.
Specification(s): comp_error
Design: VectorBodyForce
Issue(s): #13309
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: VectorDiffusion
- 1.24.137The system shall be able to assign dirichlet boundary conditions for LAGRANGE_VEC variables; obtain coupled vector variable gradients; and correctly initialize both volume and face curl shape functions when the curl of a variable is requested.
Specification(s): coupled_vector_gradient
Design: Variables SystemVectorDiffusionVectorDirichletBCVectorFunctionDirichletBC
Issue(s): #11150
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VectorDirichletBC
- 1.24.137The system shall be able to assign dirichlet boundary conditions for LAGRANGE_VEC variables; obtain coupled vector variable gradients; and correctly initialize both volume and face curl shape functions when the curl of a variable is requested.
Specification(s): coupled_vector_gradient
Design: Variables SystemVectorDiffusionVectorDirichletBCVectorFunctionDirichletBC
Issue(s): #11150
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VectorFunctionDirichletBC
- 1.24.137The system shall be able to assign dirichlet boundary conditions for LAGRANGE_VEC variables; obtain coupled vector variable gradients; and correctly initialize both volume and face curl shape functions when the curl of a variable is requested.
Specification(s): coupled_vector_gradient
Design: Variables SystemVectorDiffusionVectorDirichletBCVectorFunctionDirichletBC
Issue(s): #11150
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MooseApp
- 1.25.1The system shall support the ability to report installable inputs on the command line.
Specification(s): show_copyable_inputs
Design: MooseApp
Issue(s): #19022
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.25.2The system shall support the ability to "install" inputs:
- from a pre-determined user-readable location;
- copied using a MOOSE-based binary;
- verifying a successful copy operation;
- able to report an error if overwriting may occur using a MOOSE-based binary;
- able to link a binary to an installed location;
- able to successfully launch the TestHarness using a MOOSE-based binary;
- and cleaned up from a user-readable location.
Specification(s): test_copy_install/setup_fake_test_structure, test_copy_install/copy_tests, test_copy_install/check_files, test_copy_install/copy_warn_overwrite, test_copy_install/link_exec_installed, test_copy_install/run, test_copy_install/tear_down
Design: MooseApp
Issue(s): #19022
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionRunCommandRunAppCheckFiles
- 1.31.1The system shall support the programmatic creation of a simulation tools without the need of an input file.
Specification(s): minimal
Design: MooseApp
Issue(s): #6126
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.5The compiled application shall be capable of returning the name used for registering objects.
Specification(s): test
Design: MooseApp
Issue(s): #11337
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.6The system shall be able to run a specific application by passing a command line option.
Specification(s): specified_app
Design: MooseApp
Issue(s): #20062
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.137The system shall produce a warning when non-expired deprecated code is executed.
Specification(s): deprecated
Design: MooseApp
Issue(s): #10745
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.138The system shall produce a warning when expired deprecated code is executed.
Specification(s): expired
Design: MooseApp
Issue(s): #10745
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.139The system shall produce an error when the –no-deprecated-flag is passed and deprecated code is executed.
Specification(s): expired_error
Design: MooseApp
Issue(s): #10745
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.140The system shall produce a warning indicating a possible replacement when deprecated code is superseded.
Specification(s): renamed
Design: MooseApp
Issue(s): #10745
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.143The system allow coupling between variables on or off displaced meshes
- not using automatic differentiation methods
- using automatic differentiation methods
Specification(s): g/nonad, g/ad
Design: MooseApp
Issue(s): #9659
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.187The system shall support pausing execution for the purpose of attaching a debugger after launch.
Specification(s): test
Design: MooseApp
Issue(s): #11166
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.189The application executable shall report the version with the –version command line argument.
Specification(s): print_version_long
Design: MooseApp
Issue(s): #10163
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.190The application executable shall report the version with the -v command line argument.
Specification(s): print_version_short
Design: MooseApp
Issue(s): #10163
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.83The system shall print parameters when the
--show-input
flag is used on the command line.Specification(s): show_input_test
Design: MooseApp
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.86The system shall be able to dump input file syntax in JSON format.
Specification(s): json_full
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.36.87The system shall be able to dump input file syntax in JSON format and exclude test object syntax.
Specification(s): json_no_test_objects
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.36.88The system shall be able to dump a subset of JSON formatted syntax.
Specification(s): json_search
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.36.89The system shall dump line information along with JSON formatted syntax.
Specification(s): json_line_info
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.36.91The system shall be able to dump input file (HIT) syntax.
Specification(s): hit
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.36.92The system shall be able to dump a subset of input file (HIT) syntax.
Specification(s): hit_search
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.37.11The system shall output all registered objects in HIT format.
Specification(s): hit_registry
Design: MooseApp
Issue(s): #10952
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.37.12The system shall output all registered objects in single line format.
Specification(s): registry
Design: MooseApp
Issue(s): #10952
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: BoundaryMarker
- 1.26.2The adaptivity system shall create an auxiliary field variable that marks elements for refinement adjacent to a boundary.
Specification(s): adjacent
Design: Markers SystemBoundaryMarker
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.3The adaptivity system shall create an auxiliary field variable that marks elements for refinement within a given distance of a boundary.
Specification(s): distance
Design: Markers SystemBoundaryMarker
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: BoxMarker
- 1.26.4The adaptivity system shall create an auxiliary field variable that marks elements for refinement within a rectangular region.
Specification(s): mark_only
Design: Markers SystemBoxMarker
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.5The adaptivity system shall adapt the mesh within a rectangular region.
Specification(s): mark_and_adapt
Design: Markers SystemBoxMarker
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.7The system shall include the ability to mark elements within a subdomain to be unchanged for mesh adaptivity.
Specification(s): test
Design: Adaptivity SystemBoxMarker
Issue(s): #1275
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ComboMarker
- 1.26.6The system shall include the ability to combine multiple mesh refinement markers into a single value.
Specification(s): test
Design: ComboMarker
Issue(s): #1303
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Errorfractionmarker
- 1.26.8The system shall include a means for setting mesh refinement flags based on percent of error for a sorted vector of error values computed for each finite element.
Specification(s): test
Design: Errorfractionmarker
Issue(s): #1301
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.9The system shall include the ability to use the same error extremes during all calculations of error fraction values during mesh adaptivity.
Specification(s): no_clear
Design: Errorfractionmarker
Issue(s): #9914
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.10The system shall include a means for setting mesh refinement flags based on percent of error for a sorted vector of error values computed for each finite element using FV variables
Specification(s): fv
Design: Errorfractionmarker
Issue(s): #16069
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ErrorToleranceMarker
- 1.26.11The system shall include a means for computing mesh refinement flags based on an absolute values of error.
Specification(s): test
Design: ErrorToleranceMarker
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.12The system shall include a means for performing mesh adaptivity based on an absolute values of error.
Specification(s): adapt_test
Design: ErrorToleranceMarker
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: OrientedBoxMarker
- 1.26.14The system shall support the ability to mark elements for mesh adaptivity based on a bounding box with arbitrary orientation.
Specification(s): obm
Design: OrientedBoxMarker
Issue(s): #2514
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ReporterPointMarker
- 1.26.16The adaptivity system shall create an auxiliary field variable that marks elements containing the points from the reporter for refinement.
Specification(s): mark_only
Design: Markers SystemReporterPointMarker
Issue(s): #18886
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.26.17The marker shall create an error if the coordinate vectors are not all the same size
Specification(s): wrong_size_error
Design: Markers SystemReporterPointMarker
Issue(s): #18886
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.26.18The marker shall be used for adaptivity for a moving point, being able to coarsen elements the point moves out of but not coarsen elements if it contains point.
Specification(s): adaptivity
Design: Markers SystemReporterPointMarker
Issue(s): #18886
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: UniformMarker
- 1.26.20The system shall support marking the entire finite element mesh for refinement.
Specification(s): test
Design: UniformMarker
Issue(s): #1566
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ValueRangeMarker
- 1.26.21The system shall include the ability to mark elements within a finite element mesh for adaptivity based on if the value of a variable is within a specific range.
Specification(s): test
Design: ValueRangeMarker
Issue(s): #1815
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ValueThresholdMarker
- 1.26.22The system shall include the ability to mark elements within a finite element mesh for adaptivity based on if the value of a variable is above or below a threshold.
Specification(s): test
Design: ValueThresholdMarker
Issue(s): #1313
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MaterialADConverter
- 1.27.1The system shall be able to convert functors from AD to regular.
Specification(s): regular
Design: MaterialADConverter
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.2The system shall be able to convert functors from regular to AD.
Specification(s): ad
Design: MaterialADConverter
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ADPiecewiseLinearInterpolationMaterial
- 1.27.10ADPiecewiseLinearInterpolationMaterial shall create a material with a linear interpolation of a variable
Specification(s): test
Design: ADPiecewiseLinearInterpolationMaterial
Issue(s): #8265
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.11PiecewiseLinearInterpolationMaterial shall create a material with a linear interpolation of a variable and perform approriate scaling
Specification(s): test_scale_factor
Design: ADPiecewiseLinearInterpolationMaterial
Issue(s): #8265
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.12ADPiecewiseLinearInterpolationMaterial shall create a material with a linear interpolation and extrapolation of a variable
Specification(s): test_extrapolation
Design: ADPiecewiseLinearInterpolationMaterial
Issue(s): #15379
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.13ADPiecewiseLinearInterpolationMaterial shall throw an error if x, y, and xy_data are all specified
Specification(s): test_err1
Design: ADPiecewiseLinearInterpolationMaterial
Issue(s): #8265
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.14ADPiecewiseLinearInterpolationMaterial shall throw an error if x and xy_data are both specified
Specification(s): test_err2
Design: ADPiecewiseLinearInterpolationMaterial
Issue(s): #8265
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.15ADPiecewiseLinearInterpolationMaterial shall throw an error if x and y vectors are different lengths
Specification(s): test_err3
Design: ADPiecewiseLinearInterpolationMaterial
Issue(s): #8265
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.16ADPiecewiseLinearInterpolationMaterial shall throw an error if xy_data vector is not a multiple of two
Specification(s): test_err4
Design: ADPiecewiseLinearInterpolationMaterial
Issue(s): #8265
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.17ADPiecewiseLinearInterpolationMaterial shall calculate perfect Jacobians
Specification(s): test-jac
Design: ADPiecewiseLinearInterpolationMaterial
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: CoupledValueFunctionMaterial
- 1.27.22By default coupled variables shall map to teh x,y,z, and t function parameters.
Specification(s): order
Design: CoupledValueFunctionMaterial
Issue(s): #20193
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.23The user shall be able to provide a custom mapping of coupled variables to function parameters.
Specification(s): order_shuffled
Design: CoupledValueFunctionMaterial
Issue(s): #20193
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.24Duplicate positions in the coupled variable mapping to function parameters shall raise an error.
Specification(s): order_duplicate_error
Design: CoupledValueFunctionMaterial
Issue(s): #20193
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.25A number of positions in mapping to function parameters that does not match the number of coupled variable shall raise an error.
Specification(s): order_count_error
Design: CoupledValueFunctionMaterial
Issue(s): #20193
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.26The ADCoupledValueFunctionMaterial shall return correct derivatives for coupled AD variables.
Specification(s): adjac
Design: CoupledValueFunctionMaterial
Issue(s): #20193
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- framework: DerivativeMaterialInterface
- 1.27.28The system shall be capable of producing analytic derivatives of material properties:
- defined by function expressions,
- involving chain rules of material properties defined by function expressions, and
- for the free energy Allen-Cahn Bulk material function.
Specification(s): analytic_derivatives/property_names, analytic_derivatives/material_chaining, analytic_derivatives/parsed_material
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FUNCTIONAL
Type(s): CSVDiffRunAppExodiff
- 1.27.29The system shall support late binding of derivative material properties:
- so that construction order does not influence the outcome of the tests, and
- so that construction order does not influence the outcome of the tests when using automatic differentiation, and
- so that they may be retrieved before being declared.
Specification(s): ordering/construction, ordering/ad_construction, ordering/execution
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FUNCTIONAL
Type(s): RunAppExodiff
- 1.27.30The system shall support supplying a constant literal in place of a property name for material property derivative consumers.
Specification(s): new_getproperty_semantics
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.31The system shall support optional coupling where materials that do not exist are returned as valid objects containing zero.
Specification(s): mutliblock
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.27.32The system shall issue an error when required derivative materials that are retrieved are never declared.
Specification(s): warn
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.33The system shall handle a bad evaluation by
- passing a silent nan.
- throwing a warning and passing a silent nan.
- throwing an error.
- throwing an exception.
Specification(s): bad_evaluation/nan, bad_evaluation/warning, bad_evaluation/error, bad_evaluation/exception
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionRunApp
- 1.27.34The system shall handle a bad evaluation when using JIT by
- passing a silent nan.
- throwing a warning and passing a silent nan.
- throwing an error.
- throwing an exception.
Specification(s): bad_evaluation_jit/nan, bad_evaluation_jit/warning, bad_evaluation_jit/error, bad_evaluation_jit/exception
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionRunApp
- 1.27.35The system shall be capable of coupling postprocessor values in
- ParsedMaterial
- DerivativeParsedMaterialParsedMaterial
- ADParsedMaterial
- ADDerivativeParsedMaterial
Specification(s): postprocessor_coupling/parsed_material, postprocessor_coupling/derivative_parsed_material, postprocessor_coupling/ad_parsed_material, postprocessor_coupling/ad_derivative_parsed_material
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.36The system shall be capable of producing analytic derivatives of material properties using dual numbers:
- returning an exact jacobian.
- returning an exact jacobian in derivative materials.
- defined by function expressions,
- involving chain rules of material properties defined by function expressions, and
Specification(s): ad_analytic_derivatives/jacobian, ad_analytic_derivatives/derivative_jacobian, ad_analytic_derivatives/property_names, ad_analytic_derivatives/material_chaining
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterCSVDiffRunApp
- 1.27.37The system shall create AD material properties even if the derivatives are zero
Specification(s): ad_zero_derivatives
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.38The system shall support late binding of derivative material properties:
- so that they may be retrieved before being declared.
Specification(s): ad_ordering/execution
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.27.39The system shall support supplying a constant literal in place of a property name for material property derivative consumers that require dual numbers.
Specification(s): ad_new_getproperty_semantics
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.40The system shall support optional coupling where materials that do not exist are returned as valid objects containing zero, supporting dual numbers.
Specification(s): ad_mutliblock
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.27.41The system shall issue an error when required dual number derivative materials that are retrieved are never declared.
Specification(s): ad_warn
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.42The system shall handle a bad evaluation using dual numbers by
- passing a silent nan.
- throwing a warning and passing a silent nan.
- throwing an error.
- throwing an exception.
Specification(s): ad_bad_evaluation/nan, ad_bad_evaluation/warning, ad_bad_evaluation/error, ad_bad_evaluation/exception
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionRunApp
- 1.27.43The system shall allow users to request derivatives with respect to function symbols other than MOOSE variables
- such as derivatives w.r.t. material properties
- and error out if derivatives w.r.t unknown symbols are requested
- and error out if derivatives MOOSE variables are requested in additional_derivative_symbols (as they are requested by default)
- and error out if any symbols are supplied more than once
Specification(s): additional_derivatives/mat_props, additional_derivatives/error_unknown, additional_derivatives/error_variable, additional_derivatives/error_duplicate
Design: DerivativeMaterialInterface
Issue(s): #4299#6360#5055#6901#5039#14975#15207#18402
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- 1.27.44The system shall require explicitly coupled properties to exist
- for regular properties in ParsedMaterials
- and error out for non-existing for explicitly requested derivatives in ParsedMaterials
- for explicitly requested derivatives in ParsedMaterials
- for explicitly requested derivatives but optimized out derivatives in ParsedMaterials
- but provide for a user override to default non-existing properties to zero
- in DerivativeParsedMaterials
Specification(s): required_property/parsed_material, required_property/parsed_material_requested_non_existing_derivative, required_property/parsed_material_requested_existing_derivative, required_property/parsed_material_requested_optimized_out_derivative, required_property/allow_override, required_property/derivative_parsed_material
Design: DerivativeMaterialInterface
Issue(s): #18917
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionRunApp
- framework: DerivativeSumMaterial
- 1.27.45The system shall provide a method for summing multiple DerivativeParsedMaterialsand compare exact to a single DerivativeParsedMaterial
- validating coupling
- without validating coupling
- validating coupling using automatic differentiation
- without validating coupling using automatic differentiation
Specification(s): random_ic/validating, random_ic/no_validating, random_ic/ad_validating, random_ic/ad_no_validating
Design: DerivativeSumMaterial
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FunctorADConverter
- 1.27.51The 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.27.52The system shall error with a clear parameter error if
- the names for the regular functors to be converted are going to overlap with the new automatic differentiation functors
- the names for the regular functors to be converted are going to overlap with the other new regular functors
- the names for the automatic differentiation functors to be converted are going to overlap with the new regular functors
- the names for the automatic differentiation functors to be converted are going to overlap with the other new automatic differentiation functors
- the number of automatic differentiation functors to convert does not match the number of names for the converted functors
- 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: GenericFunctorGradientMaterial
- 1.27.54The system shall be able to create functor material properties from the gradient of other functors.
Specification(s): exo
Design: GenericFunctorGradientMaterial
Issue(s): #19943
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: GenericFunctorMaterial
- 1.27.55The system shall be able to create material properties that can be evaluated on-the-fly provided geometric arguments.
Specification(s): exo
Design: GenericFunctorMaterial
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.56The system shall error if multiple definitions are given for a functor material property on a given subdomain.
Specification(s): multiple_definitions
Design: GenericFunctorMaterial
Issue(s): #16809
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.57The system shall be able to solve a diffusion problem with different diffusivities on different subdomains and obtain the same results using
- material properties bound to references
- material properties evaluated with geometric position information
Specification(s): qp_functor/regular, qp_functor/functor
Design: GenericFunctorMaterial
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.59The system shall be able to evaluate, cache, and then clear functor material property evaluations
- at the beginning of timesteps
- always, so always perform evaluations
- on nonlinear iterations
- on linear iterations
Specification(s): prop_caching/on_timestep_begin, prop_caching/always, prop_caching/on_nonlinear, prop_caching/on_linear
Design: GenericFunctorMaterial
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.63The system shall be able to cache functor evaluations associated with cell centers.
Specification(s): elem_arg_caching
Design: GenericFunctorMaterial
Issue(s): #20470
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FunctorVectorElementalAux
- 1.27.58The system shall be able to transfer vector material properties to an auxiliary variable, on a per-component basis.
Specification(s): vector-functor
Design: FunctorVectorElementalAux
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VectorMagnitudeFunctorMaterial
- 1.27.64The system shall be able to compute the vector norm in a functor material property of component scalars
Specification(s): test
Design: VectorMagnitudeFunctorMaterial
Issue(s): #20360
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.65The system shall be able to supply a functor capable of computing the norm of a vector functor.
Specification(s): vector-test
Design: VectorMagnitudeFunctorMaterial
Issue(s): #20360
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.66The system shall error if a user provides to the vector magnitude functor material both a vector functor parameter and
- x-component functor parameter
- y-component functor parameter
Specification(s): multiple_provided/x_functor, multiple_provided/y_functor
Design: VectorMagnitudeFunctorMaterial
Issue(s): #20360
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: Output System
- 1.27.94The system shall support the output of material data as field variables including
- outputting all properties within a material definition;
- outputting all properties from the output definition;
- outputting certain properties within a material definition;
- outputting certain properties within the output definition on a subdomain;
- outputting certain properties within the material definition on a subdomain;
- outputting certain properties within the material definition on a subdomain with a displaced configuration;
- outputting certain properties within the material definition on a boundary;
- outputting certain properties within the material definition to different files; and
- 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
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.95The system shall support the output as auxiliary field variables of
- automatic differentiation vector material properties
Specification(s): data_types/ad_vector
Design: Materials SystemOutput System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.27.96The system shall 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
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.97The system shall 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
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.27.98The 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
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.27.99The system shall show the field variable names for outputting material data added by materials.
Specification(s): show_added_aux_vars
Design: Materials SystemOutput System
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.5The system shall support outputting of simulation data using the ExodusII format using simplified input file syntax.
Specification(s): exodus
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.6The system shall by default display data on the console from:
- the Postprocessor system and
- the scalar variable system.
Specification(s): console/postprocessors, console/scalar_variables
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.32The system shall support the output of postprocessors and scalars to CSV files for steady state problems.
Specification(s): steady
Design: Output SystemCSV
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.33The system shall support the output of postprocessors and scalars to CSV files for transient propblems.
Specification(s): transient
Design: Output SystemCSV
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.34The system shall support the output of postprocessors and scalars to CSV files for transient problems without a time column.
Specification(s): no_time
Design: Output SystemCSV
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.35The system shall support the output of postprocessors and scalars to Exodus files for transient problems.
Specification(s): transient_exodus
Design: Output SystemCSV
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.36The system shall support the output of CSV data:
- with checkpoint enabled and
- when restarted creates a new output file or
- 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.36.37The system shall support CSV output aligned columns and a custom delimiter.
Specification(s): align
Design: Output SystemCSV
Issue(s): #3229
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.38The system shall support CSV output to the console that is sorted by the variable name.
Specification(s): sort
Design: Output SystemCSV
Issue(s): #8974
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.53The system shall be able to output the
displacedmesh 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.36.54If the user requested the output of a displaced problem and there is none present, the system shall fallback to using the non-displaced problem.
Specification(s): non_displaced_fallback
Design: Output System
Issue(s): #11309
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.56The Output system shall be capable of applying displacements directly to the outputted mesh for steady problems.
Specification(s): test
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.57The Output system shall be capable of applying displacements directly to the outputted mesh for transient problems with Kernels using the displaced configuration.
Specification(s): displaced_eq_test
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.58The Output system shall be capable of applying displacements directly to the outputted mesh for transient problems.
Specification(s): displacement_transient_test
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.60The system shall error when two outputs with the same name are created.
Specification(s): duplicate_objects
Design: Output System
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.61The system shall error when two outputs produce a file with the same name.
Specification(s): duplicate_output_files
Design: Output System
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.62The system shall reserve names for output objects:
- "none" and
- "all."
Specification(s): reserved/none_reserved, reserved/all_reserved
Design: Output System
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.82If a postprocessor utilizes the "outputs" parameter, but postprocessor output is disabled for the console object, the system shall warn the user.
Specification(s): pps_screen_out_warn_test
Design: Output System
Issue(s): #1426
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.109The system shall support specifying an output interval for an output input file block.
Specification(s): time_step
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.110The system shall support specifying an output interval for all outputs.
Specification(s): common_time_step
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.111The system shall support limiting output to the final timestep of a simulation.
Specification(s): output_final
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.112The system shall support output at specific simulation times.
Specification(s): sync_times
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.113The system shall support multiple output objects that have different simulation synchronization times specified.
Specification(s): multiple_sync_times
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.114The system shall support the disabling of an output object by restricting the execution settings.
Specification(s): no_output
Design: Output System
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.115The system shall support the ability to limit output objects only at the beginning and end of a simulation.
Specification(s): no_intermediate
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.116The system shall not output the same information multiple times when an output object is defined to operate on the end of each timestep and the final timestep.
Specification(s): no_final_repeat
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.117The system shall support output during linear and non-linear iterations during transient simulations using the ExodusII format.
Specification(s): exodus
Design: Output System
Issue(s): #2617
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.118The system shall support output during linear and non-linear iterations during steady simulations using the ExodusII format:
- in a single file or
- 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.36.119The system shall support output during linear and non-linear iterations during transient simulations using the VTK format.
Specification(s): vtk
Design: Output System
Issue(s): #2617
Collection(s): FUNCTIONAL
Type(s): XMLDiff
- 1.36.120The system shall support output during linear and non-linear iterations during transient simulations using the CSV format.
Specification(s): csv
Design: Output System
Issue(s): #2617
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.121The system shall support output during linear and non-linear iterations during transient simulations:
- with both the start and end times defined,
- with only the start time defined,
- with the start and end timestep provided,
- with the start timestep given, and
- 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.36.130The Nemesis Output object shall output separate files per process for visualization purposes.
Specification(s): test
Design: Output System
Issue(s): #2122
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.131The Nemesis Output object shall support writing elemental variables.
Specification(s): nemesis_elemental_replicated
Design: Output System
Issue(s): #2122
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.132The Nemesis Output object shall support writing elemental variables with the same numbering on DistributedMesh.
Specification(s): nemesis_elemental_distributed
Design: Output System
Issue(s): #2122
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.133The Nemesis Ouput object shall support writing scalar variables.
Specification(s): nemesis_scalar_replicated
Design: Output System
Issue(s): #2122
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.134The Nemesis Ouput object shall support writing scalar variables when using DistributedMesh.
Specification(s): nemesis_scalar_distributed
Design: Output System
Issue(s): #2122
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.136The system shall support the ability to limit output to certain sub-applications based on name.
Specification(s): dt_from_master
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.140The system shall provide a system for outputting solution variables with a uniformly refined mesh:
- with a shift in output position,
- with a custom filename,
- with mesh adaptivity,
- with a generated mesh,
- with a file mesh, and
- 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
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.141The system shall include an example demonstrating the use of oversampling.
- without and
- with mesh adaptivity.
Specification(s): example/ex02, example/ex02_adapt
Design: Output System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.146The system shall support offseting the spatial position of a domain during output.
Specification(s): test
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.147The system shall support the ability to specify the output object for postprocessor data from within the input file block defining the postprocessor.
Specification(s): limit
Design: Output SystemOutputInterface
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.148The system shall error if an invalid output name is provided within the postprocessor input file block.
Specification(s): invalid_outputs
Design: Output SystemOutputInterface
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.149The system shall support limiting postprocessor output to the screen.
Specification(s): console
Design: Output SystemOutputInterface
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.150The system shall support limiting postprocessor output to from within the input file syntax of an output object.
Specification(s): show_hide
Design: Output SystemOutputInterface
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- The system shall error if a postprocessor variable is listed for suppression and inclusion within an output object block in the input file.
Specification(s): test_hidden_shown
Design: Output SystemOutputInterface
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.152The system shall support limiting the output of comma seperated value data to the final timestep:
- for all scalar data and
- 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.36.161The system shall support writing file to sub-directories.
Specification(s): test
Design: Output System
Issue(s): #3249
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.162The system shall print the various components of the simulation information header to the screen
Specification(s): basic
Design: Output SystemConsole
Issue(s): #2173
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.163The system shall print the mesh information to the screen when the mesh changes
Specification(s): mesh
Design: Output SystemConsole
Issue(s): #2173
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.164The system shall print the auxiliary system information to the screen when the mesh changes
Specification(s): aux
Design: Output SystemConsole
Issue(s): #2173
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.165The system shall print the nonlinear system information to the screen when the mesh changes
Specification(s): nonlinear
Design: Output SystemConsole
Issue(s): #2173
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.170The system shall support outputting field and scalar data to the ExodusII format.
Specification(s): test
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- The system shall error if a variable is marked for output and output suppression.
Specification(s): test_hidden_shown
Design: Output System
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.172The system shall error if a variable is perscribed for output but does not exist.
Specification(s): test_nonexistent
Design: Output System
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.173The system shall test that output of an auxiliary field can be disabled within the input block defining the variable.
Specification(s): block_hide
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.174The system shall support a system for including or suppressing output variables the operates when only a single variable for each type exists.
Specification(s): show_single_vars
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.175The system shall support a system for including or suppressing output variables.
Specification(s): show_hide
Design: Output System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.176The variables specified in an Output object's 'hide = ' list shall not appear in the output file.
Specification(s): nemesis_hide
Design: Output System
Issue(s): #1895
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.36Postprocessor 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.41.96The system shall support outputting the scalar Postprocessor values at specific intervals
- to a file and
- 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.41.97The 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: PiecewiseConstantByBlockMaterial
- 1.27.100The system shall provide a material object that can, for a single material property, map subdomain IDs to a possibly discontinuous property value.
Specification(s): regular
Design: PiecewiseConstantByBlockMaterial
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PiecewiseByBlockFunctorMaterial
- 1.27.101The system shall provide a material object that can, for a single functor material property, map subdomain IDs to different functors.
Specification(s): functor
Design: PiecewiseByBlockFunctorMaterial
Issue(s): #16758
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FileMesh
- 1.28.1The system shall support importing mesh information from Abaqus that includes
- element identifiers,
- element sets, and
- element sets with extra space in file.
Specification(s): abaqus/testcube_elem_id, abaqus/testcube_elset_name, abaqus/testcube_elset_name_ws
Design: FileMesh
Issue(s): #14302
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.21The system shall read GMesh (.msh) format file meshes.
Specification(s): gmsh_test
Design: FileMesh
Issue(s): #2105
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.22The system shall read GMesh (.msh) format file meshes containing multiple boundaries.
Specification(s): gmsh_bc_test
Design: FileMesh
Issue(s): #1402
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Mesh Splitting
- 1.28.12The system shall generate pre-split mesh files using a standard input file combined with command line arguments.
Specification(s): test_2
Design: Mesh Splitting
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.13The system shall use pre-split binary mesh files using a standard input file combined with command line arguments.
Specification(s): test_2a
Design: Mesh Splitting
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.14The system shall auto-detect and use pre-split meshes using a standard input file combined with command line arguments.
Specification(s): test_4
Design: Mesh Splitting
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.15The system shall use pre-split ascii meshes when the command line parameter also includes the pre-split suffix.
Specification(s): test_4a
Design: Mesh Splitting
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.16The system shall use pre-splits for several different numbers of processors auto-detected from the number of MPI processors used.
Specification(s): test_8
Design: Mesh Splitting
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.17The system shall use pre-splits for several different numbers of processors when the command line parameter also includes the pre-split suffix.
Specification(s): test_8a
Design: Mesh Splitting
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.76The system shall support optionally allowing uniform refinements when using a pre-split mesh
Specification(s): square
Design: Mesh SystemMesh Splitting
Issue(s): #18575
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.77A mesh can be split into a specified number of files using command line options.
Specification(s): make_split
Design: Mesh Splitting
Issue(s): #10623
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.28.78A mesh can be pre-split properly and used to generate equivalent results to running a simulation with the unsplit mesh.
Specification(s): use_split
Design: Mesh Splitting
Issue(s): #10623
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.79Console output should include an indicator that a pre-split mesh is being used when using –split-mesh in distributed = auto mode
- without and
- 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.28.80The mesh splitter will throw an error when an attempt is made to split a "DistributedMesh".
Specification(s): split_with_distributed_error
Design: Mesh Splitting
Issue(s): #11434
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.28.81The mesh splitter capability will honor geometric RelationshipManager objects.
Specification(s): split_with_RM_part1
Design: Mesh Splitting
Issue(s): #11434
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.28.82Meshes that are pre-split with active RelationshipManager objects work the same as if using an online DistributedMesh.
Specification(s): split_with_RM_part2
Design: Mesh Splitting
Issue(s): #11434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.83Splitting meshes from file should work with custom partitioners.
Specification(s): grid_from_file
Design: Mesh Splitting
Issue(s): #11944
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.28.84Splitting meshes from a generated mesh should work with custom partitioners.
Specification(s): grid_from_generated
Design: Mesh Splitting
Issue(s): #11944
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: ConcentricCircleMesh
- 1.28.18The system shall generate a quadrilateral mesh consisting of concentric circles.
Specification(s): test
Design: ConcentricCircleMesh
Issue(s): #11656
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Partitioner System
- 1.28.19The system shall support the ability to create custom objects for performing mesh partitioning, for example
- a linear partitioner that
- operates with a displaced configuration and
- is capable of restarting.
Specification(s): group/custom_linear_partitioner, group/custom_linear_partitioner_displacement, group/custom_linear_partitioner_restart
Design: Partitioner System
Issue(s): #5543
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.87The system shall provide a parallel partition based on mesh subdomains
Specification(s): test
Design: Partitioner System
Issue(s): #8672#8747#8950#8956
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.88The parallel partitioning capability by subdomain shall report a reasonable error when a given subdomain does not exist
Specification(s): missing_block
Design: Partitioner System
Issue(s): #8672#8747#8950#8956
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.38.3The system shall allow custom partitioners to work with mesh generators
Specification(s): test
Design: Partitioner System
Issue(s): #18696
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.38.4The system shall allow skipping partitioning after loading a mesh
Specification(s): test
Design: Partitioner System
Issue(s): #18759
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: GeneratedMesh
- 1.28.39The system shall generate a structured mesh on a Cartesian domain.
Specification(s): test
Design: GeneratedMesh
Issue(s): #760
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.40The system shall generate first-order, structured meshes with biasing in the x, y, and z directions.
Specification(s): mesh_bias
Design: GeneratedMesh
Issue(s): #6129
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.41The system shall generate second-order, structured meshes with biasing in the x, y, and z directions.
Specification(s): mesh_bias_quadratic
Design: GeneratedMesh
Issue(s): #6129
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: AnnularMeshGenerator
- 1.28.42The system shall include the ability to generate an annular mesh that errors when
- the min radius is larger than the max radius;
- the min angle is greater than or equal to the max angle;
- the angle separation is larger than 360 degrees;
- the number of elements in the angular direction is too small due to the number of elements; and
- the number of elements in the angular direction is too small due to the maximum angle.
- shall throw an error if the quadrilateral and triangular subdomain ids are the same.
- shall throw an error if both radial positions and the number of radial elements are prescribed.
- shall throw an error if both radial positions and the radius growth parameter are prescribed.
- shall throw an error if any of the radial positions fall out of the bounds between rmin and rmax.
Specification(s): annular_errors/annular_except1, annular_errors/annular_except2, annular_errors/annular_except3, annular_errors/annular_except4, annular_errors/annular_except5, annular_errors/annular_except6, annular_errors/annular_except7, annular_errors/annular_except8, annular_errors/annular_except9
Design: AnnularMeshGenerator
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.28.43The system shall include the ability to create
- an annulus using quad elements;
- an annulus sector using quad elements;
- a circular disk using quad elements; and
- circular disk sector using quad elements.
Specification(s): annular/annulus, annular/annulus_sector, annular/disc, annular/disc_sector
Design: AnnularMeshGenerator
Issue(s): #8432
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.3The system shall have the capability of generating a mesh based upon an annular geometry.
Specification(s): annular_mesh_generator
Design: AnnularMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.4The system shall have the capability of generating a mesh based upon an annular geometry with a negative growth ratio.
Specification(s): annular_mesh_generator_negative_growth
Design: AnnularMeshGenerator
Issue(s): #16699
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.6The system shall generate an annular mesh with prescribed radial positions of the intermediate rings of nodes
Specification(s): annular_mesh_generator_radial_positions
Design: AnnularMeshGenerator
Issue(s): #18486
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.7The system shall have the capability of generating an annular mesh with equal-area elements
Specification(s): equal_area
Design: AnnularMeshGenerator
Issue(s): #20422
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.8The system shall error when generating an annular mesh with equal-area elements when a growth ratio is also provided
Specification(s): conflicting_settings
Design: AnnularMeshGenerator
Issue(s): #20422
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.9The system shall error when generating an annual mesh with equal-area elements when radial positions are also provided
Specification(s): conflicting_settings_nr
Design: AnnularMeshGenerator
Issue(s): #20422
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: SpiralAnnularMesh
- 1.28.44The system shall have an algorithm for meshing an annular region with triangular elements.
Specification(s): spiral_annular_mesh
Design: SpiralAnnularMesh
Issue(s): #12205
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: RinglebMesh
- 1.28.45The system shall have an algorithm for generating triangular and quadrilateral meshes for the Ringleb problem.
Specification(s): ringleb_mesh
Design: RinglebMesh
Issue(s): #12246
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Nemesis
- 1.28.65The system shall support writing solution data in the Nemesis parallel file format.
Specification(s): nemesis_test
Design: Mesh SystemNemesis
Issue(s): #2520
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.66The system shall support the re-partitioning of mesh files input using the Nemesis format.
Specification(s): nemesis_repartitioning_test
Design: Mesh SystemNemesis
Issue(s): #2520
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.72The system shall support Nemesis output.
Specification(s): nemesis_out_test
Design: Nemesis
Issue(s): #920
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: PatternedMesh
- 1.28.69The system shall generate a mesh using one or more meshes stitched into a pattern controlled by a 2D array.
Specification(s): patterned_generation
Design: PatternedMesh
Issue(s): #6950
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.70The system shall read in a previously generated "patterned mesh" and run a simulation using that mesh.
Specification(s): patterned_run
Design: PatternedMesh
Issue(s): #6950
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: StitchedMesh
- 1.28.85The system shall support the creating a single mesh from multiple meshes stitched together.
Specification(s): test
Design: StitchedMesh
Issue(s): #8308
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.28.86The system shall error if at least one mesh file is not supplied when creating a mesh from multiple meshes stitched together.
Specification(s): files_error
Design: StitchedMesh
Issue(s): #8308
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: FileMeshGenerator
- 1.28.89The system shall read TetGen file meshes.
Specification(s): mesh_only_warning
Design: FileMeshGenerator
Issue(s): #20694
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.59The system shall have the ability to generate a mesh by reading it from a file.
Specification(s): test
Design: FileMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.60The system shall have the ability to assign element extra integers with elemental variables in an Exodus mesh file.
Specification(s): extra_integer_test
Design: FileMeshGenerator
Issue(s): #14916
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.61The system shall have the ability to read IsoGeometric Analysis meshes with rational bases in ExodusII format.
Specification(s): exodus_iga_test
Design: FileMeshGenerator
Issue(s): #18768
Collection(s): FUNCTIONAL
Type(s): XMLDiff
- 1.30.62The system shall have the ability to remove spline nodes from IsoGeometric Analysis meshes.
Specification(s): exodus_iga_nosplines_test
Design: FileMeshGenerator
Issue(s): #18768
Collection(s): FUNCTIONAL
Type(s): XMLDiff
- 1.30.63The system shall have the ability to read IsoGeometric Analysis meshes with 3D elements and sidesets in ExodusII format.
Specification(s): exodus_pseudoiga_test
Design: FileMeshGenerator
Issue(s): #18768
Collection(s): FUNCTIONAL
Type(s): XMLDiff
- 1.30.64The system shall have the ability to output checkpoint files along with the mesh meta data.
Specification(s): pre_checkpoint_load_test
Design: FileMeshGenerator
Issue(s): #16192
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.30.65The system shall have the ability to load the mesh from checkpoint files.
Specification(s): checkpoint_load_test
Design: FileMeshGenerator
Issue(s): #16192
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.89The system shall support the ability to import meshes written using the General Mesh Viewer format.
Specification(s): gmsh_test
Design: FileMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.90The system shall have the ability to read boundary information from Gmsh formatted mesh files.
Specification(s): gmsh_bc_test
Design: FileMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: TiledMesh
- 1.28.90The system shall construct a mesh by "tiling" another mesh repeatedly.
Specification(s): tiled_mesh_test
Design: TiledMesh
Issue(s): #1729
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: AllSideSetsByNormalsGenerator
- 1.30.1The system shall support automatic addition of sidesets based on outward facing normals of the mesh.
Specification(s): simple
Design: AllSideSetsByNormalsGenerator
Issue(s): #3306
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.2The system shall group automatically added sidesets when multiple surfaces share the same outward facing normal.
Specification(s): less_simple
Design: AllSideSetsByNormalsGenerator
Issue(s): #3306
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.129The system shall be able to generate mesh side sets for all external surfaces on the mesh for each unique normal.
Specification(s): generate_sidesets_normals_test
Design: AllSideSetsByNormalsGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.130The system must be able to replace the side sets when applying side sets during mesh generation.
Specification(s): replace_sidesets_test
Design: AllSideSetsByNormalsGenerator
Issue(s): #14460
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: BlockDeletionGenerator
- 1.30.11The system shall be capable of deleting
- all of the elements in a mesh based on subdomain ID,
- all of the elements in a mesh based on subdomain names and
- multiple blocks simultaneously in a mesh based on subdomain ID.
- blocks and assigning the new boundary even if the input mesh is not prepared.
Specification(s): block_deletion/all_by_block_ids, block_deletion/all_by_block_names, block_deletion/multiple_blocks, block_deletion/input_not_prepared
Design: BlockDeletionGenerator
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: BoundaryDeletionGenerator
- 1.30.12The system shall have the capability to remove boundaries in an existing mesh.
Specification(s): boundary_deletion_test
Design: BoundaryDeletionGenerator
Issue(s): #11174
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- framework: BoundingBoxNodeSetGenerator
- 1.30.13The system shall be capable of generating new mesh node sets based upon a user-specified bounding box
- where the new node set will be placed on nodes within the bounding box, or
- where the new node set will be placed on nodes outside of the bounding box.
Specification(s): gen_nodesets/inside, gen_nodesets/outside
Design: BoundingBoxNodeSetGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.14The system shall produce an error when attempting to add a new mesh node set based on a bounding box
- where the bounding box fails to span any mesh nodes, and
- where multiple boundary IDs are supplied for a single bounding box.
Specification(s): errors/bad_coord, errors/test_bad_boundaryid
Design: BoundingBoxNodeSetGenerator
Issue(s): #11640
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: BreakBoundaryOnSubdomainGenerator
- 1.30.15The system shall be capable of splitting existing mesh boundary sets where their underlying subdomain changes
- on external boundaries, and
- on internal boundaries.
Specification(s): boundary_type/external, boundary_type/internal
Design: BreakBoundaryOnSubdomainGenerator
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: BreakMeshByBlockGenerator
- 1.30.16The system shall be able to create separate blocks in a mesh
- without a split interface in 3D;
- with a split interface in 3D;
- with a polycrystal based mesh in 3D;
- without a split interface in 2D;
- with a split interface in 2D; and
- with a polycrystal based mesh in 2D.
Specification(s): break_mesh_by_blocks_generator/3d_auto_test, break_mesh_by_blocks_generator/3d_split_test, break_mesh_by_blocks_generator/3d_polycrystal_test, break_mesh_by_blocks_generator/2d_auto_test, break_mesh_by_blocks_generator/2d_splittrue_test, break_mesh_by_blocks_generator/polycrystal_test
Design: BreakMeshByBlockGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.17The system shall be able to break the mesh between listed blocks:
- without splitting the interface and with splitting the transition interface;
- with a split interface and without splitting the transition interface;
- with a split interface and splitting the transition interface;
- with a split interface, without splitting the transition interface, and without a transition interface;
- without a split interface, splitting the transition interface, or a transition interface;
Specification(s): surrounding_block_restricted/split_transition_only, surrounding_block_restricted/split_interface_only, surrounding_block_restricted/split_all, surrounding_block_restricted/no_transition, surrounding_block_restricted/transition_split
Design: BreakMeshByBlockGenerator
Issue(s): #15895
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.18The system shall be able to break the mesh between listed block pairs.
Specification(s): block_pairs_restricted
Design: BreakMeshByBlockGenerator
Issue(s): #17749
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.19The system shall be able to break the mesh between listed block pairs
- by creating one new node.
- by creating two new nodes.
- by creating three new nodes.
Specification(s): block_pairs_restricted_3blocks/one_new_node, block_pairs_restricted_3blocks/two_new_nodes, block_pairs_restricted_3blocks/three_new_nodes
Design: BreakMeshByBlockGenerator
Issue(s): #17749
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.20The system shall be able to create two sides interface when interfaces are created between listed block pairs.
Specification(s): block_pairs_restricted_two_interfaces
Design: BreakMeshByBlockGenerator
Issue(s): #17749
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.21The system shall properly assign node processor ids for paritioned meshes
Specification(s): hanging_nodes
Design: BreakMeshByBlockGenerator
Issue(s): #15793
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: CartesianMeshGenerator
- 1.30.22The system shall be capable of generating an non-uniform mesh on a Cartesian domain in
- one,
- two, and
- three dimensions.
Specification(s): cartesian_mesh/1D, cartesian_mesh/2D, cartesian_mesh/3D
Design: CartesianMeshGenerator
Issue(s): #12863
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: CombinerGenerator
- 1.30.23The system shall support the ability to combine multiple meshes:
- using a single input mesh at multiple positions,
- using a single input mesh at multiple positions obtained from a file,
- using multiple meshes at multiple positions, and
- using multiple meshes at multiple positions obtained from a file, and
- using multiple meshes with no positions, and
- while keeping name(s) of sidesets intact.
Specification(s): translations/single, translations/single_from_file, translations/multi, translations/multi_from_file, translations/none, translations/name
Design: CombinerGenerator
Issue(s): #13412
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.24The system shall error when trying to combine multiple meshes,
- but only one input is supplied with no positions, or
- but only one input is supplied with no positions file, or
- the number of meshes and the number of positions is mismatched, or
- the number of meshes and the number of positions in the file is mismatched.
Specification(s): errors/missing_pos, errors/missing_pos_file, errors/mismatch_pos, errors/mismatch_pos_from_file
Design: CombinerGenerator
Issue(s): #13412
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ConcentricCircleMeshGenerator
- 1.30.25The system shall have the capability to generate a mesh pattern consisting of concentric circles contained within a square.
Specification(s): mesh_only
Design: ConcentricCircleMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.26The winding order of the elements created by the mesh generator shall be uniform.
Specification(s): winding_order
Design: ConcentricCircleMeshGenerator
Issue(s): #17533
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ElementGenerator
- 1.30.49The system shall support the ability to create a mesh element-wise by specifying points, element types, and connectivity,
- resulting in a single element mesh, or
- resulting in a mesh with multiple disconnected elements.
Specification(s): generate/single_element, generate/multi_elem_multi_gen
Design: ElementGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MeshGenerator
- 1.30.50The system shall error when requesting
- a MeshGenerator by parameter and the parameter is not valid
- a MeshGenerator by parameter and the parameter is of the wrong type
- MeshGenerators by parameter and the parameter is not valid
- MeshGenerators by parameter and the parameter is of the wrong type
Specification(s): tests/get_mesh_invalid, tests/get_mesh_wrong_type, tests/get_meshes_by_name_invalid, tests/get_meshes_by_name_wrong_type
Design: MeshGenerator
Issue(s): #19285
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.124The system shall be able to output detailed mesh information about generated meshes.
Specification(s): test
Design: MeshGenerator
Issue(s): #16783
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.30.143The system mesh generation capability shall be extensible to allow composition of existing mesh generators.
Specification(s): stitched_subgenerators
Design: MeshGenerator
Issue(s): #17184
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ExplodeMeshGenerator
- 1.30.51The system shall have the ability to break all element-element interfaces within given subdomains both
- in 2D, and
- in 3D.
Specification(s): all/2D, all/3D
Design: ExplodeMeshGenerator
Issue(s): #21060
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ExtraNodesetGenerator
- 1.30.52The system shall have the ability to add extra mesh node sets based on existing node IDs.
Specification(s): generate_extra_nodeset
Design: ExtraNodesetGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.53The system shall have the ability to add extra mesh node sets based on node coordinates.
Specification(s): generate_extra_nodeset_coord
Design: ExtraNodesetGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.54The system shall have the ability to add extra mesh node sets based on multiple node coordinates.
Specification(s): generate_extra_nodeset_multiple_coord
Design: ExtraNodesetGenerator
Issue(s): #14936
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FancyExtruderGenerator
- 1.30.55The system shall be able to extrude a mesh with variable height elevations, with variable numbers of layers, and swap subdomain IDs
Specification(s): test
Design: FancyExtruderGenerator
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.56The system shall make sure the mesh is prepared after a mesh generator has indicated the mesh is not prepared and before running a solve.
Specification(s): prepare_mesh
Design: FancyExtruderGenerator
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.30.57The system shall be able to use the result from FancyExtruderGenerator in subsequent mesh generators
Specification(s): extruder_then_parsed_gen_sideset
Design: FancyExtruderGenerator
Issue(s): #16902
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.58The system shall be able to retain and swap element extra integers during extrusion.
Specification(s): extruder_with_element_extra_integer_swap
Design: FancyExtruderGenerator
Issue(s): #18087
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FillBetweenPointVectorsGenerator
- 1.30.66The system shall generator a bow-shape transition layer based on the two input point vectors using TRI3 elements.
Specification(s): bow
Design: FillBetweenPointVectorsGenerator
Issue(s): #20641
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.67The system shall generator a bow-shape transition layer with a provided bias growth factor based on the two input point vectors using TRI3 elements.
Specification(s): bow_man_bias
Design: FillBetweenPointVectorsGenerator
Issue(s): #20641
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.68The system shall generator a bow-shape transition layer with automatically generated bias growth factors based on the two input point vectors using TRI3 elements.
Specification(s): bow_auto_bias
Design: FillBetweenPointVectorsGenerator
Issue(s): #20641
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.69The system shall generator a bow-shape transition layer based on the two input point vectors using QUAD4 elements.
Specification(s): bow_quad
Design: FillBetweenPointVectorsGenerator
Issue(s): #20641
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.70The system shall throw an error if either input vector of points include points that are not in XY plane.
Specification(s): non_xy_plane
Design: FillBetweenPointVectorsGenerator
Issue(s): #20641
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.71The system shall throw an error if either input vector of points include less than 2 points.
Specification(s): not_enough_points
Design: FillBetweenPointVectorsGenerator
Issue(s): #20641
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.72The system shall throw an error if the two input vectors have different length and QUAD4 elements option is selected.
Specification(s): quad_with_different_vector_sizes
Design: FillBetweenPointVectorsGenerator
Issue(s): #20641
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: FillBetweenSidesetsGenerator
- 1.30.73The system shall be able to generate a connector transition layer based on the two input meshes and boundaries.
Specification(s): squares
Design: FillBetweenSidesetsGenerator
Issue(s): #20641
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.74The system shall be able to generate a connector transition layer based on the two input meshes and boundaries and stitch it with the input meshes.
Specification(s): squares_stitched
Design: FillBetweenSidesetsGenerator
Issue(s): #20641
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.75The system shall be able to generate a connector transition layer with manual biasing based on the two input meshes and boundaries.
Specification(s): squares_bias
Design: FillBetweenSidesetsGenerator
Issue(s): #20641
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.76The system shall be able to generate a connector transition layer with automatic biasing based on the two input meshes and boundaries.
Specification(s): squares_auto_bias
Design: FillBetweenSidesetsGenerator
Issue(s): #20641
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.77The system shall throw an error if the two input meshes are the same.
Specification(s): err_same_inputs
Design: FillBetweenSidesetsGenerator
Issue(s): #20641
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.78The system shall throw an error if one of the input boundary to generate a mesh in-between has multiple segments.
Specification(s): err_multiseg_boundary
Design: FillBetweenSidesetsGenerator
Issue(s): #20641
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.79The system shall throw an error if one of the input boundary to generate a mesh in-between is a closed loop.
Specification(s): err_closed_loop_boundary
Design: FillBetweenSidesetsGenerator
Issue(s): #20641
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: GeneratedMeshGenerator
- 1.30.83The 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.30.84The 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.30.85The system shall include mesh generation tools and allow adding a name prefix to the node/sideset names and maintain the
- id and
- include the added name.
Specification(s): prefix/id, prefix/name
Design: GeneratedMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.86The 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
- the shifted id and
- include the added name.
Specification(s): both/id, both/name
Design: GeneratedMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.87The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.88The 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: ImageMeshGenerator
- 1.30.91The system shall be able to read in an image.
Specification(s): image_mesh_generator_test
Design: ImageMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: LowerDBlockFromSidesetGenerator
- 1.30.92The system shall be able to create different subdomains
- using boundary ids.
- using boundary names.
Specification(s): mesh/ids, mesh/names
Design: LowerDBlockFromSidesetGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MeshCollectionGenerator
- 1.30.93The system shall be able to combine multiple meshes into a single unconnected mesh.
Specification(s): mesh_collection_generator_test
Design: MeshCollectionGenerator
Issue(s): #13221
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MeshExtruderGenerator
- 1.30.94The system shall have the capability of extruding a lower dimensional mesh to create a higher dimensional mesh
- from 2D quads to 3D hexes,
- where newly created elements can be assigned a new subdomain IDs based on old IDs,
- where newly created elements can be assigned a new subdomain IDs based on a pattern,
- where the extrusion direction is not orthogonal to the original line or plane of elements, and
- where the extrusion occurs based on another generated mesh,
- while making sure to preserve existing side set names.
Specification(s): extruder/basic, extruder/new_subdomains, extruder/new_subdomain_pattern, extruder/angled, extruder/generator, extruder/preserve_sideset_names
Design: MeshExtruderGenerator
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MeshSideSetGenerator
- 1.30.95The system shall support the generation of side sets between subdomains of a finite element mesh.
Specification(s): mesh_side_set_generator_test
Design: MeshSideSetGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MeshMetaDataInterface
- 1.30.97The system shall issue an error when mesh meta-data properties are requested but never declared.
Specification(s): meta_data_error_check
Design: MeshMetaDataInterface
Issue(s): #13841
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.98The system shall error if a invalid identifier is supplied when attempting to retrieve a restart meta data object.
Specification(s): get_meta_data_error_check
Design: MeshMetaDataInterface
Issue(s): #13841
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.99The system shall support the ability to save mesh meta data generated by mesh generators when splitting the mesh.
Specification(s): pre_split_mesh
Design: MeshMetaDataInterface
Issue(s): #16192
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.30.100The system shall support the ability to use the mesh meta data when using the split mesh.
Specification(s): test_meta_data_with_use_split
Design: MeshMetaDataInterface
Issue(s): #16192
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.32.133The system shall support the ability for actions to query the existence of a mesh attribute (meta data).
Specification(s): check_mesh_meta_data
Design: MeshMetaDataInterface
Issue(s): #15987
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: MoveNodeGenerator
- 1.30.101The system shall support the ability to modify node(s) coordinates
- in a mesh with a single first order element
- in a Cartesian 3D mesh.
Specification(s): generate/single_element, generate/3d
Design: MoveNodeGenerator
Issue(s): #18577
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.102The system shall error if the node to be moved cannot be found in the mesh.
Specification(s): failure_missing
Design: MoveNodeGenerator
Issue(s): #18577
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.103The system shall error if the node position and node id arrays do not match in size
Specification(s): failure_mismatch
Design: MoveNodeGenerator
Issue(s): #18577
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ParsedGenerateSideset
- 1.30.104The system shall have the ability to assign mesh side sets based on parsed spatial functions.
Specification(s): parsed_generate_sideset_test
Design: ParsedGenerateSideset
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.105The system shall have the ability to filter by neighboring subdomain id in ParsedGenerateSideset.
Specification(s): parsed_generate_sideset_neighbor_sub_id_test
Design: ParsedGenerateSideset
Issue(s): #15651
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ParsedSubdomainMeshGenerator
- 1.30.106The system shall have the ability to assign mesh subdomains based on parsed spatial functions.
Specification(s): parsed_subdomain_mg_test
Design: ParsedSubdomainMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PatchMeshGenerator
- 1.30.107The system shall be able to create a patch test mesh with:
- quad4 elements,
- quad8 elements,
- hex8 elements, and
- hex20 elements.
Specification(s): group/quad4, group/quad8, group/hex8, group/hex20
Design: PatchMeshGenerator
Issue(s): #13453
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PatternedMeshGenerator
- 1.30.108The system shall have the ability to stetch multiple input meshes together into a new mesh based upon a user-defined pattern.
Specification(s): patterned_mesh_generator_test
Design: PatternedMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PlaneDeletionGenerator
- 1.30.109The system shall provide a method for deleting mesh elements lying on one side of a user-defined plane.
Specification(s): test
Design: PlaneDeletionGenerator
Issue(s): #13046
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PlaneIDMeshGenerator
- 1.30.110The system shall support the generation of plane IDs for 2D Cartesian grid
- by taking x-direction as the plane axis
- by taking y-direction as the plane axis
Specification(s): 2d_cartesian_grid/x_dir, 2d_cartesian_grid/y_dir
Design: PlaneIDMeshGenerator
Issue(s): #19217
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.111The system shall support the generation of plane IDs for 3D extruded mesh
Specification(s): 3d_extruded_mesh
Design: PlaneIDMeshGenerator
Issue(s): #19217
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: RefineBlockGenerator
- 1.30.112The system shall support the ability to refine
- a single block within a multi-domain mesh
- multiple blocks within a multi-domain mesh
- multiple blocks within a multi-domain mesh, with neighbor refinement enabled
Specification(s): generate/single_block, generate/multiple_block, generate/neighbor_refinement
Design: RefineBlockGenerator
Issue(s): #18686
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: RefineSidesetGenerator
- 1.30.113The system shall support the ability to refine
- neighboring elements of an external boundary along a mesh
- neighboring elements of a specified boundary along a mesh
- both the neighboring elements of, and the elements along, a specified boundary
Specification(s): generate/left, generate/secondary, generate/both
Design: RefineSidesetGenerator
Issue(s): #18913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.114The system shall error if the specified boundary to be refined does not exist
Specification(s): failureBoundary
Design: RefineSidesetGenerator
Issue(s): #18913
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: RenameBlockGenerator
- 1.30.115The system shall be able to rename or renumber mesh blocks by:
- identifying both old and new blocks by ID,
- identifying old blocks by ID and new blocks by name,
- identifying old blocks by name and new blocks by ID, and
- identifying both old and new blocks by name,
- and by identifying blocks by both id and name.
Specification(s): rename/all_ids, rename/old_ids_new_names, rename/old_names_new_ids, rename/all_names, rename/mixed
Design: RenameBlockGenerator
Issue(s): #11640#14128#16885#17710
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.30.116The system shall be able to merge blocks in a mesh.
Specification(s): merge
Design: RenameBlockGenerator
Issue(s): #11640#14128#16885#17710
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.30.117The system shall throw a reasonable error:
- when old blocks are provided that do not exist within the mesh
- and when the provided old and new blocks are not the same length.
Specification(s): errors/missing, errors/inconsistent_size
Design: RenameBlockGenerator
Issue(s): #11640#14128#16885#17710
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.30.118The system shall be able to rename or renumber mesh blocks using old syntax by
- identifying blocks by ID
- identifying blocks by name
Specification(s): deprecated/id, deprecated/name
Design: RenameBlockGenerator
Issue(s): #11640#14128#16885#17710
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.30.119The system shall report a reasonable error when renaming or renumbering blocks using deprecated syntax when
- both old block IDs and old block names are provided
- both new block IDs and new block names are provided
- the deprecated syntax for old block id and the new syntax for old block is used
- the deprecated syntax for old block name and the new syntax for old block is used
- the deprecated syntax for new block id and the new syntax for new block is used
- the deprecated syntax for new block name and the new syntax for new block is used
Specification(s): deprecated_errors/old_block_id_and_name, deprecated_errors/new_block_id_and_name, deprecated_errors/old_block_and_id, deprecated_errors/old_block_and_name, deprecated_errors/new_block_and_id, deprecated_errors/new_block_and_name
Design: RenameBlockGenerator
Issue(s): #11640#14128#16885#17710
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: RenameBoundaryGenerator
- 1.30.120The system shall be able to rename or renumber mesh boundaries by:
- identifying both old and new boundaries by ID,
- identifying old boundaries by ID and new boundaries by name,
- identifying old boundaries by name and new boundaries by ID, and
- identifying both old and new boundaries by name,
- and by identifying boundaries by both id and name.
Specification(s): rename/all_ids, rename/old_ids_new_names, rename/old_names_new_ids, rename/all_names, rename/mixed
Design: RenameBoundaryGenerator
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.30.121The system shall be able to merge boundaries in a mesh.
Specification(s): merge
Design: RenameBoundaryGenerator
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.30.122The system shall throw a reasonable error:
- when old boundaries are provided that do not exist within the mesh
- and when the provided old and new boundaries are not the same length.
Specification(s): errors/missing, errors/inconsistent_size
Design: RenameBoundaryGenerator
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: RinglebMeshGenerator
- 1.30.123The system shall support the ability to create a mesh for a "Ringleb" geometry.
Specification(s): ringleb_mesh_generator_test
Design: RinglebMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SideSetsAroundSubdomainGenerator
- 1.30.125The system shall have the ability to create new mesh side sets around subdomains:
- for a subdomain contained completely within a larger domain,
- on specific sides of a subdomain based upon the normal to that side,
- around multiple subdomains within a larger domain, and
- around two blocks within a domain.
Specification(s): group/inside, group/one_side, group/multi_subs, group/two_inside
Design: SideSetsAroundSubdomainGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SideSetsBetweenSubdomainsGenerator
- 1.30.126The system shall have the ability to create new side sets between adjacent subdomains:
- on a mesh with several adjacent subdomains,
- where some subdomains are adjacent and not where paired subdomains are not adjacent, and
- between two subdomains in a mesh with two adjacent subdomains.
Specification(s): group/adjacent_subs, group/nonadjacent_subs, group/two_subs
Design: SideSetsBetweenSubdomainsGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SideSetsFromBoundingBoxGenerator
- 1.30.127The system shall have the ability to generate side sets based upon bounding boxes:
- a bounding box contained within the domain,
- multiple bounding boxes contained within the domain,
- multiple bounding boxes contained within a 3D domain, and
- where bounding boxes perfectly overlap but create unique ids.
Specification(s): generate/generate_sidesets_bounding_box_test, generate/test_multiple_boundary_ids, generate/test_multiple_boundary_ids_3d, generate/test_overlapping_sidesets
Design: SideSetsFromBoundingBoxGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.128The system shall issue an error when attempting to create side sets from a bounding box:
- when no elements are located within the specified bounding box,
- when the bounding box is larger than the domain so that no new side set is created, and
- when the bounding box fails to span over any nodes.
Specification(s): errors/no_elements_in_bounding_box, errors/no_side_sets_found, errors/no_nodes_found
Design: SideSetsFromBoundingBoxGenerator
Issue(s): #11640
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: SideSetsFromNormalsGenerator
- 1.30.131The system shall support the generation of multiple mesh side sets on the exterior surfaces of a mesh grouped by normal:
- where the normal varies within a tolerance from element to element,
- where the normal is fixed within a specified tolerance.
Specification(s): generate/normals_follow, generate/normals_fixed
Design: SideSetsFromNormalsGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SideSetsFromPointsGenerator
- 1.30.132The system shall be able to create sidesets.
Specification(s): sidesets_from_points_generator_test
Design: SideSetsFromPointsGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SmoothMeshGenerator
- 1.30.133The system shall be able to use libmesh mesh modification tools.
Specification(s): smooth_mesh_generator_test
Design: SmoothMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SpiralAnnularMeshGenerator
- 1.30.134The system shall be able to create a spiral annular mesh with triangle elements (TRI3 or TRI6).
Specification(s): spiral_annular_mesh_generator_test
Design: SpiralAnnularMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: StackGenerator
- 1.30.135The system shall be able to generate meshes by stacking up existing meshes in
- two and
- three dimensions and
- 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- framework: StitchedMeshGenerator
- 1.30.136The system shall support the creation of a finite element mesh from existing meshes
- by 'stitching' them together and
- be able to utilize the resulting mesh in a simulation.
Specification(s): stitched_mesh_generator/mesh_only, stitched_mesh_generator/simulation
Design: StitchedMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SubdomainBoundingBoxGenerator
- 1.30.137The system shall include the ability to assign subdomain identifiers for elements within a regular bounding box.
Specification(s): subdomain_bounding_box_generator_test
Design: SubdomainBoundingBoxGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.138The system shall include the ability to assign subdomain identifiers for elements outside of a regular bounding box.
Specification(s): subdomain_bounding_box_generator_outside_test
Design: SubdomainBoundingBoxGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.139The system shall include the ability to assign subdomain identifiers for elements within an arbitrarily oriented bounding box.
Specification(s): oriented_subdomain_bounding_box_generator_test
Design: SubdomainBoundingBoxGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.140The system shall include the ability to assign subdomain identifiers for elements with a regular bounding box that is restricted to only modify elements with specific subdomain identifiers.
Specification(s): subdomain_bounding_box_generator_restricted_test
Design: SubdomainBoundingBoxGenerator
Issue(s): #12279
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.141The system shall include the ability to assign extra element integers within a regular bounding box.
Specification(s): subdomain_bounding_box_element_integer_test
Design: SubdomainBoundingBoxGenerator
Issue(s): #13764
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SubdomainIDGenerator
- 1.30.142The system shall have the ability to change or overwrite the subdomain IDs of all elements in a mesh.
Specification(s): generate_subdomain_id_test
Design: SubdomainIDGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: TiledMeshGenerator
- 1.30.144The system shall include the ability to create a finite element mesh by tiling existing meshes.
Specification(s): tiled_mesh_generator_test
Design: TiledMeshGenerator
Issue(s): #11640
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: TransformGenerator
- 1.30.145The system shall include the ability to rotate and scale a finite element mesh.
Specification(s): rotate_and_scale
Design: TransformGenerator
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.30.146The system shall include the ability to translate a finite element mesh in a manner that
- is defined by the user,
- places the center of the mesh at the origin, or
- places the minimum of the mesh at the origin.
Specification(s): translate/user_set, translate/center_origin, translate/min_origin
Design: TransformGenerator
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: UniqueExtraIDMeshGenerator
- 1.30.147The system shall be shall support the generation of new extra element ID by parsing the existing extra element IDs
- with the default option for new id value setting
- with the new id value setting rule option
Specification(s): test/default, test/id_rule
Design: UniqueExtraIDMeshGenerator
Issue(s): #19617
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: NonlinearSystem
- 1.32.131The system shall report an error when nodal boundary condition is applied on a non-nodal variable.
Specification(s): nodal_bc_on_elemental_var
Design: NonlinearSystem
Issue(s): #14019
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.35.12The system shall apply scaling to residuals and Jacobians for volumetric PDE terms applied at nodes
Specification(s): scaling
Design: NonlinearSystem
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.52.1The system shall ignore particular variable automatic scaling factors
Specification(s): ignore
Design: NonlinearSystem
Issue(s): #19573
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.52.2The system shall not allow ignoring of particular variable automatic scaling factors if they are grouped with other variables for scaling
Specification(s): fail_with_group
Design: NonlinearSystem
Issue(s): #19573
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.52.6The system shall be able to conduct residual based automatic scaling such that the largest residual vector component corresponding to each variable has magnitude unity
- in a one variable problem
- 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.52.7The system shall be able to conduct jacobian based automatic scaling such that the largest jacobian diagonal component corresponding to each variable has magnitude unity
- in a one variable problem
- 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.52.8The system shall print current variable automatic scaling factors
Specification(s): up-to-date-scale-factors
Design: NonlinearSystem
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MooseUtils Namespace
- 1.32.132The system shall report an error when a git-lfs file pointer is encountered.
Specification(s): check_git_lfs_pointer
Design: MooseUtils Namespace
Issue(s): #17407
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: MooseObject
- 1.32.134The system shall be to find data files in designated directories, regardless of the source repository or install location.
Specification(s): exists
Design: MooseObject
Issue(s): #20839
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.135The system shall throw an exception if a data file cannot be found in any of the designated directories.
Specification(s): error
Design: MooseObject
Issue(s): #20839
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: SetupDebugAction
- 1.32.136The system shall support the output a processor id field for the purposes of debugging
Specification(s): test
Design: SetupDebugActionProcessorIDAux
Issue(s): #16154
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ProcessorIDAux
- 1.32.136The system shall support the output a processor id field for the purposes of debugging
Specification(s): test
Design: SetupDebugActionProcessorIDAux
Issue(s): #16154
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: InputParameters
- 1.32.141The system shall be able to deprecate coupled variable names, while enabling user code to only use the new, blessed name
Specification(s): deprecated_coupled_var
Design: InputParameters
Issue(s): #15497
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.142The system shall not give a deprecation warning if the user uses the blessed coupled variable name instead of the deprecated coupled variable name.
Specification(s): blessed_coupled_var
Design: InputParameters
Issue(s): #15497
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.37.13The system shall report an error if the supplied input file is not formatted correctly.
Specification(s): error
Design: InputParameters
Issue(s): #16410
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.23The system shall support vector size checking on input parameter vectors:
- for ints,
- for Reals.
Specification(s): vector_len_checks/realvectorlength, vector_len_checks/intvectorlength
Design: InputParameters
Issue(s): #3988
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.24The system shall support vector element checking:
- against constant expressions,
- against other unsigned int vector elements,
- against other long vector elements,
- against other int vector elements, and
- against other Real vector elements.
Specification(s): vector_elem_checks/all_element_check, vector_elem_checks/elementcompare_unsigned_int, vector_elem_checks/elementcompare_long, vector_elem_checks/elementcompare_int, vector_elem_checks/elementcompare_real
Design: InputParameters
Issue(s): #3988
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.25The system shall support vector bounds checking on input parameter vectors.
Specification(s): outofbounds
Design: InputParameters
Issue(s): #3988
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.37.26The system shall support checking for non-empty input parameter vectors.
Specification(s): checkempty
Design: InputParameters
Issue(s): #3988
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.41.10The system shall the substitution of a constant value in place of an optional Postprocessor coupling value
- when that value is supplied as a default in the coupling declaration
- or when that value is supplied in the input file.
Specification(s): default_value/test, default_value/real_override
Design: InputParameters
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.60.6The system shall provide a method for transferring common parameters from one object to another.
Specification(s): test
Design: InputParameters
Issue(s): #3352
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.60.7The system shall prevent the user from copying InputParameters objects inside of MooseObject-derived objects.
Specification(s): test
Design: InputParameters
Issue(s): #5439
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.60.15The system shall automatically report input errors when a required parameter is not specified.
Specification(s): error
Design: InputParameters
Issue(s): #16410
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: MooseException
- 1.32.144The system shall support throwing an exception during the residual calculation, which will cut back the time step.
Specification(s): parallel_exception_residual_transient
Design: MooseException
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.145The system shall support throwing an exception during the residual calculation on a non-zero rank, which will cut back the time step.
Specification(s): parallel_exception_residual_transient_non_zero_rank
Design: MooseException
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.146The system shall support throwing an exception during the Jacboain calculation, which will cut back the time step.
Specification(s): parallel_exception_jacobian_transient
Design: MooseException
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.147The system shall support throwing an exception during the Jacobian calculation on a non-zero rank, which will cut back the time step.
Specification(s): parallel_exception_jacobian_transient_non_zero_rank
Design: MooseException
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.148The system shall support throwing an exception during the initial condition calculation, which will terminate the solve.
Specification(s): parallel_exception_initial_condition
Design: MooseException
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.32.149The system shall support throwing an error during a residual calculation, which will terminate the solve.
Specification(s): parallel_error_residual_transient_non_zero_rank
Design: MooseException
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.150The system shall support throwing an error during a Jacobian calculation, which will terminate the solve.
Specification(s): parallel_error_jacobian_transient_non_zero_rank
Design: MooseException
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.32.151The system shall allow users to skip exception checks to avoid global communication.
Specification(s): skip_exception_check
Design: MooseException
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SetupInterface (execute_on)
- 1.32.152The system shall maintain a flag available for inspection indicating the current "execution stage" enumeration.
Specification(s): test
Design: SetupInterface (execute_on)
Issue(s): #8610
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.188The system shall support running a user-defined subroutine each time a subdomain change occurs when iterating over the mesh.
Specification(s): test
Design: SetupInterface (execute_on)
Issue(s): #9474
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.57The system shall execute objects associated with mesh entities corresponding to the number of times those objects appear:
- once for general user objects,
- for each element,
- for each side,
- for each internal side, and
- for each node.
Specification(s): setup_interface_count/GeneralUserObject, setup_interface_count/ElementUserObject, setup_interface_count/SideUserObject, setup_interface_count/InternalSideUserObject, setup_interface_count/NodalSideUserObject
Design: SetupInterface (execute_on)
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: The
hit
command - 1.32.153The
hit find
command shall be able to find- files with specific parameters,
- files not containing a specified parameter,
- parameters set to an exact specified value,
- parameters not set to an exact specified value,
- parameters with additional pattern constraints,
- parameters with additional inverted pattern constraints.
Specification(s): find/parameter_exists, find/parameter_does_not_exist, find/positive_pattern, find/negative_pattern, find/additional_pattern, find/additional_pattern_negative
Design: The
hit
commandIssue(s): #19001
Collection(s): FUNCTIONAL
Type(s): RunCommand
- 1.32.154The
hit merge
command shall be able to combine input files.Specification(s): merge
Design: The
hit
commandIssue(s): #19001
Collection(s): FUNCTIONAL
Type(s): RunCommand
- 1.32.155The
hit diff
command shall be able to- show differences between input files,
- show differences between input files marked up using terminal colors,
- show differences between input files with verbose explanations,
- show differences between input files with verbose explanations marked up using terminal colors,
- show common parameters/value pairs between input files,
Specification(s): diff/vanilla, diff/color, diff/verbose, diff/verbose_color, diff/common
Design: The
hit
commandIssue(s): #19001
Collection(s): FUNCTIONAL
Type(s): RunCommand
- framework: MaxVarNDofsPerElem
- 1.32.169The maximum number of degrees of freedom for a single variable on a 1D EDGE2 elem shall be 2
Specification(s): 1d
Design: MaxVarNDofsPerElem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.170The maximum number of degrees of freedom for a single variable on a 2D QUAD4 elem shall be 4
Specification(s): 2d
Design: MaxVarNDofsPerElem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.171The maximum number of degrees of freedom for a single variable on a 2D QUAD9 elem shall be 9
Specification(s): 2d_high_order
Design: MaxVarNDofsPerElem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.172The maximum number of degrees of freedom for a single variable on a 2D TRI3 elem shall be 3
Specification(s): triangles
Design: MaxVarNDofsPerElem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.173The maximum number of degrees of freedom for a single variable on a 2D TRI6 elem shall be 6
Specification(s): triangles_high_order
Design: MaxVarNDofsPerElem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.32.174The maximum number of degrees of freedom for a single variable on a 3D HEX8 elem shall be 8
Specification(s): 3d
Design: MaxVarNDofsPerElem
Issue(s): #5658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: NodalEqualValueConstraint
- 1.33.1The system shall support the use of constrains using the mortar method in 1D.
Specification(s): test
Design: NodalEqualValueConstraintOneDEqualValueConstraintBC
Issue(s): #4211
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: OneDEqualValueConstraintBC
- 1.33.1The system shall support the use of constrains using the mortar method in 1D.
Specification(s): test
Design: NodalEqualValueConstraintOneDEqualValueConstraintBC
Issue(s): #4211
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: WeightedGapAux
- 1.33.3The system shall be able to compute the gap between secondary and primary bodies using the mortar method and auxiliary kernels
- when the gap auxiliary variable and mesh are both first order
- when the gap auxiliary variable is first order and the mesh is second order
- 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.33.4The system shall be able to run mortar auxiliary kernels when no constraints are present in the simulation.
Specification(s): no_constraint
Design: WeightedGapAux
Issue(s): #20214
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: TransientMultiApp
- 1.34.2The system shall support running a transient simulation with sub-applications that can fail and re-execute with smaller timesteps until the execution times for the master and sub-applications are equivalent.
Specification(s): test
Design: TransientMultiApp
Issue(s): #10609
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.32The system shall support creating a Multiapp that is not initially enabled
Specification(s): initial_inactive
Design: TransientMultiApp
Issue(s): #12642
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.44The system shall allow transient multiapps to use Picard iterations to rerun the time step
Specification(s): test
Design: TransientMultiApp
Issue(s): #2116
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.47The system shall allow transient multiapps with Picard iterations controlled by relative tolerances
Specification(s): rel_tol
Design: TransientMultiApp
Issue(s): #2116
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.48The system shall allow transient multiapps with Picard iterations controlled by absolute tolerances
Specification(s): abs_tol
Design: TransientMultiApp
Issue(s): #2116
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.60The system should be able to restart from the latest solution
Specification(s): restart_from_latest_solution
Design: TransientMultiApp
Issue(s): #14056
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.61The system should be able to check if users provide valid parameter to restart app using the latest solution
Specification(s): parameter_error
Design: TransientMultiApp
Issue(s): #14056
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.63The system shall be able to run multiple timesteps of a multi-level multi-app simulation, handling the case when Picard coupling between two levels fails to converge.
Specification(s): run
Design: TransientMultiApp
Issue(s): #15166
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.34.64The system shall be able to uniformly cut the time-step across levels of a multi-app solve, even when there is no Picard coupling between two levels.
Specification(s): python
Design: TransientMultiApp
Issue(s): #15166
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.34.65The system shall support Picard iteration with multiple levels of Multiapps.
Specification(s): test
Design: TransientMultiApp
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.66The system shall support the evaluation of TIMESTEP_BEGIN and TIMESTEP_END norms even when there are not active Multiapps on both of those execute_on times.
Specification(s): test_force_norms
Design: TransientMultiApp
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.68The system shall allow transient multiapp simulations coupled by a postprocessor transfer using Picard iterations
- with a failed timestep,
- with adaptive timestepping,
- with a subapp using a smaller timestep,
- with the sub-app and the postprocessor transfers executed at the beginning of each time step,
- with the sub-app executed at the beginning of each time step and postprocessor transfers executed at the end of each timestep,
- with the sub-app executed at the end of each time step and postprocessor transfers executed at the beginning of each timestep,
- with the sub-app and the postprocessor transfers executed at the end of each time step.
- for updating the subapp postprocessor with the sub-app and the variable transfers executed at the beginning of each time step,
- for updating the subapp postprocessor with the sub-app executed at the beginning of each time step and variable transfers executed at the end of each timestep,
- for updating the subapp postprocessor with the sub-app executed at the end of each time step and variable transfers executed at the beginning of each timestep,
- and for updating the subapp postprocessor with the sub-app and the variable transfers executed at the end of each time step.
Specification(s): pp_transient/test_rerun, pp_transient/iteration_adaptive, pp_transient/sub_cycling, pp_transient/app_begin_transfers_begin, pp_transient/app_begin_transfers_end, pp_transient/app_end_transfers_begin, pp_transient/app_end_transfers_end, pp_transient/app_begin_transfers_begin_picard_sub, pp_transient/app_begin_transfers_end_picard_sub, pp_transient/app_end_transfers_begin_picard_sub, pp_transient/app_end_transfers_end_picard_sub
Design: TransientMultiApp
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.34.80The system shall allow multiapp simulations coupled by a variable transfer transformed using the Secant method for transient problems
- with a failed timestep,
- with adaptive timestepping,
- coupled with a subapp using a smaller timestep,
- with the sub-app and the variable transfers executed at the beginning of each time step,
- with the sub-app executed at the beginning of each time step and variable transfers executed at the end of each timestep,
- with the sub-app executed at the end of each time step and variable transfers executed at the beginning of each timestep,
- with the sub-app and the variable transfers executed at the end of each time step.
- and when updating the subapp variables with the sub-app and the variable transfers executed at the beginning of each time step,
- for when updating the subapp variables with the sub-app executed at the beginning of each time step and variable transfers executed at the end of each timestep,
- for updating the subapp variables with the sub-app executed at the end of each time step and variable transfers executed at the beginning of each timestep,
- and for updating the subapp variables with the sub-app and the variable transfers executed at the end of each time step.
Specification(s): variables_transient/test_rerun, variables_transient/iteration_adaptive, variables_transient/sub_cycling, variables_transient/app_begin_transfers_begin, variables_transient/app_begin_transfers_end, variables_transient/app_end_transfers_begin, variables_transient/app_end_transfers_end, variables_transient/app_begin_transfers_begin_secant_sub, variables_transient/app_begin_transfers_end_secant_sub, variables_transient/app_end_transfers_begin_secant_sub, variables_transient/app_end_transfers_end_secant_sub
Design: TransientMultiApp
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.34.82The system shall allow transient multiapp simulations coupled by a postprocessor transfer using the secant method
- with a failed timestep,
- with adaptive timestepping,
- with a subapp using a smaller timestep,
- with the sub-app and the postprocessor transfers executed at the beginning of each time step,
- with the sub-app executed at the beginning of each time step and postprocessor transfers executed at the end of each timestep,
- with the sub-app executed at the end of each time step and postprocessor transfers executed at the beginning of each timestep,
- with the sub-app and the postprocessor transfers executed at the end of each time step.
- for updating the subapp postprocessor with the sub-app and the variable transfers executed at the beginning of each time step,
- for updating the subapp postprocessor with the sub-app executed at the beginning of each time step and variable transfers executed at the end of each timestep,
- for updating the subapp postprocessor with the sub-app executed at the end of each time step and variable transfers executed at the beginning of each timestep,
- and for updating the subapp postprocessor with the sub-app and the variable transfers executed at the end of each time step.
Specification(s): pp_transient/test_rerun, pp_transient/iteration_adaptive, pp_transient/sub_cycling, pp_transient/app_begin_transfers_begin, pp_transient/app_begin_transfers_end, pp_transient/app_end_transfers_begin, pp_transient/app_end_transfers_end, pp_transient/app_begin_transfers_begin_secant_sub, pp_transient/app_begin_transfers_end_secant_sub, pp_transient/app_end_transfers_begin_secant_sub, pp_transient/app_end_transfers_end_secant_sub
Design: TransientMultiApp
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.34.85The system shall allow multiapp simulations coupled by a variable transfer transformed using Steffensen's method for transient problems
- with a failed timestep,
- with adaptive timestepping,
- coupled with a subapp using a smaller timestep,
- with the sub-app and the variable transfers executed at the beginning of each time step,
- with the sub-app executed at the beginning of each time step and variable transfers executed at the end of each timestep,
- with the sub-app executed at the end of each time step and variable transfers executed at the beginning of each timestep,
- with the sub-app and the variable transfers executed at the end of each time step.
- and when updating the subapp variables with the sub-app and the variable transfers executed at the beginning of each time step,
- for when updating the subapp variables with the sub-app executed at the beginning of each time step and variable transfers executed at the end of each timestep,
- for updating the subapp variables with the sub-app executed at the end of each time step and variable transfers executed at the beginning of each timestep,
- and for updating the subapp variables with the sub-app and the variable transfers executed at the end of each time step.
Specification(s): variables_transient/test_rerun, variables_transient/iteration_adaptive, variables_transient/sub_cycling, variables_transient/app_begin_transfers_begin, variables_transient/app_begin_transfers_end, variables_transient/app_end_transfers_begin, variables_transient/app_end_transfers_end, variables_transient/app_begin_transfers_begin_steffensen_sub, variables_transient/app_begin_transfers_end_steffensen_sub, variables_transient/app_end_transfers_begin_steffensen_sub, variables_transient/app_end_transfers_end_steffensen_sub
Design: TransientMultiApp
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.34.87The system shall allow transient multiapp simulations coupled by a postprocessor transfer using Steffensen's method
- with a failed timestep,
- with adaptive timestepping,
- with a subapp using a smaller timestep,
- with the sub-app and the postprocessor transfers executed at the beginning of each time step,
- with the sub-app executed at the beginning of each time step and postprocessor transfers executed at the end of each timestep,
- with the sub-app executed at the end of each time step and postprocessor transfers executed at the beginning of each timestep,
- with the sub-app and the postprocessor transfers executed at the end of each time step.
- for updating the subapp postprocessor with the sub-app and the variable transfers executed at the beginning of each time step,
- for updating the subapp postprocessor with the sub-app executed at the beginning of each time step and variable transfers executed at the end of each timestep,
- for updating the subapp postprocessor with the sub-app executed at the end of each time step and variable transfers executed at the beginning of each timestep,
- and for updating the subapp postprocessor with the sub-app and the variable transfers executed at the end of each time step.
Specification(s): pp_transient/test_rerun, pp_transient/iteration_adaptive, pp_transient/sub_cycling, pp_transient/app_begin_transfers_begin, pp_transient/app_begin_transfers_end, pp_transient/app_end_transfers_begin, pp_transient/app_end_transfers_end, pp_transient/app_begin_transfers_begin_steffensen_sub, pp_transient/app_begin_transfers_end_steffensen_sub, pp_transient/app_end_transfers_begin_steffensen_sub, pp_transient/app_end_transfers_end_steffensen_sub
Design: TransientMultiApp
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.34.93The system shall support a time offset between the master and a subapp when using the Multiapp system.
Specification(s): start_time
Design: TransientMultiApp
Issue(s): #12755
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.94The system shall support the execution of sub-applications:
- with a time step governed by the sub-application and
- with a time step governed by the master application.
Specification(s): group/dt_from_multi, group/dt_from_master
Design: TransientMultiApp
Issue(s): #1736
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.95The system shall support negative times by particularly ensuring that the sub-app properly updates its time without sub-cycling.
Specification(s): test_negative_time
Design: TransientMultiApp
Issue(s): #15802
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.7The system shall output a running list of coupling iteration residual norms during multiapp coupling iterations.
Specification(s): picard_norm_output
Design: TransientMultiApp
Issue(s): #12708
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.8The system shall only output the coupling iteration residual TIMESTEP_BEGIN norms when there are no TIMESTEP_END Multiapps.
Specification(s): ts_begin_multi_output
Design: TransientMultiApp
Issue(s): #12708
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.9The system shall only output the coupling iteration TIMESTEP_END norms when there are no TIMESTEP_BEGIN Multiapps.
Specification(s): ts_end_multi_output
Design: TransientMultiApp
Issue(s): #12708
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.10The system shall output the coupling iteration residual norm for TIMESTEP_BEGIN and TIMESTEP_END Multiapps when both exist in the simulation.
Specification(s): ts_both_multi_output
Design: TransientMultiApp
Issue(s): #12708
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: CentroidMultiApp
- 1.34.3The 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
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MultiApp System
- 1.34.4The system shall detect input file problems with sub app input files.
Specification(s): input_file
Design: MultiApp System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.5The system shall CLI argument problems related to sub app input files.
Specification(s): unused_subapp_param
Design: MultiApp System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.6The 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
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.7The 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
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.8The system shall 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
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.9The system shall error when both positions are provided in the input file along with a separate file of positions.
Specification(s): both_positions
Design: MultiApp System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.10The system shall error when the multiapp positions file is malformed.
Specification(s): bad_positions
Design: MultiApp System
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.11The system shall 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.12The 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.34.13The 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.34.14The 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.34.15The 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.34.16The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.17The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.18The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.19The system shall not use an empty commandLine argument file
Specification(s): empty_cliarg_file
Design: MultiApp System
Issue(s): #18596
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.20The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.21The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.22The MultiApp system shall include the ability to set command line parameters for each sub application from the input file.
Specification(s): master
Design: MultiApp System
Issue(s): #12576
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.23The MultiApp system shall include the ability to set common command line parameters for all sub applications from the input file.
Specification(s): master_common
Design: MultiApp System
Issue(s): #12576
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.24The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.25The 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.34.31The system shall 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.34.34The system shall support the ability for a sub-application to adaptive modify the time step of the master application when the sub-application operates at the
- beginning and
- end of a timestep.
Specification(s): group/begin, group/end
Design: MultiApp System
Issue(s): #7842
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.35The 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.34.36The system shall support the ability to re-position sub-applications at a specified time
- for single and
- multi-level sub-applications.
Specification(s): group/test, group/multilevel
Design: MultiApp System
Issue(s): #1971
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.37The system shall support the ability to re-position and reset sub-applications at a specified time
- for single and
- multi-level sub-applications.
Specification(s): group/test, group/multilevel
Design: MultiApp System
Issue(s): #1971
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.38The system shall support evaluating multi-level sub-applications:
- where the master application controls the time step for all sub-applications;
- where the master application controls the time step via a function for all sub-applications; and
- where the sub-application controls the time step for the master application,
Specification(s): group/dt_from_master, group/time_dt_from_master, group/dt_from_sub
Design: MultiApp System
Issue(s): #1832
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.39The 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.34.40The 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.34.41The system shall support outputting sub-application data in a specified position
- for single and
- multi-level sub-applications.
Specification(s): group/test, group/multilevel
Design: MultiApp System
Issue(s): #1888
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.42The 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.34.43The 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.34.56The system shall support performing iterative solves of sub-applications that perform additional time steps to maintain time step consistency with the master application
- resetting the initial condition for every coupling
- 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.34.57Multiapps 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.34.58CSV 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.34.59Multiapps shall be able to cut the master 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.34.69The system shall support performing iterative solves of sub-applications that used smaller time steps than master application.
Specification(s): test
Design: MultiApp System
Issue(s): #5126
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.70The 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.34.76The system shall support the ability to reset a sub-application at a specified time during the simultation
- for single and
- multi-level sub-applications.
Specification(s): group/test, group/multilevel
Design: MultiApp System
Issue(s): #1970
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.77The system shall support simulations that
- that execute sub-applications, which
- 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.34.78The system shall support simulations that
- that execute with multi-level sub-applications, which
- 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.34.79The system shall support simulations that
- that executes sub-applications, which
- 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.34.84The system shall support executing sub-applications that operate with smaller time steps then the master 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.34.88The system shall support the execution of sub-applications that operate with smaller time steps then the master application:
- with a sub-application that continues to the end time of the master application and
- with a sub-application that specifies and completion time prior to the master application.
Specification(s): group/test, group/test_short_subapp
Design: MultiApp System
Issue(s): #1880
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.89The system shall support the output of sub-application data that operate with smaller time steps then the master application.
Specification(s): test_sub_cycle_output
Design: MultiApp System
Issue(s): #1880
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.90The system shall support the execution of sub-application that operate with adaptive time steps that differ from the master application.
Specification(s): test_it_adapt
Design: MultiApp System
Issue(s): #1880
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.91The 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.34.92The system shall support the failure of sub-application that operates with differing time steps than the master application.
- The simulation shall continue by reducing the time step and
- 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.57.96The system shall support the transfer of data between a master 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: FullSolveMultiApp
- 1.34.26The system shall be capable of executing a sub-application from a Steady executioner on
- initial and
- final.
Specification(s): steady/exec_initial, steady/exec_final
Design: FullSolveMultiApp
Issue(s): #1940
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.27The system shall be capable of executing a sub-application from a Eigenvalue executioner on
- initial and
- final.
Specification(s): nl_eigen/exec_initial, nl_eigen/exec_final
Design: FullSolveMultiApp
Issue(s): #1940
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.28When sub-application solve does not converge, the system shall be able to either
- abort run,
- throw error if error_on_dtmin is not set, or
- continue run.
Specification(s): solve_not_converge/abort, solve_not_converge/error, solve_not_converge/continue
Design: FullSolveMultiApp
Issue(s): #1940
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- 1.34.50The system shall allow steady-state Picard iteration with multiapps
Specification(s): steady
Design: FullSolveMultiApp
Issue(s): #9038
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.51The system shall allow fixed number of Picard iterations
Specification(s): steady_fixed_picard_its
Design: FullSolveMultiApp
Issue(s): #9038
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.34.52The system shall allow steady-state Picard iteration with pseudo-transient multiapps
Specification(s): steady_with_pseudo_transient_sub
Design: FullSolveMultiApp
Issue(s): #9038
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.53The system shall allow convergence check with user defined postprocessor directly.
Specification(s): steady_with_postprocessor_convergence
Design: FullSolveMultiApp
Issue(s): #14642
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.54The system shall allow convergence check with the convergence of a user defined postprocessor.
Specification(s): steady_with_postprocessor_diff_convergence
Design: FullSolveMultiApp
Issue(s): #14642
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.55The system shall show the Multiapp coupling convergence history of a user defined postprocessor that is used for convergence check.
Specification(s): postprocessor_convergence_history
Design: FullSolveMultiApp
Issue(s): #16940
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.34.62The system shall support Picard iteration with a FullSolveMultiApp at the root with multiple multiapp levels.
Specification(s): test
Design: FullSolveMultiApp
Issue(s): #13310
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.67The system shall allow multiapp steady-state simulations coupled by a postprocessor transfer using Picard iterations
- with a steady-state sub-application,
- and with pseudo-transient sub-applications.
Specification(s): pp_steady/steady, pp_steady/steady_with_pseudo_transient_sub
Design: FullSolveMultiApp
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.34.81The system shall allow multiapp steady-state simulations coupled by a postprocessor transfer using the secant method
- with a steady-state sub-application,
- and with pseudo-transient sub-applications.
Specification(s): pp_steady/steady, pp_steady/steady_with_pseudo_transient_sub
Design: FullSolveMultiApp
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.34.86The system shall allow multiapp steady-state simulations coupled by a postprocessor transfer using Steffensen's method
- with a steady-state sub-application,
- and with pseudo-transient sub-applications.
Specification(s): pp_steady/steady, pp_steady/steady_with_pseudo_transient_sub
Design: FullSolveMultiApp
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.57.3The system shall support the transfer of data from a completed solve within sub-application to the master application.
Specification(s): test
Design: FullSolveMultiApp
Issue(s): #1940
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MultiAppMeshFunctionTransfer
- 1.34.29The system shall be able to use the solution of a coarse mesh as the initial guess for a fine mesh solution for a
- diffusion problem and a
- variational inequality problem resulting in a significantly reduced number of nonlinear iterations to solve the fine mesh problem
Specification(s): sequencing/diffusion, sequencing/vi
Design: MultiAppMeshFunctionTransfer
Issue(s): #14166
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.30The system shall be able to solve a fine mesh variational inequality problem without grid sequencing but with a lot more nonlinear iterations
Specification(s): no_sequencing
Design: MultiAppMeshFunctionTransfer
Issue(s): #14166
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.32The system shall support mesh to mesh interpolation with the first order elemental variable
Specification(s): L2_Lagrange
Design: MultiAppMeshFunctionTransfer
Issue(s): #13446
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.33The system shall support mesh to mesh interpolation with the first order elemental variable when a different mesh is used in sub
Specification(s): L2_Lagrange_different_mesh
Design: MultiAppMeshFunctionTransfer
Issue(s): #13446
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.34The system shall support nearest node transfer with the first order elemental variable
Specification(s): L2_Lagrange_nearest_node
Design: MultiAppMeshFunctionTransfer
Issue(s): #13446
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.35The system shall support interpolation transfer with the first order elemental variable
Specification(s): L2_Lagrange_interpolation
Design: MultiAppMeshFunctionTransfer
Issue(s): #13446
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.36The system shall support user object transfer with the first order elemental variable
Specification(s): L2_Lagrange_userobject
Design: MultiAppMeshFunctionTransfer
Issue(s): #13446
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.37The system shall support conservative transfer with L2 nonlinear variable
Specification(s): L2_Lagrange_conservative
Design: MultiAppMeshFunctionTransfer
Issue(s): #13446
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.41The system shall support the transfer of data using the finite element solution function:
- to a sub-application,
- from a sub-application,
- from a deformed mesh to a sub-application,
- from to a sub-application with a deformed mesh,
- from a sub-application with deformed mesh, and
- from a sub-application to a deformed mesh.
Specification(s): transfer/tosub, transfer/fromsub, transfer/tosub_source_displaced, transfer/tosub_target_displaced, transfer/fromsub_source_displaced, transfer/fromsub_target_displaced
Design: MultiAppMeshFunctionTransfer
Issue(s): #1836
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.42The system shall error if preforming a transfer of data using the finite element solution if:
- the evaluation point does not exist and
- if the execution settings do not match between the master and sub-applications.
Specification(s): errors/missed_point, errors/mismatch_exec_on
Design: MultiAppMeshFunctionTransfer
Issue(s): #1836
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionRunApp
- framework: UserObject
- 1.34.33The 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.59.11The 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,
- by forcing a user object to execute before auxiliary kernels
- by forcing a user object to execute after auxiliary kernels
Specification(s): test_force/preaux, test_force/postaux
Design: UserObject
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: IterationAdaptiveDT
- 1.34.45The system shall support adaptive time stepping for transient multiapps with Picard iterations controlled by tolerances
Specification(s): iteration_adaptive
Design: IterationAdaptiveDT
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.34.46The system shall reject the solve if the maximum number of Picard iterations is reached without converging
Specification(s): iteration_adaptive_picard_max_its
Design: IterationAdaptiveDT
Issue(s): #12618
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.8The system shall support the ability to force time steps consistent with points specified in a function.
Specification(s): hit_knot
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.9The system shall check that a timestep limiting function has been defined when a user specifies the 'force_step_every_function_point' parameter as true.
Specification(s): hit_knot_err1
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.56.10The system shall check that a timestep limiting function has been defined when a user specifies a value for the 'max_function_change' parameter.
Specification(s): hit_knot_err2
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.56.11The system shall support the ability to grow the time step size when specifying the initial value of dt in the TimeStepper.
Specification(s): grow_init_dt
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.12The system shall support the ability to grow the time step size when specifying the initial value of dt in the TimeStepper after a restart.
Specification(s): grow_init_dt_restart
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.13The system shall support the ability to grow the time step size when specifying the values of t and dt in the TimeStepper.
Specification(s): adapt_tstep_grow_dtfunc
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.56.14The system shall support the ability to grow the time step size when specifying the values of t and dt in the TimeStepper after a restart.
Specification(s): adapt_tstep_grow_dtfunc_restart
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.56.15The system shall support the ability to limit the time step size based on the optimal iterations and linear_iteration ratio.
Specification(s): shrink_init_dt
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.16The system shall support the ability to limit the time step size based on the optimal iterations and linear_iteration ratio after a restart.
Specification(s): shrink_init_dt_restart
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.17The system shall support the ability to limit the time step size based on a postprocessor value.
Specification(s): pps_lim
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.18The system shall support the ability to reject a time step based on a threshold value for the ratio of the ideal step size to the limit.
Specification(s): reject_large_dt
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.19The system shall support the ability to force time steps to resolve sudden changes in piecewise linear functions.
Specification(s): piecewise_linear
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.56.20The system shall support the ability to force time steps to match changes in piecewise constant functions.
Specification(s): piecewise_constant
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.56.21The system shall support the ability to force time steps to hit all nodes in a set of piecewise linear functions.
Specification(s): multi_piecewise_linear_function_point
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.56.22The system shall support the ability to force time steps to resolve sudden changes in multiple piecewise linear functions.
Specification(s): multi_piecewise_linear_function_change
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.56.23The system shall support the ability to force time steps to hit all nodes in a set of piecewise linear and constant functions.
Specification(s): multi_piecewise
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.56.24The system shall support the ability to set a new time step size after syncing the previous time step with piecewise linear and constant functions.
Specification(s): multi_piecewise_sync_dt
Design: IterationAdaptiveDT
Issue(s): #5535
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: FunctionDT
- 1.34.49The 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: PerfGraph
- 1.34.83MultiApps shall be properly identified in the PerfGraph
Specification(s): slow_sub
Design: PerfGraph
Issue(s): #19662
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.41.98The 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.41.99The 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.41.100The 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.60.16The PerfGraph shall report a reasonable error when
- registering a section without a name
- registering a section without a live message
- requesting the ID of a section that does not exist
- requesting the section info for a section that does not exist
Specification(s): errors/register_no_section, errors/register_no_live_message, errors/section_id_missing, errors/section_info_missing
Design: PerfGraph
Issue(s): #15444
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.60.17The system shall allow for timing sections of code and having automated print-outs when they take too long or use too much memory
Specification(s): test
Design: PerfGraph
Issue(s): #15444
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: NodalKernels System
- 1.35.1The system shall include ability to include contributions to the residual nodes of a finite element mesh
- on a single and
- multiple threads.
Specification(s): group/test, group/threaded
Design: NodalKernels System
Issue(s): #3029
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.35.8The system shall include ability to include contributions to the residual nodes of a finite element mesh using an LU preconditioner.
Specification(s): test
Design: NodalKernels System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.35.9The system shall include ability to include contributions to the residual nodes of a finite element mesh and compute the correct Jacobian terms for
- subdomain and
- boundary restricted terms.
Specification(s): group/block_jacobian_test, group/bc_jacobian_test
Design: NodalKernels System
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTester
- 1.35.10The system shall not duplicate computation of kernels on a node that is shared between two subdomains.
Specification(s): exo
Design: NodalKernels System
Issue(s): #16265
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: LowerBoundNodalKernel
- 1.35.2The system shall be able to enforce a lower bound on a variable using nodal NCP, nodal application of resultant forces,
- have no oscillations in the solution, and
- have a non-singular matrix
Specification(s): lower_bound/exo, lower_bound/non_singular
Design: LowerBoundNodalKernel
Issue(s): #2999
Collection(s): FUNCTIONAL
Type(s): RunAppExodiff
- framework: UpperBoundNodalKernel
- 1.35.3The system shall be able to enforce an upper bound on a variable using nodal NCP, nodal application of resultant forces,
- have no oscillations in the solution, and
- have a non-singular matrix
Specification(s): upper_bound/exo, upper_bound/non_singular
Design: UpperBoundNodalKernel
Issue(s): #2999
Collection(s): FUNCTIONAL
Type(s): RunAppExodiff
- 1.35.4The system shall be able to enforce an upper and lower bound on a variable using nodal NCP, nodal application of resultant forces,
- have no oscillations in the solution, and
- work with automatic differentiation, and
- have a non-singular matrix, and
- be incompataible with algebraic multigrid
Specification(s): upper_and_lower_bound/exo, upper_and_lower_bound/ad_exo, upper_and_lower_bound/non_singular, upper_and_lower_bound/amg_fail
Design: UpperBoundNodalKernel
Issue(s): #2999
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionRunAppExodiff
- framework: TimeIntegrator System
- 1.35.7The system shall support the use of Crank-Nicolson time integration scheme.
Specification(s): test
Design: TimeIntegrator System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.81The system shall support time integration schemes that compute a consistent number of nonlinear and linear iterations for
- four stage, A-stable DIRK;
- explicit Euler;
- lumped explicit Euler;
- lumped and preconditioned explicit Euler;
- second-order backward difference;
- Crank-Nicloson;
- quasi explicit Euler;
- explicit midpoint;
- two-stage TVD Runge-Kutta;
- Heun;
- implicit Euler;
- implicit midpoint;
- two-stage, L-stable DIRK;
- three stage, L-stable DIRK;
- four stage, L-stable DIRK;
- and Ralston methods.
Specification(s): methods/a_stable_dirk4, methods/actually_explicit_euler_consistent, methods/actually_explicit_euler_lumped, methods/actually_explicit_euler_lump_preconditioned, methods/bdf2, methods/crank_nicolson, methods/explicit_euler, methods/explicit_midpoint, methods/explicit_tvd_rk2, methods/heun, methods/implicit_euler, methods/implicit_midpoint, methods/l_stable_dirk2, methods/l_stable_dirk3, methods/l_stable_dirk4, methods/ralston
Design: TimeIntegrator System
Issue(s): #11444
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.55.10The system shall include explicit time integration using the Heun method and converge at the theoretical rate with
- a full timestep,
- a half timestep, and
- a quarter timestep.
Specification(s): explicit_heun/level0, explicit_heun/level1, explicit_heun/level2
Design: TimeIntegrator System
Issue(s): #1929
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.11The system shall include explicit time integration using the Ralston method and converge at the theoretical rate with
- a full timestep,
- a half timestep, and
- a quarter timestep.
Specification(s): explicit_ralston/level0, explicit_ralston/level1, explicit_ralston/level2
Design: TimeIntegrator System
Issue(s): #1929
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.12The system shall include explicit time integration using the midpoint method and converge at the theoretical rate with
- a full timestep,
- a half timestep, and
- a quarter timestep.
Specification(s): explicit_midpoint/level0, explicit_midpoint/level1, explicit_midpoint/level2
Design: TimeIntegrator System
Issue(s): #1929
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.13The system shall include explicit time integration using the Euler method and converge at the theoretical rate with
- a full timestep,
- a half timestep, and
- a quarter timestep.
Specification(s): explicit_euler/level0, explicit_euler/level1, explicit_euler/level2
Design: TimeIntegrator System
Issue(s): #1929
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.14The system shall include implicit time integration using the Midpoint method and converge at the theoretical rate with
- a full timestep,
- a half timestep, and
- a quarter timestep.
Specification(s): implicit_midpoint/level0, implicit_midpoint/level1, implicit_midpoint/level2
Design: TimeIntegrator System
Issue(s): #1929
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.15The system shall include implicit time integration using the L-stable DIRK3 method and converge at the theoretical rate with
- a full timestep,
- a half timestep, and
- a quarter timestep.
Specification(s): implicit_lstabledirk3/level0, implicit_lstabledirk3/level1, implicit_lstabledirk3/level2
Design: TimeIntegrator System
Issue(s): #1929
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.16The system shall include implicit time integration using the L-stable DIRK4 method and converge at the theoretical rate with
- a full timestep,
- a half timestep, and
- a quarter timestep.
Specification(s): implicit_lstabledirk4/level0, implicit_lstabledirk4/level1, implicit_lstabledirk4/level2
Design: TimeIntegrator System
Issue(s): #1929
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.17The system shall include implicit time integration using the A-stable DIRK4 method and converge at the theoretical rate with
- a full timestep,
- a half timestep, and
- a quarter timestep.
Specification(s): implicit_astabledirk4/level0, implicit_astabledirk4/level1, implicit_astabledirk4/level2
Design: TimeIntegrator System
Issue(s): #1929
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.18The system shall include implicit time integration using the A-stable DIRK4 method (bootstrapped with L-stable DIRK) and converge at the theoretical rate with
- a full timestep,
- a half timestep, and
- a quarter timestep.
Specification(s): implicit_astabledirk4_bootstrap/level0, implicit_astabledirk4_bootstrap/level1, implicit_astabledirk4_bootstrap/level2
Design: TimeIntegrator System
Issue(s): #1929
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.26Multi-stage time integrators shall check convergence for all stages
Specification(s): unconverged_1st_stage
Design: TimeIntegrator System
Issue(s): #11719
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: PenaltyDirichletNodalKernel
- 1.35.11The system shall support the application of Dirichlet type boundary conditions using the penalty method for nodesets.
Specification(s): test
Design: PenaltyDirichletNodalKernel
Issue(s): #14092
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FileOutput
- 1.36.1The system shall support the ability to append the date to output filenames.
Specification(s): test
Design: FileOutput
Issue(s): #6001
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: Checkpoint
- 1.36.2The system shall support outputting of checkpoint files:
- at a specific interval while only maintaining a specified number of recent files and
- be capable of restarting a simulation from previously exported data at this interval.
Specification(s): interval/test_files, interval/test_recover
Design: Checkpoint
Collection(s): FUNCTIONAL
Type(s): ExodiffCheckFiles
- 1.36.3The system shall support outputting of checkpoint files, using a simplified input format:
- at every timestep while maintaining the most recent two files and
- be capable of restarting a simulation from the output data.
Specification(s): default/recover_half_transient, default/recover
Design: Checkpoint
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): ExodiffCheckFiles
- 1.36.4The system shall support outputting of checkpoint files, using a complete input block:
- at every timestep while maintaining the most recent two files and
- be capable of restarting a simulation from the output data.
Specification(s): block/recover_with_checkpoint_block_half_transient, block/recover_with_checkpoint_block
Design: Checkpoint
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): ExodiffCheckFiles
- framework: Console
- 1.36.11The system shall run a simulation without producing any file-based output.
Specification(s): no_outputs_block
Design: Console
Issue(s): #3320
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.12The system shall support outputting table based Postprocessor data.
Specification(s): postprocessors
Design: Console
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.13The system shall output Scalar Variables on the console in a table to the screen.
Specification(s): scalar_variables
Design: Console
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.14The system shall warning when multiple console outputs attempt to write to the screen simultaneously.
Specification(s): warning
Design: Console
Issue(s): #3286
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.15The system shall support outputting console information to a file.
Specification(s): file_system_information
Design: Console
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.16The system shall output Scalar Variables on the console in a table to a file.
Specification(s): file_postprocessor
Design: Console
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.17The system shall support outputting Scalar Variables to a file.
Specification(s): file_scalar_aux
Design: Console
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.18The system shall support writing the console solve log to an output file.
Specification(s): file_solve_log
Design: Console
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.19The system shall support writing norms to the console for each nonlinear variable in the simulation.
Specification(s): norms
Design: Console
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.20The system shall output a Performance log based on a command line flag.
Specification(s): timing
Design: Console
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.21The system shall support writing negative time information in the console.
Specification(s): transient
Design: Console
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.22The system shall support outputting the Performance Log at user specified intervals.
Specification(s): transient_perf_int
Design: Console
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.23The system shall support writing to a buffered console object from every MooseObject-derived object.
Specification(s): _console
Design: Console
Issue(s): #3286
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.24The system shall support writing to a buffered console object from const methods in MooseObject-derived objects.
Specification(s): _console_const
Design: Console
Issue(s): #3286
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.25The system shall support outputting a transformed input file to the screen.
Specification(s): input_output
Design: Console
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.26The system shall support disabling the linear residual output.
Specification(s): print_linear_residuals_disable
Design: Console
Issue(s): #4497
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.27The system shall output a Performance Log based on a single input file parameter.
Specification(s): perf_graph
Design: Console
Issue(s): #4497
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.28The system shall override Performance Log output when conflicting values appear on the command line and input file.
Specification(s): perf_graph_disable
Design: Console
Issue(s): #4497
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.29The system shall support adding an additional output time option without clobbering existing default options.
Specification(s): additional_output_on
Design: Console
Issue(s): #4497
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.30The system shall output a "final" label at the end of the simulation before additional screen output occurs.
Specification(s): console_final
Design: Console
Issue(s): #5756
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.31The system shall error when specifying an invalid table fit width option.
Specification(s): console_fit_width_error
Design: Console
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.138The system shall allow the user to select different console output intervals.
Specification(s): postprocessor
Design: Console
Issue(s): #4454
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.139The system shall display active output information with corresponding execute flags.
Specification(s): show_outputs
Design: Console
Issue(s): #4454
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.162The system shall print the various components of the simulation information header to the screen
Specification(s): basic
Design: Output SystemConsole
Issue(s): #2173
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.163The system shall print the mesh information to the screen when the mesh changes
Specification(s): mesh
Design: Output SystemConsole
Issue(s): #2173
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.164The system shall print the auxiliary system information to the screen when the mesh changes
Specification(s): aux
Design: Output SystemConsole
Issue(s): #2173
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.165The system shall print the nonlinear system information to the screen when the mesh changes
Specification(s): nonlinear
Design: Output SystemConsole
Issue(s): #2173
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: CSV
- 1.36.32The system shall support the output of postprocessors and scalars to CSV files for steady state problems.
Specification(s): steady
Design: Output SystemCSV
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.33The system shall support the output of postprocessors and scalars to CSV files for transient propblems.
Specification(s): transient
Design: Output SystemCSV
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.34The system shall support the output of postprocessors and scalars to CSV files for transient problems without a time column.
Specification(s): no_time
Design: Output SystemCSV
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.35The system shall support the output of postprocessors and scalars to Exodus files for transient problems.
Specification(s): transient_exodus
Design: Output SystemCSV
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.36The system shall support the output of CSV data:
- with checkpoint enabled and
- when restarted creates a new output file or
- 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.36.37The system shall support CSV output aligned columns and a custom delimiter.
Specification(s): align
Design: Output SystemCSV
Issue(s): #3229
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.38The system shall support CSV output to the console that is sorted by the variable name.
Specification(s): sort
Design: Output SystemCSV
Issue(s): #8974
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.39The CSV output object shall create a symlink to the final output with with a '_FINAL' suffix for VectorPostprocessor data when there are execute flags in addition to FINAL.
Specification(s): final
Design: VectorPostprocessors SystemCSV
Issue(s): #11087
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.40The CSV output object shall create a symlink to the final output with with a '_FINAL' suffix for VectorPostprocessor data when the execute flag is set to FINAL.
Specification(s): final_only
Design: VectorPostprocessors SystemCSV
Issue(s): #11087
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.41The CSV output object 'create_final_symlink' parameter shall be able to disable the creation of the final symlink.
Specification(s): no_link
Design: VectorPostprocessors SystemCSV
Issue(s): #11087
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.42The CSV output object shall create a symlink to the most recent output with with a '_LATEST' suffix for VectorPostprocessor data.
Specification(s): latest
Design: VectorPostprocessors SystemCSV
Issue(s): #11087
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.43The CSV output object 'create_latest_symlink' parameter shall be able to disable the creation of the latest symlink.
Specification(s): no_latest
Design: VectorPostprocessors SystemCSV
Issue(s): #11087
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: VariableResidualNormsDebugOutput
- 1.36.44The system shall be include the ability to display variable residual norms.
Specification(s): show_var_residual_norms
Design: VariableResidualNormsDebugOutput
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.45The system shall include debug syntax that includes the ability to enable variable residual norm output.
Specification(s): show_var_residual_norms_debug
Design: VariableResidualNormsDebugOutputDebug System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: Debug System
- 1.36.45The system shall include debug syntax that includes the ability to enable variable residual norm output.
Specification(s): show_var_residual_norms_debug
Design: VariableResidualNormsDebugOutputDebug System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.47The system shall include debug syntax that includes the ability to enable material property information output.
Specification(s): show_material_props_block
Design: MaterialPropertyDebugOutputDebug System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.49The system shall include debug syntax that includes the ability to enable variable residual information.
Specification(s): show_top_residuals_debug
Design: TopResidualDebugOutputDebug System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.52The system shall include debug syntax that includes material property consumption information.
Specification(s): show_material_properties_consumed
Design: MaterialPropertyDebugOutputDebug System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.159The system shall support the ability to output the residual norms of individual nodal variables.
Specification(s): test
Design: Debug System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.160The system shall support the ability to output the residual norms of individual elemental variables.
Specification(s): elem
Design: Debug System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MaterialPropertyDebugOutput
- 1.36.46The system shall be include the ability to display material property information.
Specification(s): show_material_props
Design: MaterialPropertyDebugOutput
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.47The system shall include debug syntax that includes the ability to enable material property information output.
Specification(s): show_material_props_block
Design: MaterialPropertyDebugOutputDebug System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.52The system shall include debug syntax that includes material property consumption information.
Specification(s): show_material_properties_consumed
Design: MaterialPropertyDebugOutputDebug System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: TopResidualDebugOutput
- 1.36.48The system shall be include the ability to display residual information for variables.
Specification(s): show_top_residuals
Design: TopResidualDebugOutput
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.49The system shall include debug syntax that includes the ability to enable variable residual information.
Specification(s): show_top_residuals_debug
Design: TopResidualDebugOutputDebug System
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.50The system shall be include the ability to display residual information for variables that is limited to non-linear iterations.
Specification(s): show_top_residuals_nonlinear_only
Design: TopResidualDebugOutput
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.51The system shall be include the ability to display residual information for scalar variables.
Specification(s): show_top_residuals_scalar
Design: TopResidualDebugOutput
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: DOFMap
- 1.36.59The system shall support the ability to output the degree-of-freedom information:
- to a json file,
- to the screen,
- with uniform refinement, and
- with transient adaptivity.
Specification(s): group/simple, group/simple_screen, group/uniform_refine, group/transient
Design: DOFMap
Issue(s): #3847
Collection(s): FUNCTIONAL
Type(s): RunAppCheckFiles
- framework: Exodus
- 1.36.63The system shall support ExodusII output.
Specification(s): basic
Design: Exodus
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.64The system ExodusII output shall not use HDF5 unless requested.
Specification(s): hdf5
Design: Exodus
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): RunCommand
- 1.36.65The system shall support including the executed input file within the ExodusII output.
Specification(s): input
Design: Exodus
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.66The system shall support inclusion of initial condition data within the ExodusII output.
Specification(s): enable_initial
Design: Exodus
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.67The system shall support writing non-linear, auxililary, scalar, and postprocessor variables to ExodusII format.
Specification(s): output_all
Design: Exodus
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.68The system shall support the exclusion of non-linear, scalar, and postprocessor variables from ExodusII output.
Specification(s): hide_output
Design: Exodus
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.69The system shall error if the supplied names for including or excluding variables is invalid.
Specification(s): invalid_hide
Design: Exodus
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.70The system shall support outputting elemental and scalar variables as nodal variables within ExodusII output.
Specification(s): nodal_output
Design: Exodus
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.71The system shall support outputting discontinuous finite element types with the ExodusII format.
Specification(s): discontinuous
Design: Exodus
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.135The system shall support the ability to specify the output dimension when outputting in ExodusII format.
Specification(s): test
Design: Exodus
Issue(s): #9205
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.142The system shall include the ability to overwrite existing timesteps when writing ExodusII format.
Specification(s): test
Design: Exodus
Issue(s): #5857
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: GMV
- 1.36.73The system shall support GMV output.
Specification(s): gmv_out_test
Design: GMV
Issue(s): #920
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.106The system shall support outputting data to the general mesh viewer format.
Specification(s): test
Design: GMV
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: YAMLFormatter
- 1.36.74The system shall be able to dump YAML data.
Specification(s): yaml_dump_test
Design: YAMLFormatter
Issue(s): #920
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.75The system shall only give Executioner output once.
Specification(s): no_double_executioner_output
Design: YAMLFormatter
Issue(s): #2855
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: Tecplot
- 1.36.76The system shall support Tecplot output.
Specification(s): tecplot_out_test
Design: Tecplot
Issue(s): #920
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.77If the Tecplot API is available, the system shall support Tecplot output given in Tecplot binary format.
Specification(s): tecplot_bin_test
Design: Tecplot
Issue(s): #3403
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.78If the Tecplot API is not available, the system shall support Tecplot output given in ASCII format.
Specification(s): tecplot_bin_test_override
Design: Tecplot
Issue(s): #3403
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.166The system shall support writing ASCII Tecplot output.
Specification(s): test
Design: Tecplot
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.167The system shall support appending Tecplot output files.
Specification(s): test_append
Design: Tecplot
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.168The system shall optionally support writing binary Tecplot files.
Specification(s): test_binary
Design: Tecplot
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: Gnuplot
- 1.36.79The system shall be able to generate gnuplot PostScript output.
Specification(s): gnuplot_ps_out_test
Design: Gnuplot
Issue(s): #920
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.80The system shall be able to generate gnuplot PNG output.
Specification(s): gnuplot_png_out_test
Design: Gnuplot
Issue(s): #920
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.81The system shall be able to generate gnuplot GIF output.
Specification(s): gnuplot_gif_out_test
Design: Gnuplot
Issue(s): #920
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: SolutionHistory
- 1.36.84Solution history output shall work
Specification(s): sln_out_test
Design: SolutionHistory
Issue(s): #920
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: XDA/XDR
- 1.36.85The system shall support XDR output.
Specification(s): xdr_output
Design: XDA/XDR
Issue(s): #2243
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.179The system shall support the output of data using native libMesh formats:
- in XDA (ASCII) format and
- in XDR (binary) format.
Specification(s): group/xda, group/xdr
Design: XDA/XDR
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.180The system shall support simultaneous output of the ASCII and binary forms of the libMesh native format.
Specification(s): both_xda_and_xdr
Design: XDA/XDR
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: JsonInputFileFormatter
- 1.36.86The system shall be able to dump input file syntax in JSON format.
Specification(s): json_full
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.36.87The system shall be able to dump input file syntax in JSON format and exclude test object syntax.
Specification(s): json_no_test_objects
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.36.88The system shall be able to dump a subset of JSON formatted syntax.
Specification(s): json_search
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.36.89The system shall dump line information along with JSON formatted syntax.
Specification(s): json_line_info
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.36.90The system shall not include RESIDUAL and JACOBIAN template arguments in the JSON syntax format.
Specification(s): json_no_template
Design: JsonInputFileFormatter
Issue(s): #12960
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.36.91The system shall be able to dump input file (HIT) syntax.
Specification(s): hit
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- 1.36.92The system shall be able to dump a subset of input file (HIT) syntax.
Specification(s): hit_search
Design: JsonInputFileFormatterMooseApp
Issue(s): #7855#7661#2881#10839#12455
Collection(s): FUNCTIONAL
Type(s): PythonUnitTest
- framework: SONDefinitionFormatter
- 1.36.93The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check InputChoices
Specification(s): definition_input_choices_test
Design: SONDefinitionFormatter
Issue(s): #16165
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.94The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check ChildAtLeastOne
Specification(s): definition_childatleastone_test
Design: SONDefinitionFormatter
Issue(s): #9651
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.95The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check ValEnums
Specification(s): definition_valenum_test
Design: SONDefinitionFormatter
Issue(s): #9651
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.96The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check active parameter
Specification(s): definition_active_parameter_test
Design: SONDefinitionFormatter
Issue(s): #9651
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.97The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check normal_sub
Specification(s): definition_normal_sub_test
Design: SONDefinitionFormatter
Issue(s): #9651
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.98The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check type_sub
Specification(s): definition_type_sub_test
Design: SONDefinitionFormatter
Issue(s): #9651
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.99The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check default type
Specification(s): definition_default_type_test
Design: SONDefinitionFormatter
Issue(s): #9651
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.100The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check MinValInc
Specification(s): definition_minvalinc_inputdefault_test
Design: SONDefinitionFormatter
Issue(s): #9651
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.101The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check default types child parameter promotion
Specification(s): definition_default_types_child_parameter_promotion_test
Design: SONDefinitionFormatter
Issue(s): #18639
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.102The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check default subblock_types child parameter promotion
Specification(s): definition_default_subblock_types_child_parameter_promotion_test
Design: SONDefinitionFormatter
Issue(s): #18639
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.103The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check Mesh file parameter requirement removal
Specification(s): definition_mesh_file_parameter_requirement_removal_test
Design: SONDefinitionFormatter
Issue(s): #18639
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.104The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check Boolean type ValEnums choices
Specification(s): definition_boolean_type_valenum_choices_test
Design: SONDefinitionFormatter
Issue(s): #18639
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.105The system shall be able to convert a JsonSyntaxTree into Standard Object Notation (SON) for use by the NEAMS workbench. Check beginning and ending markers
Specification(s): definition_scraping_markers
Design: SONDefinitionFormatter
Issue(s): #17324
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: OutputInterface
- 1.36.107The system shall support limiting vector postrocessor data to a specific CSV output object.
Specification(s): test
Design: OutputInterface
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.137The system shall include the ability to limit automatic output of adaptivity objects, including
- indicators and
- markers.
Specification(s): group/indicators, group/markers
Design: OutputInterface
Issue(s): #3702
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.147The system shall support the ability to specify the output object for postprocessor data from within the input file block defining the postprocessor.
Specification(s): limit
Design: Output SystemOutputInterface
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.148The system shall error if an invalid output name is provided within the postprocessor input file block.
Specification(s): invalid_outputs
Design: Output SystemOutputInterface
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.149The system shall support limiting postprocessor output to the screen.
Specification(s): console
Design: Output SystemOutputInterface
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.36.150The system shall support limiting postprocessor output to from within the input file syntax of an output object.
Specification(s): show_hide
Design: Output SystemOutputInterface
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- The system shall error if a postprocessor variable is listed for suppression and inclusion within an output object block in the input file.
Specification(s): test_hidden_shown
Design: Output SystemOutputInterface
Issue(s): #1927
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: JSON
- 1.36.122The system shall support JSON output for data.
Specification(s): basic
Design: JSON
Issue(s): #11323
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.123The system shall include the ability to output simulation data in JSON format:
- that produces multiple files for parallel distributed data and
- 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.36.124The system shall support creating unique JSON output files per timestep.
Specification(s): basic
Design: JSON
Issue(s): #18133
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.36.153The system shall support the ability to output single value aggregate calculations to JSON format.
Specification(s): test
Design: JSON
Issue(s): #16543
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.36.177The system shall support the ability to output vector aggregate calculations to JSON format.
Specification(s): test
Design: JSON
Issue(s): #16543
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.47.8The system shall output aggregate simulation information to JSON format
- when the aggregate value is declared after object construction
- 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.47.9The system shall support getting a reference to an aggregate calculation before it is created.
Specification(s): decalareInitialSetup_with_get
Design: Reporter SystemJSON
Issue(s): #17468
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- framework: OutputWarehouse
- 1.36.125The system shall provide an API for retrieving an output object by type and name.
Specification(s): getOutput
Design: OutputWarehouse
Issue(s): #2885
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.126The system shall provide an API for retrieving all output objects of a type.
Specification(s): getOutputs
Design: OutputWarehouse
Issue(s): #2885
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.127The system shall provide an API for retrieving output objects for the given names and type.
Specification(s): getOutputs_with_names
Design: OutputWarehouse
Issue(s): #2885
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.128The system shall provide an API for retrieving all output object names of a type.
Specification(s): getOutputNames
Design: OutputWarehouse
Issue(s): #2885
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.36.129The system shall support the naming of output files based on the input file block name.
Specification(s): default_names
Design: OutputWarehouse
Issue(s): #2885
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.169The system shall guarantee that scalar variables are in the proper state for output when outputting:
- ExodusII format and
- CSV format.
Specification(s): group/exodus, group/csv
Design: OutputWarehouse
Issue(s): #4474
Collection(s): FUNCTIONAL
Type(s): CSVDiffExodiff
- framework: PerfGraphOutput
- 1.36.143The system shall output a performance log information for sub-applications
- that are transient,
- use differing time steps from the main, and
- execute an entire simulation.
Specification(s): perf/with_multi, perf/with_sub_cycle, perf/with_full
Design: PerfGraphOutput
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.36.144The system shall have the ability to output a detailed performance log
Specification(s): test
Design: PerfGraphOutput
Issue(s): #11551
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: PNGOutput (Outputs)
- 1.36.145The system shall be able to produce png images:
- for 2D square images,
- arbitrary shapped domains,
- and complex shapes with periodic boudary conditions.
Specification(s): image_tests/square_domain, image_tests/adv_diff_reaction, image_tests/wedge
Design: PNGOutput (Outputs)
Issue(s): #12846
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: Restartable
- 1.36.154Correctly set up initial recover files for the part2 test.
Specification(s): part1
Design: RestartableDataIO
Issue(s): #2661
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.155A simulation executed using the "–recover" flag successfully runs a simulation using the specified recover file argument.
Specification(s): part2
Design: RestartableDataIO
Issue(s): #2661
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.156Correctly set up initial recover files for the part2_latest test.
Specification(s): part1_latest
Design: RestartableDataIO
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.157A simulation executed using the "–recover" flag with a file argument using the placeholder "LATEST" successfully runs a simulation using most recent checkpoint/recover file from the specified directory.
Specification(s): part2_latest
Design: RestartableDataIO
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.48.1The 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.48.2The system shall support the ability to
- perform residual calculations that accumulate state and
- 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.48.3The system shall support the ability to
- to name problem objects in a simulation and
- 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.48.4The system shall error when
- a simulation is started with multiple processors but
- restarted with a different number processors.
Specification(s): parallel_error/error1, parallel_error/error2
Design: DataIORestartable
Issue(s): #2306
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- 1.48.5The system shall error when
- a simulation is started with multiple threads but
- restarted with a different number threads.
Specification(s): thread_error/with_threads, thread_error/threads_error
Design: DataIORestartable
Issue(s): #2306
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- 1.48.6The 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.48.7The 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.48.8The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.48.9The 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.48.10The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.48.11The 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.48.12The 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.48.13The system shall support outputting a mesh from a simulation
- with uniform refinement to ExodusII format,
- start a new simulation that adds additional refinement,
- 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.48.14The 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.48.15The 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.48.16The 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.48.17The 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.48.18The 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.48.19The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.48.20The 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.48.21The 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.48.22The 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.48.23The system shall support writing out checkpoint directly from a subapp, a subtree of the multiapp tree of the master solve.
Specification(s): two_step_solve_master
Design: DataIORestartable
Issue(s): #6297
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.48.24The system shall support restarting a subapp, a subtree of the multiapp tree of a master solve without restarting the master application.
Specification(s): two_step_solve_master_restart
Design: DataIORestartable
Issue(s): #6297
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.48.25The system shall support executing a
- a steady-state problem
- and restarting a transient simulation from the previous solution.
Specification(s): tests/steady, tests/restart_trans_from_steady
Design: RestartableDataIO
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.48.26The 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.48.27The 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.48.28The 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.48.29The 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.48.30The 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.48.31The 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.48.32The system shall be capable, on a single process, of
- writing data to a restart file
- and restarting the simulation from the restart file.
Specification(s): serial/first, serial/second
Design: Restartable
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.48.33The system shall be capable, in parallel, of
- writing data to a restart file
- and restarting the simulation from the restart file.
Specification(s): parallel/first, parallel/second
Design: Restartable
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.48.35The 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.48.36The 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.48.37The 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.48.38The 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.36.154Correctly set up initial recover files for the part2 test.
Specification(s): part1
Design: RestartableDataIO
Issue(s): #2661
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.155A simulation executed using the "–recover" flag successfully runs a simulation using the specified recover file argument.
Specification(s): part2
Design: RestartableDataIO
Issue(s): #2661
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.36.156Correctly set up initial recover files for the part2_latest test.
Specification(s): part1_latest
Design: RestartableDataIO
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.36.157A simulation executed using the "–recover" flag with a file argument using the placeholder "LATEST" successfully runs a simulation using most recent checkpoint/recover file from the specified directory.
Specification(s): part2_latest
Design: RestartableDataIO
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.48.1The 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.48.2The system shall support the ability to
- perform residual calculations that accumulate state and
- 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.48.3The system shall support the ability to
- to name problem objects in a simulation and
- 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.48.4The system shall error when
- a simulation is started with multiple processors but
- restarted with a different number processors.
Specification(s): parallel_error/error1, parallel_error/error2
Design: DataIORestartable
Issue(s): #2306
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- 1.48.5The system shall error when
- a simulation is started with multiple threads but
- restarted with a different number threads.
Specification(s): thread_error/with_threads, thread_error/threads_error
Design: DataIORestartable
Issue(s): #2306
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- 1.48.6The 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.48.7The 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.48.8The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.48.9The 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.48.10The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.48.11The 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.48.12The 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.48.13The system shall support outputting a mesh from a simulation
- with uniform refinement to ExodusII format,
- start a new simulation that adds additional refinement,
- 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.48.14The 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.48.15The 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.48.16The 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.48.17The 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.48.18The 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.48.19The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.48.20The 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.48.21The 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.48.22The 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.48.23The system shall support writing out checkpoint directly from a subapp, a subtree of the multiapp tree of the master solve.
Specification(s): two_step_solve_master
Design: DataIORestartable
Issue(s): #6297
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.48.24The system shall support restarting a subapp, a subtree of the multiapp tree of a master solve without restarting the master application.
Specification(s): two_step_solve_master_restart
Design: DataIORestartable
Issue(s): #6297
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.48.25The system shall support executing a
- a steady-state problem
- and restarting a transient simulation from the previous solution.
Specification(s): tests/steady, tests/restart_trans_from_steady
Design: RestartableDataIO
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.48.26The 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.48.27The 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.48.28The 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.48.29The 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.48.30The 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.48.31The 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.48.35The 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.48.36The 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.48.37The 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.48.38The 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.36.178The system shall optionally support output of files using the VTK format:
- in serial and
- in parallel.
Specification(s): files/serial, files/parallel
Design: VTK
Issue(s): #1927
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: XMLOutput
- 1.36.181The system shall support XML output for vector data that is
- replicated or
- distributed in parallel.
Specification(s): parallel/replicated, parallel/distributed
Design: XMLOutput
Issue(s): #14634
Collection(s): FUNCTIONAL
Type(s): XMLDiff
- 1.36.182The system shall support XML output for vector data during nonlinear solve.
Specification(s): iterations
Design: XMLOutput
Issue(s): #14634
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: CommandLine
- 1.37.6The system shall support the ability to override input file parameters from the command line.
Specification(s): test
Design: CommandLine
Issue(s): #581
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.37.7The system shall support the ability to globally change MultiApp input file syntax from the command line.
Specification(s): cli_override_all
Design: CommandLine
Issue(s): #2137
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.37.8The system shall support the ability to change a whole MultiApp's (multiple SubApps) input file syntax from the command line.
Specification(s): cli_override_group
Design: CommandLine
Issue(s): #2137
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.37.9The system shall support the ability to change individual SubApp input file syntax from the command line.
Specification(s): cli_override_single
Design: CommandLine
Issue(s): #2137
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.37.10The system shall produce an error when a SubApp command line override index is not valid.
Specification(s): cli_override_error_check
Design: CommandLine
Issue(s): #2137
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: BlockWeightedPartitioner
- 1.38.1The system shall support a block-weighted partitioner
- when using ReplicatedMesh
- and when using DistributedMesh.
Specification(s): tests/replicated_mesh, tests/distributed_mesh
Design: BlockWeightedPartitioner
Issue(s): #13675
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.38.2The block-weighted partitioner shall report a reasonable error when
- the input blocks do not match the size of the input weights
- an input block is not found in the mesh
Specification(s): errors/size_mismatch, errors/missing_block
Design: BlockWeightedPartitioner
Issue(s): #13675
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: GridPartitioner
- 1.38.5The system shall provide a simple regular grid-based partitioner
Specification(s): test
Design: GridPartitioner
Issue(s): #11437
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: HierarchicalGridPartitioner
- 1.38.6The system shall have the ability to do hierarchical partitioning based on a regular grid.
Specification(s): test
Design: HierarchicalGridPartitioner
Issue(s): #12531
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PetscExternalPartitioner
- 1.38.7Make MOOSE support ptscotch via PETSc
Specification(s): ptscotch
Design: PetscExternalPartitioner
Issue(s): #11628
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.38.8ptscotch shall support element-weighted graphs for balancing workload
Specification(s): ptscotch_weight_elment
Design: PetscExternalPartitioner
Issue(s): #11628
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.38.9ptscotch shall support side-weighted graphs for minimizing communication
Specification(s): ptscotch_weight_side
Design: PetscExternalPartitioner
Issue(s): #11628
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.38.10ptscotch shall take both side weights and element weights into consideration
Specification(s): ptscotch_weight_both
Design: PetscExternalPartitioner
Issue(s): #11628
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.38.11Make MOOSE support parmetis via PETSc
Specification(s): parmetis
Design: PetscExternalPartitioner
Issue(s): #11628
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.38.12Parmetis shall support element-weighted graphs for balancing workload
Specification(s): parmetis_weight_element
Design: PetscExternalPartitioner
Issue(s): #11628
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.38.13Parmetis shall support side-weighted graphs for minimizing communication
Specification(s): parmetis_weight_side
Design: PetscExternalPartitioner
Issue(s): #11628
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.38.14Parmetis shall take side weights and element weights into consideration
Specification(s): parmetis_weight_both
Design: PetscExternalPartitioner
Issue(s): #11628
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.38.15Parmetis shall support presplit
Specification(s): parmetis_presplit_mesh
Design: PetscExternalPartitioner
Issue(s): #11628
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- 1.38.16The system shall support a serial partitioner Chaco
Specification(s): chaco
Design: PetscExternalPartitioner
Issue(s): #11628
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.38.17The system shall support a serial partitioner party
Specification(s): party
Design: PetscExternalPartitioner
Issue(s): #11628
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: RandomPartitioner
- 1.38.18The system shall provide a random partitioner
Specification(s): test
Design: RandomPartitioner
Issue(s): #14419
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SingleRankPartitioner
- 1.38.19The system shall allow restricting apps to just one MPI rank
Specification(s): test
Design: SingleRankPartitioner
Issue(s): #18729
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.38.20The system shall error if an out of range rank is given to SingleRankPartitioner
Specification(s): test_error
Design: SingleRankPartitioner
Issue(s): #18729
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: Use, Performance, and System Interfaces for MOOSE
- 1.39.1The system shall support the use of multiple processors using
- distributed memory,
- shared memory, and
- both distributed and shared memory.
Specification(s): multiprocess/mpi, multiprocess/thread, multiprocess/both
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): PERFORMANCE
Type(s): RunApp
- 1.39.2The system shall support execution on
- macOS and
- Linux operating systems.
Specification(s): os/macOS, os/linux
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): PERFORMANCE
Type(s): RunApp
- 1.53.1The system shall support the use of message passing interface (MPI).
Specification(s): mpi
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): SYSTEM
Type(s): RunApp
- 1.53.2The system shall support the use of shared memory threads using
- 'pthreads' or
- OpenMP.
Specification(s): thread/pthread, thread/openmp
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): SYSTEM
Type(s): RunApp
- 1.53.3The system shall support the use of the following parallel mesh partitioners:
- Chaco,
- ParMETIS,
- Party, and
- PTScotch.
Specification(s): partitioner/chaco, partitioner/parmetis, partitioner/party, partitioner/ptscotch
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): SYSTEM
Type(s): RunApp
- 1.53.4The system shall support the use of the following solver packages:
- SuperLU,
- MUMPS, and
- SLEPc.
Specification(s): solver/superlu, solver/mumps, solver/slepc
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): SYSTEM
Type(s): RunApp
- 1.53.5The system shall support the use of the following C++ libraries:
- Visualization ToolKit (VTK) and
- BOOST.
Specification(s): libraries/vtk, libraries/boost
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): SYSTEM
Type(s): RunApp
- 1.53.6The system shall interface operate with the following C++ compilers:
- Clang and
- GCC.
Specification(s): compiler/clang, compiler/gcc
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): SYSTEM
Type(s): RunApp
- 1.58.1The system will be operated using a command-line interface that
- reports the available options when none are provided and
- accepts defined command-line flags.
Specification(s): command-line/empty, command-line/flags
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): USABILITY
Type(s): RunApp
- 1.58.2The system will be operated using
- an input file and
- command-line options.
Specification(s): input/input_file, input/command_line
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): USABILITY
Type(s): RunApp
- 1.58.3The system shall return usage messages when unidentified arguments or incorrectly used arguments are passed.
Specification(s): message
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): USABILITY
Type(s): RunException
- 1.58.4The system shall provide diagnostics when the input file fails to parse, or the format is incorrect.
Specification(s): diagnostic
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): USABILITY
Type(s): RunException
- 1.58.5The system will provide on screen information about the simulation characteristics of the solves under normal operating conditions.
Specification(s): normal
Design: Use, Performance, and System Interfaces for MOOSE
Issue(s): #16410
Collection(s): USABILITY
Type(s): RunApp
- framework: PhiZero
- 1.40.1The system shall be able to construct zero objects for shape functions and shape function gradients consistent with the maximum number ofshape functions and quadrature points in the simulation.
Specification(s): phi_zero_linear
Design: PhiZero
Issue(s): #15204
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.40.2The system shall be able to construct zero objects for shape functions and shape function gradients consistent with the maximum number ofshape functions and quadrature points in the simulation. This test checks the size of zero objects when using second-order elements and second order-variables.
Specification(s): phi_zero_quadratic
Design: PhiZero
Issue(s): #15204
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: AreaPostprocessor
- 1.41.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.41.50The 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.41.51The 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: AverageNodalVariableValue
- 1.41.2The system shall compute the average value of a field variable over time
- at the end of a time step and
- and at the beginning of the time step.
Specification(s): avg_nodal_value/test_avg_nodal_var_value, avg_nodal_value/test_avg_nodal_var_value_ts_begin
Design: AverageNodalVariableValue
Issue(s): #2281
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: AxisymmetricCenterlineAverageValue
- 1.41.3The system shall compute the average value of a quantity along the axis of rotation in an axisymmetric coordinate system.
Specification(s): test
Design: AxisymmetricCenterlineAverageValue
Issue(s): #7528
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ChangeOverFixedPointPostprocessor
- 1.41.4The system shall support calculating the value change overFixedPoint
- with respect to the previous calculation and
- with respect to the initial calculation.
Specification(s): change_over_fixed_point/change_with_respect_to_previous, change_over_fixed_point/change_with_respect_to_initial
Design: ChangeOverFixedPointPostprocessor
Issue(s): #10327
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.5The system shall issue an error when the dependent "change ofFixedPoint" calculation
- "with respect to initial" isn't calculated at the initial step and
- "with respect to previous" isn't calculated at the previous step.
Specification(s): change_over_fixed_point_error/change_with_respect_to_initial_error_dependent, change_over_fixed_point_error/change_with_respect_to_initial_error_this
Design: ChangeOverFixedPointPostprocessor
Issue(s): #10327
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ChangeOverTimePostprocessor
- 1.41.6The system shall support calculating the value change over time
- with respect to the previous calculation and
- with respect to the initial calculation.
Specification(s): change_over_time/change_with_respect_to_previous, change_over_time/change_with_respect_to_initial
Design: ChangeOverTimePostprocessor
Issue(s): #10327
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.7The system shall issue an error when the dependent "change of time" calculation
- "with respect to initial" isn't calculated at the initial step and
- "with respect to previous" isn't calculated at the previous step.
Specification(s): change_over_time_error/change_with_respect_to_initial_error_dependent, change_over_time_error/change_with_respect_to_initial_error_this
Design: ChangeOverTimePostprocessor
Issue(s): #10327
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: CumulativeValuePostprocessor
- 1.41.9The system shall have the ability to accumulate a scalar value over time.
Specification(s): cumulative_value_postprocessor
Design: CumulativeValuePostprocessor
Issue(s): #7976
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: DifferencePostprocessor
- 1.41.11The system shall support computing the difference between two scalar Postprocessor values.
Specification(s): test
Design: DifferencePostprocessor
Issue(s): #3268
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.12The system shall execute dependent Postprocessors first when computing the difference between two Postprocessors.
Specification(s): depend_check
Design: DifferencePostprocessor
Issue(s): #3268
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ElementAverageMaterialProperty
- 1.41.14The system shall compute the the average value of a non-AD material property over the domain.
Specification(s): non_ad
Design: ElementAverageMaterialProperty
Issue(s): #14648
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.15The system shall compute the the average value of an AD material property over the domain.
Specification(s): ad
Design: ElementAverageMaterialProperty
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ElementAverageValue
- 1.41.16The system shall contain a "Postprocessor" that computes the average value of a variable
- one a single block and
- on multiple blocks.
Specification(s): elem_average_value/single_block, elem_average_value/test_elem_multi_block
Design: ElementAverageValue
Issue(s): #2281
Collection(s): FUNCTIONAL
Type(s): CSVDiffExodiff
- framework: ElementExtremeFunctorValue
- 1.41.17The system shall compute the extreme (min/max) values of a functor evaluated at each element over the domain.
Specification(s): elemental_extreme
Design: ElementExtremeFunctorValue
Issue(s): #20151
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.18The system shall compute the value of a functor at the element where a proxy functor reaches the extreme (max/min) value over the domain.
Specification(s): proxy_elemental_extreme
Design: ElementExtremeFunctorValue
Issue(s): #20151
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ElementExtremeMaterialProperty
- 1.41.19The system shall compute the the extreme (min/max) values of a non-AD material property over the domain.
Specification(s): non_ad
Design: ElementExtremeMaterialProperty
Issue(s): #14648
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.20The system shall compute the the extreme (min/max) values of an AD material property over the domain.
Specification(s): ad
Design: ElementExtremeMaterialProperty
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ElementExtremeValue
- 1.41.21The system shall compute the extreme (min/max) values of an elemental field variable over the domain.
Specification(s): elemental_extreme
Design: ElementExtremeValue
Issue(s): #2776
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.22The system shall compute the value of a variable at the point where a proxy variable reaches the extreme (max/min) value over the domain.
Specification(s): proxy_elemental_extreme
Design: ElementExtremeValue
Issue(s): #18936
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ElementH1Error
- 1.41.23The 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: ElementIntegralVariablePostprocessor
- 1.41.24The system shall compute the element integral of a variable
- over the whole domain and
- over a subset of the domain.
Specification(s): element_integral/test, element_integral/block_test
Design: ElementIntegralVariablePostprocessor
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.26The system shall support computing the integral of a variable quantity over the domain on the mesh
- during the initial setup step
- and at the end of each time step, for FE variables
- and FV variables.
Specification(s): element_integral/test_inital, element_integral/pps_old_test, element_integral/pps_old_test_fv
Design: ElementIntegralVariablePostprocessor
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ElementL1Error
- 1.41.27The 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: ElementL2Difference
- 1.41.28The system shall compute the element-wise L2 difference between two field variables.
Specification(s): test
Design: ElementL2Difference
Issue(s): #5771
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ElementL2Error
- 1.41.29The 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.41.63The 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.41.64The system shall verify calculations using the method of manufactured solutions using sine functions for linear elements:
- on a 3D mesh
- verified with an analytical 3D solution and
- on a 2D mesh
- 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.41.65The 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: ElementAverageTimeDerivative
- 1.41.31The system shall compute the average time derivative of a solution value computed per element in 2D.
Specification(s): element_time_derivative_test
Design: ElementAverageTimeDerivative
Issue(s): #1820
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.32The system shall compute the average time derivative of a solution value computed per element in 1D.
Specification(s): el_time_deriv_1d_test
Design: ElementAverageTimeDerivative
Issue(s): #1820
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ElementalVariableValue
- 1.41.33The system shall support sampling a specific quantity integrated over a single element.
Specification(s): elem_var_value_test
Design: ElementalVariableValue
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.34The system shall support sampling a specific quantity integrated over a single element with finite volume variables.
Specification(s): elem_var_value_fv_test
Design: ElementalVariableValue
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ElementVectorL2Error
- 1.41.35The system shall compute the Vector L2 Error of three scalar variables simultaneously as three orthogonal components of a vector.
Specification(s): test
Design: ElementVectorL2Error
Issue(s): #2838
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: FindValueOnLine
- 1.41.38The system shall be capable of find a value on a monotonically changing line.
Specification(s): find_value_on_line
Design: FindValueOnLine
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.39The system shall report and error when the target value is lower than one of the sampled endpoints.
Specification(s): below_min
Design: FindValueOnLine
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.41.40The system shall report and error when the target value is greater than one of the sampled endpoints.
Specification(s): above_max
Design: FindValueOnLine
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.41.41The 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
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.42The 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
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.43The 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
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.44The 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
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.45The system shall report and error when the sampling line extends beyond the mesh bounding box.
Specification(s): line_out_of_bounds
Design: FindValueOnLine
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.41.46The system shall report and error when the line sampling algorithm fails to converge within the desired depth.
Specification(s): depth_exceeded
Design: FindValueOnLine
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: FunctionElementIntegral
- 1.41.47The system shall integrate functions over volume.
Specification(s): test
Design: FunctionElementIntegral
Issue(s): #13418
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: FunctionSideIntegral
- 1.41.48The system shall compute the integral of a function over a boundary.
Specification(s): function_sideintegral
Design: FunctionSideIntegral
Issue(s): #4799
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: FunctionValuePostprocessor
- 1.41.49The system shall support evaluating a function of space and time at a single point as a Postprocessor value.
Specification(s): test
Design: FunctionValuePostprocessor
Issue(s): #5197
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: VolumePostprocessor
- 1.41.50The 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.41.51The 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.41.130The 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: InterfaceDiffusiveFluxAverage
- 1.41.52The system shall be able to compute the integral of the diffusive flux at an interface
- with finite element variables,
- and with finite volume variables.
Specification(s): interface_diffusive_flux_integral/fe, interface_diffusive_flux_integral/fv
Design: InterfaceDiffusiveFluxAverage
Issue(s): #17637
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.53The system shall be able to compute the average diffusive flux at an interface
- with finite element variables,
- and with finite volume variables.
Specification(s): average/fe, average/fv
Design: InterfaceDiffusiveFluxAverage
Issue(s): #17637
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: InterfaceAverageVariableValuePostprocessor
- 1.41.54Testing 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.41.56Testing 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
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: InterfaceIntegralVariableValuePostprocessor
- 1.41.55Testing 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.41.57Testing 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
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: LinearCombinationPostprocessor
- 1.41.59The system shall support the ability to compute a linear combination of scalar values (Postprocessors).
Specification(s): linear_combination
Design: LinearCombinationPostprocessor
Issue(s): #10145
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.60The system shall allow a mix of postprocessor names and real numbers to be provided to PostprocessorName parameters.
Specification(s): linear_combination_defaulted_pps
Design: LinearCombinationPostprocessor
Issue(s): #10145
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: MemoryUsage
- 1.41.61The 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.41.62The 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: NearestNodeNumber
- 1.41.66The system shall have the capability to compute the nearest node number to a given point.
Specification(s): nearest_node_number_1
Design: NearestNodeNumber
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.67The system shall have the capability to compute the nearest node number to a given point, and will choose the smallest node number if more than one node is equidistant.
Specification(s): nearest_node_number_2
Design: NearestNodeNumber
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.68The system shall have the capability to compute the nearest node number to a given point, including when the mesh is adapting
Specification(s): nearest_node_number_3
Design: NearestNodeNumber
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: NodalExtremeValue
- 1.41.69The system shall compute the extreme (min/max) values of a nodal field variable over the domain.
Specification(s): nodal_extreme
Design: NodalExtremeValue
Issue(s): #2026
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.70The system shall compute the value of a variable at the point at which a proxy variable reaches the extreme (min/max) value.
Specification(s): nodal_extreme_proxy
Design: NodalExtremeValue
Issue(s): #18936
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.71The system shall compute the maximum value of a field variable by sampling nodes
- over the whole domain and
- within a subdomain.
Specification(s): nodal_max/test_nodal_max, nodal_max/test
Design: NodalExtremeValue
Issue(s): #658
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: NodalSum
- 1.41.72The system shall compute the sum of nodal values of a variable
- on the whole domain,
- on a subset of the domain, and
- on multiple overlapping blocks visiting some nodes multiple times.
Specification(s): nodal_sum/all, nodal_sum/nodal_sum_block, nodal_sum/nodal_sum_block_non_unique
Design: NodalSum
Issue(s): #5680
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: NodalVariableValue
- 1.41.73The system shall report the value of a variable at a specified node
- for auxiliary variables and
- for primary (nonlinear) variables.
Specification(s): nodal_var_value/test_nodal_aux_var_value, nodal_var_value/test_nodal_var_value
Design: NodalVariableValue
Issue(s): #2281
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.74The system shall support selecting the output for a single Postprocessor
- to a file and
- to the console.
Specification(s): nodal_var_value_output/pps_output_test, nodal_var_value_output/screen_output_test
Design: NodalVariableValue
Issue(s): #2281
Collection(s): FUNCTIONAL
Type(s): RunAppExodiff
- framework: NumDOFs
- 1.41.78The 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
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: NumElems
- 1.41.79The NumElems Postprocessor shall report the number of elements (active or total) in the simulation.
Specification(s): test
Design: NumElems
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.80The 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
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: NumNodes
- 1.41.82The 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.41.83The NumNodes Postprocessor shall report the number of nodes in the simulation when using distributed (pre-split) mesh.
Specification(s): test_split
Design: NumNodes
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: NumResidualEvaluations
- 1.41.84The system shall be capable of outputting the number of Residual evaluations
Specification(s): test
Design: NumResidualEvaluations
Issue(s): #2089
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: NumVars
- 1.41.85The 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: ParsedPostprocessor
- 1.41.89The system shall be able to compute a postprocessor based on a parsed expression of other postprocessors.
Specification(s): test
Design: ParsedPostprocessor
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: PerfGraphData
- 1.41.90The 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.41.91The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: PointValue
- 1.41.92The 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.41.93The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: PostprocessorComparison
- 1.41.94The system shall include the ability to compare post-processor data and return a boolean value for
- greater than operator and the
- less than operator.
Specification(s): group/greater_than, group/less_than
Design: PostprocessorComparison
Issue(s): #11910
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: Receiver
- 1.41.104The system shall support the ability to report a scalar value set by arbitrary objects in the simulation
- with an initial default value and
- 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
- framework: RelativeDifferencePostprocessor
- 1.41.105The system shall support computing the relative difference between two scalar values (Postprocessors)
- when values are non-zero, and
- when values are approximately zero.
Specification(s): relative_difference/non_zero, relative_difference/close_to_zero
Design: RelativeDifferencePostprocessor
Issue(s): #10148
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: RelativeSolutionDifferenceNorm
- 1.41.106The system shall be capable of computing the relative norm of the solution difference between two consecutive time steps.
Specification(s): test
Design: RelativeSolutionDifferenceNorm
Issue(s): #7118
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ScalarVariable
- 1.41.108The 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.41.109The 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.41.110The 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.59.62The system shall 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
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: SideAverageMaterialProperty
- 1.41.111The system shall support computing the average of a material property over a side on the mesh.
- if the material property is of
Real
type - if the material property is of
RealVectorValue
type - if the material property is of
std::vector<Real>
type - if the material property is of
RankTwoTensor
type - if the material property is of
RankThreeTensor
type - if the material property is of
RankFourTensor
type - And shall error out if the index components do not match the dimension of the supplied property
Specification(s): side_average_material_property/real, side_average_material_property/realvector, side_average_material_property/stdvec, side_average_material_property/ranktwo, side_average_material_property/rankthree, side_average_material_property/rankfour, side_average_material_property/error
Design: SideAverageMaterialProperty
Issue(s): #18649
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionCSVDiff
- if the material property is of
- framework: SideDiffusiveFluxAverage
- 1.41.112The 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.41.113The 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
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SideDiffusiveFluxIntegral
- 1.41.114The system shall be capable of computing the integral of the diffusive flux through a specified boundary on the mesh
- with a scalar diffusivity,
- with an anisotropic vector diffusivity.
Specification(s): test/scalar_diffusivity, test/vector_diffusivity
Design: SideDiffusiveFluxIntegral
Issue(s): #2201
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.115The system shall be capable of computing the integral of the diffusive flux integral of a finite volume variable through a specified boundary on the mesh
- with a scalar diffusivity,
- with a vector diffusivity.
Specification(s): test_fv/scalar_diffusivity, test_fv/vector_diffusivity
Design: SideDiffusiveFluxIntegral
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: GenericVectorFunctorMaterial
- 1.41.116The system shall yield equivalent results when vector material properties are computed with pre-initialized data or computed on-the-fly.
Specification(s): vector_functor
Design: GenericVectorFunctorMaterial
Issue(s): #16809
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SideIntegralVariablePostprocessor
- 1.41.117The system shall support computing the integral of a variable quantity over a side on the mesh.
Specification(s): fe_test
Design: SideIntegralVariablePostprocessor
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.41.118The system shall support computing the integral of a finite volume variable quantity over a side on the mesh.
Specification(s): fv_test
Design: SideIntegralVariablePostprocessor
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SideIntegralMaterialProperty
- 1.41.119The system shall support computing the integral of a material property over a side on the mesh.
- if the material property is of
Real
type - if the material property is of
RealVectorValue
type - if the material property is of
RankTwoTensor
type - And shall error out if the index components do not match teh dimension of the supplied property
Specification(s): side_integral_material_property/real, side_integral_material_property/realvector, side_integral_material_property/ranktwo, side_integral_material_property/error
Design: SideIntegralMaterialProperty
Issue(s): #18649
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionCSVDiff
- if the material property is of
- framework: SideIntegralFunctorPostprocessor
- 1.41.120The system shall
- support computing the integral of a functor over one or more sides on the mesh.
- support computing the integral of a functor over a functor domain boundary inside a mesh.
- support computing the integral of a functor over one or more evenly refined sides on the mesh.
Specification(s): functors/mesh_side, functors/domain_side, functors/mesh_side_refined
Design: SideIntegralFunctorPostprocessor
Issue(s): #18086
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: TableOutput
- 1.41.122The 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: TimeExtremeValue
- 1.41.123The system shall have the ability to record a minimum or maximum value of a field variable over time.
Specification(s): time_extreme_pps
Design: TimeExtremeValue
Issue(s): #6902
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.124The system shall have the ability to return the time at which a minimum or maximum value of a field variable over time occurred.
Specification(s): time_of_time_extreme_pps
Design: TimeExtremeValue
Issue(s): #14904
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: VariableInnerProduct
- 1.41.125The system shall include the ability to compute the inner product of two variables.
Specification(s): variable_inner_product_test
Design: VariableInnerProduct
Issue(s): #7532
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: VariableResidual
- 1.41.126The system shall compute the difference between the test and trial functions (Residual) for a specified variable.
Specification(s): variable_residual_test
Design: VariableResidual
Issue(s): #7206
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: VectorPostprocessorComparison
- 1.41.127Vector post-processor values shall be able to be compared and return a boolean value for
- greater than or equal,
- greater than,
- less than, or
- equal.
Specification(s): group/greater_than_equals, group/greater_than, group/less_than_equals, group/equals
Design: VectorPostprocessorComparison
Issue(s): #11704
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: VectorPostprocessorComponent
- 1.41.128The system shall provide a Postprocessor that returns a single specified component of a VectorPostprocessor
Specification(s): vpp_component
Design: VectorPostprocessorComponent
Issue(s): #11439
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.41.129The Postprocessor that returns a single specified component of a VectorPostprocessor shall generate an error if the requested component is out of the range of the vector
Specification(s): vpp_component_range_err
Design: VectorPostprocessorComponent
Issue(s): #11439
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: CreateExecutionerAction
- 1.42.1The system shall support the disabling of an automatically created preconditioning object when preforming a Newton solve.
Specification(s): manual
Design: CreateExecutionerAction
Issue(s): #13411
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.42.2The system shall automatically create the correct preconditioning object when preforming a Newton solve.
Specification(s): auto
Design: CreateExecutionerAction
Issue(s): #13411
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.42.3The system shall not automatically create a preconditioning object when preforming a Newton solve if the auto preconditioning capability is disabled.
Specification(s): fail
Design: CreateExecutionerAction
Issue(s): #13411
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: FSP
- 1.42.7The system shall support the use of field split preconditioner on
- a single subdomain and
- multiple subdomains.
Specification(s): group/test, group/fsp_image
Design: FSP
Issue(s): #1851
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: HMG
- 1.42.8The system shall support the use of HMG (high performance MG)
Specification(s): hmg
Design: HMG
Issue(s): #16210
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.42.9The system shall support the use of HMG (high performance MG) for 3D problems
Specification(s): hmg_3D
Design: HMG
Issue(s): #16210
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.42.10The system shall support the use of strumpack (sparse direct solver) for 3D problems
Specification(s): hmg_strumpack
Design: HMG
Issue(s): #16501
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: Preconditioning System
- 1.42.11The system shall support the ability to use multiple cycles within hypre during preconditioning with PETSc.
Specification(s): test
Design: Preconditioning System
Issue(s): #1048
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.42.15The system shall support the ability to use the conjugate gradient method for preconditioning with PETSc.
Specification(s): test
Design: Preconditioning System
Issue(s): #8681
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PBP
- 1.42.12The system shall support the use of a physics based preconditioner
- without and
- with mesh adaptivity.
Specification(s): pbp/test, pbp/pbp_adapt_test
Design: PBP
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.42.13The system shall support the ability to add arbitrary options to the solver when using a physics based precondioner.
Specification(s): check_petsc_options_test
Design: PBP
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.42.14The system shall support the ability to control the variable solve order when using a physics base preconditioner.
Specification(s): lots_of_variables
Design: PBP
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: SMP
- 1.42.16The system shall support the use of a single matrix preconditioner
- without and
- with mesh adaptivity.
Specification(s): smp/smp_test, smp/smp_adapt_test
Design: SMP
Issue(s): #1048
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.42.17The system shall support the ability to group variables when using a single matrix preconditioner.
Specification(s): smp_group_test
Design: SMP
Issue(s): #1048
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: VCP
- 1.42.18The system shall converge when using the VCP interface with AMG as the preconditioner.
Specification(s): condense_amg_test
Design: VCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.42.19The system shall converge while computing the full inverse of the coupling matrix.
Specification(s): condense_amg_test_dinv
Design: VCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.42.20The system shall converge while using LU as the solver.
Specification(s): no-condense_amg_test
Design: VCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: SimplePredictor
- 1.43.1The system shall include a means for predicting future solution based on previous solutions.
Specification(s): test
Design: SimplePredictor
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.43.2The system shall include a means for predicting future solution based on previous solutions and print the scale factor to the output stream.
Specification(s): output
Design: SimplePredictor
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.43.3The system shall support the ability to skip performing solution predictions
- using solution times or
- previous solution times.
Specification(s): skip/test_skip, skip/test_skip_old
Design: SimplePredictor
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.43.4The system shall support the ability to skip a prediction after a failed time step
Specification(s): skip_after_failed_timestep
Design: SimplePredictor
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: DumpObjectsProblem
- 1.44.6The system shall have a capability to dump the equivalent input file syntax for all objects added by a given action.
Specification(s): add_mat_and_kernel
Design: DumpObjectsProblem
Issue(s): #8875
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: Eigenvalue
- 1.44.7The system shall include the support for Eigen value calculations that utilize
- an array of residual contributions;
- multiple variables; and
- 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.44.8Eigenvalue system should support standard eigenvalue problems
Specification(s): test
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.9Eigenvalue system should support generalized eigenvalue problems
Specification(s): gipm_test
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.10Eigenvalue system should support IntegratedBC
Specification(s): gipm_ibc
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.11Eigenvalue system should not allow users to use inhomogeneous nodal boundary conditions
Specification(s): wrong_dirichlet_value_eigen
Design: Eigenvalue
Issue(s): #7398
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.44.12Eigenvalue system should use homogeneous boundary conditions only
Specification(s): wrong_NodalBC_type_eigen
Design: Eigenvalue
Issue(s): #7398
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.44.13Eigenvalue system requires SLEPc installed
Specification(s): no_slepc
Design: Eigenvalue
Issue(s): #7398
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.44.14Eigenvalue system should be able to solve a nonlinear eigenvalue problem
Specification(s): nonlinear_power
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.15Eigenvalue system should be able to solve a nonlinear eigenvalue problem using Newton
Specification(s): monolith_newton
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.16Eigenvalue system should be able to solve a deficient eigenvalue problem
Specification(s): ne_deficient
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.17Eigenvalue system should be able to compute a nonlinear eigenvalue problem
Specification(s): nonlinear_laplace
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.18Eigenvalue system should be able to compute a coupled nonlinear eigenvalue problem
Specification(s): coupled_system
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.19Eigenvalue system should be able to handle scalar kernels
Specification(s): eigen_scalar_kernel
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.20Eigenvalue system should be able to handle DG kernels
Specification(s): dg_krylovschur
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.21Eigenvalue system shall support Picard iteration using eigenvalue executioner as a master.
Specification(s): eigen_as_master
Design: Eigenvalue
Issue(s): #15513
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.22Eigenvalue system shall support Picard iteration using eigenvalue executioner as a master and output eigen vectors as an exodus file.
Specification(s): eigen_as_master_exodus
Design: Eigenvalue
Issue(s): #15513
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.44.23Eigenvalue system shall support Picard iteration using eigenvalue executioner as a sub app.
Specification(s): eigen_as_sub
Design: Eigenvalue
Issue(s): #15513
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.24Eigenvalue system shall support Picard iteration using eigenvalue executioner as a sub app and output eigen vectors as an exodus file.
Specification(s): eigen_as_sub_exodus
Design: Eigenvalue
Issue(s): #15513
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.44.25Eigenvalue system should be able scale eigenvector such that postprocessor is a certain value
Specification(s): scaled_eigenvector
Design: Eigenvalue
Issue(s): #14500
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.44.26The system shall be able to automatically condition a nonlinear eigen-solve based on diagonal entries in the preconditioning matrix.
Specification(s): coupled-system-auto-scaling
Design: Eigenvalue
Issue(s): #15048
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.27The system shall be able to automatically scale a nonlinear eigen-solve based on entries in the non-eigen residual vector.
Specification(s): coupled-system-resid-auto-scaling
Design: Eigenvalue
Issue(s): #15048
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.28The system shall provide an initial guess to Newton if users request.
Specification(s): newton_intial_guess
Design: Eigenvalue
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.29The system shall support eigenvalue execution without free power iterations.
Specification(s): newton_no_free_power
Design: Eigenvalue
Issue(s): #17026
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.30The system shall provide an option to output the eigenvalue as its inverse.
Specification(s): inverse_eigenvalue_postprocessor
Design: Eigenvalue
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.31The system shall provide an option to output the eigenvalue on screen as its inverse.
Specification(s): output_inverse_eigenvalue
Design: Eigenvalue
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.44.32The system shall support extra power iterations.
Specification(s): extra_power_iterations
Design: Eigenvalue
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.44.33The system shall support extra power iterations and check eigenvalue.
Specification(s): extra_power_iterations_csv
Design: Eigenvalue
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.34The system shall support eigenvalue calculations with an initial condition including the initial solution vector and the initial eigenvalue.
Specification(s): newton_with_exact_initialization
Design: Eigenvalue
Issue(s): #20454
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.44.35The system shall support use of matrix-vector multiplication as residual evaluation for eigenvalue calculations
Specification(s): ne_array_mo
Design: Eigenvalue
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.36The system shall support evaluation of auxiliary variables on linear with the matrix-only eigenvalue solve type
Specification(s): ne_mo_with_linear_aux
Design: Eigenvalue
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.37The system shall support use of matrix-vector multiplication as residual evaluation for eigenvalue calculations with constant matrices
Specification(s): const_mats
Design: Eigenvalue
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.38The system shall support compatibility of solve type and constant-matrices flag
Specification(s): check_solve_type
Design: Eigenvalue
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.44.39The system shall support use of matrix-vector multiplication as residual evaluation for coupled eigenvalue problems
Specification(s): ne_coupled_mo
Design: Eigenvalue
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.40The system shall support use of matrix-vector multiplication with full-coupled matrices (by default) as residual evaluation for coupled eigenvalue problems
Specification(s): ne_coupled_mo_full
Design: Eigenvalue
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.41The system shall support use of matrix-vector multiplication as residual evaluation for non-homogeneous problems
Specification(s): non-homogeneous
Design: Eigenvalue
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.42Eigen solver should work with a physics-based preconditioner
Specification(s): newton_pbp
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.43The system shall support a physics-based preconditioner with using JFNK
Specification(s): JFNK_pbp
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.44Eigen solver should work with a physics-based preconditioner with a shell preconditioning matrix
Specification(s): newton_pbp_shell_precond
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.44.45Eigen solver should work with a physics-based preconditioner with a PETSc shell matrix
Specification(s): newton_pbp_shell_precond_shell_matrix
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.44.46Eigen solver should work with a physics-based preconditioner with including eigen kernels in the preconditioning matrix
Specification(s): newton_pbp_precond_include_eigen_kernels
Design: Eigenvalue
Issue(s): #7398
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ExternalProblem
- 1.44.47The system shall support an code coupling interface that can trigger external solves.
Specification(s): external_steady
Design: ExternalProblem
Issue(s): #12024
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.44.48The system shall support an code coupling interface that can trigger external solves for transient simulations.
Specification(s): external_transient
Design: ExternalProblem
Issue(s): #12024
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: ReferenceResidualProblem
- 1.44.54The system shall have the ability to base convergence on the comparison of individual variables to reference quantities of those variables.
Specification(s): base
Design: ReferenceResidualProblem
Issue(s): #9151
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.44.55The system shall fail to find a converged solution when basing convergence on individual variable reference quantities with poor scaling.
Specification(s): scaled_bad
Design: ReferenceResidualProblem
Issue(s): #9151
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.44.56The system shall have the ability to automatically scale a originally poorly scaled problem and achieve convergence based on individual reference quantities
Specification(s): scaled_good
Design: ReferenceResidualProblem
Issue(s): #9151
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.44.57The system shall have the ability to base system convergence on the convergence of a subset of variables.
Specification(s): converge_on
Design: ReferenceResidualProblem
Issue(s): #9151
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.44.58The system shall require all grouped variables to be included in the convergence check.
Specification(s): converge_on_group_error
Design: ReferenceResidualProblem
Issue(s): #9151
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.44.59The system shall support wildcards for choosing the variables to base convergence on.
Specification(s): wildcard
Design: ReferenceResidualProblem
Issue(s): #9151
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: Quadrature System
- 1.45.1The system shall support the use of Gauss-Lobatto quadrature for numerical integration.
Specification(s): gauss_lobatto
Design: Quadrature System
Issue(s): 8f90ad2609945db87dc89c5e06a5a1554eb8f4a6
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.45.2The system shall support the ability to manually increase the quadrature order used for numerical integration on the entire mesh.
Specification(s): order3
Design: Quadrature System
Issue(s): #3380
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.45.3The system shall support the ability to manually specify the quadrature order used for numerical integration on a per-block basis with face quadrature between blocks preferring the higher-order between the two sides.
Specification(s): per-block-order
Design: Quadrature System
Issue(s): #14055
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.45.4The system shall support the ability for objects to increase quadrature order in code during runtime.
Specification(s): code-order-bump
Design: Quadrature System
Issue(s): #14055
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.45.5The system shall support the ability to control the volumetric and side quadrature orders used for numerical integration on the entire mesh.
Specification(s): elem5_side7
Design: Quadrature System
Issue(s): #3380
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.45.6The system shall support the ability to allow object code to increase the quadrature order used for numerical integration on a per-block basis.
Specification(s): material-bumps-block-order
Design: Quadrature System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: SetupQuadratureAction
- 1.45.7The system shall support the ability to force positive quadrature weights.
Specification(s): weights
Design: SetupQuadratureAction
Issue(s): #19066
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: AccumulateReporter
- 1.47.1The system shall be able to accumulate reporter values over time steps into a vector reporter value.
Specification(s): accumulate_reporter
Design: AccumulateReporter
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- framework: ConstantReporter
- 1.47.6The system shall be able to produce arbitrary integer, real number, dof_id_types and string scalar/vector values for use in other calculations.
Specification(s): constant_reporter
Design: ConstantReporter
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.47.7The system shall throw an error when producing constant reporter values if
- no values are specified,
- no names are specified,
- or the number of values and names are not equal.
Specification(s): errors/no_values, errors/no_names, errors/mismatch
Design: ConstantReporter
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ExtraIDIntegralReporter
- 1.47.10The system shall be able to report the variable integral parsed by extra IDs to the JSON format:
- single variable integral with single extra ID
- single variable integral with multiple extra IDs
- multiple variable integrals with multiple extra IDs
Specification(s): test/default, test/multi_ids, test/multi_ids_multi_vars
Design: ExtraIDIntegralReporter
Issue(s): #19617
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- framework: IterationInfo
- 1.47.11The system shall include the ability to report iteration information:
- that outputs all information be default;
- that outputs specific information;
- 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: MeshInfo
- 1.47.12The system shall include the ability to report mesh information:
- that outputs all information be default and
- that outputs specific information.
Specification(s): info/default, info/limit
Design: MeshInfo
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- framework: PerfGraphReporter
- 1.47.13The system shall include the ability to report performance information
- in JSON format
- and shall provide a tool to post process said information
Specification(s): test/run, test/verify
Design: PerfGraphReporter
Issue(s): #16256
Collection(s): FUNCTIONAL
Type(s): RunCommandRunApp
- 1.47.14The system shall include the ability to serialize report performance information with the recover system
Specification(s): recover_initial
Design: PerfGraphReporter
Issue(s): #16256
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.47.15The system shall include the ability to report performance information from a recovered solve
- in JSON format
- and shall provide a tool to post process said information
Specification(s): recover/run, recover/verify
Design: PerfGraphReporter
Issue(s): #16256
Collection(s): FUNCTIONAL
Type(s): RunCommandRunApp
- framework: BoundaryRestrictable Interface
- 1.49.6The system shall include an interface that provides a method for returning all associated boundaries:
- as a list of names or
- as a list of ids.
Specification(s): ids/boundary, ids/boundaryIDs
Design: BoundaryRestrictable Interface
Issue(s): #2149
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.49.7The system shall include an interface that provides methods for indicating if the supplied boundary identifier(s) exists on the object:
- if a single boundary is supplied and the object is restricted to a set of boundaries and
- if multiple boundaries are supplied.
Specification(s): has/hasBoundary, has/isBoundarySubset
Design: BoundaryRestrictable Interface
Issue(s): #2149
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.49.8The system shall include an interface that provides a method for indicating if the supplied material property exists on the same boundaries as the object:
- the method shall return true if the property boundaries match with the object boundaries and
- the method shall return false if the property boundaries dot not match with the object boundaries.
Specification(s): mat/hasBoundaryMaterialProperty_true, mat/hasBoundaryMaterialProperty_false
Design: BoundaryRestrictable Interface
Issue(s): #2149
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: Sampler
- 1.50.1The system shall include a random number sampling system that operates in parallel
- with threads,
- MPI, and
- that operates with a row-based iteration scheme.
Specification(s): parallel/threads, parallel/mpi, parallel/iter
Design: Sampler
Issue(s): #13906
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.50.2The system shall include a random number sampling system that creates replicated and/or distribute sample data that is consistent:
- on a single processor,
- on a two processors,
- on a three processors,
- on a one processor with random numbers,
- on two processor with random numbers, and
- on thre processor with random numbers.
Specification(s): global_vs_local/base_1rank, global_vs_local/base_2rank, global_vs_local/base_3rank, global_vs_local/rand_1rank, global_vs_local/rand_2rank, global_vs_local/rand_3rank
Design: Sampler
Issue(s): #13906
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.50.3The system shall include a random number sampling system that errors
- if the number of rows is altered during sample access,
- if the number of columns is altered during sample access,
- if the number of random number generator seeds is set after object construction,
- if the number of rows is set to zero,
- if the number of columns is set to zero,
- if the number of random number generator seeds is set to zero,
- if the number of entries in the global sample matrix exceeds the maximum allowed,
- if the number of entries in the local sample matrix exceeds the maximum allowed, and
- if the number of entries in the local sample matrix row exceeds the maximum allowed.
Specification(s): errors/setNumberOfRows, errors/setNumberOfCols, errors/setNumberOfRandomSeeds, errors/zero_rows, errors/zero_cols, errors/zero_seeds, errors/getGlobalSamples_max, errors/getLocalSamples_max, errors/getNextLocalRow_max
Design: Sampler
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.50.4The system shall error when the expected size of a sampler is altered and accessed prior to initialization by accessing the
- the global sample matrix;
- the local sample matrix;
- the local sample matrix row;
- the total row count;
- the local row count;
- the first local row index;
- the last local row index;
- the column count.
Specification(s): reinit_errors/getGlobalSamples, reinit_errors/getLocalSamples, reinit_errors/getNextLocalRow, reinit_errors/getNumberOfRows, reinit_errors/getNumberOfLocalRows, reinit_errors/getLocalRowBegin, reinit_errors/getLocalRowEnd, reinit_errors/getNumberOfCols
Design: Sampler
Issue(s): #13906
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.50.5The system shall include a random number sampling system
- that distributes samples in parallel and
- demonstrates efficient parallel scaling of memory use.
Specification(s): scale/execute, scale/plot
Design: Sampler
Issue(s): #13906
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: ADScalarTimeDerivative
- 1.51.4The system shall provide the ability to compute the time derivative of a scalar variable and have its Jacobian computed using automatic differentiation.
Specification(s): test
Design: ADScalarTimeDerivative
Issue(s): #18535
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ActuallyExplicitEuler
- 1.55.2The system shall support the use of explicit solvers, including
- first-order, forward Euler,
- with mass lumping, and
- with mass lumping and preconditioning.
Specification(s): group/test, group/lumped, group/lump_preconditioned
Design: ActuallyExplicitEuler
Issue(s): #10837
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.3The system shall report an error if an explicit solver fails to converge with
- first-order, forward Euler,
- with mass lumping, and
- with mass lumping and preconditioning.
Specification(s): errors/diverged, errors/diverged_lumped, errors/diverged_lump_prec
Design: ActuallyExplicitEuler
Issue(s): #10837
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.55.4The system shall correctly solve a time dependent Laplace equation using an explicit first-order, forward Euler scheme with:
- for a 1D problem using linear Lagrange elements and Dirichlet boundary conditions;
- for a 1D problem using second-order Lagrange elements and Dirichlet boundary conditions;
- for a 1D problem using second-order Lagrange elements and Neumann boundary conditions;
- for a 2D problem using linear Lagrange elements and Dirichlet boundary conditions;
- for a 2D problem using linear Lagrange elements, Dirichlet boundary conditions, and mesh adaptivity;
- for a 2D problem using second-order Lagrange elements and Dirichlet 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: ActuallyExplicitEuler
Issue(s): #10837
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.5The system shall correctly solve a time dependent ordinary differential equation using an explicit first-order, forward Euler scheme.
Specification(s): ode
Design: ActuallyExplicitEuler
Issue(s): #10837
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: AB2PredictorCorrector
- 1.55.6The system shall support the use of the Adams Bashforth predictor for time integration.
Specification(s): test
Design: AB2PredictorCorrector
Issue(s): #1288
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: BDF2
- 1.55.7The system shall support the second-order backward difference method for time integration
- with and
- without mesh adaptivity.
Specification(s): group/test, group/adapt
Design: BDF2
Issue(s): #1953
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: CentralDifference
- 1.55.8The CentralDifference time integrator shall correctly compute the first and second time derivatives.
Specification(s): central_difference
Design: CentralDifference
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.55.9A central differencing time integrator shall correctly compute the second time derivative of an automatic differentiation variable.
Specification(s): ad_central_difference_dotdot
Design: CentralDifference
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: CrankNicolson
- 1.55.19The system shall support the second-order Crank-Nicolson method for time integration
- with and
- without mesh adaptivity.
Specification(s): group/adapt, group/test
Design: CrankNicolson
Issue(s): #1953
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.33The system shall support th used of Crank-Nicolson time integration method for scalar variables with
- scalar variables within and ordinary differential equations including
- stiff and
- nonlinear systems.
Specification(s): group/scalar, group/stiff_linear, group/stiff_nonlinear
Design: CrankNicolson
Issue(s): #1953
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: LStableDirk2
- 1.55.20The system shall support the L-stable DIRK method for time integration
- with and
- without mesh adaptivity.
Specification(s): group/dirk-2d-heat, group/dirk-2d-heat-adap
Design: LStableDirk2
Issue(s): #1953
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: ExplicitEuler
- 1.55.21The system shall support the use of quasi-explicit Euler solver with
- 1D elements with first order shape functions and Dirichlet boundary conditions;
- 1D elements with second order shape functions and Dirichlet boundary conditions;
- 1D elements with second order shape functions and Neumann boundary conditions;
- 2D elements with first order shape functions and Dirichlet boundary conditions;
- 2D elements with second order shape functions and Dirichlet boundary conditions; and
- 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: ExplicitSSPRungeKutta
- 1.55.22The system shall include the strong-stability-preserving Runge-Kutta method of
- 1st order
- 2nd order
- 3rd order
Specification(s): all/first_order, all/second_order, all/third_order
Design: ExplicitSSPRungeKutta
Issue(s): #11855
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.55.23The system shall provide an informative error message when a user uses an invalid solve type for an explicit time integrator.
Specification(s): invalid_solve_type
Design: ExplicitSSPRungeKutta
Issue(s): #18646
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: ImplicitEuler
- 1.55.24The system shall support the use of an implicit Euler solver with
- with and
- without mesh adaptivity.
Specification(s): group/test, group/adapt
Design: ImplicitEuler
Issue(s): #1953
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.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.55.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
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.55.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
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.55.29The NewmarkBeta time integrator shall correctly use the inactive_tsteps parameter.
Specification(s): newmark_beta_inactive_steps
Design: NewmarkBeta
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.55.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
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ExplicitMidpoint
- 1.55.31The system shall support the use of an explicit midpoint time integration scheme for
- 1D elements with linear finite element shape functions and
- 2D elements with quadratic finite element shape functions.
Specification(s): group/1d-linear, group/2d-quadratic
Design: ExplicitMidpoint
Issue(s): #1953
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.32The system shall compute the Jacobian during explicit midpoint time integration for
- 1D elements with linear finite element shape functions and
- 2D elements with quadratic finite element shape functions.
Specification(s): jacobian/1d-linear_num-of-jacobian-calls, jacobian/2d-quadratic_num-of-jacobian-calls
Design: ExplicitMidpoint
Issue(s): #1953
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: ExplicitTVDRK2
- 1.55.34The system shall support the use of an total variation diminishing Runge-Kutta time integration schemefor
- 1D elements with linear finite element shape functions and
- 2D elements with quadratic finite element shape functions.
Specification(s): group/1d-linear, group/2d-quadratic
Design: ExplicitTVDRK2
Issue(s): #1953
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.55.35The system shall compute the Jacobian during total variation diminishing Runge-Kutta time integration for
- 1D elements with linear finite element shape functions and
- 2D elements with quadratic finite element shape functions.
Specification(s): jacobian/1d-linear_num-of-jacobian-calls, jacobian/2d-quadratic_num-of-jacobian-calls
Design: ExplicitTVDRK2
Issue(s): #1953
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: TimeStepper System
- 1.56.1The system shall calculate the time step size based one the number of steps and the end time of the simulation when the initial time step size is not supplied:
- when the start time is not supplied, and
- 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.56.2The system shall include a means for performing simulations with a constant time step.
Specification(s): constant_dt
Design: TimeStepper System
Issue(s): #1953
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.3The system shall support the ability to regrow a time step that has been previously cut due to a solve failure.
Specification(s): test
Design: TimeStepper System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.4The system shall support how time step size is cut, using user-specified cutback_factor_at_failure, due to a solve failure. Here, the original time step size is specified as a constant value.
Specification(s): constant_dt_cutback
Design: TimeStepper System
Issue(s): #13874
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.5The system shall support how time step size is cut, using user-specified cutback_factor_at_failure, due to a solve failure. Here, the original time step size is specified as a function of time.
Specification(s): function_dt_cutback
Design: TimeStepper System
Issue(s): #13874
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.6The system shall suppport the ability to sample a piecewise linear function for time step sizes while supporting a minimum time step size.
Specification(s): function_dt_min
Design: TimeStepper System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.7The system shall support the ability to sample a piecewise constant function for time step sizes choosing either the left or right values between adjacent constants.
Specification(s): function_dt_no_interpolation
Design: TimeStepper System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.27The system shall support the ability to select time step sizes based upon the ratio of the real (wall) time of the solve and the size of the time step.
Specification(s): test
Design: TimeStepper System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.56.32The system shall report an error if the initial time step size is calculated to be zero.
Specification(s): test
Design: TimeStepper System
Issue(s): #10553
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: LogConstantDT
- 1.56.25The system shall support the ability to select a time step size based upon a scaled log-constant calculation.
Specification(s): logconstant_dt
Design: LogConstantDT
Issue(s): #9312
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PostprocessorDT
- 1.56.26The system shall support the ability to use a scalar value computed after a solve to be used as a scaled time step size.
Specification(s): test
Design: PostprocessorDT
Issue(s): #1963
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: TimeSequenceStepper
- 1.56.28The system shall support the ability to choose time step sizes based on a sequence of increasing numbers:
- beginning at the default start time,
- beginning at an earlier time than the sequence numbers,
- beginning at a time somewhere in-between existing sequence numbers, and
- when reading the sequence from an ExodusII formatted input file.
- that must be sorted in ascending order,
- that must be sorted in strictly ascending order,
- when reading the sequence from a comma-separated input file.
Specification(s): time_sequence/timesequence_no_start_time, time_sequence/timesequence_earlier_start_time, time_sequence/timesequence_later_start_time, time_sequence/exodustimesequence, time_sequence/not_sorted, time_sequence/not_sorted_strictly, time_sequence/csvtimesequence
Design: TimeSequenceStepper
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- 1.56.29The system shall support the ability to override time sequence time step sizes when solves fail.
Specification(s): timesequence_failed
Design: TimeSequenceStepper
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.30The system shall support the ability to run a calculation for the purpose of creating a time sequence restart file:
- when writing the checkpoint file,
- when restarting where the time sequence is identical, and
- when restarting where the time sequence is different after the point of the checkpoint.
Specification(s): restart/timesequence_restart1, restart/timesequence_restart2, restart/timesequence_restart3
Design: TimeSequenceStepper
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.56.31The system shall support the ability to run a calculation for the purpose of creating a time sequence restart file suitable for failure:
- when writing the checkpoint file,
- when restarting where the time sequence is different prior to the failure.
Specification(s): restart_failure/timesequence_restart_failure_1, restart_failure/timesequence_restart_failure2
Design: TimeSequenceStepper
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionExodiff
- framework: Transfers System
- 1.57.1The system shall 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.2The system shall 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.95The 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.57.96The system shall support the transfer of data between a master 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: MultiAppConservativeTransfer
- 1.57.5The system shall support conservative transfers
Specification(s): test
Design: MultiAppConservativeTransfer
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.6The system shall check execute_on for PP in sub app
Specification(s): test_execute_on
Design: MultiAppConservativeTransfer
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.7The system shall support conservative transfers using regular postprocessors
Specification(s): subs
Design: MultiAppConservativeTransfer
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.8The system shall check execute_on for PP in master app
Specification(s): subs_execute_on
Design: MultiAppConservativeTransfer
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.9The system shall support conservative transfers with nearestpoint VectorPostprocessors
Specification(s): nearest_point
Design: MultiAppConservativeTransfer
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.10The system shall check execute_on for vector PP in master app
Specification(s): nearest_point_execute_on
Design: MultiAppConservativeTransfer
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.11The system shall be able to output the adjusting values in conservative transfers
Specification(s): nearest_point_vector_pps
Design: MultiAppConservativeTransfer
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.57.12The system shall support conservative transfers in MultiAppUserObjectTransfer
Specification(s): userobject_transfer
Design: MultiAppConservativeTransfer
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.13The system shall be able to output the adjusting values in conservative transfers for MultiAppUserObjectTransfer
Specification(s): userobject_transfer_csv
Design: MultiAppConservativeTransfer
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.57.14The systen shall allow adjustment if both from and to adjuster are negative.
Specification(s): negative_adjuster
Design: MultiAppConservativeTransfer
Issue(s): #15952
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.15The systen shall allow to skip adjustments without throwing an error if from/to adjusters do not satisfy conditions.
Specification(s): skip_adjustment
Design: MultiAppConservativeTransfer
Issue(s): #15952
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MultiAppCopyTransfer
- 1.57.16The 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.57.17The system shall support the transfer of auxiliary field variables between identical meshes:
- from a sub-application and
- to a sub-application.
Specification(s): transfer/from_sub_to_master, transfer/to_sub_to_master
Design: MultiAppCopyTransfer
Issue(s): #13754
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.18The system shall error if a variable, during a direct copy of auxiliary field variables, does not exist
- in the sub-application when transferring form it and
- in the master application when transferring for it.
Specification(s): errors/error_from_sub_to_master, errors/error_to_sub_to_master
Design: MultiAppCopyTransfer
Issue(s): #13754
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.19The system shall support the transfer of auxiliary field variables between identical meshes:
- between two subapps
Specification(s): transfer/from_sub_to_sub
Design: MultiAppCopyTransfer
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.20The 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.57.21The 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.57.22The system shall error when the MultiAppCopyTransfer object is used on non-identical meshes.
Specification(s): different_mesh
Design: MultiAppCopyTransfer
Issue(s): #7757
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.23The system shall 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.24The 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.57.25The 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.57.26The 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.57.27The 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.57.28The 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.57.29The 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.57.30The 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.57.31The 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
- framework: MultiAppInterpolationTransfer
- 1.57.38The system shall allow to interpolate variables from the master app to the sub apps
Specification(s): tosub
Design: MultiAppInterpolationTransfer
Issue(s): #1879
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.39The system shall allow to interpolate variables from the sub apps to the master app
Specification(s): fromsub
Design: MultiAppInterpolationTransfer
Issue(s): #1879
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.40The system shall allow to interpolate block restricted variables from the sub apps to the master app
Specification(s): fromsub_restricted
Design: MultiAppInterpolationTransfer
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.79The system shall be able to create virtually translated points during MultiApp transfers.
Specification(s): fromsub
Design: MultiAppInterpolationTransfer
Issue(s): #15567
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.94The system shall support support the ability to perform interpolation between time steps when transferring field data between a master application and sub-applications.
Specification(s): test
Design: MultiAppInterpolationTransfer
Issue(s): #1950
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MultiAppNearestNodeTransfer
- 1.57.43The system shall transfer both nodal and elemental fields to a SubApp from the Master App.
Specification(s): tosub
Design: MultiAppNearestNodeTransfer
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.44The system shall transfer both nodal and elemental fields from SubApps to the Master App.
Specification(s): fromsub
Design: MultiAppNearestNodeTransfer
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.45The system shall transfer values from SubApps which set the displaced_source_mesh flag to true.
Specification(s): fromsub_displaced
Design: MultiAppNearestNodeTransfer
Issue(s): #1868
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.46The system shall support the 'fixed_meshes' flag which allows caching of nearest neighbors.
Specification(s): fromsub_fixed_meshes
Design: MultiAppNearestNodeTransfer
Issue(s): #2126
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.47The system shall transfer values to multiple SubApps from the Master App's boundary.
Specification(s): boundary_tosub
Design: MultiAppNearestNodeTransfer
Issue(s): #6156
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.48The system shall transfer values from a SubApp boundary to the Master App.
Specification(s): boundary_tomaster
Design: MultiAppNearestNodeTransfer
Issue(s): #6156
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.49The system shall transfer values to multiple target boundaries in both the Master and Sub App.
Specification(s): multiple_target_boundaries
Design: MultiAppNearestNodeTransfer
Issue(s): #18467
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.50The system shall work when there are multiple SubApps present.
Specification(s): two_way_many_apps
Design: MultiAppNearestNodeTransfer
Issue(s): #5360
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.51The system shall work in parallel between meshes with different spatial dimensions.
Specification(s): parallel
Design: MultiAppNearestNodeTransfer
Issue(s): #8004
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.52The system shall support target boundary transfer when use multiple mpi ranks
Specification(s): target_boundary
Design: MultiAppNearestNodeTransfer
Issue(s): #18730
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.53The system shall support source boundary transfer when use multiple mpi ranks
Specification(s): source_boundary
Design: MultiAppNearestNodeTransfer
Issue(s): #18730
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.54The system shall support source-and-target boundary transfer when use multiple mpi ranks
Specification(s): source_target_boundary
Design: MultiAppNearestNodeTransfer
Issue(s): #18730
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MultiAppPostprocessorInterpolationTransfer
- 1.57.55The system shall support the transfer of scalars to a field variable between an application and sub-applications:
- using a inverse distance algorithm,
- if the destination variable is CONSTANT MONOMIAL,
- using a radial basis algorithm,
- with multi-level sub-applications,
- with multiple sub-application files, and
- with a single sub-application file.
Specification(s): basis/test, basis/test_constant_monomial, basis/radial_basis, basis/multilevel, basis/from_sub_to_master, basis/from_sub_to_master_single_sub_file
Design: MultiAppPostprocessorInterpolationTransfer
Issue(s): #1737
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.56The system shall report an error if a data transfer is requested for a data variable that is not defined.
Specification(s): test_error
Design: MultiAppPostprocessorInterpolationTransfer
Issue(s): #1737
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.57The system shall report an error if a variable is specified that is not LINEAR LAGRANGE or CONSTANT MONOMIAL
Specification(s): fetype_error
Design: MultiAppPostprocessorInterpolationTransfer
Issue(s): #1737
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.58The system shall report an error if parameters for an unsupported direction are provided for the transfer between sub-app scalars and a main app field variablea.
Specification(s): direction_error
Design: MultiAppPostprocessorInterpolationTransfer
Issue(s): #1737
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: MultiAppPostprocessorToAuxScalarTransfer
- 1.57.59The system shall support the transfer of scalar post processing data to scalar auxiliary variables between multiapps
Specification(s): transfer
Design: MultiAppPostprocessorToAuxScalarTransfer
Issue(s): #19451
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.57.60The system shall support the transfer of data between a master and sub-applications for scalar unknowns and postprocessing data:
- from the master application to the sub-applications and
- to the master application from the sub-applications.
Specification(s): transfer/master_to_sub, transfer/sub_to_master
Design: MultiAppPostprocessorToAuxScalarTransfer
Issue(s): #2340
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.61The system shall error during the transfer of scalar variable and postprocessor data if the number of sub-applications differs from the order of the scalar variable if
- the order is too large and
- the order is too small.
Specification(s): error/sub_to_master_wrong_order, error/sub_to_master_wrong_positions
Design: MultiAppPostprocessorToAuxScalarTransfer
Issue(s): #2340
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: MultiAppPostprocessorTransfer
- 1.57.62The system shall support the transfer of scalar post processing data between multiapps
Specification(s): transfer
Design: MultiAppPostprocessorTransfer
Issue(s): #19451
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.57.63The system shall support the transfer of scalar post processing data:
- from the master application to sub-applications and
- to the master application from sub-applications.
Specification(s): transfer/to_multiapp, transfer/from_multiapp
Design: MultiAppPostprocessorTransfer
Issue(s): #2115
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.64The system shall support the transfer of scalar post processing data from a single sub-application.
Specification(s): from_one_sub
Design: MultiAppPostprocessorTransfer
Issue(s): #2115
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MultiAppProjectionTransfer
- 1.57.65The system shall support the transfer of field data using L2 projection:
- from the master application to sub-applications and
- to the master application from sub-applications.
Specification(s): transfer/tosub, transfer/fromsub
Design: MultiAppProjectionTransfer
Issue(s): #1913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.66The system shall support the transfer of field data using L2 projection for first order shaped monomial shape functions.
Specification(s): high_order
Design: MultiAppProjectionTransfer
Issue(s): #1913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.67The system shall support the transfer of field data using L2 projection and include optimization for non deforming meshes.
Specification(s): fixed_meshes
Design: MultiAppProjectionTransfer
Issue(s): #1913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MultiAppReporterTransfer
- 1.57.68The system shall support the transfer of reporter data between multiapps
Specification(s): transfer
Design: MultiAppReporterTransfer
Issue(s): #19451
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.57.69The system shall support the ability to transfer vectorpostprocessor data
- from the main application to all sub-applications,
- from the main application to a single sub-applications,
- and from a sub-application to the main application.
Specification(s): vpp/to_all_from_main, vpp/to_one_from_main, vpp/from_one_sub_to_main
Design: MultiAppReporterTransferMultiAppCloneReporterTransfer
Issue(s): #16055
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.57.70The system shall support the ability to transfer integer, real, vector, and string reporter data.
Specification(s): reporter
Design: MultiAppReporterTransferMultiAppCloneReporterTransfer
Issue(s): #16055
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.57.71The system shall support the ability to transfer reporter data and error if an invalid sub-application number is supplied when transferring data
- to a sub-application,
- from a sub-application.
- from multiple sub-applications.
Specification(s): errors/to_app, errors/from_app, errors/from_multi_app
Design: MultiAppReporterTransferMultiAppCloneReporterTransfer
Issue(s): #16055
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.72The system shall support declaring reporter value clone on a main application and transferring sub-application data into it
- in serial and
- in parallel.
Specification(s): clone/serial, clone/parallel
Design: MultiAppReporterTransferMultiAppCloneReporterTransfer
Issue(s): #16055
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.57.73If processors do not contain a sub-application and reporter clone transfer is requested, the system shall
- be able to transfer if reporter types are specified and
- error if types are not specified.
Specification(s): clone_type/type_specified, clone_type/error
Design: MultiAppReporterTransferMultiAppCloneReporterTransfer
Issue(s): #16055
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionJSONDiff
- framework: MultiAppCloneReporterTransfer
- 1.57.69The system shall support the ability to transfer vectorpostprocessor data
- from the main application to all sub-applications,
- from the main application to a single sub-applications,
- and from a sub-application to the main application.
Specification(s): vpp/to_all_from_main, vpp/to_one_from_main, vpp/from_one_sub_to_main
Design: MultiAppReporterTransferMultiAppCloneReporterTransfer
Issue(s): #16055
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.57.70The system shall support the ability to transfer integer, real, vector, and string reporter data.
Specification(s): reporter
Design: MultiAppReporterTransferMultiAppCloneReporterTransfer
Issue(s): #16055
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.57.71The system shall support the ability to transfer reporter data and error if an invalid sub-application number is supplied when transferring data
- to a sub-application,
- from a sub-application.
- from multiple sub-applications.
Specification(s): errors/to_app, errors/from_app, errors/from_multi_app
Design: MultiAppReporterTransferMultiAppCloneReporterTransfer
Issue(s): #16055
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.72The system shall support declaring reporter value clone on a main application and transferring sub-application data into it
- in serial and
- in parallel.
Specification(s): clone/serial, clone/parallel
Design: MultiAppReporterTransferMultiAppCloneReporterTransfer
Issue(s): #16055
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.57.73If processors do not contain a sub-application and reporter clone transfer is requested, the system shall
- be able to transfer if reporter types are specified and
- error if types are not specified.
Specification(s): clone_type/type_specified, clone_type/error
Design: MultiAppReporterTransferMultiAppCloneReporterTransfer
Issue(s): #16055
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionJSONDiff
- framework: MultiAppScalarToAuxScalarTransfer
- 1.57.74The system shall support the transfer of scalar variables to auxiliary scalar variables between multiapps.
Specification(s): transfer
Design: MultiAppScalarToAuxScalarTransfer
Issue(s): #19451
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.57.75The system shall include the ability to transfer scalar variables to an applications from sub-applications.
Specification(s): sub_to_master
Design: MultiAppScalarToAuxScalarTransfer
Issue(s): #9444
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.76The system shall error if the variable order does not match when transferring scalar variables to an application from sub-applications.
Specification(s): sub_to_master_wrong_order
Design: MultiAppScalarToAuxScalarTransfer
Issue(s): #9444
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.77The system shall include the ability to transfer scalar variables from an applications to sub-applications.
Specification(s): master_to_sub
Design: MultiAppScalarToAuxScalarTransfer
Issue(s): #9444
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.78The system shall error if the variable order does not match when transferring scalar variables from an application to sub-applications.
Specification(s): master_to_sub_wrong_order
Design: MultiAppScalarToAuxScalarTransfer
Issue(s): #9444
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: MultiAppUserObjectTransfer
- 1.57.80The system shall support an interface for transferring user-defined spatial data
- to a master application from sub-applications,
- to a master application from the nearest sub-applications,
- from a master application to sub-applications,
- from a master application to sub-applications that have a deformed mesh, and
- between a 3D master application and 1D sub-applications.
Specification(s): transfer/from_sub, transfer/from_sub_nearest_sub_app, transfer/to_sub, transfer/to_sub_displaced, transfer/3d_1d
Design: MultiAppUserObjectTransfer
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.81The system shall transfer user-defined spatial data into block and boundary restricted nodal variables.
Specification(s): restricted_node
Design: MultiAppUserObjectTransfer
Issue(s): #16241
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.82The system shall transfer user-defined spatial data into block and boundary restricted elemental variables.
Specification(s): restricted_elem
Design: MultiAppUserObjectTransfer
Issue(s): #16241
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.83MultiAppUserObjectTransfer shall generate an error if a master node/element is not contained within any sub application domains.
Specification(s): 3d_1d_err
Design: MultiAppUserObjectTransfer
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.84MultiAppUserObjectTransfer shall allow skipping the bounding box test.
Specification(s): two_pipes
Design: MultiAppUserObjectTransfer
Issue(s): #13701
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MultiAppVariableValueSampleTransfer
- 1.57.85The system shall include the ability to transfer a field variable sampled at a point to populate a field variable on the sub-application with the supplied value.
Specification(s): to_multiapp_test
Design: MultiAppVariableValueSampleTransfer
Issue(s): #1737#16099#20816#20913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.86The system shall include the ability to transfer a component of an array field variable sampled at a point to post processing variable on the sub-application.
Specification(s): array_test
Design: MultiAppVariableValueSampleTransfer
Issue(s): #1737#16099#20816#20913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.87The system shall include the ability to transfer a field variable sampled at a point to post processing variable on the sub-application
- from a linear Lagrange source variable and
- from a constant monomial source variable and
- from a finite volume constant monomial source variable.
Specification(s): pp/pp_test, pp/monomial_to_sub_pp, pp/finite_volume
Design: MultiAppVariableValueSampleTransfer
Issue(s): #1737#16099#20816#20913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.88The system shall support the ability to disable the use of parallel barriers when streaming text to the screen.
Specification(s): silence_barriers
Design: MultiAppVariableValueSampleTransfer
Issue(s): #1737#16099#20816#20913
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.57.89The system shall guarantee that constant monomial variables transferred via MultiAppVariableValueSamplePostprocessorTransfer to the subapp are retrieved unchanged when transferred back using MultiAppVariableValueSamplePostprocessorTransfer in case the CentroidMultiApp is used.
Specification(s): full_domain_primary
Design: MultiAppVariableValueSampleTransfer
Issue(s): #1737#16099#20816#20913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.57.90The systen shall error out if more than one sub-applications are in the same distance from an element.
Specification(s): same_distance_error
Design: MultiAppVariableValueSampleTransfer
Issue(s): #1737#16099#20816#20913
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.91The systen shall error out if the MultiAppVariableValueSamplePostprocessorTransfer transfers postprocessor values on sub-applications to a primary variable on the main application.
Specification(s): from_multiapp_set_primary_var_error
Design: MultiAppVariableValueSampleTransfer
Issue(s): #1737#16099#20816#20913
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.57.92The systen shall allow transferring CONSTANT MONOMIAL variables from the sub-applications
- using block restriction in the CentroidMultiApp and
- using block restriction in both the CentroidMultiApp and the variable.
Specification(s): block_restricted_primary/multiapp, block_restricted_primary/multiapp_and_var
Design: MultiAppVariableValueSampleTransfer
Issue(s): #1737#16099#20816#20913
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MultiAppVectorPostprocessorTransfer
- 1.57.93The system shall support the ability transfer vectors of post processing data between the master application and sub-applications.
Specification(s): vector_pp_transfer
Design: MultiAppVectorPostprocessorTransfer
Issue(s): #10319
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: Terminator
- 1.59.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.59.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
Design: Terminator
Issue(s): #16452
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.59.3The terminator system shall output a custom info, warning, or error message.
Specification(s): terminator_message_1
Design: Terminator
Issue(s): #17000
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.59.4The terminator system shall check the compatibility of the suplied parameters.
Specification(s): terminator_message_2
Design: Terminator
Issue(s): #17000
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.59.5The 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): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.59.6The 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
- framework: UserObject System
- 1.59.7The 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
- framework: ElementQualityChecker
- 1.59.8The system shall evaluate the quality of all the mesh elements and report
- a warning when the "warning" option is selected,
- an error when the "error" option is selected, or
- a message when the selected metric does not apply to the element type being examined.
Specification(s): quality_checks/failure_warning, quality_checks/failure_error, quality_checks/bypass_warning
Design: ElementQualityChecker
Issue(s): #10377
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionRunApp
- framework: CoupledVarThresholdElementSubdomainModifier
- 1.59.9The framework shall include the ability to change element subdomain during simulation
- reversibly,
- irreversibly,
- with and without a specified boundary,
- with solution
- and stateful material properties properly initialized.
Specification(s): group/reversible, group/block_restricted, group/no_moving_boundary, group/initial_condition, group/stateful_property
Design: CoupledVarThresholdElementSubdomainModifier
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.10The framework shall include the ability to change element subdomain for a steady state simulation
Specification(s): steady
Design: CoupledVarThresholdElementSubdomainModifier
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: FunctionLayeredIntegral
- 1.59.12The system shall be able to integrate a function over layers
Specification(s): function_layered_integral
Design: FunctionLayeredIntegral
Issue(s): #19478
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: GeometrySphere
- 1.59.13The system shall support "snapping" or moving new nodes and sides 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
- framework: InterfaceQpValueUserObject
- 1.59.14Testing 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.59.15The 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.59.16Testing 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.59.17Testing 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.59.14Testing 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.59.15The 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.59.16Testing 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.59.17Testing the implementation of the InterfaceQpMaterialPropertyRealUO.
Specification(s): interface_Qp_real_material
Design: InterfaceQpValueUserObjectInterfaceValueUserObjectAux
Issue(s): #14680
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: InternalSideUserObject
- 1.59.18The system shall support executing custom algorithms on all internal sides of the mesh where properties retrieved on that side come from:
- the same subdomain, or
- different subdomains.
Specification(s): internal_side/test, internal_side/get_neighbor_test
Design: InternalSideUserObject
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: LayeredAverage
- 1.59.19The system shall allow taking averages of variables along a coordinate axis in layers
Specification(s): test
Design: LayeredAverage
Issue(s): #1737
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.20The system shall allow automatic specification of points to output the unique user object values
Specification(s): unique_points
Design: LayeredAverage
Issue(s): #19220
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.59.21The system shall be capable of computing layered averages of a variable given bounds.
Specification(s): bounds
Design: LayeredAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.22The system shall error when computing layered averages of a variable if
- the bounding box is set along with the number of layers or
- sample interpolate and
- if neither the bounds or number of layers are set.
Specification(s): errors/bounds_and_num_layers, errors/bounds_and_interp, errors/no_bounds_or_num_layers
Design: LayeredAverage
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.59.23The system shall allow interpolating between layers for layered averages
Specification(s): interpolate
Design: LayeredAverage
Issue(s): #1845
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.24The system shall respect mesh displacements in layered average
Specification(s): 1d_displaced
Design: LayeredAverage
Issue(s): #10960
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.25The system shall be capable of computing layered averages of a variable
- within a subdomain and
- within a prescribed region in a subdomain.
Specification(s): layered_average/layered_average_block, layered_average/block_restricted
Design: LayeredAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.26The system shall respect block restriction for layered averages even when using num_layers
Specification(s): block_restricted_num_layers
Design: LayeredAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.27The system shall allow bounds for layered averages when using num_layers to come from a block different than the block restriction
Specification(s): block_restricted_bounding_block
Design: LayeredAverage
Issue(s): #12479
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: LayeredBase
- 1.59.28The 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
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: LayeredIntegral
- 1.59.29The system shall include the ability to computes volume integrals of a variable storing partial sums for the specified number of intervals in a direction (x,y,z)
- using 3 layers with
- automatic specification of points to output unique values and
- as a cumulative calculation and
- as a cumulative calculation in the negative direction and
- as an average calculation,
- and using finite volume variables.
Specification(s): group/test, group/unique_points, group/cumulative, group/cumulative_negative, group/average_sample, group/fv_test
Design: LayeredIntegral
Issue(s): #1289#16099#19220#19480
Collection(s): FUNCTIONAL
Type(s): CSVDiffExodiff
- framework: LayeredSideIntegral
- 1.59.30The system shall correctly compute layered integrals along a specified boundary.
Specification(s): test
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.31The system shall allow automatic specification of points to output the unique user object values for a layered integral.
Specification(s): unique_points
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.59.32The system shall correctly compute layered integrals of finite volume variables along a specified boundary.
Specification(s): fv_test
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.33The system shall allow taking averages of variables along a coordinate axis in layers on a boundary.
Specification(s): average
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.34The system shall allow automatic specification of points to output the unique user object values for a layered average.
Specification(s): average_unique_points
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.59.35The system shall allow taking averages of the diffusive flux of variables along a coordinate axis in layers on a boundary.
Specification(s): diffusive_flux_average
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.36The system shall allow taking averages of the diffusive flux of finite volume variables along a coordinate axis in layers on a boundary.
Specification(s): diffusive_flux_average_fv
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.37The system shall not allow both the block and boundary parameter to be specified for layered side integrals.
Specification(s): layered_side_average_error_check
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: LayeredSideAverage
- 1.59.30The system shall correctly compute layered integrals along a specified boundary.
Specification(s): test
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.31The system shall allow automatic specification of points to output the unique user object values for a layered integral.
Specification(s): unique_points
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.59.32The system shall correctly compute layered integrals of finite volume variables along a specified boundary.
Specification(s): fv_test
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.33The system shall allow taking averages of variables along a coordinate axis in layers on a boundary.
Specification(s): average
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.34The system shall allow automatic specification of points to output the unique user object values for a layered average.
Specification(s): average_unique_points
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.59.35The system shall allow taking averages of the diffusive flux of variables along a coordinate axis in layers on a boundary.
Specification(s): diffusive_flux_average
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.36The system shall allow taking averages of the diffusive flux of finite volume variables along a coordinate axis in layers on a boundary.
Specification(s): diffusive_flux_average_fv
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.37The system shall not allow both the block and boundary parameter to be specified for layered side integrals.
Specification(s): layered_side_average_error_check
Design: LayeredSideIntegralLayeredSideAverage
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: NearestPointLayeredAverage
- 1.59.39The system shall compute layered averages that computed from the closest values for a list of points that are explicitly specified in an input file
Specification(s): test
Design: NearestPointLayeredAverage
Issue(s): #1878
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.40The system shall compute layered averages that computed from the closest values for a list of points that are specified in an external file
Specification(s): from_file
Design: NearestPointLayeredAverage
Issue(s): #12356
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.59.41The system shall report an error when points are not specified in an input file nor an external file when computing nearest point layered averages
Specification(s): error_missing_point_spec
Design: NearestPointLayeredAverage
Issue(s): #12356
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.59.42The system shall report an error when points are specified both in an input file and an external file when computing nearest point layered averages
Specification(s): error_conflicting_point_spec
Design: NearestPointLayeredAverage
Issue(s): #12356
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.59.43The system shall report an error when there is not enough coordinates specified in an external file specifing the point for computing nearest point layered averages
Specification(s): error_not_enough_points_in_a_file
Design: NearestPointLayeredAverage
Issue(s): #12356
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.59.45The system shall compute 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): points_from_uo
Design: NearestPointLayeredAverage
Issue(s): #18931
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.59.47The system shall error if user-set direction bounds conflict with block-type bound specifications
Specification(s): error_duplicate_block_specs
Design: NearestPointLayeredAverage
Issue(s): #19122
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.59.48The system shall error if a direction bound is missing
Specification(s): error_missing_bound
Design: NearestPointLayeredAverage
Issue(s): #19122
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.59.49The system shall error if the maximum bound is lower than the minimum bound
Specification(s): error_invalid_bounds
Design: NearestPointLayeredAverage
Issue(s): #19122
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.59.50The system shall allow specification of direction bounds to skip bounding box calculation
Specification(s): test_with_automatic_bounds
Design: NearestPointLayeredAverage
Issue(s): #1878
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: NearestRadiusLayeredAverage
- 1.59.44The 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.59.46The 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.59.51The 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.59.52The 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: NearestPointLayeredSideAverage
- 1.59.53The system shall compute layered side averages that computed from the closest values for a list of points
Specification(s): test
Design: NearestPointLayeredSideAverage
Issue(s): #13252
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: NearestPointLayeredSideIntegral
- 1.59.54The system shall compute layered side integrals that computed from the closest values for a list of points
Specification(s): test
Design: NearestPointLayeredSideIntegral
Issue(s): #18702
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: PostprocessorSpatialUserObject
- 1.59.55The system shall be able to keep track of a postprocessor value associated with a sub-app at a geometrical location
Specification(s): test
Design: PostprocessorSpatialUserObject
Issue(s): #15434
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: GeneralUserObject
- 1.59.56The system shall consider that when auxkernel depends on a UO, the exec flag will be taken into consideration to determin when the UO must be executed preaux.
Specification(s): test_preaux_based_on_exec_flag_final
Design: GeneralUserObject
Issue(s): #18189
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ShapeElementUserObject
- 1.59.58The system shall support optionally initializing shape function data structures for use in custom algorithm (UserObject) calculations.
Specification(s): shape_element_user_object
Design: ShapeElementUserObject
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.59.59The system shall compute the proper shape functions which can be used to verify Residual and Jacobian calculations
- of a single variable,
- of two coupled variables with explicit off-diagonals requested,
- of two coupled variables with a full Jacobian matrix
- on the side of elements, and
- for a full physics test.
Specification(s): shape_user_object/simple_shape_element_uo, shape_user_object/jacobian_test1, shape_user_object/jacobian_test2, shape_user_object/shape_side_uo_jac_test, shape_user_object/shape_side_uo_physics_test
Design: ShapeElementUserObject
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- 1.59.60The system shall error if a user attempts to use nonlocal residual objects without appropriate coupling specified in a preconditioning object. These residual objects include
- kernels
- boundary conditions
Specification(s): diagonal/kernels, diagonal/bcs
Design: ShapeElementUserObject
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.59.61The system shall be able to perform automatic scaling in the presence of nonlocal residual objects such as
- kernels
- boundary conditions
Specification(s): automatic_scaling/kernels, automatic_scaling/bcs
Design: ShapeElementUserObject
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: ThreadedGeneralUserObject
- 1.59.65The system shall support creating n-thread copies of user-defined objects (GeneralUserObjects) for the purpose of running multiple related calculations simultaneously, avoiding thread locks during common look-up operations, where individual thread ids may be used to calculate a quantity based on the number of threads for:
- one thread,
- two threads,
- three threads,
- four threads,
- five threads,
- six threads,
- seven threads, and
- eight threads.
Specification(s): thread_copies_guo/th1, thread_copies_guo/th2, thread_copies_guo/th3, thread_copies_guo/th4, thread_copies_guo/th5, thread_copies_guo/th6, thread_copies_guo/th7, thread_copies_guo/th8
Design: ThreadedGeneralUserObject
Issue(s): #11834
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: BilinearInterpolation
- 1.60.1The system shall support a piecewise bilinear interpolation object to be constructed from x, y data read from an external file.
Specification(s): test
Design: BilinearInterpolation
Issue(s): #1405
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.60.2The system shall support a piecewise bilinear interpolation object to be constructed from x, y data.
Specification(s): test_internal
Design: BilinearInterpolation
Issue(s): #5991
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.60.3The system shall error when a file and data are supplied simultaneously in the PiecewiseBilinear object.
Specification(s): data_file_and_xyz_error
Design: BilinearInterpolation
Issue(s): #5991
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.60.4The system shall error when there is a mismatch in vector lengths in the PiecewiseBilinear object.
Specification(s): size_xyz_error
Design: BilinearInterpolation
Issue(s): #5991
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.60.5The system shall error when there are insufficient parameters supplied for the PiecewiseBilinear object.
Specification(s): xyz_error
Design: BilinearInterpolation
Issue(s): #5991
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: LibtorchArtificialNeuralNet
- 1.60.8The system shall throw an error
- when encountering an unsupported activation function for the neural network.
- when encountering the wrong number of activation functions.
Specification(s): libtorch-nn-errors/wrong-activation, libtorch-nn-errors/wrong-activation-number
Design: LibtorchArtificialNeuralNet
Issue(s): #19571
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.60.9The system shall be able to create and evaluate a neural network with
- relu activation functions.
- sigmoid activation functions.
- gelu activation functions.
- elu activation functions.
- linear activation functions.
Specification(s): libtorch-nn-activation/relu, libtorch-nn-activation/sigmoid, libtorch-nn-activation/gelu, libtorch-nn-activation/elu, libtorch-nn-activation/linear
Design: LibtorchArtificialNeuralNet
Issue(s): #19571
Collection(s): FUNCTIONAL
Type(s): RunApp
- framework: MathUtils Namespace
- 1.60.10The system shall have a function that evaluates the polynomial and derivative of polyonimal of varying degree and arbitrary coefficients
Specification(s): poly
Design: MathUtils Namespace
Issue(s): #13184
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.60.11The system shall have a clamp function that returns a value limited to upper and lower bounds
Specification(s): clamp
Design: MathUtils Namespace
Issue(s): #13231
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.60.12The system shall have a smootherstep function that returns a smooth transition value between an upper and lower bound
Specification(s): smootherstep
Design: MathUtils Namespace
Issue(s): #13231
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: Samplers System
- 1.60.18The system shall include a utility for swapping values within a vector of data.
Specification(s): swap
Design: Samplers System
Issue(s): #14830
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.60.19The system shall include a utility for shuffling values within a vector of data.
Specification(s): serial
Design: Samplers System
Issue(s): #14830
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- 1.60.20The system shall include a utility for resampling values within a vector of data.
Specification(s): resample
Design: Samplers System
Issue(s): #14830
Collection(s): FUNCTIONAL
Type(s): JSONDiff
- framework: SplineFunction
- 1.60.21The system shall include a utility for computing spline functions.
Specification(s): regular_spline
Design: SplineFunction
Issue(s): #10918
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.60.22The system shall include a utility for computing bicubic spline functions
- using the x-component, and
- using the y-component.
- using the z-component,
Specification(s): bicubic/spline_x, bicubic/spline_y, bicubic/spline_z
Design: SplineFunction
Issue(s): #10918
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MooseVariableFVReal
- 1.61.6The system shall be able to solve a finite volume problem while caching all variable values and gradients.
Specification(s): full_caching
Design: MooseVariableFVReal
Issue(s): #18009
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.7The system shall be able to solve a finite volume problem without caching face values, except at extrapolated boundary faces.
Specification(s): no_face_value_caching
Design: MooseVariableFVReal
Issue(s): #18009
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.8The system shall be able to solve a finite volume problem without caching face gradients, except at extrapolated boundary faces.
Specification(s): face_gradient_caching
Design: MooseVariableFVReal
Issue(s): #18009
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 1.61.9The system shall be able to solve a finite volume problem without caching face values or gradients, except at extrapolated boundary faces.
Specification(s): no_caching
Design: MooseVariableFVReal
Issue(s): #18009
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: MooseVariableConstMonomial
- 1.61.31The system shall compute time derivatives on a neighbor element for constant monomials
Specification(s): test
Design: MooseVariableConstMonomial
Collection(s): FUNCTIONAL
Type(s): Exodiff
- framework: LineMaterialRealSampler
- 1.62.1Line sampling shall account for floating point precision error.
Specification(s): test
Design: LineMaterialRealSampler
Issue(s): #9500
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.38The system shall support the ability to sample a scalar material along an arbitrary line through the mesh domain.
Specification(s): test
Design: LineMaterialRealSampler
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: CSVReader
- 1.62.4The system shall support the ability to read a comma separated file into an object and make it accessible through easy to use standard C++ containers.
Specification(s): read
Design: CSVReader
Issue(s): #9167
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.5The system shall support the ability to read CSV data on only one processor and broadcast it to other ranks.
Specification(s): parallel
Design: CSVReader
Issue(s): #9167
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.62.6The system shall error if the broadcast CSV data does not match on all ranks in a parallel job.
Specification(s): tester_fail
Design: CSVReader
Issue(s): #9167
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.62.7The system shall support the ability to read a comma separated file into an object prior to initial setup.
Specification(s): read_preic
Design: CSVReader
Issue(s): #14785
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.8The system shall issue an error if the CSVReader is used in a UserObjectTransfer because the former does not have any notion of "spatial" information.
Specification(s): csv_reader_in_transfer
Design: CSVReader
Issue(s): #9860
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.62.32The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a zeroth-rder polynomial with data provided by a CSVReader
Specification(s): least_squares_csv0
Design: LeastSquaresFitCSVReader
Issue(s): #13498
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.33The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a first-rder polynomial with data provided by a CSVReader
Specification(s): least_squares_csv1
Design: LeastSquaresFitCSVReader
Issue(s): #13498
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.34The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a second-rder polynomial with data provided by a CSVReader
Specification(s): least_squares_csv2
Design: LeastSquaresFitCSVReader
Issue(s): #13498
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.35The LeastSquaresFit vectorpostprocessor shall generate an error if a fit for a third-order polynomial is requested and only three data points are provided
Specification(s): least_squares_csv3_order_err
Design: LeastSquaresFitCSVReader
Issue(s): #13498
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: CylindricalAverage
- 1.62.9The system shall support the computation of averages of variables over cylindrical shells.
Specification(s): cyl_average
Design: CylindricalAverage
Issue(s): #12979
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: LineValueSampler
- 1.62.11The system shall support dynamic numbers of sample points during the simulation.
Specification(s): dynamic_point_sampler
Design: LineValueSampler
Issue(s): #12934
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.12The system shall support dynamic numbers of sample points during the simulation with move semantics of the points vector.
Specification(s): dynamic_point_sampler_transfer
Design: LineValueSampler
Issue(s): #12934
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.31The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a first-order polynomial sampled from a solution field using LineValueSampler with shifting and scaling parameters specified
Specification(s): least_squares
Design: LeastSquaresFitLineValueSampler
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.39The system shall allow sampling of variables at equally spaced points for outputting.
Specification(s): test
Design: LineValueSampler
Issue(s): #3087
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.40The system shall allow sampling of variables at equally spaced points in parallel.
Specification(s): parallel
Design: LineValueSampler
Issue(s): #3087
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.41The system shall allow scaling the line value sampler with a postprocessor.
Specification(s): scaling
Design: LineValueSampler
Issue(s): #12314
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.42The system shall allow sampling of auxvariables at equally spaced points with CSV delimiter and precision setting.
Specification(s): delimiter
Design: LineValueSampler
Issue(s): #3593
Collection(s): FUNCTIONAL
Type(s): CheckFiles
- framework: ElementIDInterface
- 1.62.13The system shall have the ability to retrieve element integers when visiting elements.
Specification(s): element_counter_with_ids
Design: ElementIDInterface
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.14The system shall have the ability to retrieve element integers when visiting elements only on certain subdomains.
Specification(s): element_counter_with_ids_block_restricted
Design: ElementIDInterface
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.15The system shall have the ability to retrieve element integers of attached elements when visiting sides of a side set.
Specification(s): element_counter_with_ids_on_side
Design: ElementIDInterface
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.16The system shall have the ability to retrieve element integers of attached elements on both sides when visiting internal interfaces.
Specification(s): element_counter_with_ids_on_interface
Design: ElementIDInterface
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.17The system shall have the ability to retrieve element integers of attached elements on both sides when visiting all internal sides.
Specification(s): element_counter_with_ids_on_internal_side
Design: ElementIDInterface
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ElementValueSampler
- 1.62.18The system shall support sampling of a field variable at the centroid of every element in the domain
- for elemental FE variables and
- for FV variables,
- but not for nodal variables.
Specification(s): element_value_sampler/monomial, element_value_sampler/fv, element_value_sampler/lagrange
Design: ElementValueSampler
Issue(s): #11594
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunExceptionCSVDiff
- framework: ElementVariablesDifferenceMax
- 1.62.19The system shall be capable of locating the maximum distances (the element) between two field variables:
- the true maximum involving a simple difference, and
- the absolute maximum involving the difference between absolute values.
Specification(s): max_difference/true, max_difference/absolute
Design: ElementVariablesDifferenceMax
Issue(s): #9231
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ElementsAlongLine
- 1.62.20The ElementsAlongLine VectorPostprocessor shall output the IDs of all elements intersected by a line on a 1D mesh
Specification(s): 1d
Design: ElementsAlongLine
Issue(s): #4345
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.21The ElementsAlongLine VectorPostprocessor shall output the IDs of all elements intersected by a line on a 2D mesh
Specification(s): 2d
Design: ElementsAlongLine
Issue(s): #4345
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.22The ElementsAlongLine VectorPostprocessor shall output the IDs of all elements intersected by a line on a 3D mesh
Specification(s): 3d
Design: ElementsAlongLine
Issue(s): #4345
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ElementsAlongPlane
- 1.62.23The ElementsAlongPlane VectorPostprocessor shall output the IDs of all elements intersected by a plane on a 1D mesh
Specification(s): 1d
Design: ElementsAlongPlane
Issue(s): #6852
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.24The ElementsAlongPlane VectorPostprocessor shall output the IDs of all elements intersected by a plane on a 2D mesh
Specification(s): 2d
Design: ElementsAlongPlane
Issue(s): #6852
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.25The ElementsAlongPlane VectorPostprocessor shall output the IDs of all elements intersected by a plane on a 3D mesh
Specification(s): 3d
Design: ElementsAlongPlane
Issue(s): #6852
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: ExtraIDIntegralVectorPostprocessor
- 1.62.26The system shall be able to integrate variables parsed by extra IDs
- with a single variable integral and a single extra ID
- with a single variable integral and multiple extra IDs
- with multiple variable integrals and multiple extra IDs
Specification(s): test/default, test/multi_ids, test/multi_ids_multi_vars
Design: ExtraIDIntegralVectorPostprocessor
Issue(s): #19617
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: HistogramVectorPostprocessor
- 1.62.27The system shall be able to compute a histogram of each vector of data produced by a vector data producer (VectorPostprocessor).
Specification(s): test
Design: HistogramVectorPostprocessor
Issue(s): #11218
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.28The histogram vector postprocessor shall generate an error if the vector postprocessor that it operates on does not have any declared vectors
Specification(s): test_size0_err
Design: HistogramVectorPostprocessor
Issue(s): #18459
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: IntersectionPointsAlongLine
- 1.62.29The system shall support finding all of the elements intersected by a line:
- in 1D,
- in 2D, and
- in 3D.
Specification(s): intersecting_elems/1d, intersecting_elems/2d, intersecting_elems/3d
Design: IntersectionPointsAlongLine
Issue(s): #5897
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: LeastSquaresFit
- 1.62.31The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a first-order polynomial sampled from a solution field using LineValueSampler with shifting and scaling parameters specified
Specification(s): least_squares
Design: LeastSquaresFitLineValueSampler
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.32The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a zeroth-rder polynomial with data provided by a CSVReader
Specification(s): least_squares_csv0
Design: LeastSquaresFitCSVReader
Issue(s): #13498
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.33The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a first-rder polynomial with data provided by a CSVReader
Specification(s): least_squares_csv1
Design: LeastSquaresFitCSVReader
Issue(s): #13498
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.34The LeastSquaresFit vectorpostprocessor shall compute a least squares fit of a second-rder polynomial with data provided by a CSVReader
Specification(s): least_squares_csv2
Design: LeastSquaresFitCSVReader
Issue(s): #13498
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.35The LeastSquaresFit vectorpostprocessor shall generate an error if a fit for a third-order polynomial is requested and only three data points are provided
Specification(s): least_squares_csv3_order_err
Design: LeastSquaresFitCSVReader
Issue(s): #13498
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: LeastSquaresFitHistory
- 1.62.36The system shall support computing the least squares fit of a set of time values obtained from an aggregate operation defined by the developer.
Specification(s): least_squares_history
Design: LeastSquaresFitHistory
Issue(s): #11709
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: LineFunctionSampler
- 1.62.37The system shall support sampling one or more spatial functions along a line with fixed sampling intervals.
Specification(s): test
Design: LineFunctionSampler
Issue(s): #6438
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: MaterialVectorPostprocessor
- 1.62.43The system shall be able to output material properties calculated at quadrature points on user-defined elements in a comma separated format.
Specification(s): basic
Design: MaterialVectorPostprocessor
Issue(s): #8436
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.44The system shall issue an error if material output samples are attempted for elements:
- but the material is restricted to a boundary, or
- the material is restricted to a block not containing the desired elements.
Specification(s): errors/boundary_restrict, errors/block_restrict
Design: MaterialVectorPostprocessor
Issue(s): #8436
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: NearestPointIntegralVariablePostprocessor
- 1.62.45The system shall compute integrals computed from the closest values for a list of points and output to a spatial vector postprocessor with one point per point
Specification(s): points_from_uo
Design: NearestPointIntegralVariablePostprocessor
Issue(s): #18931
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: NodalValueSampler
- 1.62.46The system shall support sampling of a field variable at every node in the domain.
Specification(s): test
Design: NodalValueSampler
Issue(s): #3087
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.47The system shall issue an error when a nodal sampler is used on a field that does not have values defined at the nodes.
Specification(s): not_nodal
Design: NodalValueSampler
Issue(s): #3087
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: PointValueSampler
- 1.62.50The system shall support the ability to sample field variables at user specified points.
Specification(s): test
Design: PointValueSampler
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.51The system shall support the ability to sample field FV variables at user specified points.
Specification(s): test_fv
Design: PointValueSampler
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.52The system shall report an error when requested sample points do not fall within the mesh domain.
Specification(s): error
Design: PointValueSampler
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 1.62.53The system shall report a warning when variables requested are discontinuous and requested sample points are
- on element faces and
- on element nodes.
Specification(s): warning_discontinuous_variable/on_face, warning_discontinuous_variable/at_node
Design: PointValueSampler
Issue(s): #17115
Collection(s): FUNCTIONAL
Type(s): RunApp
- 1.62.54The system shall make a consistent choice as to which element value to report when variables requested are discontinuous and requested sample points are
- on element faces and
- on element nodes.
- whether elements are renumbered or not and
- on process domain boundaries.
Specification(s): consistent_discontinuous_variable/on_face, consistent_discontinuous_variable/at_node, consistent_discontinuous_variable/at_node_no_renumbering, consistent_discontinuous_variable/on_domain_boundary
Design: PointValueSampler
Issue(s): #17115
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: SideValueSampler
- 1.62.56The system shall be capable of sampling one or more field variables along a side/boundary at each quadrature point along the side.
Specification(s): external
Design: SideValueSampler
Issue(s): #3087
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.57The system shall be capable of sampling one or more field variables along an internal side at each quadrature point along the side.
Specification(s): internal
Design: SideValueSampler
Issue(s): #3087
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: SidesetInfoVectorPostprocessor
- 1.62.58The system shall allow outputting relevant information about sidesets
Specification(s): sideset_info
Design: SidesetInfoVectorPostprocessor
Issue(s): #14275
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: SpatialUserObjectVectorPostprocessor
- 1.62.59The system shall be able to query a spatial user object and aggregate the results into a vector postprocessor.
Specification(s): test
Design: SpatialUserObjectVectorPostprocessor
Issue(s): #18473
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 1.62.60The system shall error if the points are specified in more than one manner for a spatial vector postprocessor.
Specification(s): missing_pts
Design: SpatialUserObjectVectorPostprocessor
Issue(s): #19831
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- framework: SphericalAverage
- 1.62.61The system shall support computing the spherical average of a variable as a function of radius throughout the mesh domain.
Specification(s): test
Design: SphericalAverage
Issue(s): #7810
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: VariableValueVolumeHistogram
- 1.62.63The system shall allow support the creation of histogram or binned data of volume fractions with respect to variable values.
Specification(s): test
Design: VariableValueVolumeHistogram
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- framework: VectorOfPostprocessors
- 1.62.64The system shall be able to aggregate an arbitrary set of scalar data producers (Postprocessors) into a single vector of Postprocessors.
Specification(s): test
Design: VectorOfPostprocessors
Issue(s): #4176
Collection(s): FUNCTIONAL
Type(s): CSVDiff