Tensor Mechanics System Design Description

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

commentnote

This document serves as an addendum to Framework System Design Description and captures information for SDD specific to the Tensor Mechanics application.

Introduction

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

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

  • A streamlined build system

  • An API aimed at extensible

  • Straightforward APIs providing sensible default information

  • Integrated, automatic, and rigorous testing

  • Rapid, continuous integration development cycle

  • Codified, rigorous path for contributing

  • Applications are modular and composable

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

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

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

Use Cases

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

System Purpose

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

System Scope

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

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

Dependencies and Limitations

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

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

Figure 1: A diagram of the MOOSE code platform.

References

  1. ISO/IEC/IEEE 24765:2010(E). Systems and software engineering—Vocabulary. first edition, December 15 2010.[BibTeX]
  2. 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

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

Design Stakeholders and Concerns

Design Stakeholders

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

Stakeholder Design Concerns

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

System Design

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

System Structure

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

Adaptivity

Adaptivity/Indicators

Adaptivity/Markers

AuxKernels

AuxKernels/MatVecRealGradAuxKernel

AuxKernels/MaterialVectorAuxKernel

AuxKernels/MaterialVectorGradAuxKernel

AuxScalarKernels

AuxVariables

AuxVariables/MultiAuxVariables

BCs

BCs/CavityPressure

BCs/CoupledPressure

BCs/InclinedNoDisplacementBC

BCs/Periodic

BCs/Pressure

Bounds

Closures

Components

Constraints

Contact

ControlLogic

Controls

CoupledHeatTransfers

Covariance

DGKernels

Dampers

Debug

Debug/MaterialDerivativeTest

DeprecatedBlock

DiracKernels

Distributions

DomainIntegral

Executioner

Executioner/Adaptivity

Executioner/Predictor

Executioner/Quadrature

Executioner/TimeIntegrator

Executioner/TimeStepper

Executors

FVBCs

FVInterfaceKernels

FVKernels

FluidPropertiesInterrogator

Functions

GeochemicalModelInterrogator

GlobalParams

GrayDiffuseRadiation

HeatStructureMaterials

ICs

ICs/PolycrystalICs

ICs/PolycrystalICs/BicrystalBoundingBoxIC

ICs/PolycrystalICs/BicrystalCircleGrainIC

ICs/PolycrystalICs/PolycrystalColoringIC

ICs/PolycrystalICs/PolycrystalRandomIC

ICs/PolycrystalICs/PolycrystalVoronoiVoidIC

ICs/PolycrystalICs/Tricrystal2CircleGrainsIC

InterfaceKernels

Kernels

Kernels/CHPFCRFFSplitKernel

Kernels/DynamicTensorMechanics

Kernels/HHPFCRFFSplitKernel

Kernels/PFCRFFKernel

Kernels/PolycrystalElasticDrivingForce

Kernels/PolycrystalKernel

Kernels/PolycrystalStoredEnergy

Kernels/PoroMechanics

Kernels/RigidBodyMultiKernel

Kernels/TensorMechanics

Materials

Mesh

Mesh/Partitioner

Modules

Modules/CompressibleNavierStokes

Modules/FluidProperties

Modules/HeatConduction

Modules/HeatConduction/ThermalContact

Modules/HeatConduction/ThermalContact/BC

Modules/IncompressibleNavierStokes

Modules/NavierStokesFV

Modules/Peridynamics

Modules/Peridynamics/Mechanics

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

Modules/PhaseField

Modules/PhaseField/Conserved

Modules/PhaseField/DisplacementGradients

Modules/PhaseField/EulerAngles2RGB

Modules/PhaseField/GrainGrowth

Modules/PhaseField/GrandPotential

Modules/PhaseField/Nonconserved

Modules/PorousFlow

Modules/PorousFlow/BCs

Modules/TensorMechanics

Modules/TensorMechanics/CohesiveZoneMaster

Modules/TensorMechanics/DynamicMaster

Modules/TensorMechanics/GeneralizedPlaneStrain

Modules/TensorMechanics/GlobalStrain

Modules/TensorMechanics/LineElementMaster

Modules/TensorMechanics/Master

Modules/TensorMechanics/MaterialVectorBodyForce

MortarGapHeatTransfer

MultiApps

NodalKernels

NodalNormals

Outputs

PorousFlowBasicTHM

PorousFlowFullySaturated

PorousFlowUnsaturated

Postprocessors

Preconditioning

Problem

RayBCs

RayKernels

ReactionNetwork

ReactionNetwork/AqueousEquilibriumReactions

ReactionNetwork/SolidKineticReactions

Reporters

Samplers

ScalarKernels

SpatialReactionSolver

StochasticTools

Surrogates

ThermalContact

TimeDependentReactionSolver

TimeIndependentReactionSolver

Trainers

Transfers

UserObjects

Variables

Variables/CHPFCRFFSplitVariables

Variables/HHPFCRFFSplitVariables

Variables/PFCRFFVariables

Variables/PolycrystalVariables

VectorPostprocessors

XFEM

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

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

Data Design and Control

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

Human-Machine Interface Design

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

System Design Interface

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

Security Structure

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

Requirements Cross-Reference

  • tensor_mechanics: Generalized Plane Strain
  • 2.3.10The tensor mechanics strain calculators shall solve generalized plane strain in the x-y plane for small strain

    Specification(s): gps_xy_small

    Design: Generalized Plane Strain

    Issue(s): #11257

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.3.11The tensor mechanics strain calculators shall solve generalized plane strain in the x-y plane for incremental strain

    Specification(s): gps_xy_incremental

    Design: Generalized Plane Strain

    Issue(s): #11257

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.3.12The tensor mechanics strain calculators shall solve generalized plane strain in the x-y plane for finite strain

    Specification(s): gps_xy_finite

    Design: Generalized Plane Strain

    Issue(s): #11257

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.3.13The tensor mechanics strain calculators shall solve generalized plane strain in the x-z plane for small strain

    Specification(s): gps_xz_small

    Design: Generalized Plane Strain

    Issue(s): #11257

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.3.14The tensor mechanics strain calculators shall solve generalized plane strain in the x-z plane for incremental strain

    Specification(s): gps_xz_incremental

    Design: Generalized Plane Strain

    Issue(s): #11257

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.3.15The tensor mechanics strain calculators shall solve generalized plane strain in the x-z plane for finite strain

    Specification(s): gps_xz_finite

    Design: Generalized Plane Strain

    Issue(s): #11257

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.3.16The tensor mechanics strain calculators shall solve generalized plane strain in the y-z plane for small strain

    Specification(s): gps_yz_small

    Design: Generalized Plane Strain

    Issue(s): #11257

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.3.17The tensor mechanics strain calculators shall solve generalized plane strain in the y-z plane for incremental strain

    Specification(s): gps_yz_incremental

    Design: Generalized Plane Strain

    Issue(s): #11257

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.3.18The tensor mechanics strain calculators shall solve generalized plane strain in the y-z plane for finite strain

    Specification(s): gps_yz_finite

    Design: Generalized Plane Strain

    Issue(s): #11257

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • tensor_mechanics: ADComputeFiniteStrain
  • 2.14.2We shall be able to reproduce finite strain elasticity results of the hand-coded simulation using automatic differentiation.

    Specification(s): finite_elastic

    Design: ADComputeFiniteStrain

    Issue(s): #12650

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.14.3The Jacobian for the AD finite strain elasticity problem shall be perfect

    Specification(s): finite_elastic-jac

    Design: ADComputeFiniteStrain

    Issue(s): #12650

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.15.1Finite strain methods in Tensor Mechanics should be able to adequately simulate a bar bending simulation in 2D using AD and match non-AD methods

    Specification(s): bending

    Design: ADComputeFiniteStrain

    Issue(s): #7228#13260

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.15.2Finite strain methods in Tensor Mechanics should be able to adequately simulate a bar bending simulation in 2D using a volumetric locking correction using AD and match non-AD methods

    Specification(s): bending_Bbar

    Design: ADComputeFiniteStrain

    Issue(s): #7228#13260

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.15.3Finite strain methods in Tensor Mechanics should be able to adequately simulate a tensile test simulation in 3D using AD and match non-AD methods

    Specification(s): 3d_bar

    Design: ADComputeFiniteStrain

    Issue(s): #7228#13260

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.15.4Finite strain methods in Tensor Mechanics should be able to adequately simulate a tensile test simulation in 3D using a volumetric locking correction using AD and match non-AD methods

    Specification(s): 3d_bar_Bbar

    Design: ADComputeFiniteStrain

    Issue(s): #7228#13260

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.15.5Finite strain methods in Tensor Mechanics should be able to adequately simulate a bar bending simulation in 2D using AD and calculate perfect Jacobians

    Specification(s): bending-jac

    Design: ADComputeFiniteStrain

    Issue(s): #12650#13260

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.15.6Finite strain methods in Tensor Mechanics should be able to adequately simulate a bar bending simulation in 2D using a volumetric locking correction using AD and calculate perfect Jacobians

    Specification(s): bending_Bbar-jac

    Design: ADComputeFiniteStrain

    Issue(s): #12650#13260

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.15.7Finite strain methods in Tensor Mechanics should be able to adequately simulate a tensile test simulation in 3D using AD and calculate perfect Jacobians

    Specification(s): 3d_bar-jac

    Design: ADComputeFiniteStrain

    Issue(s): #12650#13260

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.15.8Finite strain methods in Tensor Mechanics should be able to adequately simulate a tensile test simulation in 3D using a volumetric locking correction using AD and calculate perfect Jacobians

    Specification(s): 3d_bar_Bbar-jac

    Design: ADComputeFiniteStrain

    Issue(s): #12650#13260

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • tensor_mechanics: Pressure Action System
  • 2.19.1The Pressure boundary condition action shall create the objects needed to apply automatic differentiation pressure boundary conditions on a 3D model as demonstrated by correctly computing the response of an elastic small-strain isotropic unit cube with pressure applied on three faces to create a hydrostatic pressure and match non-AD methods.

    Specification(s): 3D

    Design: Pressure Action System

    Issue(s): #4781#13260

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.19.2The Pressure boundary condition action shall create the objects needed to apply automatic differentiation pressure boundary conditions on a 3D model as demonstrated by correctly computing the response of an elastic small-strain isotropic unit cube with pressure applied on three faces to create a hydrostatic pressure using the volumetric locking correction b-bar formulation and match non-AD methods.

    Specification(s): 3D_Bbar

    Design: Pressure Action System

    Issue(s): #4781#8235#13260

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.19.3The Pressure boundary condition action shall create the objects needed to apply automatic differentiation pressure boundary conditions on a 3D model as demonstrated by correctly computing the response of an elastic small-strain isotropic unit cube with pressure applied on three faces to create a hydrostatic pressure and calculate a perfect Jacobian.

    Specification(s): 3D-jac

    Design: Pressure Action System

    Issue(s): #4781#13260

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.19.4The Pressure boundary condition action shall create the objects needed to apply automatic differentiation pressure boundary conditions on a 3D model as demonstrated by correctly computing the response of an elastic small-strain isotropic unit cube with pressure applied on three faces to create a hydrostatic pressure using the volumetric locking correction b-bar formulation and calculate a perfect Jacobian.

    Specification(s): 3D_Bbar-jac

    Design: Pressure Action System

    Issue(s): #4781#8235#13260

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.87.1The Pressure boundary condition action shall create the objects needed to apply pressure boundary conditions on a 3D model as demonstrated by correctly computing the response of an elastic small-strain isotropic unit cube with pressure applied on three faces to create a hydrostatic pressure.

    Specification(s): 3D

    Design: Pressure Action System

    Issue(s): #4781

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.87.2The Pressure boundary condition action shall create the objects needed to apply pressure boundary conditions on a 3D model as demonstrated by correctly computing the response of an elastic small-strain isotropic unit cube with pressure applied on three faces to create a hydrostatic pressure using the volumetric locking correction b-bar formulation.

    Specification(s): 3D_Bbar

    Design: Pressure Action System

    Issue(s): #4781#8235

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • tensor_mechanics: Line Element Action System
  • 2.27.1The LineElementAction class shall correctly create the objects required for a mechanics simulation using beam or truss elements.

    Specification(s): 2_block_action

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.2The LineElementAction class shall correctly set the common parameters in the action subblocks.

    Specification(s): 2_block_common_action

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.3The LineElementAction class shall produce an error when the displacement variables are not provided by the user.

    Specification(s): beam_action_test1

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.4The LineElementAction class shall produce an error if the user provided inputs for strain_type, rotation_type and use_displaced_mesh parameters are not compatible.

    Specification(s): beam_action_test2

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.5The LineElementAction class shall produce an error if the number of variables listed in the save_in parameter differs from the number of displacement variables.

    Specification(s): beam_action_test3

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.6The LineElementAction class shall produce an error if the number of variables listed in the diag_save_in parameter differs from the number of displacement variables.

    Specification(s): beam_action_test4

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.7The LineElementAction class shall produce an error if the names for the rotational degrees of freedom are not provided by the user.

    Specification(s): beam_action_test5

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.8The LineElementAction class shall produce an error if the number of rotational variables provided as input differs from the number of displacement variables.

    Specification(s): beam_action_test6

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.9The LineElementAction class shall produce an error if the moment of inertia, area and orientation of the beam are not provided as input.

    Specification(s): beam_action_test7

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.10The LineElementAction class shall produce an error if translational and rotational velocities and accelerations are not provided as input for dynamic simulations using beam elements.

    Specification(s): beam_action_test8

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.11The LineElementAction class shall produce an error if the number of translational and rotational velocities and accelerations differs from the number of displacement variables.

    Specification(s): beam_action_test9

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.12The LineElementAction class shall produce an error if Newmark time integration parameters (beta and gamma) are not provided as input for dynamic simulations using beam elements.

    Specification(s): beam_action_test10

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.13The LineElementAction class shall produce an error if density is not provided as input for dynamic beam simulations using beams elements with consistent mass/inertia matrix.

    Specification(s): beam_action_test11

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.14The LineElementAction class shall produce an error if nodal mass is not provided as input for dynamic beam simulations using beam elements with nodal mass matrix.

    Specification(s): beam_action_test12

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.15The LineElementAction class shall produce an error if nodal inertia is not provided as input for dynamic beam simulations using beam elements with nodal inertia matrix.

    Specification(s): beam_action_test13

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.16The LineElementAction class shall produce an error if multiple subblocks specify properties for the same mesh block.

    Specification(s): beam_action_test14

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.17The LineElementAction class shall produce an error if an action subblock is mesh block restricted while another is not.

    Specification(s): beam_action_test15

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.18The LineElementAction class shall produce an error if dynamic_nodal_translational_inertia is set to true in the common action block but the subblocks do not have the parameters required for a dynamic beam simulation using beam elements.

    Specification(s): beam_action_test16

    Design: Line Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.30The LineElementAction shall create the translational and rotational velocities and accelerations required for a dynamic simulation using beam elements.

    Specification(s): add_dynamic_variables_action

    Design: C0 Timoshenko Beam ElementLine Element Action System

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.33The LineElementAction shall correctly create the input blocks required for a dynamic beam simulation using beam elements and a consistent mass/inertia matrix in the presence of Rayleigh damping and numerical damping in the form of Hilber-Hughes-Taylor (HHT) time integration.

    Specification(s): dyn_euler_rayleigh_hht_action

    Design: C0 Timoshenko Beam ElementLine Element Action System

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.34The LineElmentAction shall correctly create the input blocks required for a dynamic beam simulation using beam elements and nodal mass/inertia matrix in the presence of Rayleigh damping and numerical damping in the form of Hilber-Hughes-Taylor (HHT) time integration.

    Specification(s): dyn_euler_added_mass_inertia_damping_action

    Design: C0 Timoshenko Beam ElementLine Element Action System

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.51The LineElementAction class shall produce an error if add_dynamic_variables option is set to false while dynamic_consistent_inertia, dynamic_nodal_rotational_inertia or dynamic_nodal_translational_inertia options are set to true.

    Specification(s): error_16

    Design: C0 Timoshenko Beam ElementLine Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • tensor_mechanics: C0 Timoshenko Beam Element
  • 2.27.19The mechanics system shall accurately predict the displacement of a beam element with a frictionless contact constraint.

    Specification(s): frictionless_constraint

    Design: C0 Timoshenko Beam Element

    Issue(s): #14873

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.27.20The mechanics system shall accurately predict the displacement of a beam element with a glued contact constraint.

    Specification(s): glued_constraint

    Design: C0 Timoshenko Beam Element

    Issue(s): #14873

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.27.21The mechanics system shall accurately predict the displacement of a beam element with a frictional contact constraint.

    Specification(s): frictional_constraint

    Design: C0 Timoshenko Beam Element

    Issue(s): #14873

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.27.22The mechanics system shall correctly predict the natural frequencies of an Euler-Bernoulli beam modeled using beam elements with consistent mass/inertia.

    Specification(s): dyn_euler

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Verification: Beams

  • 2.27.23The mechanics system shall correctly predict the natural frequencies of a Timoshenko beam modeled using beam elements with consistent mass/inertia.

    Specification(s): dyn_timoshenko

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Verification: Beams

  • 2.27.24The mechanics system shall correctly predict the natural frequencies of an Euler-Bernoulli beam modeled using beam elements in the presence of Rayleigh damping and numerical damping introduced by Hilber-Hughes-Taylor (HHT) time integration.

    Specification(s): dyn_euler_rayleigh_hht

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.25The mechanics system shall correctly predict the natural frequencies of an Euler-Bernoulli beam modeled using beam elements in the presence of Rayleigh damping and numerical damping introduced by Hilber-Hughes-Taylor (HHT) time integration when using the velocity and acceleration computed using the Newmark-Beta time integrator.

    Specification(s): dyn_euler_rayleigh_hht_ti

    Design: C0 Timoshenko Beam Element

    Issue(s): #12185

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.26The mechanics system shall correctly predict the natural frequencies of a massless Euler-Bernoulli beam modeled using beam elements with a nodal masses placed at the ends.

    Specification(s): dyn_euler_added_mass

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Verification: Beams

  • 2.27.27The mechanics system shall correctly predict the natural frequencies of a massless Euler-Bernoulli beam modeled using beam elements with added nodal masses when the location and values of the masses are provided using a csv file.

    Specification(s): dyn_euler_added_mass_file

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.28The mechanics system shall correctly model the response of a beam modeled using beam elements when gravitational force (proportional to nodal mass) is applied to the beam.

    Specification(s): dyn_euler_added_mass_gravity

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.29The mechanics system shall correctly model the response of a beam modeled using beam elements under gravitational force when the nodal mass distribution is provided using a csv file.

    Specification(s): dyn_euler_added_mass_gravity_2

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.30The LineElementAction shall create the translational and rotational velocities and accelerations required for a dynamic simulation using beam elements.

    Specification(s): add_dynamic_variables_action

    Design: C0 Timoshenko Beam ElementLine Element Action System

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.31The mechanics system shall correctly model the response of a beam modeled using beam elements in the presence of nodal mass, nodal inertia and Rayleigh damping.

    Specification(s): dyn_euler_added_mass_inertia_damping

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Verification: Beams

  • 2.27.32The mechanics system shall correctly model the response of a beam modeled using beam elements in the presence of nodal mass, nodal inertia and Rayleigh damping when using the velocity and accelerations computed by the Newmark-Beta time integrator.

    Specification(s): dyn_euler_added_mass_inertia_damping_ti

    Design: C0 Timoshenko Beam Element

    Issue(s): #12185

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.33The LineElementAction shall correctly create the input blocks required for a dynamic beam simulation using beam elements and a consistent mass/inertia matrix in the presence of Rayleigh damping and numerical damping in the form of Hilber-Hughes-Taylor (HHT) time integration.

    Specification(s): dyn_euler_rayleigh_hht_action

    Design: C0 Timoshenko Beam ElementLine Element Action System

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.34The LineElmentAction shall correctly create the input blocks required for a dynamic beam simulation using beam elements and nodal mass/inertia matrix in the presence of Rayleigh damping and numerical damping in the form of Hilber-Hughes-Taylor (HHT) time integration.

    Specification(s): dyn_euler_added_mass_inertia_damping_action

    Design: C0 Timoshenko Beam ElementLine Element Action System

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.35The mechanics system shall correctly predict the natural frequency of a cantilever beam modeled using beam elements with a mass at the free end.

    Specification(s): dyn_euler_added_mass2

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.27.36The InertialForceBeam class shall produce an error if the number of variables provided for rotations differs from that provided for displacements.

    Specification(s): error_1

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.37The NodalRotatioanlInertia class shall produce an error if the number of rotational velocities and accelerations provided as input differ from the number of rotations.

    Specification(s): error_2

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.38The NodalRotationalInertia class shall produce an error if the user provided nodal inertia is not positive definite.

    Specification(s): error_3

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.39The NodalRotatioanlInertia class shall produce an error if the user provided x and y orientations are not unit vectors.

    Specification(s): error_4

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.40The NodalRotatioanlInertia class shall produce an error if the user provided x and y orientations are not perpendicular to each other.

    Specification(s): error_5

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.41The NodalRotatioanlInertia class shall produce an error if only x or y orientation is provided as input by the user.

    Specification(s): error_6

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.42The InertialForceBeam class shall produce an error if the number of translational and rotational velocities and accelerations provided as input differ from the number of displacement variables.

    Specification(s): error_7

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.43The NodalTranslationalInertia class shall produce an error if nodal mass is provided as input both as a constant value and also using a csv file.

    Specification(s): error_8

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.44The NodalTranslationalInertia class shall produce an error if nodal mass is not provided as input either as a constant value or using a csv file.

    Specification(s): error_9

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.45The NodalTranslationalInertia class shall produce an error if the number of columns in the nodal mass file is not 4.

    Specification(s): error_10

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.46The NodalTranslationalInertia class shall produce an error if all the nodal positions provided in the nodal mass file cannot be found in the given boundary or mesh block.

    Specification(s): error_11

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.47The NodalGravity class shall produce an error if nodal mass is provided as input both as a constant value and also using a csv file.

    Specification(s): error_12

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.48The NodalGravity class shall produce an error if nodal mass is not provided as input either as a constant value or using a csv file.

    Specification(s): error_13

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.49The NodalGravity class shall produce an error if the number of columns in the nodal mass file is not 4.

    Specification(s): error_14

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.50The NodalGravity class shall produce an error if all the nodal positions provided in the nodal mass file cannot be found in the given boundary or mesh block.

    Specification(s): error_15

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.51The LineElementAction class shall produce an error if add_dynamic_variables option is set to false while dynamic_consistent_inertia, dynamic_nodal_rotational_inertia or dynamic_nodal_translational_inertia options are set to true.

    Specification(s): error_16

    Design: C0 Timoshenko Beam ElementLine Element Action System

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.52The NodalTranslationalInertia class shall produce an error if nodal mass is provided as input both as constant value and also using a csv file.

    Specification(s): error_17

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.56The mechanics system shall accurately predict the static bending response of a Timoshenko beam modeled using beam elements under small deformations in the y direction.

    Specification(s): timoshenko_small_strain_y

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Verification: Beams

  • 2.27.57The mechanics system shall accurately predict the static bending response of a Timoshenko beam modeled using beam elements under small deformations in the z direction.

    Specification(s): timoshenko_small_strain_z

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.58The mechanics system shall accurately predict the static bending response of a Euler-Bernoulli beam modeled using beam elements under small deformations in the y direction.

    Specification(s): euler_small_strain_y

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Verification: Beams

  • 2.27.59The mechanics system shall accurately predict the static bending response of a Euler-Bernoulli beam modeled using beam elements under small deformations in the z direction.

    Specification(s): euler_small_strain_z

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.60The mechanics system shall accurately predict the static bending response of a Euler-Bernoulli beam modeled using beam elements under finite deformations in the y direction.

    Specification(s): euler_finite_rot_y

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Verification: Beams

  • 2.27.61The mechanics system shall accurately predict the static bending response of a Euler-Bernoulli beam modeled using beam elements under finite deformations in the z direction.

    Specification(s): euler_finite_rot_z

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.62The LineElementAction class shall accurately create the objects required to model the static bending response of an Euler-Bernoulli beam modeled using beam elements under small deformations.

    Specification(s): euler_small_y_with_action

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.63The LineElementAction class shall accurately create the objects required to model the static bending response of an Euler-Bernoulli beam modeled using beam elements under finite deformations.

    Specification(s): euler_finite_y_with_action

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.64The mechanics system shall accurately predict the axial displacement of an Euler-Bernoulli pipe modeled using beam elements.

    Specification(s): euler_pipe_axial_disp

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.27.65The mechanics system shall accurately predict the axial forces on an Euler-Bernoulli pipe modeled using beam elements.

    Specification(s): euler_pipe_axial_force

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

    Verification: Beams

  • 2.27.66The mechanics system shall accurately predict the bending response of an Euler-Bernoulli pipe modeled using beam elements.

    Specification(s): euler_pipe_bend

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.27.67The ComputeIncrementalBeamStrain class shall produce an error if the number of supplied displacements and rotations do not match.

    Specification(s): error_displacements1

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.68The StressDivergenceBeam class shall produce an error if the number of supplied displacements and rotations do not match.

    Specification(s): error_displacements2

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.69The ComputeIncrementalBeamStrain class shall produce an error if large strain calculation is requested for asymmetric beam configurations with non-zero first or third moments of area.

    Specification(s): error_large_strain

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.70The ComputeIncrementalBeamStrain class shall produce an error if the y orientation provided is not perpendicular to the beam axis.

    Specification(s): error_y_orientation

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.27.71The mechanics system shall accurately predict the torsional response of a beam modeled using beam elements with auto-calculated polar moment of inertia.

    Specification(s): torsion_1

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

    Verification: Beams

  • 2.27.72The mechanics system shall accurately predict the torsional response of a beam modeled using beam elements with user provided polar moment of inertia.

    Specification(s): torison_2

    Design: C0 Timoshenko Beam Element

    Issue(s): #10313

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.27.73The mechanics system shall accurately predict the static bending response of an Euler beam modeled using beam elements under small deformation when the beam is
    1. oriented along the global Z axis.
    2. oriented on the YZ plane at a 45 deg. angle.
    3. oriented on the YZ plane at a 45 deg. angle and has in-plane loading.
    4. oriented on the YZ plane at a 45 deg. angle and has in-plane loading with non-symmetric cross section geometry.
    5. oriented on the YZ plane at a 45 deg. angle and has in-plane loading and the cross section geometry is non-symmetric.
    6. oriented along the global Y axis.
    7. oriented on the XZ plane at a 45 deg. angle.
    8. oriented on the XZ plane at a 45 deg. angle, and the external loading takes place on the same plane.
    9. oriented on the XY plane at a 45 deg. angle.
    10. oriented on the XY plane at a 45 deg. angle, and the external loading takes place on the same plane.

    Specification(s): euler_small_strain/orientation_z, euler_small_strain/orientation_yz, euler_small_strain/orientation_yz_force_yz, euler_small_strain/orientation_yz_force_yz_cross_section, euler_small_strain/orientation_yz_cross_section, euler_small_strain/orientation_y, euler_small_strain/orientation_xz, euler_small_strain/orientation_xz_force_xz, euler_small_strain/orientation_xy, euler_small_strain/orientation_xy_force_xy

    Design: C0 Timoshenko Beam Element

    Issue(s): #14772

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.27.74The mechanics system shall accurately predict the static bending response of an Euler beam modeled using beam elements under small deformations when the beam is
    1. subjected to simply supported BCs and distributed loading.
    2. subjected to combined bending and torsion loading.

    Specification(s): verification_tests/ansys_vm2, verification_tests/ansys_vm12

    Design: C0 Timoshenko Beam Element

    Issue(s): #14772

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • tensor_mechanics: CappedWeakPlaneStressUpdate
  • 2.30.1The CappedWeakPlaneStressUpdate model shall generate an error if the friction angle is negative

    Specification(s): except1

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.30.2The CappedWeakPlaneStressUpdate model shall generate an error if the dilation angle is negative

    Specification(s): except2

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.30.3The CappedWeakPlaneStressUpdate model shall generate an error if the friction angle is less than the dilation angle

    Specification(s): except3

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.30.4The CappedWeakPlaneStressUpdate model shall generate an error if the cohesion is negative

    Specification(s): except4

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.30.5The CappedWeakPlaneStressUpdate model shall generate an error if the sum of the tensile and compressive strength is less than smoothing_tol

    Specification(s): except5

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.30.6The CappedWeakPlaneStressUpdate model shall generate an error if the normal vector has zero length

    Specification(s): except6

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.30.7The CappedWeakPlaneStressUpdate model shall correctly compute stresses in the elastic regime

    Specification(s): small1

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.30.8The CappedWeakPlaneStressUpdate model shall correctly represent tensile failure with the Lame coefficient lambda=0

    Specification(s): small2

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.30.9The CappedWeakPlaneStressUpdate model shall correctly represent tensile failure with the Lame coefficient lambda=4

    Specification(s): small3

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.30.10The CappedWeakPlaneStressUpdate model shall correctly represent compression failure

    Specification(s): small4

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.30.11The CappedWeakPlaneStressUpdate model shall correctly represent shear failure

    Specification(s): small5

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.30.12The CappedWeakPlaneStressUpdate model shall correctly represent both tensile and shear failure

    Specification(s): small6

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.30.13The CappedWeakPlaneStressUpdate model shall correctly represent tensile behavior with hardening

    Specification(s): small7

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.30.14The CappedWeakPlaneStressUpdate model shall correctly represent compression behavior with hardening

    Specification(s): small8

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.30.15The CappedWeakPlaneStressUpdate model shall correctly represent shear behavior with hardening

    Specification(s): small9

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.30.16The CappedWeakPlaneStressUpdate model shall correctly represent hardening under combined tension and shear

    Specification(s): small10

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.30.17The CappedWeakPlaneStressUpdate model shall correctly represent hardening under combined tension and shear with an initial stress

    Specification(s): small11

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.30.18The CappedWeakPlaneStressUpdate model shall correctly represent the behavior of a column of elements that is pulled, then pushed

    Specification(s): pull_push

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.30.19The CappedWeakPlaneStressUpdate model shall correctly represent the behavior of a column of elements that is pulled, then pushed, with tensile hardening

    Specification(s): pull_push_h

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7784

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.30.20The CappedWeakPlaneStressUpdate model shall correctly represent the behavior of a beam with its ends fully clamped

    Specification(s): cwp_beam

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7960

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.30.21The CappedWeakPlaneStressUpdate model shall correctly represent the tensile failure of a single layer of elements in 1 nonlinear step

    Specification(s): pull_and_shear_1step

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7960

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.30.22The CappedWeakPlaneStressUpdate model shall correctly represent a dynamic problem with plasticity in which a column of material is pulled in tension

    Specification(s): pull_and_shear

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7960

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.30.23The CappedWeakPlaneStressUpdate model shall correctly represent a dynamic problem with plasticity in which a column of material is pushed in compression

    Specification(s): push_and_shear

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7960

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.30.24The system shall permit exceptions to be thrown from material models with stateful properties without reading/writing to/from uninitialized memory

    Specification(s): throw_test

    Design: CappedWeakPlaneStressUpdate

    Issue(s): #7960

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • tensor_mechanics: CentralDifference
  • 2.31.1The NewmarkBeta timeintegrator shall correctly calculate the response of a 1D mesh.

    Specification(s): implicit

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.2The CentralDifference timeintegrator shall correctly calculate the response of a 1D mesh when the the consistent mass matrix option is used.

    Specification(s): explicit

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.3The NewmarkBeta timeintegrator shall correctly calculate the response of a 2D mesh.

    Specification(s): implicit

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.4The CentralDifference timeintegrator shall correctly calculate the response of a 2D mesh when the the consistent mass matrix option is used.

    Specification(s): explicit

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.5The NewmarkBeta timeintegrator shall correctly calculate the response of a 3D mesh.

    Specification(s): implicit

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.6The CentralDifference timeintegrator shall correctly calculate the response of a 3D mesh when the the consistent mass matrix option is used.

    Specification(s): explicit

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.7The system shall include central difference time integration that correctly calculates the response of a 1D mesh with nodal masses equal to those of a corresponding lumped mass system.

    Specification(s): explicit_nodalmass

    Design: CentralDifference

    Issue(s): #13964#9726#16163

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.8The system shall include Newmark-beta time integration that correctly calculate the response of a 1D mesh with nodal masses equal to those of a corresponding lumped mass system.

    Specification(s): implicit_nodalmass

    Design: CentralDifference

    Issue(s): #13964#9726#16163

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.9The system shall include a central difference time integration that when used with the lumped mass shall correctly calculate the response of a 1D mesh and produce results that are identical to those calculated using equivalent nodal masses.

    Specification(s): explicit_lumped

    Design: CentralDifference

    Issue(s): #13964#9726#16163

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.10The system shall include central difference time integration that when used with the constant mass option shall correctly calculate the response of a 1D mesh and produce results that are identical to those calculated using equivalent nodal masses.

    Specification(s): explicit_constant_mass

    Design: CentralDifference

    Issue(s): #13964#9726#16163

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.11The system shall include central difference time integration that correctly calculates the response of a 2D mesh with nodal masses equal to those of a corresponding lumped mass system.

    Specification(s): explicit_nodalmass

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.12The system shall include Newmark-beta time integration that correctly calculates the response of a 2D mesh with nodal masses equal to those of a corresponding lumped mass system.

    Specification(s): implicit_nodalmass

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.13The system syall include central difference time integration that when used with the lumped mass option shall correctly calculate the response of a 2D mesh and produce results that are identical to those calculated using equivalent nodal masses.

    Specification(s): explicit_lumped

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.14The system syall include central difference time integration that when used with the constant mass option shall correctly calculate the response of a 2D mesh and produce results that are identical to those calculated using equivalent nodal masses.

    Specification(s): explicit_constant_mass

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.15The system shall include central difference time integration that correctly calculates the response of a 3D mesh with nodal masses equal to those of a corresponding lumped mass system.

    Specification(s): explicit_nodalmass

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.16The system shall include Newmar-beta time integration that correctly calculates the response of a 3D mesh with nodal masses equal to those of a corresponding lumped mass system.

    Specification(s): implicit_nodalmass

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.17The system shall include central difference time integration that when used with the lumped mass option shall correctly calculate the response of a 3D mesh and produce results that are identical to those calculated using equivalent nodal masses.

    Specification(s): explicit_lumped

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.31.18The system shall include central difference time integration that when used with the constant mass option shall correctly calculate the response of a 3D mesh and produce results that are identical to those calculated using equivalent nodal masses.

    Specification(s): explicit_constant_mass

    Design: CentralDifference

    Issue(s): #13964#9726

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • tensor_mechanics: Tensor Mechanics Module
  • 2.39.7This is a deprecated system that has been replaced by the user object based plasticity and should be removed.

    Specification(s): test

    Design: Tensor Mechanics Module

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.39.8This is a deprecated system that has been replaced by the user object based plasticity and should be removed.

    Specification(s): test_fileread

    Design: Tensor Mechanics Module

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.39.9This is a deprecated system that has been replaced by the user object based plasticity and should be removed.

    Specification(s): test_user_object

    Design: Tensor Mechanics Module

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.39.10This is a deprecated system that has been replaced by the user object based plasticity and should be removed.

    Specification(s): test_save_euler

    Design: Tensor Mechanics Module

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.39.11This is a deprecated system that has been replaced by the user object based plasticity and should be removed.

    Specification(s): test_read_slip_prop

    Design: Tensor Mechanics Module

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.39.12This is a deprecated system that has been replaced by the user object based plasticity and should be removed.

    Specification(s): test_cutback

    Design: Tensor Mechanics Module

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.39.13This is a deprecated system that has been replaced by the user object based plasticity and should be removed.

    Specification(s): test_substep

    Design: Tensor Mechanics Module

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.39.14This is a deprecated system that has been replaced by the user object based plasticity and should be removed.

    Specification(s): test_linesearch

    Design: Tensor Mechanics Module

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.39.15This is a deprecated system that has been replaced by the user object based plasticity and should be removed.

    Specification(s): orthotropic_rotation

    Design: Tensor Mechanics Module

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • tensor_mechanics: Introduction
  • 2.39.22The Zienkiewicz-Zhu patch shall calculate the stress components at the nodes, with equivalent results in both serial and parallel simulations, in the stress-update based crystal plasticity implementation

    Specification(s): patch_recovery

    Design: Introduction

    Issue(s): #18721

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.39.42The Zienkiewicz-Zhu patch shall calculate the stress components at the nodes, with equivalent results in both serial and parallel simulations, in a crystal plasticity finite strain application.

    Specification(s): patch_recovery

    Design: Introduction

    Issue(s): #18721

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.79.1The TensorMechanics module shall be able to construct nodal variables from material properties that are defined at quadrature points.

    Specification(s): nodal_patch_recovery

    Design: Introduction

    Issue(s): #15748#12036

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.97.1The Zienkiewicz-Zhu patch shall calculate the stress components at the nodes, with equivalent results in both serial and parallel simulations, in a small strain application.

    Specification(s): patch_small_strain

    Design: Introduction

    Issue(s): #11880

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.97.2The Zienkiewicz-Zhu patch shall calculate the stress components at the nodes, with equivalent results in both serial and parallel simulations, in a finite strain application.

    Specification(s): patch_finite_strain

    Design: Introduction

    Issue(s): #18721

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.97.3In areas of high concentration gradients, the Zienkiewicz-Zhu implementation shall recover the specified material property.

    Specification(s): stress_concentration

    Design: Introduction

    Issue(s): #11880

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • tensor_mechanics: PropertyReadFile
  • 2.39.43The system shall provide an object to read values from a file and map them onto a mesh besed on mesh block IDs

    Specification(s): prop_block_read

    Design: PropertyReadFile

    Issue(s): #4066

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.46.1The system shall provide an object to read values from a file and map them onto a mesh based on mesh element IDs

    Specification(s): test_elem

    Design: PropertyReadFile

    Issue(s): #4066

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.46.2The system shall provide an object to read values from a file and map them onto a mesh based on grain IDs determined by a random Voronoi tessellation

    Specification(s): test_grain

    Design: PropertyReadFile

    Issue(s): #4066

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • tensor_mechanics: DomainIntegral System
  • 2.40.1The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D.

    Specification(s): test_jthermal

    Design: DomainIntegral System

    Issue(s): #3807#10232

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.40.2The Domain Integral Action shall compute all of the fracture domain integrals including the C integral for problems in 2D.

    Specification(s): c_integral_2d

    Design: DomainIntegral System

    Issue(s): #3807#10232

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.40.3The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in 2D.

    Specification(s): test_iithermal

    Design: DomainIntegral System

    Issue(s): #7527#9966

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.40.4The interaction integral shall account for the contributions of the gradients of arbitrary eigenstrains in 2D

    Specification(s): test_ii_arb_eig_grad

    Design: DomainIntegral System

    Issue(s): #18804

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.40.5The DomainIntegralAction shall generate an error if a user specifies the eigenstrain gradient and also request the J integral

    Specification(s): test_ii_arb_eig_grad_err_jint

    Design: DomainIntegral System

    Issue(s): #18804

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.40.6The DomainIntegralAction shall generate an error if a user specifies the temperature and also provides the eigenstrain_gradient

    Specification(s): test_ii_arb_eig_grad_err_temp

    Design: DomainIntegral System

    Issue(s): #18804

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.40.7The interaction integral shall account for the contributions of body forces in 2D

    Specification(s): test_ii_bf

    Design: DomainIntegral System

    Issue(s): #18804

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.40.8The DomainIntegralAction shall generate an error if a user specifies the body force and also request the J integral

    Specification(s): test_ii_bf_err_jint

    Design: DomainIntegral System

    Issue(s): #18804

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.40.9The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in any plane for 2D.

    Specification(s): test_iithermal_rot

    Design: DomainIntegral System

    Issue(s): #7527#9966

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.40.10The Domain Integral Action shall compute all of the fracture domain integrals including the C(t) integral for problems in 2D.

    Specification(s): interaction_integral_2d_c

    Design: DomainIntegral System

    Issue(s): #7527#9966

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.40.11The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D using the instantaneous thermal expansion function eigenstrain.

    Specification(s): test_jthermal_ctefunc

    Design: DomainIntegral System

    Issue(s): #3807#10232

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.40.12The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D using the mean thermal expansion function eigenstrain.

    Specification(s): test_jthermal_mean_ctefunc

    Design: DomainIntegral System

    Issue(s): #3807#10232

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.40.13The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D using the instantaneous thermal expansion function eigenstrain.

    Specification(s): test_jthermal_inst_ctefunc

    Design: DomainIntegral System

    Issue(s): #3807#10232

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.60.1The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in 2D.

    Specification(s): ii_2d

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.60.2The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems for all planes in 2D.

    Specification(s): ii_2d_rot

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.60.3The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in 3d evaluated as 2D.

    Specification(s): ii_3d_as_2d

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.60.4The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in 3D.

    Specification(s): ii_3d

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.60.5The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in 3D while supressing the output of q function values.

    Specification(s): ii_3d_noq

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.60.6The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in 3D at specified points.

    Specification(s): ii_3d_points

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.60.7The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in any plane in 3D.

    Specification(s): ii_3d_rot

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.60.8The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in 2D while outputting q vlaues.

    Specification(s): ii_2d_chk_q

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.60.9The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in any plane 2D while outputting q values.

    Specification(s): ii_2d_rot_chk_q

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.60.10The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in 3D evaluated as 2D.

    Specification(s): ii_3d_as_2d_chk_q

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.60.11The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in 3D while outputting q values.

    Specification(s): ii_3d_chk_q

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.60.12The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in 3D for specified points, while outputting q values.

    Specification(s): ii_3d_points_chk_q

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.60.13The Domain Integral Action shall compute all of the fracture domain integrals including the interaction integral for problems in any plane in 3D while outputting q values.

    Specification(s): ii_3d_rot_chk_q

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.61.1The system shall compute mixed-mode fracture integrals that match values of K fields applied at the boundary of a 3D disk cut on one side by a slit

    Specification(s): test

    Design: DomainIntegral System

    Issue(s): #3705

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.1The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D.

    Specification(s): j_2d

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.2The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D using small strain.

    Specification(s): j_2d_small_strain

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.3The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D at specified points.

    Specification(s): j_2d_points

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.4The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D given a mouth direction.

    Specification(s): j_2d_mouth_dir

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.5The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D using the topology type q function.

    Specification(s): j_2d_topo_q

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.6The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D evaluated as a 2D problem.

    Specification(s): j_3d_as_2d

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.7The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D evaluated as a 2D problem using the topology type q function.

    Specification(s): j_3d_as_2d_topo_q

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.8The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D.

    Specification(s): j_3d

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.9The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D with the q function turned off.

    Specification(s): j_3d_noq

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.10The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D with specified points.

    Specification(s): j_3d_points

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.11The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D given a crack mouth direction.

    Specification(s): j_3d_mouth_dir

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.12The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D given a crack mouth direction and end direction vector.

    Specification(s): j_3d_mouth_dir_end_dir_vec

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.13The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D with a topology type q function.

    Specification(s): j_3d_topo_q

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.14The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D evaluated as a 2D problem using the topology type q function.

    Specification(s): j_3d_as_2d_topo_q_outq

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.15The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D given a crack mouth direction.

    Specification(s): j_3d_mouth_dir_outq

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.16The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D while supressing the output of the q function values.

    Specification(s): j_2d_noq

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.66.17The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D while outputting the q function values.

    Specification(s): j_2d_chk_q

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.66.18The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 2D with the topology type q function and outputting the values.

    Specification(s): j_2d_topo_chk_q

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.66.19The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D while supressing the output of the q values.

    Specification(s): j_3d_chk_q

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.66.20The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for problems in 3D with the topology type q function and outputting the values.

    Specification(s): j_3d_topo_chk_q

    Design: DomainIntegral System

    Issue(s): #2814

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.67.1The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for surface breaking elliptical cracks.

    Specification(s): j_ellip

    Design: DomainIntegral System

    Issue(s): #2717

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.67.2The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for surface breaking elliptical cracks using the crack mouth specification.

    Specification(s): J_ellip_cm

    Design: DomainIntegral System

    Issue(s): #2717

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.67.3The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for surface breaking elliptical cracks using the crack mouth specification computing the system Jacobian via automatic differentiation.

    Specification(s): J_ellip_cm_ad

    Design: DomainIntegral System

    Issue(s): #2717

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.67.4The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for surface breaking elliptical cracks with crack face pressure.

    Specification(s): j_ellip_cfp

    Design: DomainIntegral System

    Issue(s): #2717

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.67.5The Domain Integral Action shall compute all of the fracture domain integrals including the J integral for surface breaking elliptical cracks with crack face pressure and crack mouth boundary specified.

    Specification(s): J_ellip_cm_cfp

    Design: DomainIntegral System

    Issue(s): #2717

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.67.6The Domain Integral Action shall compute all of the fracture domain integrals including the C integral for surface breaking elliptical cracks.

    Specification(s): c_int_surfbreak_ellip_crack_sym_mm

    Design: DomainIntegral System

    Issue(s): #2717

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.67.7The Domain Integral Action shall compute all of the fracture domain integrals including the C integral for surface breaking elliptical cracks using automatic differentiation.

    Specification(s): c_int_surfbreak_ellip_crack_sym_mm_ad

    Design: DomainIntegral System

    Issue(s): #2717

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.99.1The Domain Integral Action shall compute all of the fracture domain integrals including the T stress for cracks in an infinite plate.

    Specification(s): 2d

    Design: DomainIntegral System

    Issue(s): #4276

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.99.2The Domain Integral Action shall compute all of the fracture domain integrals including the T stress for an elliptical crack in 3D.

    Specification(s): 3d

    Design: DomainIntegral System

    Issue(s): #4276

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • tensor_mechanics: Dynamics
  • 2.42.1The PresetAcceleration class shall accurately prescribe the acceleration at the given boundary.

    Specification(s): acceleration_bc

    Design: DynamicsPresetAcceleration

    Issue(s): #7642

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.2The PresetAcceleration class shall accurately prescribe the acceleration at the given boundary when the Newmark-Beta time integrator is used to calculate the velocity and acceleration.

    Specification(s): acceleration_bc_ti

    Design: DynamicsPresetAcceleration

    Issue(s): #12185

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.4The PresetDisplacement class shall accurately prescribe the displacement at the given boundary.

    Specification(s): displacement_bc

    Design: DynamicsPresetDisplacement

    Issue(s): #7642

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.5The PresetDisplacement class shall accurately prescribe the displacement at the given boundary using the velocity and and acceleration computed using the Newmark-Beta time integrator.

    Specification(s): displacement_bc_ti

    Design: DynamicsPresetDisplacement

    Issue(s): #12185

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.6The mechanics system shall accurately conduct a static analysis in a small number of time steps to equilibrate the system under gravity before starting the dynamic analysis.

    Specification(s): displacement_bc_gravity

    Design: Dynamics

    Issue(s): #7642

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.7The mechanics system shall accurately predict the dynamic response of a linear elastic system with both Rayleigh damping and numerical damping resulting from Hilber-Hughes-Taylor (HHT) time integration.

    Specification(s): hht

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.8The mechanics system shall accurately predict the dynamic response of a linear elastic system with both Rayleigh damping and numerical damping resulting from Hilber-Hughes-Taylor (HHT) time integration when using the velocity and acceleration computed using the Newmark-Beta time integrator.

    Specification(s): hht_ti

    Design: Dynamics

    Issue(s): #12185

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.9The mechanics system shall accurately predict the dynamic response of a linear elastic system with a constant Rayleigh damping.

    Specification(s): newmark

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.10The mechanics system shall accurately predict the dynamic response of a linear elastic system with Rayleigh damping provided as a material property.

    Specification(s): newmark_material

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.11The mechanics system shall accurately predict the dynamic response of a linear elastic system using Hilber-Hughes-Taylor (HHT) time integration.

    Specification(s): hht

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.12The mechanics system shall accurately predict the dynamic response of a linear elastic system using Hilber-Hughes-Taylor (HHT) time integration when using the dynamic tensor mechanics action.

    Specification(s): hht_action

    Design: Dynamics

    Issue(s): #18388

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.13The mechanics system shall accurately predict the dynamic response of a linear elastic system using Newmark time integration.

    Specification(s): newmark

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.14The mechanics system shall accurately predict the dynamic response of a linear elastic system using Newmark time integration and the dynamic tensor mechanics action.

    Specification(s): newmark_action

    Design: Dynamics

    Issue(s): #18388

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.15The mechanics system shall accurately predict the dynamic response of a linear elastic system using Hilber-Hughes-Taylor (HHT) time integration when velocity and acceleration of the system are calculated using the Newmark-Beta time integrator.

    Specification(s): hht_ti

    Design: Dynamics

    Issue(s): #12185

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.16The dynamic tensor mechanics action shall support automatic differentiation using the Newmark-Beta time integrator.

    Specification(s): ad_newmark_action

    Design: Dynamics

    Issue(s): #18687

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.17The mechanics system shall correctly predict 1D wave propagation in a linear elastic material with numerical damping resulting from Hilber-Hughes-Taylor (HHT) time integration.

    Specification(s): hht

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.18The mechanics system shall correctly predict 1D wave propagation in a linear elastic material with no numerical or structural damping.

    Specification(s): newmark

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.19The mechanics system shall correctly predict 1D wave propagation in a linear elastic material with both Rayleigh damping and numerical damping resulting from Hilber-Hughes-Taylor (HHT) time integration.

    Specification(s): rayleigh_hht

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.20The mechanics system shall correctly predict 1D wave propagation in a linear elastic material with both Rayleigh damping and numerical damping resulting from Hilber-Hughes-Taylor (HHT) time integration when automatic differentiation is used.

    Specification(s): rayleigh_hht_ad

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.21The mechanics system shall correctly compute the Jacobian for 1D wave propagation in a linear elastic material with both Rayleigh damping and numerical damping resulting from Hilber-Hughes-Taylor (HHT) time integration when automatic differentiation is used.

    Specification(s): rayleigh_hht_ad_jac

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.42.22The mechanics system shall correctly predict 1D wave propagation in a linear elastic material with both Rayleigh damping and numerical damping resulting from Hilber-Hughes-Taylor (HHT) time integration when using the velocity and acceleration computed using the Newmark-Beta time integrator.

    Specification(s): rayleigh_hht_ti

    Design: Dynamics

    Issue(s): #12185

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.23The mechanics system shall correctly predict 1D wave propagation in a linear elastic material with Rayleigh damping.

    Specification(s): rayleigh_newmark

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.42.24The mechanics system shall correctly predict 1D wave propagation in a linear elastic material with Rayleigh damping when using the dynamic tensor mechanics master action.

    Specification(s): rayleigh_newmark_action

    Design: Dynamics

    Issue(s): #5559

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • tensor_mechanics: Stress Divergence
  • 2.50.1The system shall track a changing global stress state when a model undergoes rigid body rotation

    Specification(s): rotation_test

    Design: Stress Divergence

    Issue(s): #8422

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.50.2The system shall compute a uniform stress state given a uniform strain state with finite strains

    Specification(s): patch_test

    Design: Stress Divergence

    Issue(s): #12584

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • tensor_mechanics: Global Strain
  • 2.52.1The globalstrain system shall correctly compute the volume change due to applied stress while still maintaining periodicity in 2D.

    Specification(s): test

    Design: Global Strain

    Issue(s): #11314

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.52.2The globalstrain system shall correctly compute the volume change under uniaxial stress while still maintaining periodicity in all the directions in 3D.

    Specification(s): uniaxial

    Design: Global Strain

    Issue(s): #11314

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.52.3The globalstrain system shall correctly compute the volume change under hydrostratic stress while still maintaining periodicity in all the directions in 3D.

    Specification(s): hydrostat

    Design: Global Strain

    Issue(s): #11314

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.52.4The globalstrain system shall correctly compute the shear deformation due to applied stress while still maintaining periodicity in all the directions in 3D.

    Specification(s): shear

    Design: Global Strain

    Issue(s): #11314

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.52.5The globalstrain system shall correctly compute the deformation behavior in 2D with applied displacement boundary condition in one direction while still maintaining periodicity in the other.

    Specification(s): direction

    Design: Global Strain

    Issue(s): #11314

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.52.6The globalstrain system shall correctly compute the deformation behavior in 3D with applied displacement boundary condition in one direction while still maintaining periodicity in the others.

    Specification(s): disp

    Design: Global Strain

    Issue(s): #11314

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.52.7The globalstrain system shall correctly compute the deformation behavior in 3D with pressure boundary condition in one direction while still maintaining periodicity in the others.

    Specification(s): pressure_3D

    Design: Global Strain

    Issue(s): #11314

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.52.8The 'GlobalStrainAction' should set all the objects reqiured for the globalstrain system to correctly compute the deformation behavior maintaining strain periodicity.

    Specification(s): action_check

    Design: Global Strain

    Issue(s): #11314

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • tensor_mechanics: Gravity
  • 2.53.1The tensor mechanics module shall have the capability of applying a body force term in the stress divergence equilibrium equation that accounts for the force of gravity on a solid object due to its own weight.

    Specification(s): gravity_test

    Design: Gravity

    Issue(s): #4781

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • tensor_mechanics: ADGravity
  • 2.53.2The tensor mechanics module shall be able to reproduce gravity test results of the hand-coded jacobian using automatic differentiation.

    Specification(s): ad_gravity_test

    Design: ADGravity

    Issue(s): #13100

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.53.3The Jacobian for the AD gravity problem shall be perfect

    Specification(s): ad_gravity_test-jac

    Design: ADGravity

    Issue(s): #13100

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • tensor_mechanics: KineticEnergyAux
  • 2.53.5The system shall provide a way to compute the system total kinetic energy through the use of auxiliary kernels and postprocessors. This test verifies that a body falls at the right acceleration under the action of gravity and that the computed kinetic energy matches the analytical expression.

    Specification(s): block-gravity-kinetic-energy

    Design: KineticEnergyAux

    Issue(s): #19671

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • tensor_mechanics: Volume Weighted Weibull
  • 2.56.1VolumeWeightedWeibull shall generate a randomly distributed field that approximates the analytic expression for the Weibull distribution when the mesh is uniform and the reference volume is set equal to the element size

    Specification(s): test

    Design: Volume Weighted Weibull

    Issue(s): #10221

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.56.2VolumeWeightedWeibull shall generate a randomly distributed field that approaches the analytic expression for the Weibull distribution when the mesh is uniform and the reference volume is set equal to the element size as the mesh density is increased

    Specification(s): test_finer

    Design: Volume Weighted Weibull

    Issue(s): #10221

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.56.3VolumeWeightedWeibull shall generate a randomly distributed field that approximates the analytic expression for the Weibull distribution when the mesh is uniform, the reference volume is set to a value different from the element size, and the median is adjusted to account for the different reference volume

    Specification(s): test_ref_vol

    Design: Volume Weighted Weibull

    Issue(s): #10221

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • tensor_mechanics: Inertial Torque
  • 2.58.1The tensor mechanics module computes residual for a simplesituation correctly

    Specification(s): residual

    Design: Inertial Torque

    Issue(s): #13634

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.58.2The tensor mechanics module computes the ith component ofinertial torque where the only degree of freedom in y

    Specification(s): simple

    Design: Inertial Torque

    Issue(s): #13634

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • tensor_mechanics: ComputeEigenstrainFromInitialStress
  • 2.59.1TensorMechanics shall allow users to specify initial stresses, but shall error-out with appropriate message if the user does not supply the correct number of functions to define the initial stress tensor

    Specification(s): except01

    Design: ComputeEigenstrainFromInitialStress

    Issue(s): #9749

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.59.2TensorMechanics shall allow users to specify initial stresses, but shall error-out with appropriate message if the user does not supply the correct number of AuxVariables to define the initial stress tensor

    Specification(s): except02

    Design: ComputeEigenstrainFromInitialStress

    Issue(s): #13087

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.59.3TensorMechanics shall allow users to specify initial stresses using Functions

    Specification(s): gravity

    Design: ComputeEigenstrainFromInitialStress

    Issue(s): #9749

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.59.4TensorMechanics shall allow users to specify initial stresses using AuxVariables

    Specification(s): gravity_with_aux

    Design: ComputeEigenstrainFromInitialStress

    Issue(s): #13087

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.59.5TensorMechanics shall allow users to specify initial stresses for problems with Cosserat mechanics

    Specification(s): gravity_cosserat

    Design: ComputeEigenstrainFromInitialStress

    Issue(s): #9749

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.59.6TensorMechanics shall allow users to specify initial stresses for problems with plasticity, and if the initial stresses are inadmissible, the return-map algorithm will be applied, perhaps incrementally, to bring the initial stresses back to the admissible region

    Specification(s): mc_tensile

    Design: ComputeEigenstrainFromInitialStress

    Issue(s): #9749

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • tensor_mechanics: MooseException
  • 2.86.1The system shall gracefully allow exceptions from the radial return mapping algorithm
    1. not using automatic differentiation methods.
    2. using automatic differentiation methods.

    Specification(s): exception/non, exception/ad

    Design: MooseException

    Issue(s): #9659#20290

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • tensor_mechanics: Pressure
  • 2.87.3The Pressure boundary condition shall compute the correct Jacobian for a problem in 3D space using hex8 elements.

    Specification(s): jacobian_3D_hex8

    Design: Pressure

    Issue(s): #19657

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.87.4The Pressure boundary condition shall compute the correct Jacobian for a problem in 3D space using hex20 elements.

    Specification(s): jacobian_3D_hex20

    Design: Pressure

    Issue(s): #19657

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.87.5The Pressure boundary condition shall compute the correct Jacobian for a problem in RZ coordinates with quad4 elements.

    Specification(s): jacobian_RZ

    Design: Pressure

    Issue(s): #19657

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.87.6The Pressure boundary condition shall compute the correct Jacobian for a problem in RZ coordinates with quad8 elements.

    Specification(s): jacobian_RZ_quad8

    Design: Pressure

    Issue(s): #19657

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.102.21The mechanics system shall correctly compute the jacobian for spherical problems using small, incremental strain.

    Specification(s): incstrn_pressure_spherical

    Design: Pressure

    Issue(s): #8235

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • tensor_mechanics: Strain Energy Density
  • 2.96.1The system shall be capable of calculating strain energy density incrementally in materials with elastic stress and finite strain.

    Specification(s): incr_elas

    Design: Strain Energy Density

    Issue(s): #10972

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.96.2The system shall be capable of informing a user when they incorrectly choose not to use the incremental strain energy density formulation with an incremental material model.

    Specification(s): incr_chk1

    Design: Strain Energy Density

    Issue(s): #10972

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.96.3The system shall be capable of calculating strain energy density for materials with elastic stress and small strain.

    Specification(s): tot_elas

    Design: Strain Energy Density

    Issue(s): #10972

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.96.4The system shall be capable of informing a user when they incorrectly choose to use the incremental strain energy density formulation in a material utilizing small strain.

    Specification(s): tot_chk1

    Design: Strain Energy Density

    Issue(s): #10972

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.96.5The system shall be capable of calculating strain energy density incrementally in materials with inelastic stress and isotropic plasticity.

    Specification(s): incr_elas_plas

    Design: Strain Energy Density

    Issue(s): #10972

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • tensor_mechanics: Abaqus UMAT Stress
  • 2.109.1The system shall provide an interface to use Abaqus UMAT materials as constitutive models, with support for stateful properties

    Specification(s): linear_strain_hardening

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.2The system shall raise an error if a UMAT that requires incremental quantities is being used with a total strain formulation

    Specification(s): total_strain_error

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FAILURE_ANALYSISFUNCTIONAL

    Type(s): RunException

  • 2.109.3The system shall provide an interface to use Abaqus UMAT materials written in Fortran77 as constitutive models, with support for finite strain elastic material models

    Specification(s): elastic

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.4The system shall provide an interface to use Abaqus UMAT materials written in Fortran77 as constitutive models, with support for small strain elastic material models

    Specification(s): elastic_small

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.5The system shall provide an interface to use Abaqus UMAT materials written in C/C++ as constitutive models, with support for finite strain elastic material models

    Specification(s): elastic_C

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.6The Abaqus UMAT interface shall produce the same results as the built-in MOOSE material models for finite strain elasticity

    Specification(s): elastic_reference

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.7The Abaqus UMAT interface shall produce the same results as the built-in MOOSE material models for small strain elasticity

    Specification(s): elastic_small_reference

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.8The system shall provide an interface to use Abaqus UMAT materials as constitutive models, with support for incremental strain elastic material models

    Specification(s): elastic_incremental

    Design: Abaqus UMAT Stress

    Issue(s): #18843

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.9The Abaqus UMAT interface shall produce the same results (stress, strain, displacements) as the built-in MOOSE capabilities for a mechanical problem with an external field (not temperature) affecting material behavior

    Specification(s): predef

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.10The system shall avoid regression in a simple mechanical problem where a strain field modifies the stiffness of the material through CompositeElasticityTensor. This test also serves as a reference for UMAT external field verification

    Specification(s): predef_reference

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.11The Abaqus UMAT interface shall produce the same results (stress, strain, displacements) as the built-in MOOSE capabilities for a mechanical problem with an external field (not temperature) step increment affecting material behavior

    Specification(s): dpredef

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.12The system shall avoid regression in a simple mechanical problem where a real number representing the strain increment modifies the stiffness of the material through CompositeElasticityTensor. This test also serves as a reference for UMAT external field increment verification

    Specification(s): dpredef_reference

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.13The Abaqus UMAT interface shall produce the same results (stress, strain, displacements) as the built-in MOOSE capabilities for a mechanical problem with two external fields (not temperature) affecting material behavior

    Specification(s): predef_multiple

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.14The system shall avoid regression in a simple mechanical problem where two strain fields modifies the stiffness of the material through CompositeElasticityTensor. This test also serves as a reference for UMAT external field verification

    Specification(s): predef_multiple_reference

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.15The Abaqus UMAT interface shall produce the same results (stress, strain, displacements) as the built-in MOOSE capabilities for a mechanical problem with two external material properties affecting material behavior

    Specification(s): predef_multiple_mat

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.16The system shall avoid regression in a simple mechanical problem where two strain fields modifies the stiffness of the material through CompositeElasticityTensor. This test also serves as a reference for UMAT external material property verification

    Specification(s): predef_multiple_reference_mat

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.17The Abaqus UMAT interface shall pass correct values for STRAN, DSTRAN, TIME, CMNAME, NDI, NSHR, NTENS, COORDS, DROT, CELENT, DFGRD0, DFGRD1, NOEL, NPT, and KINC, when a single element is subjected to axial loading. Values are checked against verified references

    Specification(s): predef

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 2.109.18The Abaqus UMAT interface shall produce the same results (stress, strain, displacements) as the built-in MOOSE capabilities for a mechanical problem with two external fields (not temperature) step increment affecting material behavior and shear deformation

    Specification(s): print_shear

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.19The system shall avoid regression in a simple mechanical problem where two strain increments modify the stiffness of the material through CompositeElasticityTensor. This test also serves as a reference for UMAT behavior in the presence of shear deformation.

    Specification(s): print_shear_reference

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.20The Abaqus UMAT interface shall pass the correct values for STRAN, DSTRAN, TIME, CMNAME, NDI, NSHR, NTENS, COORDS, DROT, CELENT, DFGRD0, DFGRD1, NOEL, NPT, and KINC, when shear deformation (causing nontrivial rotation kinematics) is present.

    Specification(s): print_shear_print

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 2.109.21The Abaqus UMAT interface shall pass correct values into a C UMAT routine for STRAN, DSTRAN, TIME, CMNAME, NDI, NSHR, NTENS, COORDS, DROT, CELENT, DFGRD0, DFGRD1, NOEL, NPT, and KINC, when a single element is subjected to axial loading. Values are checked against verified references

    Specification(s): print_c

    Design: Abaqus UMAT Stress

    Issue(s): #18237

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 2.109.22The system shall generate identical numerical results regardless of whether the UMAT interface is written in Fortran or C. Generation of reference results.

    Specification(s): print_compare_c

    Design: Abaqus UMAT Stress

    Issue(s): #18237

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.23The system shall generate identical numerical results regardless of whether the UMAT interface is written in Fortran or C. Verification.

    Specification(s): print_compare_f

    Design: Abaqus UMAT Stress

    Issue(s): #18237

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.24The system shall allow for the correct use of Eigen matrices in C UMAT functions.

    Specification(s): print_eigen

    Design: Abaqus UMAT Stress

    Issue(s): #18237

    Collection(s): FUNCTIONAL

    Type(s): RunApp

  • 2.109.25UMAT shall generate the correct shear deformation and stress when a single element is sheared via a Dirichlet boundary condition on the XY plane with anisotropic shear stiffness; results must coincide with those of MOOSE.

    Specification(s): shear_order_umat_umat_x

    Design: Abaqus UMAT Stress

    Issue(s): #20111

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.26UMAT shall generate the correct shear deformation and stress when a single element is sheared via a Dirichlet boundary condition on the YZ plane with anisotropic shear stiffness; results must coincide with those of MOOSE.

    Specification(s): shear_order_umat_umat_z

    Design: Abaqus UMAT Stress

    Issue(s): #20111

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.27The system shall generate reference results of a sheared finite element on the XY plane.

    Specification(s): shear_order_umat_moose_x

    Design: Abaqus UMAT Stress

    Issue(s): #20111

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.28The system shall generate reference results of a sheared finite element on the YZ plane.

    Specification(s): shear_order_umat_moose_z

    Design: Abaqus UMAT Stress

    Issue(s): #20111

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.29The system shall generate a system Jacobian from the UMAT routines using large strain kinematics that is of the same order as the one generated by MOOSE using Rashid strain incrementation when the shear stiffness is anisotropic.

    Specification(s): shear_order_umat_umat_z_jacobian

    Design: Abaqus UMAT Stress

    Issue(s): #20111

    Collection(s): FUNCTIONAL

    Type(s): PetscJacobianTester

  • 2.109.30The system shall provide an interface to use Abaqus UMAT materials as constitutive models, with support for finite strain elastic material models and temperature dependence

    Specification(s): elastic_temperature

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.31The Abaqus UMAT interface shall produce the same results as the built-in MOOSE material models for finite strain elasticity and temperature dependence

    Specification(s): elastic_temperature_reference

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.32The system shall provide an interface to use Abaqus UMAT materials as constitutive models, with support for finite strain elastic material models and temperature dependence, include the temperature step increment

    Specification(s): elastic_dtemperature

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.33The Abaqus UMAT interface shall produce the same results as the built-in MOOSE material models for finite strain elasticity and temperature dependence, including the temperature step increment

    Specification(s): elastic_dtemperature_reference

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • 2.109.34The system shall provide an interface to use Abaqus UMAT materials that allows the user to control the time step increment within the UMAT routine and combine it with MOOSE native time step controls, including cutback and growth factors, and soft terminations.

    Specification(s): elastic_timestep

    Design: Abaqus UMAT Stress

    Issue(s): #14974

    Collection(s): FUNCTIONAL

    Type(s): Exodiff

  • tensor_mechanics: ComputeVolumetricDeformGrad
  • 2.111.3The ComputeVolumeDeformGrad and the VolumeDeformGradCorrectedStress classes shall correctly compute the volumetric deformation gradient, total deformation gradient and transform the stress from previous configuration to the current configuration.

    Specification(s): interface

    Design: ComputeVolumetricDeformGrad

    Issue(s): #6604

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff

  • 2.111.4The ComputeVolumeDeformGrad and the VolumeDeformGradCorrectedStress classes shall correctly compute the volumetric deformation gradient, total deformation gradient and transform the stress from previous configuration to the current configuration when volumetric locking correction is used.

    Specification(s): interface_Bbar

    Design: ComputeVolumetricDeformGradVolumeDeformGradCorrectedStressVolumetric Locking Correction

    Issue(s): #6604

    Collection(s): FUNCTIONAL

    Type(s): CSVDiff