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

Figure 1: A diagram of the MOOSE code platform.
References
Definitions and Acronyms
This section defines, or provides the definition of, all terms and acronyms required to properly understand this specification.
Definitions
- Pull (Merge) Request: A proposed change to the software (e.g. usually a code change, but may also include documentation, requirements, design, and/or testing). - Baseline: A specification or product (e.g., project plan, maintenance and operations (M&O) plan, requirements, or design) that has been formally reviewed and agreed upon, that thereafter serves as the basis for use and further development, and that can be changed only by using an approved change control process (NQA-1, 2009). - Validation: Confirmation, through the provision of objective evidence (e.g., acceptance test), that the requirements for a specific intended use or application have been fulfilled (24765:2010(E), 2010). - Verification: (1) The process of: evaluating a system or component to determine whether the products of a given development phase satisfy the conditions imposed at the start of that phase. (2) Formal proof of program correctness (e.g., requirements, design, implementation reviews, system tests) (24765:2010(E), 2010).
Acronyms
Acronym | Description |
---|---|
API | Application Programming Interface |
DOE-NE | Department of Energy, Nuclear Energy |
FE | finite element |
FEM | Finite Element Method |
GUI | graphical user interface |
HIT | Hierarchical Input Text |
HPC | High Performance Computing |
I/O | Input/Output |
INL | Idaho National Laboratory |
MOOSE | Multiphysics Object Oriented Simulation Environment |
MPI | Message Passing Interface |
PDEs | partial differential equations |
SDD | Software Design Description |
Design Stakeholders and Concerns
Design Stakeholders
Stakeholders for MOOSE include several of the funding sources including Department of Energy, Nuclear Energy (DOE-NE) and the INL. However, Since MOOSE is an open-source project, several universities, companies, and foreign governments have an interest in the development and maintenance of the MOOSE project.
Stakeholder Design Concerns
Concerns from many of the stakeholders are similar. These concerns include correctness, stability, and performance. The mitigation plan for each of these can be addressed. For correctness, MOOSE development requires either regression or unit testing for all new code added to the repository. The project contains several comparisons against analytical solutions where possible and also other verification methods such as MMS. For stability, MOOSE maintains multiple branches to incorporate several layers of testing both internally and for dependent applications. Finally, performance tests are also performed as part of the the normal testing suite to monitor code change impacts to performance.
System Design
The MOOSE framework itself is composed of a wide range of pluggable systems. Each system is generally composed of a single or small set of C++ objects intended to be specialized by a Developer to solve a specific problem. To accomplish this design goal, MOOSE uses several modern object-oriented design patterns. The primary overarching pattern is the "Factory Pattern". Users needing to extend MOOSE may inherit from one of MOOSE's systems to providing an implementation meeting his or her needs. The design of each of these systems is documented on the mooseframework.org wiki in the Tutorial section. Additionally, up-to-date documentation extracted from the source is maintained on the the mooseframework.org documentation site after every successful merge to MOOSE's stable branch. After these objects are created, the can be registered with the framework and used immediately in a MOOSE input file.
System Structure
The MOOSE framework architecture consists of a core and several pluggable systems. The core of MOOSE consists of a number of key objects responsible for setting up and managing the user-defined objects of a finite element simulation. This core set of objects has limited extendability and exist for every simulation configuration that the framework is capable of running.
Adaptivity
Adaptivity/Indicators
Adaptivity/Markers
AuxKernels
AuxKernels/MatVecRealGradAuxKernel
AuxKernels/MaterialVectorAuxKernel
AuxKernels/MaterialVectorGradAuxKernel
AuxScalarKernels
AuxVariables
AuxVariables/MultiAuxVariables
BCs
BCs/CavityPressure
BCs/CoupledPressure
BCs/InclinedNoDisplacementBC
BCs/Periodic
BCs/Pressure
Bounds
Closures
Components
Constraints
Contact
ControlLogic
Controls
CoupledHeatTransfers
Covariance
DGKernels
Dampers
Debug
Debug/MaterialDerivativeTest
DeprecatedBlock
DiracKernels
Distributions
DomainIntegral
Executioner
Executioner/Adaptivity
Executioner/Predictor
Executioner/Quadrature
Executioner/TimeIntegrator
Executioner/TimeStepper
Executors
FVBCs
FVInterfaceKernels
FVKernels
FluidPropertiesInterrogator
Functions
GeochemicalModelInterrogator
GlobalParams
GrayDiffuseRadiation
HeatStructureMaterials
ICs
ICs/PolycrystalICs
ICs/PolycrystalICs/BicrystalBoundingBoxIC
ICs/PolycrystalICs/BicrystalCircleGrainIC
ICs/PolycrystalICs/PolycrystalColoringIC
ICs/PolycrystalICs/PolycrystalRandomIC
ICs/PolycrystalICs/PolycrystalVoronoiVoidIC
ICs/PolycrystalICs/Tricrystal2CircleGrainsIC
InterfaceKernels
Kernels
Kernels/CHPFCRFFSplitKernel
Kernels/DynamicTensorMechanics
Kernels/HHPFCRFFSplitKernel
Kernels/PFCRFFKernel
Kernels/PolycrystalElasticDrivingForce
Kernels/PolycrystalKernel
Kernels/PolycrystalStoredEnergy
Kernels/PoroMechanics
Kernels/RigidBodyMultiKernel
Kernels/TensorMechanics
Materials
Mesh
Mesh/Partitioner
Modules
Modules/CompressibleNavierStokes
Modules/FluidProperties
Modules/HeatConduction
Modules/HeatConduction/ThermalContact
Modules/HeatConduction/ThermalContact/BC
Modules/IncompressibleNavierStokes
Modules/NavierStokesFV
Modules/Peridynamics
Modules/Peridynamics/Mechanics
Modules/Peridynamics/Mechanics/GeneralizedPlaneStrain
Modules/Peridynamics/Mechanics/Master
Modules/PhaseField
Modules/PhaseField/Conserved
Modules/PhaseField/DisplacementGradients
Modules/PhaseField/EulerAngles2RGB
Modules/PhaseField/GrainGrowth
Modules/PhaseField/GrandPotential
Modules/PhaseField/Nonconserved
Modules/PorousFlow
Modules/PorousFlow/BCs
Modules/TensorMechanics
Modules/TensorMechanics/CohesiveZoneMaster
Modules/TensorMechanics/DynamicMaster
Modules/TensorMechanics/GeneralizedPlaneStrain
Modules/TensorMechanics/GlobalStrain
Modules/TensorMechanics/LineElementMaster
Modules/TensorMechanics/Master
Modules/TensorMechanics/MaterialVectorBodyForce
MortarGapHeatTransfer
MultiApps
NodalKernels
NodalNormals
Outputs
PorousFlowBasicTHM
PorousFlowFullySaturated
PorousFlowUnsaturated
Postprocessors
Preconditioning
Problem
RayBCs
RayKernels
ReactionNetwork
ReactionNetwork/AqueousEquilibriumReactions
ReactionNetwork/SolidKineticReactions
Reporters
Samplers
ScalarKernels
SpatialReactionSolver
StochasticTools
Surrogates
ThermalContact
TimeDependentReactionSolver
TimeIndependentReactionSolver
Trainers
Transfers
UserObjects
Variables
Variables/CHPFCRFFSplitVariables
Variables/HHPFCRFFSplitVariables
Variables/PFCRFFVariables
Variables/PolycrystalVariables
VectorPostprocessors
XFEM
The MooseApp is the top-level object used to hold all of the other objects in a simulation. In a normal simulation a single MooseApp object is created and "run()". This object uses it's Factory objects to build user defined objects which are stored in a series of Warehouse objects and executed. The Finite Element data is stored in the Systems and Assembly object while the domain information (the Mesh) is stored in the Mesh object. A series of threaded loops are used to run parallel calculations on the objects created and stored within the warehouses.
MOOSE's pluggable systems are documented on the mooseframework.org wiki. Each of these systems has set of defined polymorphic interfaces and are designed to accomplish a specific task within the simulation. The design of these systems is fluid and is managed through agile methods and ticket request system on the Github.org website.
Data Design and Control
At a high level, the system is designed to process Hierarchical Input Text (HIT) input files to construct several objects that will constitute an finite element (FE) simulation. Some of the objects in the simulation may in turn load other file-based resources to complete the simulation. Examples include meshes or data files. The system will then assemble systems of equations and solve them using the libraries of the Code Platform. The system can then output the solution in one or more supported output formats commonly used for visualization.
Human-Machine Interface Design
MOOSE is a command-line driven program. All interaction with MOOSE and MOOSE-based codes is ultimately done through the command line. This is typical for HPC applications that use the MPI interface for running on super computing clusters. Optional GUIs may be used to assist in creating input files and launching executables on the command line.
System Design Interface
All external system interaction is performed either through file Input/Output (I/O) or through local Application Programming Interface (API) calls. Neither the framework, nor the modules are designed to interact with any external system directly through remote procedure calls. Any code to code coupling performed using the framework are done directly through API calls either in a static binary or after loading shared libraries.
Security Structure
The framework does not require any elevated privileges to operate and does not run any stateful services, daemons or other network programs. Distributed runs rely on the MPI library.
Requirements Cross-Reference
- contact: Constraints System
- 4.1.1The system shall solve a 3D frictionless bouncing block problem with mortar constraint
Specification(s): frictionless-mortar-3d
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.1.2The system shall solve a 3D frictionless bouncing block problem with mortar constraints where the primary suface is composed of a single element and the secondary side is composed of first order faces with a required derivative container size of less than 50
Specification(s): frictionless-mortar-3d-test-derivative-trimming
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): RunApp
- 4.1.3The system shall solve a 3D frictionless bouncing block problem with mortar constraint using the contact action
Specification(s): frictionless-mortar-3d-action
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.1.4The system shall solve a 3D frictionless bouncing block problem with mortar constraint using the contact action and selecting the temporary flag correct edge dropping
Specification(s): frictionless-mortar-3d-action-correct-edge-dropping
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.1.5The system shall solve a 3D frictionless bouncing block problem with mortar constraint and output the mortar segment mesh for debugging purposes
Specification(s): frictionless-mortar-3d-debug-mesh
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.1.6The system shall solve a 3D frictionless bouncing block problem with mortar constraint and output the normal and tangent vector fields for debugging purposes
Specification(s): frictionless-mortar-3d-debug-mesh-geometry
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.1.7The system shall solve a 3D frictional bouncing block problem with mortar constraint using nodal-attached geometry
Specification(s): frictional-mortar-3d
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.1.8The system shall solve a 3D frictional bouncing block problem with mortar constraints using nodal-attached geometry and a frictional pressure vector generated by an auxiliary kernel through a user-friendly action. Results are diffed against non-action output
Specification(s): frictional-mortar-3d-action
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.1.9The system shall solve a 3D frictional bouncing block problem with mortar constraint using weakly interpolated mesh geometry, such as normal and tangent vectors
Specification(s): frictional-mortar-3d-interp-geometry
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.2.1Contact shall be enforced on new nodes created due to mesh refinement
Specification(s): contact_initial_adaptivity
Design: Constraints System
Issue(s): #6799
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.2The node-face discretization with a RANFS formulation for frictionless mechanical contact shall be susceptible to ping-ponging, specifically in this case to a secondary node oscillating back and forth between different primary faces
Specification(s): ranfs-ping-pong
Design: Constraints System
Issue(s): #10950
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 4.3.3The node-face discretization with a kinematic formulation for frictionless mechanical contact shall be susceptible to ping-ponging, specifically in this case to a secondary node oscillating back and forth between different primary faces
Specification(s): kinematic-ping-pong
Design: Constraints System
Issue(s): #10950
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 4.3.4A variational consistent mortar formulation with dual bases for frictionless mechanical contact shall not show any ping-ponging behavior
Specification(s): mortar-no-ping-pong_weighted
Design: Constraints System
Issue(s): #10950
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.5We will solve the frictionless bouncing block problem with nodal constraint enforcement, mortar application of forces, and min NCP function
Specification(s): frictionless-nodal-min-lm-mortar-disp-coarse
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.6We will solve the frictionless bouncing block problem with nodal constraint enforcement, mortar application of forces, and fb NCP function
Specification(s): frictionless-nodal-fb-lm-mortar-disp-coarse
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.7We will solve the frictionless bouncing block problem with nodal constraint enforcement, nodal application of forces, and min NCP function
Specification(s): frictionless-nodal-min-lm-nodal-disp-coarse
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.8We will solve the frictionless bouncing block problem with nodal constraint enforcement, nodal application of forces, and fb NCP function
Specification(s): frictionless-nodal-fb-lm-nodal-disp-coarse
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.9We will solve the frictionless bouncing block problem with mortar constraint enforcement, mortar application of forces, and min NCP function
Specification(s): frictionless-mortar-min-lm-mortar-disp-coarse
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.10We will solve the frictionless bouncing block problem with mortar constraint enforcement, mortar application of forces, and fb NCP function
Specification(s): frictionless-mortar-fb-lm-mortar-disp-coarse
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.11We will solve the frictional bouncing block problem with mortar constraint enforcement, mortar application of forces, and min NCP function
Specification(s): frictional-mortar-min-lm-mortar-disp-coarse
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.12We will solve the frictional bouncing block problem with mortar constraint enforcement, mortar application of forces, and fb NCP function
Specification(s): frictional-mortar-fb-lm-mortar-disp-coarse
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.13We will solve the frictional bouncing block problem with nodal constraint enforcement, mortar application of forces, and min NCP function
Specification(s): frictional-nodal-min-lm-mortar-disp-coarse
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.14We will solve the frictional bouncing block problem with nodal constraint enforcment for the normal LM using min NCP, mortar constraint enforcement of the tangential LM with fb, and mortar application of forces
Specification(s): frictional-nodal-min-normal-lm-mortar-fb-tangential-lm-mortar-disp-coarse
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.15The system shall be able to solve frictionless mechanical contact using a reduced active nonlinear function set scheme (RANFS) in conjunction with a node-face geometric discretization. The RANFS scheme shall be
- nonsingular both with bounds projection and
- without bounds projection and be
- solvable with amg both with bounds projection
- and without bounds projection.
- The system's RANFS scheme shall have a perfect Jacobian for mechanical contact that only has one non-zero normal component
- The system shall be able to detect when a secondary node is ping-ponging back and forth between different primary faces and consequently tie the locations of the secondary and corresponding primary node using Lagrange Multipliers corresponding to equality constraints, e.g. more RANFS
- The system shall be able to solve a smaller model of the full ping-ponging problem
Specification(s): reduced_active_set/ranfs-project-svd, reduced_active_set/ranfs-dont-project-svd, reduced_active_set/ranfs-project-amg, reduced_active_set/ranfs-dont-project-amg, reduced_active_set/ranfs-jacobian, reduced_active_set/full-bouncing-block, reduced_active_set/bouncing-block
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- 4.3.16Using a RANFS scheme with Lagrange multipliers corresponding to equality constraints the system shall be able to
- tie nodes together and
- have a perfect Jacobian
Specification(s): tied_node/physics, tied_node/jac
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterExodiff
- 4.3.17The system shall support a variationally consistent weighted gap implementation of the zero-penetration contact constraint
- using equal, first order bases for displacements and the lagrange multiplier
- using a second order basis for displacements and a first order basis for the lagrange multiplier
- using equal, first order bases for displacements and the lagrange multiplier with correct edge dropping
Specification(s): weighted_gap/equal_order, weighted_gap/mixed_order, weighted_gap/equal_order_edge_dropping
Design: Constraints System
Issue(s): #16961
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.18The system shall support a variationally consistent mortar frictional constraints with dual bases
- using verbose input file
- using the contact action
Specification(s): weighted_vel_pdass/verbose, weighted_vel_pdass/action
Design: Constraints System
Issue(s): #17495
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.19The system shall be able to solve a frictional, variationally consistent, mortar mechanical contact problem in which the secondary side of the contact interface is split between processes when run in parallel.
Specification(s): split_secondary
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.3.20The system shall not attempt to zero Lagrange multipliers that do not exist on inactive nodes.
Specification(s): mixed_inactive_nodes
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.12.1The system shall be able to apply automatic scaling in conjunection with kinematic contact constraint enforcement and show no penetration and exhibit good nonlinear convergence
Specification(s): auto-scaling
Design: Constraints System
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.12.2The system shall yield the same physical results when solving a kinematic contact problem with and without automatic scaling
Specification(s): no-scaling
Design: Constraints System
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.17.1The system shall be able to use automatic differentiation to compute a soft block bouncing on a soft plank problem on a first order 2D mesh using tensor mechanics and mortar contact
- using the small strain formulation.
- using the finite strain formulation.
- using the finite strain formulation with automatic scaling.
- using the finite strain formulation and reference residual.
- using the small strain formulation and calculate a perfect Jacobian.
- using the finite strain formulation and calculate a perfect Jacobian.
Specification(s): soft/small, soft/finite, soft/finite_scaling, soft/finite_rr, soft/small-jac, soft/finite-jac
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterCSVDiff
- 4.17.2The system shall be able to use automatic differntiation to compute a block bouncing on a plank problem on a first order 2D mesh using tensor mechanics and mortar contact and finite strain
- using with a stiff block and a stiff plank.
- using with a soft block and a stiff plank.
Specification(s): stiff/stiff_stiff, stiff/soft_stiff
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.17.3The system shall be able to use automatic differntiation to compute a soft block bouncing on a soft plank problem on a second order 2D mesh using tensor mechanics and mortar contact
- using the small strain formulation.
- using the finite strain formulation.
- using the finite strain formulation with automatic scaling.
- using the finite strain formulation and reference residual.
- using the small strain formulation and calculate a perfect Jacobian.
- using the finite strain formulation and calculate a perfect Jacobian.
Specification(s): soft/small, soft/finite, soft/finite_scaling, soft/finite_rr, soft/small-jac, soft/finite-jac
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterCSVDiff
- 4.17.4The system shall be able to use automatic differntiation to compute a block bouncing on a plank problem on a second order 2D mesh using tensor mechanics and mortar contact and finite strain
- using with a stiff block and a stiff plank.
- using with a soft block and a stiff plank.
Specification(s): stiff/stiff_stiff, stiff/soft_stiff
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.17.5The system shall be able to compute a soft block bouncing on a soft plank problem on a first order 2D mesh using tensor mechanics and mortar contact
- using the small strain formulation.
- using the finite strain formulation.
- using the finite strain formulation with automatic scaling.
- using the finite strain formulation and reference residual.
Specification(s): soft/small, soft/finite, soft/finite_scaling, soft/finite_rr
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.17.6The system shall be able to compute a block bouncing on a plank problem on a first order 2D mesh using tensor mechanics and mortar contact and finite strain
- using with a stiff block and a stiff plank.
- using with a soft block and a stiff plank.
Specification(s): stiff/stiff_stiff, stiff/soft_stiff
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.17.7The system shall be able to compute a soft block bouncing on a soft plank problem on a second order 2D mesh using tensor mechanics and mortar contact
- using the small strain formulation.
- using the finite strain formulation.
- using the finite strain formulation with automatic scaling.
- using the finite strain formulation and reference residual.
Specification(s): soft/small, soft/finite, soft/finite_scaling, soft/finite_rr
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.17.8The system shall be able to compute a block bouncing on a plank problem on a second order 2D mesh using tensor mechanics and mortar contact and finite strain
- using with a stiff block and a stiff plank.
- using with a soft block and a stiff plank.
Specification(s): stiff/stiff_stiff, stiff/soft_stiff
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.17.9The system shall be able to use automatic differntiation to compute a soft block bouncing on a soft plank problem on a first order 2DRz mesh using tensor mechanics and mortar contact
- using the small strain formulation.
- using the finite strain formulation.
- using the finite strain formulation with automatic scaling.
- using the finite strain formulation and reference residual.
- using the small strain formulation and calculate a perfect Jacobian.
- using the finite strain formulation and calculate a perfect Jacobian.
Specification(s): soft/small, soft/finite, soft/finite_scaling, soft/finite_rr, soft/small-jac, soft/finite-jac
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterCSVDiff
- 4.17.10The system shall be able to use automatic differntiation to compute a block bouncing on a plank problem on a first order 2DRz mesh using tensor mechanics and mortar contact and finite strain
- using with a stiff block and a stiff plank.
- using with a soft block and a stiff plank.
Specification(s): stiff/stiff_stiff, stiff/soft_stiff
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.17.11The system shall be able to use automatic differentiation to compute a soft block bouncing on a soft plank problem on a second order 2DRz mesh using tensor mechanics and mortar contact
- using the small strain formulation.
- using the finite strain formulation.
- using the finite strain formulation with automatic scaling.
- using the finite strain formulation and reference residual.
- using the small strain formulation and calculate a perfect Jacobian.
- using the finite strain formulation and calculate a perfect Jacobian.
Specification(s): soft/small, soft/finite, soft/finite_scaling, soft/finite_rr, soft/small-jac, soft/finite-jac
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): PetscJacobianTesterCSVDiff
- 4.17.12The system shall be able to use automatic differntiation to compute a block bouncing on a plank problem on a second order 2DRz mesh using tensor mechanics and mortar contact and finite strain
- using with a stiff block and a stiff plank.
- using with a soft block and a stiff plank.
Specification(s): stiff/stiff_stiff, stiff/soft_stiff
Design: Constraints System
Issue(s): #13080
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.17.13The system shall be able to compute a soft block bouncing on a soft plank problem on a first order 2DRz mesh using tensor mechanics and mortar contact
- using the small strain formulation.
- using the finite strain formulation.
- using the finite strain formulation with automatic scaling.
- using the finite strain formulation and reference residual.
Specification(s): soft/small, soft/finite, soft/finite_scaling, soft/finite_rr
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.17.14The system shall be able to compute a block bouncing on a plank problem on a first order 2DRz mesh using tensor mechanics and mortar contact and finite strain
- using with a stiff block and a stiff plank.
- using with a soft block and a stiff plank.
Specification(s): stiff/stiff_stiff, stiff/soft_stiff
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.17.15The system shall be able to compute a soft block bouncing on a soft plank problem on a second order 2DRz mesh using tensor mechanics and mortar contact
- using the small strain formulation.
- using the finite strain formulation.
- using the finite strain formulation with automatic scaling.
- using the finite strain formulation and reference residual.
Specification(s): soft/small, soft/finite, soft/finite_scaling, soft/finite_rr
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.17.16The system shall be able to compute a block bouncing on a plank problem on a second order 2DRz mesh using tensor mechanics and mortar contact and finite strain
- using with a stiff block and a stiff plank.
- using with a soft block and a stiff plank.
Specification(s): stiff/stiff_stiff, stiff/soft_stiff
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.25.1The system shall be able to apply automatic scaling in conjunction with ranfs contact
Specification(s): auto-scaling
Design: Constraints System
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.25.2The system shall be able to solve ranfs contact with no scaling
Specification(s): no-scaling
Design: Constraints System
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.27.5The system shall simulate correct contact behavior in 2D when two blocks with the same height come into contact using the dual basis
Specification(s): frictionless-compress-2d
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.27.6The system shall simulate correct contact behavior in 2D when two blocks with the same height come into contact using the standard (non-dual) basis
Specification(s): frictionless-compress-2d-nondual
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.27.7The system shall simulate correct contact behavior in 3D when two blocks with the same height come into contact using the dual basis
Specification(s): frictionless-compress-3d
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.27.8The system shall simulate correct contact behavior in 3D when two blocks with the same height come into contact using the standard (non-dual) basis
Specification(s): frictionless-compress-3d-nondual
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.28.1The system shall simulate correct contact behavior in 2D when the node from a secondary mortar element does not project to the primary surface using the dual basis
Specification(s): frictionless-slide-2d
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.28.2The system shall simulate correct contact behavior in 2D when the node from a secondary mortar element does not project to the primary surface using the standard (non-dual) basis
Specification(s): frictionless-slide-2d-nondual
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.28.3The system shall simulate correct contact behavior in 3D when the node from a secondary mortar element does not project to the primary surface
Specification(s): frictionless-slide-3d
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.28.4The system shall simulate correct contact behavior in 3D when the node from a secondary mortar element does not project to the primary surface using the standard (non-dual) basis
Specification(s): frictionless-slide-3d-nondual
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.28.5We shall be able to run our canonical frictional sliding block problem with lagrange multipliers and the mortar method
Specification(s): frictionless_lm
Design: Constraints System
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.29.1The system shall be able to apply automatic scaling in conjunection with tangential penalty contact constraint enforcement and show no penetration and exhibit good nonlinear convergence
Specification(s): auto-scaling
Design: Constraints System
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.29.2The system shall yield the same physical results when solving a tangential penalty contact problem with and without automatic scaling
Specification(s): no-scaling
Design: Constraints System
Issue(s): #12601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- contact: FEProblemBase
- 4.3.1The system shall use grid sequencing in order to improve the performance of the nonlinear solve in a frictional contact problem
Specification(s): grid_sequencing
Design: FEProblemBase
Collection(s): FUNCTIONAL
Type(s): Exodiff
- contact: Contact
- 4.4.1The contact system shall enforce three-dimensional block to block interaction using a penalty approach.
Specification(s): catch_release
Design: ContactMechanicalContactConstraint
Issue(s): #10906
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.8.1The contact system shall enforce 2D single-point contact with significant accumulated slip.
Specification(s): single_point_2d
Design: ContactMechanicalContactConstraint
Issue(s): #6524
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.8.2The contact system shall enforce 2D single-point contact with significant accumulated slip. With predictor solver options.
Specification(s): single_point_2d_predictor
Design: ContactMechanicalContactConstraint
Issue(s): #6524
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.8.3The contact system shall enforce 2D single-point contact with significant accumulated slip when formulation selected is tangential_penalty contact.
Specification(s): single_point_2d_tp
Design: ContactMechanicalContactConstraint
Issue(s): #6524
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.8.4The contact system shall enforce 2D line contact between quads with significant accumulated slip.
Specification(s): sliding_elastic_blocks_2d
Design: ContactMechanicalContactConstraint
Issue(s): #6524
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.8.5The contact system shall enforce 2D line contact between quads with significant accumulated slip, when formulation selected is tangential_penalty.
Specification(s): sliding_elastic_blocks_2d_tp
Design: ContactMechanicalContactConstraint
Issue(s): #6524
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.9.1The contact system shall enforce a glued contact constraint that ties together two blocks that are separated by an initial gap when the come in contact with each other so that the blocks move together.
Specification(s): glued_contact_mechanical_constraint
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.10.1The Contact system shall simulate Hertz contact between sphere and plane as a 2D axisymmetric problem with Quad4 elements.
Specification(s): hertz_contact_rz
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): RunApp
- 4.10.2The Contact system shall simulate Hertz contact between sphere and plane as a 2D axisymmetric problem with Quad8 elements.
Specification(s): hertz_contact_rz_quad8
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): RunApp
- 4.10.3The Contact system shall simulate Hertz contact between sphere and plane as a 3D problem with Hex8 elements.
Specification(s): hertz_contact
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): RunApp
- 4.10.4The Contact system shall simulate Hertz contact between sphere and plane as a 3D problem with Hex27 elements.
Specification(s): hertz_contact_hex27
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): RunApp
- 4.13.1The contact system shall enforce a frictionless mechanical contact condition between two blocks with a combination of normal and tangential motion using a kinematic enforcement with the Constraint system.
Specification(s): frictionless_kinematic
Design: ContactMechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.13.2The contact system shall enforce a frictionless mechanical contact condition between two blocks with gap offsets on both primary and secondary blocks using a kinematic enforcement with the DiracKernel system.
Specification(s): frictionless_kinematic_gap_offset
Design: ContactMechanicalContactConstraint
Issue(s): #14089
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.13.3The contact system shall enforce a frictionless mechanical contact condition between two blocks with a combination of normal and tangential motion using a penalty enforcement with the Constraint system.
Specification(s): frictionless_penalty
Design: ContactMechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.13.4The contact system shall enforce a glued mechanical contact condition between two blocks with a combination of normal and tangential motion using a kinematic enforcement with the Constraint system.
Specification(s): glued_kinematic
Design: ContactMechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.13.5The contact system shall enforce a glued mechanical contact condition between two blocks with a combination of normal and tangential motion using a penalty enforcement with the Constraint system.
Specification(s): glued_penalty
Design: ContactMechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.17.17
Specification(s): horizontal_blocks_mortar_TM
Design: ContactMechanicalContactConstraint
Issue(s): #14630
Collection(s): FUNCTIONAL
Type(s): RunApp
- 4.18.1Contact module action shall allow for multiple contact pairs when selecting node-face formulation.
Specification(s): multiple_pairs
Design: ContactMechanicalContactConstraint
Issue(s): #18022
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.1The system shall compute the nodal area for use with contact calculations in 3D.
Specification(s): 3D
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.2The system shall compute the nodal area in parallel for use with contact calculations in 3D.
Specification(s): 3D2Proc
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.3The system shall compute the nodal area for use with contact calculations in 2D.
Specification(s): 2D
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.4The system shall compute the nodal area in parallel for use with contact calculations in 2D.
Specification(s): 2D2Proc
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.5The system shall compute the nodal area for Hex20 elements for use with contact calculations.
Specification(s): Hex20
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.6The system shall compute the nodal area for Hex20 elements for use with frictionless contact calculations.
Specification(s): Hex20_2
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.7The system shall compute the nodal area for Hex20 elements for use with penalty contact calculations.
Specification(s): Hex20_3
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.8The system shall compute the nodal area in parallel for Hex20 elements for use with contact calculations.
Specification(s): Hex202Proc
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.9The system shall compute the nodal area for Hex27 elements for use with contact calculations.
Specification(s): Hex27
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.10The system shall compute the nodal area in parallel for Hex27 elements for use with contact calculations.
Specification(s): Hex272Proc
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.22.1The contact system shall yield repeatable results for 2D contact with elements of various aspect ratios. Penalty contact.
Specification(s): normalized_penalty
Design: ContactMechanicalContactConstraint
Issue(s): #3532
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.22.2The contact system shall yield repeatable results for 2D contact with Q8 elements of various aspect ratios. Penalty contact.
Specification(s): normalized_penalty_Q8
Design: ContactMechanicalContactConstraint
Issue(s): #3532
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.22.3The contact system shall yield repeatable results for 2D contact with elements of various aspect ratios. Kinematic contact.
Specification(s): normalized_penalty_kin
Design: ContactMechanicalContactConstraint
Issue(s): #3532
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.22.4The contact system shall yield repeatable results for 2D contact with Q8 elements of various aspect ratios. Kinematic contact.
Specification(s): normalized_penalty_kin_Q8
Design: ContactMechanicalContactConstraint
Issue(s): #3532
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.24.1The contact system shall reproduce contact pressure results among various formulation types. Augmented Lagrangian formulation.
Specification(s): pressureAugLag
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.24.2The contact system shall reproduce contact pressure results among various formulation types. Penalty.
Specification(s): pressurePenalty
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.24.3The contact system shall reproduce contact pressure results among various formulation types. Mechanical constraint.
Specification(s): pressurePenalty_mechanical_constraint
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.26.1The contact system shall enforce contact between three-dimensional non-conformal surfaces with Hex20 elements.
Specification(s): ring_contact
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.27.1
Specification(s): simple_contact_test
Design: ContactMechanicalContactConstraint
Issue(s): #3958
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.27.2
Specification(s): simple_contact_test2
Design: ContactMechanicalContactConstraint
Issue(s): #3958
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.27.3
Specification(s): simple_contact_rz_test
Design: ContactMechanicalContactConstraint
Issue(s): #3958
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.27.4
Specification(s): simple_contact_rspherical
Design: ContactMechanicalContactConstraint
Issue(s): #3958
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.30.1The contact system shall enforce and release contact conditions. 4 elements.
Specification(s): 4ElemTensionRelease
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.30.2The contact system shall enforce and release contact conditions. 4 elements and mechanical constraints.
Specification(s): 4ElemTensionRelease_mechanical_constraint
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.30.3The contact system shall enforce and release contact conditions. 4 elements and ensure no new Jacobian allocations.
Specification(s): 4ElemTensionRelease_no_new_nonzeros
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.30.4The contact system shall enforce and release contact conditions. 8 elements.
Specification(s): 8ElemTensionRelease
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.31.1The Contact system shall enforce glued, kinematic contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.2The Contact system shall enforce glued, penalty contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.3The Contact system shall enforce frictionless, kinematic contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.4The Contact system shall enforce frictionless, penalty contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.5The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.6The Contact system shall enforce frictional, penalty contact for 2D Hertz half-symmetry cylindrical contact problem with friction coefficient of 0.
Specification(s): mu_0_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.7The Contact system shall enforce frictional, penalty contact for 2D Hertz half-symmetry cylindrical contact problem with friction coefficient of 0.2.
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.8The Contact system shall enforce frictional, penalty contact for 2D Hertz half-symmetry cylindrical contact problem with friction coefficient of 1.0.
Specification(s): mu_1_0_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.9The Contact system shall enforce frictional, Augmented Lagrange contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.10The Contact system shall enforce glued, kinematic contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.11The Contact system shall enforce glued, penalty contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.12The Contact system shall enforce frictionless, kinematic contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.13The Contact system shall enforce frictionless, penalty contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.14The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.15The Contact system shall enforce frictional, penalty contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements and with a friction coefficient of 0.
Specification(s): mu_0_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.16The Contact system shall enforce frictional, penalty contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements and with a friction coefficient of 1.0.
Specification(s): mu_1_0_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.17The Contact system shall enforce frictional, Augmented Lagrange contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.18The Contact system shall enforce glued, kinematic contact for 2D Hertz quarter-symmetry cylindrical contact problem.
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.19The Contact system shall enforce glued, penalty contact for 2D Hertz quarter-symmetry cylindrical contact problem.
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.20The Contact system shall enforce frictionless, kinematic contact for 2D Hertz quarter-symmetry cylindrical contact problem.
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.21The Contact system shall enforce frictionless, penalty contact for 2D Hertz quarter-symmetry cylindrical contact problem.
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.22The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D Hertz quarter-symmetry cylindrical contact problem.
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.23The Contact system shall enforce glued, kinematic contact for 2D Hertz quarter-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.24The Contact system shall enforce glued, penalty contact for 2D Hertz quarter-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.25The Contact system shall enforce frictionless, kinematic contact for 2D Hertz quarter-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.26The Contact system shall enforce frictionless, penalty contact for 2D Hertz quarter-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.27The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D Hertz quarter-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.28The Contact system shall enforce eliminating initial overclosure between the primary and secondary surfaces.
Specification(s): test
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.31.29The Contact system shall enforce the automatic patch update using the iteration option.
Specification(s): sliding_blocks
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.31.30The Contact system shall enforce that the nearest neighbor node is inside the ghosted set of elements.
Specification(s): error_test
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 4.31.31The Contact system shall enforce glued, kinematic contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.32The Contact system shall enforce glued, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.33The Contact system shall enforce frictionless, kinematic contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.34The Contact system shall enforce frictionless, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.35The Contact system shall enforce frictionless, Augmented Lagrange contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.36The Contact system shall enforce frictional, Augmented Lagrange contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.37The Contact system shall enforce frictional, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.38The Contact system shall enforce glued, kinematic contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.39The Contact system shall enforce glued, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.40The Contact system shall enforce frictionless, kinematic contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.41The Contact system shall enforce frictionless, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.42The Contact system shall enforce frictionless, Augmented Lagrange contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.43The Contact system shall enforce frictional, Augmented Lagrange contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.44The Contact system shall enforce frictional, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.45The Contact system shall enforce frictionless, kinematic contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.46The Contact system shall enforce frictionless, penalty contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.47The Contact system shall enforce frictionless, Augmented Lagrange contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.48The Contact system shall enforce frictional, Augmented Lagrange contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.49The Contact system shall enforce frictional, penalty contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.50The Contact system shall enforce glued, kinematic contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.51The Contact system shall enforce glued, penalty contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.52The Contact system shall enforce frictionless, kinematic contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.53The Contact system shall enforce frictionless, penalty contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.54The Contact system shall enforce frictionless, Augmented Lagrange contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.55The Contact system shall enforce frictional, Augmented Lagrange contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.56The Contact system shall enforce frictional, penalty contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.57The Contact system shall enforce glued, kinematic contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.58The Contact system shall enforce glued, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.59The Contact system shall enforce frictionless, kinematic contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.60The Contact system shall enforce frictionless, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.61The Contact system shall enforce frictionless, penalty Augmented Lagrange contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.62The Contact system shall enforce frictional, Augmented Lagrange contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.63The Contact system shall enforce frictional, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.64The Contact system shall enforce glued, kinematic contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.65The Contact system shall enforce glued, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.66The Contact system shall enforce frictionless, kinematic contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.67The Contact system shall enforce frictionless, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.68The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.69The Contact system shall enforce frictional, Augmented Lagrange contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.70The Contact system shall enforce frictional, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.71The Contact system shall enforce glued, kinematic contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.72The Contact system shall enforce glued, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.73The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.74The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.75The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.76The Contact system shall enforce frictional, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.77The Contact system shall enforce glued, kinematic contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.78The Contact system shall enforce glued, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.79The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.80The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.81The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.82The Contact system shall enforce frictional, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.83The Contact system shall enforce glued, kinematic contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.84The Contact system shall enforce glued, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.85The Contact system shall enforce frictionless, kinematic contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.86The Contact system shall enforce frictionless, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.87The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.88The Contact system shall enforce frictional, Augmented Lagrange contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.89The Contact system shall enforce frictional, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.90The Contact system shall enforce glued, kinematic contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.91The Contact system shall enforce glued, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.92The Contact system shall enforce frictionless, kinematic contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.93The Contact system shall enforce frictionless, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.94The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.95The Contact system shall enforce frictional, Augmented Lagrange contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.96The Contact system shall enforce frictional, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.97The Contact system shall enforce glued, kinematic contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.98The Contact system shall enforce glued, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.99The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.100The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.101The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.102The Contact system shall enforce frictional, Augmented Lagrange contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.103The Contact system shall enforce frictional, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.104The Contact system shall enforce glued, kinematic contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.105The Contact system shall enforce glued, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.106The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.107The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.108The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.109The Contact system shall enforce frictional, Augmented Lagrange contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.110The Contact system shall enforce frictional, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.111The Contact system shall enforce glued, kinematic contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.112The Contact system shall enforce glued, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.113The Contact system shall enforce frctionless, kinematic contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.114The Contact system shall enforce frctionless, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.115The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.116The Contact system shall enforce frictional, Augmented Lagrange contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.117The Contact system shall enforce frictional, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.118The Contact system shall enforce glued, kinematic contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.119The Contact system shall enforce glued, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.120The Contact system shall enforce frictionless, kinematic contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.121The Contact system shall enforce frictionless, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.122The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.123The Contact system shall enforce frictional, Augmented Lagrange contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.124The Contact system shall enforce frictional, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.125The Contact system shall enforce glued, kinematic contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.126The Contact system shall enforce glued, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.127The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.128The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.129The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.130The Contact system shall enforce frictional, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.131The Contact system shall enforce glued, kinematic contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.132The Contact system shall enforce glued, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.133The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.134The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.135The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.136The Contact system shall enforce frictional, Augmented Lagrange contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.137The Contact system shall enforce frictional, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.138The Contact system shall enforce glued, kinematic contact for 2D plane strain single point contact model.
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.139The Contact system shall enforce glued, penalty contact for 2D plane strain single point contact model.
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.140The Contact system shall enforce frictionless, kinematic contact for 2D plane strain single point contact model.
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.141The Contact system shall enforce frictionless, penalty contact for 2D plane strain single point contact model.
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.142The Contact system shall enforce frictionless, penalty contact for 2D plane strain single point contact model using the contact line search solver options.
Specification(s): frictionless_pen_contact_line_search
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.143The Contact system shall enforce frictional, kinematic contact for 2D plane strain single point contact model.
Specification(s): mu_0_0_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.144The Contact system shall enforce frictional, penalty contact for 2D plane strain single point contact model.
Specification(s): mu_0_0_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.145The Contact system shall enforce frictional, kinematic contact for 2D plane strain single point contact model with a non-zero friction coefficient.
Specification(s): mu_0_2_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.146The Contact system shall enforce frictional, penalty contact for 2D plane strain single point contact model with a non-zero friction coefficient.
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- contact: MechanicalContactConstraint
- 4.4.1The contact system shall enforce three-dimensional block to block interaction using a penalty approach.
Specification(s): catch_release
Design: ContactMechanicalContactConstraint
Issue(s): #10906
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.8.1The contact system shall enforce 2D single-point contact with significant accumulated slip.
Specification(s): single_point_2d
Design: ContactMechanicalContactConstraint
Issue(s): #6524
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.8.2The contact system shall enforce 2D single-point contact with significant accumulated slip. With predictor solver options.
Specification(s): single_point_2d_predictor
Design: ContactMechanicalContactConstraint
Issue(s): #6524
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.8.3The contact system shall enforce 2D single-point contact with significant accumulated slip when formulation selected is tangential_penalty contact.
Specification(s): single_point_2d_tp
Design: ContactMechanicalContactConstraint
Issue(s): #6524
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.8.4The contact system shall enforce 2D line contact between quads with significant accumulated slip.
Specification(s): sliding_elastic_blocks_2d
Design: ContactMechanicalContactConstraint
Issue(s): #6524
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.8.5The contact system shall enforce 2D line contact between quads with significant accumulated slip, when formulation selected is tangential_penalty.
Specification(s): sliding_elastic_blocks_2d_tp
Design: ContactMechanicalContactConstraint
Issue(s): #6524
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.9.1The contact system shall enforce a glued contact constraint that ties together two blocks that are separated by an initial gap when the come in contact with each other so that the blocks move together.
Specification(s): glued_contact_mechanical_constraint
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.10.1The Contact system shall simulate Hertz contact between sphere and plane as a 2D axisymmetric problem with Quad4 elements.
Specification(s): hertz_contact_rz
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): RunApp
- 4.10.2The Contact system shall simulate Hertz contact between sphere and plane as a 2D axisymmetric problem with Quad8 elements.
Specification(s): hertz_contact_rz_quad8
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): RunApp
- 4.10.3The Contact system shall simulate Hertz contact between sphere and plane as a 3D problem with Hex8 elements.
Specification(s): hertz_contact
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): RunApp
- 4.10.4The Contact system shall simulate Hertz contact between sphere and plane as a 3D problem with Hex27 elements.
Specification(s): hertz_contact_hex27
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): RunApp
- 4.13.1The contact system shall enforce a frictionless mechanical contact condition between two blocks with a combination of normal and tangential motion using a kinematic enforcement with the Constraint system.
Specification(s): frictionless_kinematic
Design: ContactMechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.13.2The contact system shall enforce a frictionless mechanical contact condition between two blocks with gap offsets on both primary and secondary blocks using a kinematic enforcement with the DiracKernel system.
Specification(s): frictionless_kinematic_gap_offset
Design: ContactMechanicalContactConstraint
Issue(s): #14089
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.13.3The contact system shall enforce a frictionless mechanical contact condition between two blocks with a combination of normal and tangential motion using a penalty enforcement with the Constraint system.
Specification(s): frictionless_penalty
Design: ContactMechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.13.4The contact system shall enforce a glued mechanical contact condition between two blocks with a combination of normal and tangential motion using a kinematic enforcement with the Constraint system.
Specification(s): glued_kinematic
Design: ContactMechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.13.5The contact system shall enforce a glued mechanical contact condition between two blocks with a combination of normal and tangential motion using a penalty enforcement with the Constraint system.
Specification(s): glued_penalty
Design: ContactMechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.17.17
Specification(s): horizontal_blocks_mortar_TM
Design: ContactMechanicalContactConstraint
Issue(s): #14630
Collection(s): FUNCTIONAL
Type(s): RunApp
- 4.18.1Contact module action shall allow for multiple contact pairs when selecting node-face formulation.
Specification(s): multiple_pairs
Design: ContactMechanicalContactConstraint
Issue(s): #18022
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.22.1The contact system shall yield repeatable results for 2D contact with elements of various aspect ratios. Penalty contact.
Specification(s): normalized_penalty
Design: ContactMechanicalContactConstraint
Issue(s): #3532
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.22.2The contact system shall yield repeatable results for 2D contact with Q8 elements of various aspect ratios. Penalty contact.
Specification(s): normalized_penalty_Q8
Design: ContactMechanicalContactConstraint
Issue(s): #3532
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.22.3The contact system shall yield repeatable results for 2D contact with elements of various aspect ratios. Kinematic contact.
Specification(s): normalized_penalty_kin
Design: ContactMechanicalContactConstraint
Issue(s): #3532
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.22.4The contact system shall yield repeatable results for 2D contact with Q8 elements of various aspect ratios. Kinematic contact.
Specification(s): normalized_penalty_kin_Q8
Design: ContactMechanicalContactConstraint
Issue(s): #3532
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.24.1The contact system shall reproduce contact pressure results among various formulation types. Augmented Lagrangian formulation.
Specification(s): pressureAugLag
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.24.2The contact system shall reproduce contact pressure results among various formulation types. Penalty.
Specification(s): pressurePenalty
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.24.3The contact system shall reproduce contact pressure results among various formulation types. Mechanical constraint.
Specification(s): pressurePenalty_mechanical_constraint
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.26.1The contact system shall enforce contact between three-dimensional non-conformal surfaces with Hex20 elements.
Specification(s): ring_contact
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.27.1
Specification(s): simple_contact_test
Design: ContactMechanicalContactConstraint
Issue(s): #3958
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.27.2
Specification(s): simple_contact_test2
Design: ContactMechanicalContactConstraint
Issue(s): #3958
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.27.3
Specification(s): simple_contact_rz_test
Design: ContactMechanicalContactConstraint
Issue(s): #3958
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.27.4
Specification(s): simple_contact_rspherical
Design: ContactMechanicalContactConstraint
Issue(s): #3958
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.28.6We shall be able to solve the Coulomb friction sliding block problem using the penalty method and a friction coefficient of .2
Specification(s): frictional_02_penalty
Design: MechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.28.7We shall be able to solve the Coulomb friction sliding block problem using the penalty method and a friction coefficient of .4
Specification(s): frictional_04_penalty
Design: MechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.28.8We shall be able to solve the frictionless sliding block problem using a kinematic constraint formulation.
Specification(s): frictionless_kinematic
Design: MechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.28.9Kinematic contact shall produce the same results regardless of whether variable scaling is used or not
Specification(s): frictionless_kinematic_scaling
Design: MechanicalContactConstraint
Issue(s): #11601
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.28.10We shall be able to solve the frictionless sliding block problem using a penalty constraint formulation.
Specification(s): frictionless_penalty
Design: MechanicalContactConstraint
Issue(s): #2816
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.30.1The contact system shall enforce and release contact conditions. 4 elements.
Specification(s): 4ElemTensionRelease
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.30.2The contact system shall enforce and release contact conditions. 4 elements and mechanical constraints.
Specification(s): 4ElemTensionRelease_mechanical_constraint
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.30.3The contact system shall enforce and release contact conditions. 4 elements and ensure no new Jacobian allocations.
Specification(s): 4ElemTensionRelease_no_new_nonzeros
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.30.4The contact system shall enforce and release contact conditions. 8 elements.
Specification(s): 8ElemTensionRelease
Design: ContactMechanicalContactConstraint
Issue(s): #3418
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.31.1The Contact system shall enforce glued, kinematic contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.2The Contact system shall enforce glued, penalty contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.3The Contact system shall enforce frictionless, kinematic contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.4The Contact system shall enforce frictionless, penalty contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.5The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.6The Contact system shall enforce frictional, penalty contact for 2D Hertz half-symmetry cylindrical contact problem with friction coefficient of 0.
Specification(s): mu_0_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.7The Contact system shall enforce frictional, penalty contact for 2D Hertz half-symmetry cylindrical contact problem with friction coefficient of 0.2.
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.8The Contact system shall enforce frictional, penalty contact for 2D Hertz half-symmetry cylindrical contact problem with friction coefficient of 1.0.
Specification(s): mu_1_0_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.9The Contact system shall enforce frictional, Augmented Lagrange contact for 2D Hertz half-symmetry cylindrical contact problem.
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.10The Contact system shall enforce glued, kinematic contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.11The Contact system shall enforce glued, penalty contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.12The Contact system shall enforce frictionless, kinematic contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.13The Contact system shall enforce frictionless, penalty contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.14The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.15The Contact system shall enforce frictional, penalty contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements and with a friction coefficient of 0.
Specification(s): mu_0_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.16The Contact system shall enforce frictional, penalty contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements and with a friction coefficient of 1.0.
Specification(s): mu_1_0_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.17The Contact system shall enforce frictional, Augmented Lagrange contact for 2D Hertz half-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.18The Contact system shall enforce glued, kinematic contact for 2D Hertz quarter-symmetry cylindrical contact problem.
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.19The Contact system shall enforce glued, penalty contact for 2D Hertz quarter-symmetry cylindrical contact problem.
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.20The Contact system shall enforce frictionless, kinematic contact for 2D Hertz quarter-symmetry cylindrical contact problem.
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.21The Contact system shall enforce frictionless, penalty contact for 2D Hertz quarter-symmetry cylindrical contact problem.
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.22The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D Hertz quarter-symmetry cylindrical contact problem.
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.23The Contact system shall enforce glued, kinematic contact for 2D Hertz quarter-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.24The Contact system shall enforce glued, penalty contact for 2D Hertz quarter-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.25The Contact system shall enforce frictionless, kinematic contact for 2D Hertz quarter-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.26The Contact system shall enforce frictionless, penalty contact for 2D Hertz quarter-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.27The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D Hertz quarter-symmetry cylindrical contact problem using higher order QUAD8 elements.
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.28The Contact system shall enforce eliminating initial overclosure between the primary and secondary surfaces.
Specification(s): test
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.31.29The Contact system shall enforce the automatic patch update using the iteration option.
Specification(s): sliding_blocks
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.31.30The Contact system shall enforce that the nearest neighbor node is inside the ghosted set of elements.
Specification(s): error_test
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 4.31.31The Contact system shall enforce glued, kinematic contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.32The Contact system shall enforce glued, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.33The Contact system shall enforce frictionless, kinematic contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.34The Contact system shall enforce frictionless, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.35The Contact system shall enforce frictionless, Augmented Lagrange contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.36The Contact system shall enforce frictional, Augmented Lagrange contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.37The Contact system shall enforce frictional, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.38The Contact system shall enforce glued, kinematic contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.39The Contact system shall enforce glued, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.40The Contact system shall enforce frictionless, kinematic contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.41The Contact system shall enforce frictionless, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.42The Contact system shall enforce frictionless, Augmented Lagrange contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.43The Contact system shall enforce frictional, Augmented Lagrange contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.44The Contact system shall enforce frictional, penalty contact for 3D brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.45The Contact system shall enforce frictionless, kinematic contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.46The Contact system shall enforce frictionless, penalty contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.47The Contact system shall enforce frictionless, Augmented Lagrange contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.48The Contact system shall enforce frictional, Augmented Lagrange contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.49The Contact system shall enforce frictional, penalty contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.50The Contact system shall enforce glued, kinematic contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.51The Contact system shall enforce glued, penalty contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.52The Contact system shall enforce frictionless, kinematic contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.53The Contact system shall enforce frictionless, penalty contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.54The Contact system shall enforce frictionless, Augmented Lagrange contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.55The Contact system shall enforce frictional, Augmented Lagrange contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.56The Contact system shall enforce frictional, penalty contact for 3D HEX20 brick geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.57The Contact system shall enforce glued, kinematic contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.58The Contact system shall enforce glued, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.59The Contact system shall enforce frictionless, kinematic contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.60The Contact system shall enforce frictionless, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.61The Contact system shall enforce frictionless, penalty Augmented Lagrange contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.62The Contact system shall enforce frictional, Augmented Lagrange contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.63The Contact system shall enforce frictional, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.64The Contact system shall enforce glued, kinematic contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.65The Contact system shall enforce glued, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.66The Contact system shall enforce frictionless, kinematic contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.67The Contact system shall enforce frictionless, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.68The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.69The Contact system shall enforce frictional, Augmented Lagrange contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.70The Contact system shall enforce frictional, penalty contact for 2D axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.71The Contact system shall enforce glued, kinematic contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.72The Contact system shall enforce glued, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.73The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.74The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.75The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.76The Contact system shall enforce frictional, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.77The Contact system shall enforce glued, kinematic contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.78The Contact system shall enforce glued, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.79The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.80The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.81The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.82The Contact system shall enforce frictional, penalty contact for 2D QUAD8 axisymmetric geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.83The Contact system shall enforce glued, kinematic contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.84The Contact system shall enforce glued, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.85The Contact system shall enforce frictionless, kinematic contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.86The Contact system shall enforce frictionless, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.87The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.88The Contact system shall enforce frictional, Augmented Lagrange contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.89The Contact system shall enforce frictional, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.90The Contact system shall enforce glued, kinematic contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.91The Contact system shall enforce glued, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.92The Contact system shall enforce frictionless, kinematic contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.93The Contact system shall enforce frictionless, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.94The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.95The Contact system shall enforce frictional, Augmented Lagrange contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.96The Contact system shall enforce frictional, penalty contact for 2D plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.97The Contact system shall enforce glued, kinematic contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.98The Contact system shall enforce glued, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.99The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.100The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.101The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.102The Contact system shall enforce frictional, Augmented Lagrange contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.103The Contact system shall enforce frictional, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.104The Contact system shall enforce glued, kinematic contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.105The Contact system shall enforce glued, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.106The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.107The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.108The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.109The Contact system shall enforce frictional, Augmented Lagrange contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.110The Contact system shall enforce frictional, penalty contact for 2D QUAD8 plane geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.111The Contact system shall enforce glued, kinematic contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.112The Contact system shall enforce glued, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.113The Contact system shall enforce frctionless, kinematic contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.114The Contact system shall enforce frctionless, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.115The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.116The Contact system shall enforce frictional, Augmented Lagrange contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.117The Contact system shall enforce frictional, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.118The Contact system shall enforce glued, kinematic contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.119The Contact system shall enforce glued, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.120The Contact system shall enforce frictionless, kinematic contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.121The Contact system shall enforce frictionless, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.122The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.123The Contact system shall enforce frictional, Augmented Lagrange contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.124The Contact system shall enforce frictional, penalty contact for 2D axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.125The Contact system shall enforce glued, kinematic contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.126The Contact system shall enforce glued, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.127The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.128The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.129The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.130The Contact system shall enforce frictional, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with matched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.131The Contact system shall enforce glued, kinematic contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.132The Contact system shall enforce glued, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.133The Contact system shall enforce frictionless, kinematic contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.134The Contact system shall enforce frictionless, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.135The Contact system shall enforce frictionless, Augmented Lagrange contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): frictionless_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.136The Contact system shall enforce frictional, Augmented Lagrange contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_aug
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.137The Contact system shall enforce frictional, penalty contact for 2D QUAD8 axisymmetric ring geometry (NAFEMS CGS1 contact patch test with mismatched nodes).
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.138The Contact system shall enforce glued, kinematic contact for 2D plane strain single point contact model.
Specification(s): glued_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.139The Contact system shall enforce glued, penalty contact for 2D plane strain single point contact model.
Specification(s): glued_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.140The Contact system shall enforce frictionless, kinematic contact for 2D plane strain single point contact model.
Specification(s): frictionless_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.141The Contact system shall enforce frictionless, penalty contact for 2D plane strain single point contact model.
Specification(s): frictionless_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.142The Contact system shall enforce frictionless, penalty contact for 2D plane strain single point contact model using the contact line search solver options.
Specification(s): frictionless_pen_contact_line_search
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.143The Contact system shall enforce frictional, kinematic contact for 2D plane strain single point contact model.
Specification(s): mu_0_0_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.144The Contact system shall enforce frictional, penalty contact for 2D plane strain single point contact model.
Specification(s): mu_0_0_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.145The Contact system shall enforce frictional, kinematic contact for 2D plane strain single point contact model with a non-zero friction coefficient.
Specification(s): mu_0_2_kin
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.31.146The Contact system shall enforce frictional, penalty contact for 2D plane strain single point contact model with a non-zero friction coefficient.
Specification(s): mu_0_2_pen
Design: ContactMechanicalContactConstraint
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- contact: Contact Module
- 4.5.1
Specification(s): contact_displacements
Design: Contact Module
Issue(s): #2816
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 4.21.1The system shall provide an option for extending primary surfaces when doing mortar contact to ensure that secondary nodes which project near the edge of the primary surface are registered with the near-surface.
Specification(s): exo
Design: Contact Module
Issue(s): #10950
Collection(s): FUNCTIONAL
Type(s): Exodiff
- contact: Contact Action
- 4.6.1The system shall converge and match the solution produced by standard mortar contact.
Specification(s): dm_contact
Design: Contact ActionVCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.6.2The system shall converge and match the solution produced by dual mortar contact.
Specification(s): std_contact
Design: Contact ActionVCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.6.3The system shall converge and match the solution with the standard methods using variable condenstation with AMG.
Specification(s): dm_contact_precon
Design: Contact ActionVCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.6.4The system shall converge and match the solution with the standard methods using variable condenstation with AMG, by always condensing out the LMs.
Specification(s): dm_contact_precon_no_adaptivity
Design: Contact ActionVCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.6.5The system shall converge and match the solution with the standard methods using variable condenstation with AMG, by using LU to solve for the LM variable (not assuming diagonal coupling with the primal variable).
Specification(s): dm_contact_precon_full_dinv
Design: Contact ActionVCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.28.12The system shall support mechanics frictional contact problems
Specification(s): frictional_mu02_penalty
Design: Contact Action
Issue(s): #12527
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.28.13The system shall support mechanics frictional contact problems
Specification(s): frictional_mu04_penalty
Design: Contact Action
Issue(s): #12527
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.28.14The system shall support mechanics frictionless contact problems
Specification(s): frictionless_kinematic
Design: Contact Action
Issue(s): #12527
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.28.15The system shall support mechanics frictionless contact problems
Specification(s): frictionless_penalty
Design: Contact Action
Issue(s): #12527
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.28.16The system shall support mechanics frictionless contact problems
Specification(s): frictionless_aug
Design: Contact Action
Issue(s): #12527
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.28.17The system shall support mechanics frictional contact problems
Specification(s): frictional_mu02_aug
Design: Contact Action
Issue(s): #12527
Collection(s): FUNCTIONAL
Type(s): Exodiff
- contact: VCP
- 4.6.1The system shall converge and match the solution produced by standard mortar contact.
Specification(s): dm_contact
Design: Contact ActionVCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.6.2The system shall converge and match the solution produced by dual mortar contact.
Specification(s): std_contact
Design: Contact ActionVCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.6.3The system shall converge and match the solution with the standard methods using variable condenstation with AMG.
Specification(s): dm_contact_precon
Design: Contact ActionVCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.6.4The system shall converge and match the solution with the standard methods using variable condenstation with AMG, by always condensing out the LMs.
Specification(s): dm_contact_precon_no_adaptivity
Design: Contact ActionVCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.6.5The system shall converge and match the solution with the standard methods using variable condenstation with AMG, by using LU to solve for the LM variable (not assuming diagonal coupling with the primal variable).
Specification(s): dm_contact_precon_full_dinv
Design: Contact ActionVCP
Issue(s): #15215
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- contact: FSP
- 4.7.1The system shall allow for split preconditioning based on contact surfaces.
Specification(s): 2block-3D
Design: FSPNormalNodalLMMechanicalContactTangentialMortarLMMechanicalContact
Collection(s): FUNCTIONAL
Type(s): Exodiff
- contact: NormalNodalLMMechanicalContact
- 4.7.1The system shall allow for split preconditioning based on contact surfaces.
Specification(s): 2block-3D
Design: FSPNormalNodalLMMechanicalContactTangentialMortarLMMechanicalContact
Collection(s): FUNCTIONAL
Type(s): Exodiff
- contact: TangentialMortarLMMechanicalContact
- 4.7.1The system shall allow for split preconditioning based on contact surfaces.
Specification(s): 2block-3D
Design: FSPNormalNodalLMMechanicalContactTangentialMortarLMMechanicalContact
Collection(s): FUNCTIONAL
Type(s): Exodiff
- contact: ComputeDynamicFrictionalForceLMMechanicalContact
- 4.14.1Contact module shall compute nodal weighted gap distance velocity values via a mortar auxiliary kernel.
Specification(s): block-dynamics-aux-vel
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.14.1Contact module shall compute nodal weighted gap distance velocity values via a mortar auxiliary kernel.
Specification(s): block-dynamics-aux-vel
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.14.2Contact module shall compute nodal wear depth values in accordance with Archard equation via a mortar auxiliary kernel.
Specification(s): block-dynamics-aux-wear
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.14.2Contact module shall compute nodal wear depth values in accordance with Archard equation via a mortar auxiliary kernel.
Specification(s): block-dynamics-aux-wear
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.14.3Contact module shall compute nodal wear depth values in accordance with Archard equation and the mortar gap velocity via mortar auxiliary kernels in the same input file.
Specification(s): block-dynamics-aux-wear-vel
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.14.3Contact module shall compute nodal wear depth values in accordance with Archard equation and the mortar gap velocity via mortar auxiliary kernels in the same input file.
Specification(s): block-dynamics-aux-wear-vel
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.14.4Contact module shall compute nodal frictional status of mortar surfaces for a simple problem in which nodes are in stick and slip states.
Specification(s): frictional-mortar-3d-status
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.14.4Contact module shall compute nodal frictional status of mortar surfaces for a simple problem in which nodes are in stick and slip states.
Specification(s): frictional-mortar-3d-status
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.14.5Contact module shall generate an informative error if the nodal frictional status auxiliary kernel is not provided a second frictional Lagrange multiplier for a three-dimensional problem.
Specification(s): frictional-mortar-3d-status-error
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 4.14.5Contact module shall generate an informative error if the nodal frictional status auxiliary kernel is not provided a second frictional Lagrange multiplier for a three-dimensional problem.
Specification(s): frictional-mortar-3d-status-error
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 4.14.6Contact module shall compute nodal wear depth values in accordance with Archard equation and the mortar gap velocity via mortar auxiliary kernels while including these computations in the definition of mortar normal contact constraints in an asymmetric problem for a short simulation.
Specification(s): block-dynamics-aux-fretting-wear-test-quick
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.14.6Contact module shall compute nodal wear depth values in accordance with Archard equation and the mortar gap velocity via mortar auxiliary kernels while including these computations in the definition of mortar normal contact constraints in an asymmetric problem for a short simulation.
Specification(s): block-dynamics-aux-fretting-wear-test-quick
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.1The system shall solve mortar frictionless contact between two blocks with weighted gap time stabilization using mortar nodal geometry.
Specification(s): block-dynamics
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.1The system shall solve mortar frictionless contact between two blocks with weighted gap time stabilization using mortar nodal geometry.
Specification(s): block-dynamics
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.2The system shall solve mortar frictionless contact between two blocks with weighted gap time stabilization using mortar nodal geometry via the contact mechanics action.
Specification(s): block-dynamics-action
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.2The system shall solve mortar frictionless contact between two blocks with weighted gap time stabilization using mortar nodal geometry via the contact mechanics action.
Specification(s): block-dynamics-action
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.3The system shall generate an error if dynamics is not specifically requested and Newmark-beta integration parameter beta is provided.
Specification(s): block-dynamics-action-beta-error
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 4.15.3The system shall generate an error if dynamics is not specifically requested and Newmark-beta integration parameter beta is provided.
Specification(s): block-dynamics-action-beta-error
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 4.15.4The system shall generate an error if dynamics is not specifically requested and Newmark-beta integration parameter gamma is provided.
Specification(s): block-dynamics-action-gamma-error
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 4.15.4The system shall generate an error if dynamics is not specifically requested and Newmark-beta integration parameter gamma is provided.
Specification(s): block-dynamics-action-gamma-error
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FAILURE_ANALYSISFUNCTIONAL
Type(s): RunException
- 4.15.5The system shall solve mortar frictional contact between two blocks with weighted gap time stabilization using mortar nodal geometry.
Specification(s): block-dynamics-friction
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.5The system shall solve mortar frictional contact between two blocks with weighted gap time stabilization using mortar nodal geometry.
Specification(s): block-dynamics-friction
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.6The system shall solve mortar frictional contact between two blocks with weighted gap time stabilization using mortar nodal geometry via the contact action.
Specification(s): block-dynamics-friction-action
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.6The system shall solve mortar frictional contact between two blocks with weighted gap time stabilization using mortar nodal geometry via the contact action.
Specification(s): block-dynamics-friction-action
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.7The system shall simulate mortar frictional contact between two blocks with weighted gap time stabilization using mortar nodal geometry with a creep material model.
Specification(s): block-dynamics-friction-creep
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.7The system shall simulate mortar frictional contact between two blocks with weighted gap time stabilization using mortar nodal geometry with a creep material model.
Specification(s): block-dynamics-friction-creep
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.8The system shall solve a dynamic 3D frictional bouncing block problem with mortar constraint using nodal-attached geometry
Specification(s): frictional-mortar-3d-dynamics
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.15.8The system shall solve a dynamic 3D frictional bouncing block problem with mortar constraint using nodal-attached geometry
Specification(s): frictional-mortar-3d-dynamics
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.15.9The system shall solve a dynamic 3D frictional one-element bouncing block problem with mortar constraint using nodal-attached geometry and the correct edge dropping setting
Specification(s): frictional-mortar-3d-dynamics-light
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.9The system shall solve a dynamic 3D frictional one-element bouncing block problem with mortar constraint using nodal-attached geometry and the correct edge dropping setting
Specification(s): frictional-mortar-3d-dynamics-light
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.10The system shall solve a dynamic 3D frictional one-element bouncing block problem with mortar constraint using nodal-attached geometry and the incorrect edge dropping setting
Specification(s): frictional-mortar-3d-dynamics-light-miss-dropping
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.10The system shall solve a dynamic 3D frictional one-element bouncing block problem with mortar constraint using nodal-attached geometry and the incorrect edge dropping setting
Specification(s): frictional-mortar-3d-dynamics-light-miss-dropping
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.11The system shall solve a dynamic 3D frictional one-element bouncing block problem with mortar constraint using nodal-attached geometry and a friction coefficient that depends on the normal contact pressure and the relative tangential velocity
Specification(s): frictional-mortar-3d-dynamics-light-function
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.15.11The system shall solve a dynamic 3D frictional one-element bouncing block problem with mortar constraint using nodal-attached geometry and a friction coefficient that depends on the normal contact pressure and the relative tangential velocity
Specification(s): frictional-mortar-3d-dynamics-light-function
Design: ComputeDynamicFrictionalForceLMMechanicalContactComputeDynamicFrictionalForceLMMechanicalContact
Issue(s): #19671
Collection(s): FUNCTIONAL
Type(s): Exodiff
- contact: ComputeFrictionalForceLMMechanicalContact
- 4.16.1The system shall be able to run a two-dimensional frictional model using the contact action for mortar applications
Specification(s): frictional_bouncing_block_action_restart_1
Design: ComputeFrictionalForceLMMechanicalContact
Issue(s): #17495
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.16.2The system shall be able to restart a mortar mechanical contact simulation via the action without generating additional lower dimensional subdomains which may be unused
Specification(s): frictional_bouncing_block_action_restart_2
Design: ComputeFrictionalForceLMMechanicalContact
Issue(s): #17495
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.20.1The system shall not generate singular Jacobians in frictional mortar contact.
Specification(s): nonsingular
Design: ComputeFrictionalForceLMMechanicalContact
Issue(s): #17495
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.23.1Contact module shall solve frictional contact between a cylinder and a plane.
Specification(s): cylinder_friction
Design: ComputeFrictionalForceLMMechanicalContact
Issue(s): #17495
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.23.2Contact module shall solve frictional contact between a semicircular tool and flexible base material.
Specification(s): ironing
Design: ComputeFrictionalForceLMMechanicalContact
Issue(s): #17495
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.23.3Contact module shall solve frictional contact between a bouncing block and flexible base material.
Specification(s): frictional_bouncing_block
Design: ComputeFrictionalForceLMMechanicalContact
Issue(s): #17495
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.23.4Contact module shall solve frictional contact between a bouncing block and flexible base material verifying setup in the contact action.
Specification(s): frictional_bouncing_block_action
Design: ComputeFrictionalForceLMMechanicalContact
Issue(s): #17495
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- 4.23.5Contact module shall solve frictional contact between a bouncing block and a flexible substrate when correct edge dropping is enabled. Additional requirement is that the correct edge dropping treatment must yield same results as incorrect edge dropping treatment when there is not actual edge dropping, e.g.: All secondary surface projects to the primary surface.
Specification(s): frictional_bouncing_block_edge_dropping
Design: ComputeFrictionalForceLMMechanicalContact
Issue(s): #17495
Collection(s): FUNCTIONAL
Type(s): CSVDiff
- contact: NodalArea
- 4.19.1The system shall compute the nodal area for use with contact calculations in 3D.
Specification(s): 3D
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.2The system shall compute the nodal area in parallel for use with contact calculations in 3D.
Specification(s): 3D2Proc
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.3The system shall compute the nodal area for use with contact calculations in 2D.
Specification(s): 2D
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.4The system shall compute the nodal area in parallel for use with contact calculations in 2D.
Specification(s): 2D2Proc
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.5The system shall compute the nodal area for Hex20 elements for use with contact calculations.
Specification(s): Hex20
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.6The system shall compute the nodal area for Hex20 elements for use with frictionless contact calculations.
Specification(s): Hex20_2
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.7The system shall compute the nodal area for Hex20 elements for use with penalty contact calculations.
Specification(s): Hex20_3
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.8The system shall compute the nodal area in parallel for Hex20 elements for use with contact calculations.
Specification(s): Hex202Proc
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.9The system shall compute the nodal area for Hex27 elements for use with contact calculations.
Specification(s): Hex27
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- 4.19.10The system shall compute the nodal area in parallel for Hex27 elements for use with contact calculations.
Specification(s): Hex272Proc
Issue(s): #716
Collection(s): FUNCTIONAL
Type(s): Exodiff
- contact: ContactLineSearch
- 4.28.11We shall be able to solve the frictionless sliding block problem with a line serach customized for mechanical contact.
Specification(s): frictionless_penalty_contact_line_search
Design: ContactLineSearch
Issue(s): #10950
Collection(s): FUNCTIONAL
Type(s): Exodiff