BlackBear Input File Syntax
Listed below are all of the possible input parameter options for a BlackBear input file. Click the blue link shown to the right of each heading to see a more detailed description of its purpose.
Adaptivity
- Moose App
- SetAdaptivityOptionsActionAction for defining adaptivity parameters.
- Indicators
- Markers
Adaptivity/Indicators
- Moose App
- AddElementalFieldActionAdds elemental auxiliary variable for adaptivity system.
- AddIndicatorActionAdd an Indicator object to a simulation.
- AnalyticalIndicatorCompute the square of the error as the difference between an unknown variable and an analytical solution.
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- GradientJumpIndicatorCompute the jump of the solution gradient across element boundaries.
- LaplacianJumpIndicatorCompute the jump of the solution laplacian across element bondaries.
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- ValueJumpIndicatorCompute the jump of the solution across element bondaries.
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange or Nedelec
Adaptivity/Markers
- Moose App
- AddElementalFieldActionAdds elemental auxiliary variable for adaptivity system.
- AddMarkerActionAdd a Marker object to a simulation.
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- BoundaryMarkerMarks all elements with sides on a given boundary for refinement/coarsening
- BoxMarkerMarks the region inside and outside of a 'box' domain for refinement or coarsening.
- ComboMarkerA marker that converts many markers into a single marker by considering the maximum value of the listed markers (i.e., refinement takes precedent).
- ErrorFractionMarkerMarks elements for refinement or coarsening based on the fraction of the min/max error from the supplied indicator.
- ErrorToleranceMarkerCoarsen or refine elements based on an absolute tolerance allowed from the supplied indicator.
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- OrientedBoxMarkerMarks inside and outside a box that can have arbitrary orientation and center point.
- UniformMarkerUniformly mark all elements for refinement or coarsening.
- ValueRangeMarkerMark elements for adaptivity based on the supplied upper and lower bounds and the specified variable.
- ValueThresholdMarkerThe the refinement state based on a threshold value compared to the specified variable.
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange or Nedelec
AuxKernels
- Moose App
- AddKernelActionAdd a Kernel object to the simulation.
- ADMaterialRankTwoTensorAuxAccess a component of a RankTwoTensor for automatic material property output
- ADMaterialRealAuxOutputs element volume-averaged material properties
- ADMaterialRealVectorValueAuxCapture a component of a vector material property in an auxiliary variable.
- ADVectorMaterialRealVectorValueAuxConverts a vector-quantity material property into a vector auxiliary variable
- ArrayVariableComponentCopy a component of an array variable.
- BuildArrayVariableAuxCombines multiple standard variables into an array variable.
- ConstantAuxCreates a constant field in the domain.
- ConstantBoundsAuxProvides constant bound of a variable for the PETSc's variational inequalities solver
- DebugResidualAuxPopulate an auxiliary variable with the residual contribution of a variable.
- DiffusionFluxAuxCompute components of flux vector for diffusion problems .
- ElemExtraIDAuxPuts element extra IDs into an aux variable.
- ElementH1ErrorFunctionAuxComputes the H1 or W^{1,p} error between an exact function and a coupled variable.
- ElementIntegerAuxCreates a field showing the element integer.
- ElementL2ErrorFunctionAuxA class for computing the element-wise L^2 (Euclidean) error between a function and a coupled variable.
- ElementLengthAuxCompute the element size using Elem::hmin() or Elem::hmax() from libMesh.
- ElementLpNormAuxCompute an elemental field variable (single value per element) equal to the Lp-norm of a coupled Variable.
- ElementQualityAuxGenerates a field containing the quality metric for each element. Useful for visualizing mesh quality.
- ElementUOAuxAux Kernel to display generic spatial (elemental) information from a UserObject that satisfies the underlying ElementUOProvider interface.
- FunctionArrayAuxAuxiliary Kernel that creates and updates an array field variable by sampling functions through space and time.
- FunctionAuxAuxiliary Kernel that creates and updates a field variable by sampling a function through space and time.
- GapValueAuxReturn the nearest value of a variable on a boundary from across a gap.
- GhostingAuxColors the elements ghosted to the chosen PID.
- HardwareIDAuxCreates a field showing the assignment of partitions to physical nodes in the cluster.
- InterfaceValueUserObjectAuxGet stored value from the specified InterfaceQpUserObjectBase.
- MaterialRankFourTensorAuxAccess a component of a RankFourTensor for automatic material property output
- MaterialRankTwoTensorAuxAccess a component of a RankTwoTensor for automatic material property output
- MaterialRealAuxOutputs element volume-averaged material properties
- MaterialRealDenseMatrixAuxPopulate an auxiliary variable with an entry from a dense matrix material property.
- MaterialRealTensorValueAuxObject for extracting a component of a rank two tensor material property to populate an auxiliary variable.
- MaterialRealVectorValueAuxCapture a component of a vector material property in an auxiliary variable.
- MaterialStdVectorAuxExtracts a component of a material type std::vector<Real> to an aux variable. If the std::vector is not of sufficient size then zero is returned
- MaterialStdVectorRealGradientAuxExtracts a component of a material's std::vector<RealGradient> to an aux variable. If the std::vector is not of sufficient size then zero is returned
- NearestNodeDistanceAuxStores the distance between a block and boundary or between two boundaries.
- NearestNodeValueAuxRetrieves a field value from the closest node on the paired boundary and stores it on this boundary or block.
- NormalizationAuxNormalizes a variable based on a Postprocessor value.
- ParsedAuxParsed function AuxKernel.
- PenetrationAuxAuxiliary Kernel for computing several geometry related quantities between two contacting bodies.
- ProcessorIDAuxCreates a field showing the processors and partitioning.
- QuotientAuxDivides two coupled variables.
- SelfAuxReturns the specified variable as an auxiliary variable with the same value.
- SolutionAuxCreates fields by using information from a SolutionUserObject.
- SpatialUserObjectAuxPopulates an auxiliary variable with a spatial value returned from a UserObject spatialValue method.
- TagMatrixAuxCouple the diag of a tag matrix, and return its nodal value
- TagVectorAuxCouple a tag vector, and return its nodal value
- VariableGradientComponentCreates a field consisting of one component of the gradient of a coupled variable.
- VariableOldValueBoundsAuxProvides the upper and lower bound of the phase field fracture variable to PETSc's SNES variational inequalities solver.
- VariableTimeIntegrationAuxIntegrates a field variable in time.
- VectorFunctionAuxAuxiliary Kernel that creates and updates a vector field variable by sampling a Function object, via the vectorValue method, through space and time.
- VectorMagnitudeAuxCreates a field representing the magnitude of three coupled variables using an Euclidean norm.
- VectorMaterialRealVectorValueAuxConverts a vector-quantity material property into a vector auxiliary variable
- VectorPostprocessorVisualizationAuxRead values from a VectorPostprocessor that is producing vectors that are 'number of processors' * in length. Puts the value for each processor into an elemental auxiliary field.
- VectorVariableComponentAuxCreates a field consisting of one component of a coupled vector variable.
- VectorVariableMagnitudeAuxCreates a field consisting of the magnitude of a coupled vector variable.
- Tensor Mechanics App
- ADRankFourAuxAccess a component of a RankFourTensor
- ADRankTwoAuxAccess a component of a RankTwoTensor
- ADRankTwoScalarAuxCompute a scalar property of a RankTwoTensor
- AccumulateAux
- CylindricalRankTwoAuxTakes RankTwoTensor material and outputs component in cylindrical coordinates
- DomainIntegralQFunctionComputes the q-function for a segment along the crack front, used in the calculation of the J-integral
- DomainIntegralTopologicalQFunctionDetermines if a node is within the ring of the crack front defintion; this object is normally created by the DomainIntegralAction.
- ElasticEnergyAuxCompute the local elastic energy
- GlobalDisplacementAuxAuxKernel to visualize the displacements generated by the global strain tensor
- NewmarkAccelAuxComputes the current acceleration using the Newmark method.
- NewmarkVelAuxCalculates the current velocity using Newmark method.
- RadialDisplacementCylinderAuxCompute the radial component of the displacement vector for cylindrical models.
- RadialDisplacementSphereAuxCompute the radial component of the displacement vector for spherical models.
- RankFourAuxAccess a component of a RankFourTensor
- RankTwoAuxAccess a component of a RankTwoTensor
- RankTwoScalarAuxCompute a scalar property of a RankTwoTensor
- RotationAngleCompute the field of angular rotations of points around an axis defined by an origin point and a direction vector
- TestNewmarkTIAssigns the velocity/acceleration calculated by time integrator to the velocity/acceleration auxvariable.
- XFEMApp
- CutSubdomainIDAuxFill the elemental variable with CutSubdomainID
- LineSegmentLevelSetAuxAuxiliary Kernel that calcuates level set value using line segments' description.
- XFEMCutPlaneAuxComputes the normal and origin of a cutting plane for each partial element.
- XFEMMarkerAuxIdentify the crack tip elements.
- XFEMVolFracAuxComputes the volume fraction of the physical material in each partial element.
- Misc App
- CoupledDirectionalMeshHeightInterpolation
- Contact App
- ContactPressureAuxComputes the contact pressure from the contact force and nodal area
- Black Bear App
- MineralDissolutionPrecipAux
- Heat Conduction App
- JouleHeatingHeatGeneratedAuxCompute heat generated from Joule heating .
AuxScalarKernels
- Moose App
- AddScalarKernelActionAdd a AuxScalarKernel object to the simulation.
- ConstantScalarAuxCompute a histogram of volume fractions binned according to variable values.
- FunctionScalarAuxSets a value of a scalar variable based on a function.
- QuotientScalarAuxCompute the ratio of two scalar variables.
- ScalarTagMatrixAuxCouple a tag matrix, and return its nodal value
- ScalarTagVectorAuxCouple a tag vector, and return its value
- SolutionScalarAuxSets scalar variable by using information from a SolutionUserObject.
- Tensor Mechanics App
- GeneralizedPlaneStrainReferenceResidualGeneralized Plane Strain Reference Residual Scalar Kernel
AuxVariables
- Moose App
- AddAuxVariableActionAdd auxiliary variable to the simulation.
- CopyNodalVarsActionCopies variable information from a file.
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange or Nedelec
BCs
- Moose App
- AddBCActionAdd a BoundaryCondition object to the simulation.
- ADDirichletBCImposes the essential boundary condition , where is a constant, controllable value.
- ADFunctionDirichletBCImposes the essential boundary condition , where is calculated by a function.
- ADFunctionNeumannBCImposes the integrated boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- ADFunctionPenaltyDirichletBCEnforces a (possibly) time and space-dependent MOOSE Function Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet data.
- ADNeumannBCImposes the integrated boundary condition , where is a constant, controllable value.
- ADPenaltyDirichletBCEnforces a Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet data.
- ADVectorFunctionDirichletBCImposes the essential boundary condition , where components are calculated with functions.
- ADVectorMatchedValueBCImplements a ADVectorNodalBC which equates two different Variables' values on a specified boundary.
- ArrayDirichletBCImposes the essential boundary condition , where are constant, controllable values.
- ArrayHFEMDirichletBCImposes the Dirichlet BC with HFEM.
- ArrayNeumannBCImposes the integrated boundary condition , where is a constant, controllable value.
- ArrayPenaltyDirichletBCEnforces a Dirichlet boundary condition in a weak sense with , where is the constant scalar penalty; is the test functions and is the differences between the current solution and the Dirichlet data.
- ArrayVacuumBCImposes the Robin boundary condition .
- ConvectiveFluxBCDetermines boundary values via the initial and final values, flux, and exposure duration
- CoupledVarNeumannBCImposes the integrated boundary condition , where is a variable.
- DGFunctionDiffusionDirichletBCDiffusion Dirichlet boundary condition for discontinuous Gelerkin method.
- DiffusionFluxBCComputes a boundary residual contribution consistent with the Diffusion Kernel. Does not impose a boundary condition; instead computes the boundary contribution corresponding to the current value of grad(u) and accumulates it in the residual vector.
- DirichletBCImposes the essential boundary condition , where is a constant, controllable value.
- EigenArrayDirichletBCArray Dirichlet BC for eigenvalue solvers
- EigenDirichletBCDirichlet BC for eigenvalue solvers
- FunctionDirichletBCImposes the essential boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- FunctionGradientNeumannBCImposes the integrated boundary condition arising from integration by parts of a diffusion/heat conduction operator, and where the exact solution can be specified.
- FunctionNeumannBCImposes the integrated boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- FunctionPenaltyDirichletBCEnforces a (possibly) time and space-dependent MOOSE Function Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet data.
- HFEMDirichletBCImposes the Dirichlet BC with HFEM.
- LagrangeVecDirichletBCImposes the essential boundary condition , where are constant, controllable values.
- LagrangeVecFunctionDirichletBCImposes the essential boundary condition , where components are calculated with functions.
- MatchedValueBCImplements a NodalBC which equates two different Variables' values on a specified boundary.
- NeumannBCImposes the integrated boundary condition , where is a constant, controllable value.
- OneDEqualValueConstraintBCComputes the \f$ \int \lambda dg\f$ term from the mortar method (for two 1D domains only).
- PenaltyDirichletBCEnforces a Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet data.
- PostprocessorDirichletBCDirichlet boundary condition with value prescribed by a Postprocessor value.
- PostprocessorNeumannBCNeumann boundary condition with value prescribed by a Postprocessor value.
- SinDirichletBCImposes a time-varying essential boundary condition , where varies from an given initial value at time to a given final value over a specified duration.
- SinNeumannBCImposes a time-varying flux boundary condition , where varies from an given initial value at time to a given final value over a specified duration.
- VacuumBCVacuum boundary condition for neutron diffusion on the boundary.
- VectorDirichletBCImposes the essential boundary condition , where are constant, controllable values.
- VectorFunctionDirichletBCImposes the essential boundary condition , where components are calculated with functions.
- VectorNeumannBCImposes the integrated boundary condition , where is a user-defined, constant vector.
- VectorPenaltyDirichletBCEnforces a Dirichlet boundary condition for vector nonlinear variables in a weak sense by applying a penalty to the difference in the current solution and the Dirichlet data.
- WeakGradientBCComputes a boundary residual contribution consistent with the Diffusion Kernel. Does not impose a boundary condition; instead computes the boundary contribution corresponding to the current value of grad(u) and accumulates it in the residual vector.
- Periodic
- Tensor Mechanics App
- ADPressureApplies a pressure on a given boundary in a given direction
- ADTorqueApply a moment as tractions distributed over a surface around a pivot point. This should operate on the displaced mesh for large deformations.
- CoupledPressureBCApplies a pressure from a variable on a given boundary in a given direction
- DashpotBC
- DisplacementAboutAxisImplements a boundary condition that enforces rotationaldisplacement around an axis on a boundary
- InteractionIntegralBenchmarkBCImplements a boundary condition that enforces a displacement field around a crack tip based on applied stress intensity factors.
- PenaltyInclinedNoDisplacementBCPenalty Enforcement of an inclined boundary condition
- PresetAccelerationPrescribe acceleration on a given boundary in a given direction
- PresetDisplacementPrescribe the displacement on a given boundary in a given direction.
- PresetVelocity
- PressureApplies a pressure on a given boundary in a given direction
- StickyBCImposes the boundary condition if exceeds the bounds provided
- TorqueApply a moment as tractions distributed over a surface around a pivot point. This should operate on the displaced mesh for large deformations.
- CavityPressure
- CoupledPressure
- InclinedNoDisplacementBC
- Pressure
- XFEMApp
- CrackTipEnrichmentCutOffBCImposes the essential boundary condition , where is a constant, controllable value.
- Black Bear App
- SpecifiedVaporPressureBCPrescribed vapor pressure boundary condition for moisture transport in concrete.
- Heat Conduction App
- ADConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficent given by material properties.
- ConvectiveFluxFunctionDetermines boundary value by fluid heat transfer coefficient and far-field temperature
- ConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficent given by material properties.
- CoupledConvectiveFlux
- CoupledConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficent given by auxiliary variables.
- FunctionRadiativeBCBoundary condition for radiative heat exchange where the emissivity function is supplied by a Function.
- GapHeatTransferTransfers heat across a gap between two surfaces dependent on the gap geometry specified.
- GrayLambertNeumannBCThis BC imposes a heat flux density that is computed from the GrayLambertSurfaceRadiationBase userobject.
- HeatConductionBC
- InfiniteCylinderRadiativeBCBoundary condition for radiative heat exchange with a cylinderwhere the boundary is approximated as a cylinder as well.
BCs/CavityPressure
- Tensor Mechanics App
- CavityPressureActionAction to setup cavity pressure boundary condition
- CavityPressurePPActionThis Action creates a CavityPressurePostprocessor.
- CavityPressureUOActionAction to add user objects for cavity pressure
BCs/CoupledPressure
- Tensor Mechanics App
- CoupledPressureActionSet up Coupled Pressure boundary conditions
BCs/InclinedNoDisplacementBC
- Tensor Mechanics App
- InclinedNoDisplacementBCActionSet up inclined no displacement boundary conditions
BCs/Periodic
- Moose App
- AddPeriodicBCActionAction that adds periodic boundary conditions
BCs/Pressure
- Tensor Mechanics App
- PressureActionSet up Pressure boundary conditions
Bounds
- Moose App
- AddBoundsVectorsActionAction to add vectors to nonlinear system when using the Bounds syntax.
- AddKernelActionAdd a Kernel object to the simulation.
- ADVectorMaterialRealVectorValueAuxConverts a vector-quantity material property into a vector auxiliary variable
- BuildArrayVariableAuxCombines multiple standard variables into an array variable.
- FunctionArrayAuxAuxiliary Kernel that creates and updates an array field variable by sampling functions through space and time.
- VectorFunctionAuxAuxiliary Kernel that creates and updates a vector field variable by sampling a Function object, via the vectorValue method, through space and time.
- VectorMaterialRealVectorValueAuxConverts a vector-quantity material property into a vector auxiliary variable
Constraints
- Moose App
- AddConstraintActionAdd a Constraint object to the simulation.
- CoupledTiedValueConstraintRequires the value of a variable to be the consistent on both sides of an interface.
- EqualGradientConstraintEqualGradientConstraint enforces continuity of a gradient component between secondary and primary sides of a mortar interface using lagrange multipliers
- EqualValueBoundaryConstraintConstraint for enforcing that variables on each side of a boundary are equivalent.
- EqualValueConstraintEqualValueConstraint enforces solution continuity between secondary and primary sides of a mortar interface using lagrange multipliers
- EqualValueEmbeddedConstraintThis is a constraint enforcing overlapping portions of two blocks to have the same variable value
- LinearNodalConstraintConstrains secondary node to move as a linear combination of primary nodes.
- OldEqualValueConstraintOldEqualValueConstraint enforces solution continuity between secondary and primary sides of a mortar interface using lagrange multipliers
- TiedValueConstraintConstraint that forces the value of a variable to be the same on both sides of an interface.
- Tensor Mechanics App
- NodalFrictionalConstraintFrictional nodal constraint for contact
- NodalStickConstraintSticky nodal constraint for contact
- XFEMApp
- XFEMEqualValueAtInterfaceEnforce that the solution have the same value on opposing sides of an XFEM interface.
- XFEMSingleVariableConstraintEnforce constraints on the value or flux associated with a variable at an XFEM interface.
- Contact App
- ApplyPenetrationConstraintLMMechanicalContactImplements the KKT conditions for normal contact using an NCP function, in this case just the min function. This function enforces that either the gap distance or the normal contact pressure (represented by the value of
variable
) is zero. - ComputeWeightedGapLMMechanicalContactComputes the weighted gap that will later be used to enforce the zero-penetration mechanical contact conditions
- MechanicalContactConstraintApply non-penetration constraints on the mechanical deformation using a node on face, primary/secondary algorithm, and multiple options for the physical behavior on the interface and the mathematical formulation for constraint enforcement
- NormalMortarLMMechanicalContactEnforces the normal contact complementarity conditions in a mortar discretization
- NormalMortarMechanicalContactThis class is used to apply normal contact forces using lagrange multipliers
- NormalNodalLMMechanicalContactImplements the KKT conditions for normal contact using an NCP function. Requires that either the gap distance or the normal contact pressure (represented by the value of
variable
) is zero. The LM variable must be of the same order as the mesh - NormalNodalMechanicalContactApplies the normal contact force to displacement residuals through a Lagrange Multiplier
- RANFSNormalMechanicalContactApplies the Reduced Active Nonlinear Function Set scheme in which the secondary node's non-linear residual function is replaced by the zero penetration constraint equation when the constraint is active
- TangentialMortarLMMechanicalContactEnsures that the Karush-Kuhn-Tucker conditions of Coulomb frictional contact are satisfied
- TangentialMortarMechanicalContactUsed to apply tangential stresses from frictional contact using lagrange multipliers
- TangentialNodalLMMechanicalContactImplements the KKT conditions for frictional Coulomb contact using an NCP function. Requires that either the relative tangential velocity is zero or the tangential stress is equal to the friction coefficient times the normal contact pressure.
- Heat Conduction App
- GapConductanceConstraintComputes the residual and Jacobian contributions for the 'Lagrange Multiplier' implementation of the thermal contact problem. For more information, see the detailed description here: http://tinyurl.com/gmmhbe9
Contact
- Contact App
- ContactActionSets up all objects needed for mechanical contact enforcement
Controls
- Moose App
- AddControlActionAdd a Control object to the simulation.
- BoolFunctionControlSets the value of a 'bool' input parameters to the value of a provided function.
- ConditionalFunctionEnableControlControl for enabling/disabling objects when a function value is true
- PIDTransientControlSets the value of a 'Real' input parameter (or postprocessor) based on a Proportional Integral Derivative control of a postprocessor to match a target a target value.
- RealFunctionControlSets the value of a 'Real' input parameters to the value of a provided function.
- TimePeriodControl the enabled/disabled state of objects with time.
- Stochastic Tools App
- MultiAppCommandLineControlControl for modifying the command line arguments of MultiApps.
- SamplerReceiverControl for receiving data from a Sampler via SamplerParameterTransfer.
Covariance
- Stochastic Tools App
- AddCovarianceActionAdds Covariance objects contained within the
[Trainers]
and[Surrogates]
input blocks. - ExponentialCovarianceExponential covariance function.
- MaternHalfIntCovarianceMatern half-integer covariance function.
- SquaredExponentialCovarianceSquared Exponential covariance function.
DGKernels
- Moose App
- AddDGKernelActionAdd a DGKernel object to the simulation.
- ADDGDiffusionDG kernel for diffusion operator
- ArrayDGDiffusionImplements interior penalty method for array diffusion equations.
- ArrayHFEMDiffusionImposes the constraints on internal sides with HFEM.
- DGConvectionDG upwinding for the convection
- DGDiffusionComputes residual contribution for the diffusion operator using discontinous Galerkin method.
- HFEMDiffusionImposes the constraints on internal sides with HFEM.
Dampers
- Moose App
- AddDamperActionAdd a Damper object to the simulation.
- BoundingValueElementDamperThis class implements a damper that limits the value of a variable to be within user-specified bounds.
- BoundingValueNodalDamperLimits the value of a variable to be within user-specified bounds.
- ConstantDamperModifies the non-linear step by applying a constant damping factor.
- MaxIncrementLimits a variable's update by some max fraction
- Tensor Mechanics App
- ElementJacobianDamperDamper that limits the change in element Jacobians
- Contact App
- ContactSlipDamperDamp the iterative solution to minimize oscillations in frictional contact constriants between nonlinear iterations
Debug
- Moose App
- SetupDebugActionAdds various debugging type Output objects to the simulation system.
- SetupResidualDebugActionAdds the necessary objects for computing the residuals for individual variables.
- MaterialDerivativeTest
Debug/MaterialDerivativeTest
- Moose App
- MaterialDerivativeTestActionAction for setting up the necessary objects for debugging material property derivatives.
DeprecatedBlock
- Moose App
- DeprecatedBlockActionTool for marking input syntax as deprecated.
DiracKernels
- Moose App
- AddDiracKernelActionAdd a DiracKernel object to the simulation.
- ConstantPointSourceResidual contribution of a constant point source term.
- FunctionDiracSourceResidual contribution from a point source defined by a function.
- VectorPostprocessorPointSourceApply a point load defined by VectorPostprocessor.
- Contact App
- ContactPrimary
- SecondaryConstraint
- Heat Conduction App
- GapHeatPointSourceMaster
- XFEMApp
- XFEMPressureApplies a pressure on an interface cut by XFEM.
Distributions
- Moose App
- AddDistributionActionAdd a Distribution object to the simulation.
- Stochastic Tools App
- JohnsonSBJohnson Special Bounded (SB) distribution.
- JohnsonSBDistributionJohnson Special Bounded (SB) distribution.
- KernelDensity1DKernelDensity1D distribution
- LogisticLogistic distribution.
- LogisticDistributionLogistic distribution.
- LognormalLognormal distribution
- NormalNormal distribution
- NormalDistributionNormal distribution
- TruncatedNormalTruncated normal distribution
- TruncatedNormalDistributionTruncated normal distribution
- UniformContinuous uniform distribution.
- UniformDistributionContinuous uniform distribution.
- WeibullThree-parameter Weibull distribution.
- WeibullDistributionThree-parameter Weibull distribution.
DomainIntegral
- Tensor Mechanics App
- DomainIntegralActionCreates the MOOSE objects needed to compute fraction domain integrals
Executioner
- Moose App
- CreateExecutionerActionAdd an Executioner object to the simulation.
- EigenvalueEigenvalue solves a standard/generalized linear or nonlinear eigenvalue problem
- InversePowerMethodInverse power method for eigenvalue problems.
- NonlinearEigenExecutioner for eigenvalue problems.
- SteadyExecutioner for steady-state simulations.
- TransientExecutioner for time varying simulations.
- Adaptivity
- Predictor
- Quadrature
- TimeIntegrator
- TimeStepper
Executioner/Adaptivity
- Moose App
- AdaptivityActionAdd libMesh based adaptation schemes via the Executioner/Adaptivity input syntax.
Executioner/Predictor
- Moose App
- SetupPredictorActionAdd a Predictor object to the simulation.
- AdamsPredictorImplements an explicit Adams predictor based on two old solution vectors.
- SimplePredictorAlgorithm that will predict the next solution based on previous solutions.
Executioner/Quadrature
- Moose App
- SetupQuadratureActionSets the quadrature type for the simulation.
Executioner/TimeIntegrator
- Moose App
- SetupTimeIntegratorActionAdd a TimeIntegrator object to the simulation.
- AStableDirk4Fourth-order diagonally implicit Runge Kutta method (Dirk) with three stages plus an update.
- ActuallyExplicitEulerImplementation of Explicit/Forward Euler without invoking any of the nonlinear solver
- BDF2Second order backward differentiation formula time integration scheme.
- CentralDifferenceImplementation of explicit, Central Difference integration without invoking any of the nonlinear solver
- CrankNicolsonCrank-Nicolson time integrator.
- ExplicitEulerTime integration using the explicit Euler method.
- ExplicitMidpointTime integration using the explicit midpoint method.
- ExplicitSSPRungeKuttaExplicit strong stability preserving Runge-Kutta methods
- ExplicitTVDRK2Explicit TVD (total-variation-diminishing) second-order Runge-Kutta time integration method.
- HeunHeun's (aka improved Euler) time integration method.
- ImplicitEulerTime integration using the implicit Euler method.
- ImplicitMidpointSecond-order Runge-Kutta (implicit midpoint) time integration.
- LStableDirk2Second order diagonally implicit Runge Kutta method (Dirk) with two stages.
- LStableDirk3Third order diagonally implicit Runge Kutta method (Dirk) with three stages.
- LStableDirk4Fourth-order diagonally implicit Runge Kutta method (Dirk) with five stages.
- NewmarkBetaComputes the first and second time derivative of variable using Newmark-Beta method.
- RalstonRalston's time integration method.
Executioner/TimeStepper
- Moose App
- SetupTimeStepperActionAdd and initialize a TimeStepper object to the simulation.
- AB2PredictorCorrectorImplements second order Adams-Bashforth method for timestep calculation.
- CSVTimeSequenceStepperSolves the Transient problem at a sequence of given time points read in a file.
- ConstantDTTimestepper that takes a constant time step size
- DT2An adaptive timestepper that compares the solution obtained from a single step of size dt with two steps of size dt/2 and adjusts the next timestep accordingly.
- ExodusTimeSequenceStepperSolves the Transient problem at a sequence of time points taken from a specified exodus file.
- FunctionDTTimestepper whose steps vary over time according to a user-defined function
- IterationAdaptiveDTAdjust the timestep based on the number of iterations
- LogConstantDTTimeStepper which imposes a time step constant in the logarithmic space
- PostprocessorDTComputes timestep based on a Postprocessor value.
- SolutionTimeAdaptiveDTCompute simulation timestep based on actual solution time.
- TimeSequenceStepperSolves the Transient problem at a sequence of given time points.
FVBCs
- Moose App
- CheckFVBCActionCheck that boundary conditions are defined correctly for finite volume problems.
- AddFVBCActionAdd a FVBoundaryCondition object to the simulation.
- FVAdvectionFunctionBCImposes the integrated boundary condition arising from integration by parts of an advection operator, and where the exact solution can be specified.
- FVConstantScalarOutflowBCConstant velocity scalar advection boundary conditions for finite volume method.
- FVDiffusionFunctionBCImposes the integrated boundary condition arising from integration by parts of a Laplacian operator, and where the exact solution can be specified.
- FVDirichletBCDefines a Dirichlet boundary condition for finite volume method.
- FVFunctionDirichletBCImposes the essential boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- FVMatAdvectionFunctionBCImposes the integrated boundary condition arising from integration by parts of an advection operator, where the advected quantity is computed in a material, and where the exact solution can be specified.
- FVMatAdvectionOutflowBCOutflow boundary condition taking the advected quantity from a material property
- FVNeumannBCNeumann boundary condition for finite volume method.
- FVPostprocessorDirichletBCDefines a Dirichlet boundary condition for finite volume method.
FVInterfaceKernels
- Moose App
- AddFVInterfaceKernelActionAdd a FVInterfaceKernel object to the simulation.
- FVOneVarDiffusionInterfaceComputes residual for diffusion operator across an interface for finite volume method.
FVKernels
- Moose App
- AddFVKernelActionAdd a FVKernel object to the simulation.
- FVAdvectionResidual contribution from advection operator for finite volume method.
- FVBodyForceDemonstrates the multiple ways that scalar values can be introduced into finite volume kernels, e.g. (controllable) constants, functions, and postprocessors.
- FVCoupledForceImplements a source term proportional to the value of a coupled variable.
- FVDiffusionComputes residual for diffusion operator for finite volume method.
- FVMatAdvectionComputes the residual of advective term using finite volume method.
- FVReactionSimple consuming reaction term
- FVScalarLagrangeMultiplierThis class is used to enforce integral of phi = volume * phi_0 with a Lagrange multiplier approach.
- FVTimeKernelResidual contribution from time derivative of a variable for the finite volume method.
Functions
- Moose App
- AddFunctionActionAdd a Function object to the simulation.
- Axisymmetric2D3DSolutionFunctionFunction for reading a 2D axisymmetric solution from file and mapping it to a 3D Cartesian model
- BicubicSplineFunctionDefine a bicubic spline function from interpolated data defined by input parameters.
- CoarsenedPiecewiseLinearPerform a point reduction of the tabulated data upon initialization, then evaluate using a linear interpolation.
- CompositeFunctionMultiplies an arbitrary set of functions together
- ConstantFunctionA function that returns a constant value as defined by an input parameter.
- ImageFunctionFunction with values sampled from an image or image stack.
- LinearCombinationFunctionReturns the linear combination of the functions
- ParsedFunctionFunction created by parsing a string
- ParsedGradFunctionDefines a function and its gradient using input file parameters.
- ParsedVectorFunctionReturn a vector component values based on a string function.
- PiecewiseBilinearInterpolates values from a csv file
- PiecewiseConstantDefines data using a set of x-y data pairs
- PiecewiseLinearLinearly interpolates between pairs of x-y data
- PiecewiseMulticonstantPiecewiseMulticonstant performs constant interpolation on 1D, 2D, 3D or 4D data. The data_file specifies the axes directions and the function values. If a point lies outside the data range, the appropriate end value is used.
- PiecewiseMultilinearPiecewiseMultilinear performs linear interpolation on 1D, 2D, 3D or 4D data. The data_file specifies the axes directions and the function values. If a point lies outside the data range, the appropriate end value is used.
- SolutionFunctionFunction for reading a solution from file.
- SplineFunctionDefine a spline function from interpolated data defined by input parameters.
- VectorPostprocessorFunctionProvides piecewise linear interpolation of from two columns of a VectorPostprocessor
GlobalParams
- Moose App
- GlobalParamsActionAction used to aid in the application of parameters defined in the GlobalParams input block.
GrayDiffuseRadiation
- Heat Conduction App
- RadiationTransferActionThis action sets up the net radiation calculation between specified sidesets.
ICs
- Moose App
- AddInitialConditionActionAdd an InitialCondition object to the simulation.
- ArrayConstantICSets constant component values for an array field variable.
- ArrayFunctionICAn initial condition that uses a normal function of x, y, z to produce values (and optionally gradients) for a field variable.
- BoundingBoxICBoundingBoxIC allows setting the initial condition of a value inside and outside of a specified box. The box is aligned with the x, y, z axes
- ConstantICSets a constant field value.
- FunctionICAn initial condition that uses a normal function of x, y, z to produce values (and optionally gradients) for a field variable.
- FunctionScalarICInitializes a scalar variable using a function.
- RandomICInitialize a variable with randomly generated numbers following either a uniform distribution or a user-defined distribution
- ScalarComponentICInitial condition to set different values on each component of scalar variable.
- ScalarConstantICInitalize a scalar variable with a constant value prescribed by an input parameter.
- VectorConstantICSets constant component values for a vector field variable.
- VectorFunctionICSets component values for a vector field variable based on a vector function.
- Tensor Mechanics App
- VolumeWeightedWeibullInitialize a variable with randomly generated numbers following a volume-weighted Weibull distribution
InterfaceKernels
- Moose App
- AddInterfaceKernelActionAdd an InterfaceKernel object to the simulation.
- InterfaceReactionImplements a reaction to establish ReactionRate=k_f*u-k_b*v at interface.
- Tensor Mechanics App
- CZMInterfaceKernelInterface kernel for use with cohesive zone models (CZMs) that compute traction as a function of the displacement jump
- Heat Conduction App
- ConjugateHeatTransferThis InterfaceKernel models conjugate heat transfer. Fluid side must be primary side and solid side must be secondary side. T_fluid is provided in case that variable ( fluid energy variable) is not temperature but e.g. internal energy.
- SideSetHeatTransferKernelModeling conduction, convection, and radiation across internal side set.
Kernels
- Moose App
- AddKernelActionAdd a Kernel object to the simulation.
- ADBodyForceDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- ADCoupledTimeDerivativeTime derivative Kernel that acts on a coupled variable. Weak form: .
- ADDiffusionSame as
Diffusion
in terms of physics/residual, but the Jacobian is computed using forward automatic differentiation - ADMatDiffusionDiffusion equation kernel that takes an isotropic diffusivity from a material property
- ADMaterialPropertyValueResidual term (u - prop) to set variable u equal to a given material property prop
- ADTimeDerivativeThe time derivative operator with the weak form of .
- ADVectorDiffusionThe Laplacian operator (), with the weak form of . The Jacobian is computed using automatic differentiation
- ADVectorTimeDerivativeThe time derivative operator with the weak form of .
- AnisotropicDiffusionAnisotropic diffusion kernel with weak form given by .
- ArrayBodyForceApplies body forces specified with functions to an array variable.
- ArrayDiffusionThe array Laplacian operator (), with the weak form of .
- ArrayReactionThe array reaction operator with the weak form of .
- ArrayTimeDerivativeArray time derivative operator with the weak form of .
- BodyForceDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- CoefReactionImplements the residual term (p*u, test)
- CoefTimeDerivativeThe time derivative operator with the weak form of .
- ConservativeAdvectionConservative form of which in its weak form is given by: .
- CoupledForceImplements a source term proportional to the value of a coupled variable. Weak form: .
- CoupledTimeDerivativeTime derivative Kernel that acts on a coupled variable. Weak form: .
- DiffusionThe Laplacian operator (), with the weak form of .
- MassEigenKernelAn eigenkernel with weak form where is the eigenvalue.
- MassLumpedTimeDerivativeLumped formulation of the time derivative . Its corresponding weak form is where denotes the time derivative of the solution coefficient associated with node .
- MatCoupledForceImplements a forcing term RHS of the form PDE = RHS, where RHS = Sum_j c_j * m_j * v_j. c_j, m_j, and v_j are provided as real coefficients, material properties, and coupled variables, respectively.
- MatDiffusionDiffusion equation Kernel that takes an isotropic Diffusivity from a material property
- MatReactionKernel to add -L*v, where L=reaction rate, v=variable
- MaterialDerivativeRankFourTestKernelClass used for testing derivatives of a rank four tensor material property.
- MaterialDerivativeRankTwoTestKernelClass used for testing derivatives of a rank two tensor material property.
- MaterialDerivativeTestKernelClass used for testing derivatives of a scalar material property.
- MaterialPropertyValueResidual term (u - prop) to set variable u equal to a given material property prop
- NullKernelKernel that sets a zero residual.
- ReactionImplements a simple consuming reaction term with weak form .
- ScalarLagrangeMultiplierThis class is used to enforce integral of phi = V_0 with a Lagrange multiplier approach.
- TimeDerivativeThe time derivative operator with the weak form of .
- UserForcingFunctionDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- VectorBodyForceDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- VectorCoupledTimeDerivativeTime derivative Kernel that acts on a coupled vector variable. Weak form: .
- VectorDiffusionThe Laplacian operator (), with the weak form of .
- VectorTimeDerivativeThe time derivative operator with the weak form of .
- Tensor Mechanics App
- ADDynamicStressDivergenceTensorsResidual due to stress related Rayleigh damping and HHT time integration terms
- ADGravityApply gravity. Value is in units of acceleration.
- ADInertialForceShellCalculates the residual for the inertial force/moment and the contribution of mass dependent Rayleigh damping and HHT time integration scheme.
- ADStressDivergenceRSphericalTensorsCalculate stress divergence for a spherically symmetric 1D problem in polar coordinates.
- ADStressDivergenceRZTensorsCalculate stress divergence for an axisymmetric problem in cylindrical coordinates.
- ADStressDivergenceShellQuasi-static stress divergence kernel for Shell element
- ADStressDivergenceTensorsStress divergence kernel with automatic differentiation for the Cartesian coordinate system
- ADWeakPlaneStressPlane stress kernel to provide out-of-plane strain contribution.
- AsymptoticExpansionHomogenizationKernelKernel for asymptotic expansion homogenization for elasticity
- CosseratStressDivergenceTensorsStress divergence kernel for the Cartesian coordinate system
- DynamicStressDivergenceTensorsResidual due to stress related Rayleigh damping and HHT time integration terms
- GeneralizedPlaneStrainOffDiagGeneralized Plane Strain kernel to provide contribution of the out-of-plane strain to other kernels
- GravityApply gravity. Value is in units of acceleration.
- InertialForceCalculates the residual for the inertial force () and the contribution of mass dependent Rayleigh damping and HHT time integration scheme ($\eta \cdot M \cdot ((1+\alpha)velq2-\alpha \cdot vel-old) $)
- InertialForceBeamCalculates the residual for the inertial force/moment and the contribution of mass dependent Rayleigh damping and HHT time integration scheme.
- InertialTorqueKernel for inertial torque: density * displacement x acceleration
- MomentBalancing
- OutOfPlanePressureApply pressure in the out-of-plane direction in 2D plane stress or generalized plane strain models
- PhaseFieldFractureMechanicsOffDiagStress divergence kernel for phase-field fracture: Computes off diagonal damage dependent Jacobian components. To be used with StressDivergenceTensors or DynamicStressDivergenceTensors.
- PlasticHeatEnergyPlastic heat energy density = coeff * stress * plastic_strain_rate
- PoroMechanicsCouplingAdds , where the subscript is the component.
- StressDivergenceBeamQuasi-static and dynamic stress divergence kernel for Beam element
- StressDivergenceRSphericalTensorsCalculate stress divergence for a spherically symmetric 1D problem in polar coordinates.
- StressDivergenceRZTensorsCalculate stress divergence for an axisymmetric problem in cylindrical coordinates.
- StressDivergenceTensorsStress divergence kernel for the Cartesian coordinate system
- StressDivergenceTensorsTrussKernel for truss element
- WeakPlaneStressPlane stress kernel to provide out-of-plane strain contribution.
- DynamicTensorMechanics
- PoroMechanics
- TensorMechanics
- XFEMApp
- CrackTipEnrichmentStressDivergenceTensorsEnrich stress divergence kernel for small-strain simulations
- Misc App
- ADThermoDiffusionCalculates diffusion due to temperature gradient and Soret Coefficient
- CoefDiffusionKernel for diffusion with diffusivity = coef + function
- ThermoDiffusionKernel for thermo-diffusion (Soret effect, thermophoresis, etc.)
- Black Bear App
- ConcreteLatentHeatLatent heat term for heat transfer in concrete.
- ConcreteMoistureDehydrationSource term for dehydrated water for moisture transfer in concrete.
- ConcreteMoistureDiffusionFickian and Soret diffusion terms for moisture transfer in concrete.
- ConcreteMoistureTimeIntegrationTime derivative term for moisture transport in concrete.
- ConcreteThermalConductionConduction term for thermal transport in concrete.
- ConcreteThermalConvectionConvective transport term for heat transfer due to fluid flow in concrete.
- ConcreteThermalTimeIntegrationTime derivative term for heat transfer in concrete.
- Heat Conduction App
- ADHeatConductionSame as
Diffusion
in terms of physics/residual, but the Jacobian is computed using forward automatic differentiation - ADHeatConductionTimeDerivativeAD Time derivative term of the heat equation for quasi-constant specific heat and the density .
- ADJouleHeatingSourceCalculates the heat source term corresponding to electrostatic Joule heating, with Jacobian contributions calculated using the automatic differentiation system.
- ADMatHeatSourceForce term in thermal transport to represent a heat source
- AnisoHeatConduction
- HeatCapacityConductionTimeDerivativeTime derivative term of the heat equation with the heat capacity as an argument.
- HeatConductionComputes residual/Jacobian contribution for term.
- HeatConductionTimeDerivativeTime derivative term of the heat equation for quasi-constant specific heat and the density .
- HeatSourceDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- HomogenizedHeatConductionKernel for asymptotic expansion homogenization for thermal conductivity
- JouleHeatingSourceCalculates the heat source term corresponding to electrostatic Joule heating.
- SpecificHeatConductionTimeDerivativeTime derivative term of the heat equation with the specific heat and the density as arguments.
Kernels/DynamicTensorMechanics
- Tensor Mechanics App
- DynamicTensorMechanicsActionSet up dynamic stress divergence kernels
Kernels/PoroMechanics
- Tensor Mechanics App
- PoroMechanicsActionSet up stress divergence kernels with coordinate system aware logic
Kernels/TensorMechanics
- Tensor Mechanics App
- LegacyTensorMechanicsActionSet up stress divergence kernels with coordinate system aware logic
Materials
- Moose App
- AddMaterialActionAdd a Material object to the simulation.
- ADDerivativeParsedMaterialParsed Function Material with automatic derivatives.
- ADDerivativeSumMaterialMeta-material to sum up multiple derivative materials
- ADGenericConstantMaterialDeclares material properties based on names and values prescribed by input parameters.
- ADGenericConstantRankTwoTensorObject for declaring a constant rank two tensor as a material property.
- ADGenericConstantVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
- ADGenericFunctionMaterialMaterial object for declaring properties that are populated by evaluation of Function object.
- ADGenericFunctionRankTwoTensorMaterial object for defining rank two tensor properties using functions.
- ADParsedMaterialParsed Function Material.
- ADPiecewiseLinearInterpolationMaterialCompute a property using a piecewise linear interpolation to define its dependence on a variable
- DerivativeParsedMaterialParsed Function Material with automatic derivatives.
- DerivativeSumMaterialMeta-material to sum up multiple derivative materials
- GenericConstant2DArrayA material evaluating one material property in type of RealEigenMatrix
- GenericConstantArrayA material evaluating one material property in type of RealEigenVector
- GenericConstantMaterialDeclares material properties based on names and values prescribed by input parameters.
- GenericConstantRankTwoTensorObject for declaring a constant rank two tensor as a material property.
- GenericConstantVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
- GenericFunctionMaterialMaterial object for declaring properties that are populated by evaluation of Function object.
- GenericFunctionRankTwoTensorMaterial object for defining rank two tensor properties using functions.
- MaterialConverterConverts regular material properties to AD properties and visa versa
- ParsedMaterialParsed Function Material.
- PiecewiseLinearInterpolationMaterialCompute a property using a piecewise linear interpolation to define its dependence on a variable
- RankFourTensorMaterialConverterConverts regular material properties to AD properties and visa versa
- RankTwoTensorMaterialConverterConverts regular material properties to AD properties and visa versa
- Tensor Mechanics App
- ADAbruptSofteningSoftening model with an abrupt stress release upon cracking. This class relies on automatic differentiation and is intended to be used with ADComputeSmearedCrackingStress.
- ADComputeAxisymmetricRZFiniteStrainCompute a strain increment for finite strains under axisymmetric assumptions.
- ADComputeAxisymmetricRZIncrementalStrainCompute a strain increment and rotation increment for finite strains under axisymmetric assumptions.
- ADComputeAxisymmetricRZSmallStrainCompute a small strain in an Axisymmetric geometry
- ADComputeDilatationThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the total dilatation as a function of temperature
- ADComputeEigenstrainComputes a constant Eigenstrain
- ADComputeElasticityTensorCompute an elasticity tensor.
- ADComputeFiniteShellStrainCompute a large strain increment for the shell.
- ADComputeFiniteStrainCompute a strain increment and rotation increment for finite strains.
- ADComputeFiniteStrainElasticStressCompute stress using elasticity for finite strains
- ADComputeGreenLagrangeStrainCompute a Green-Lagrange strain.
- ADComputeIncrementalShellStrainCompute a small strain increment for the shell.
- ADComputeIncrementalSmallStrainCompute a strain increment and rotation increment for small strains.
- ADComputeInstantaneousThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the instantaneous thermal expansion as a function of temperature
- ADComputeIsotropicElasticityTensorCompute a constant isotropic elasticity tensor.
- ADComputeIsotropicElasticityTensorShellCompute a plane stress isotropic elasticity tensor.
- ADComputeLinearElasticStressCompute stress using elasticity for small strains
- ADComputeMeanThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the mean thermal expansion as a function of temperature
- ADComputeMultipleInelasticStressCompute state (stress and internal parameters such as plastic strains and internal parameters) using an iterative process. Combinations of creep models and plastic models may be used.
- ADComputeMultiplePorousInelasticStressCompute state (stress and internal parameters such as plastic strains and internal parameters) using an iterative process. A porosity material property is defined and is calculated from the trace of inelastic strain increment.
- ADComputePlaneFiniteStrainCompute strain increment and rotation increment for finite strain under 2D planar assumptions.
- ADComputePlaneIncrementalStrainCompute strain increment for small strain under 2D planar assumptions.
- ADComputePlaneSmallStrainCompute a small strain under generalized plane strain assumptions where the out of plane strain is generally nonzero.
- ADComputeRSphericalFiniteStrainCompute a strain increment and rotation increment for finite strains in 1D spherical symmetry problems.
- ADComputeRSphericalIncrementalStrainCompute a strain increment for incremental strains in 1D spherical symmetry problems.
- ADComputeRSphericalSmallStrainCompute a small strain 1D spherical symmetry case.
- ADComputeShellStressCompute in-plane stress using elasticity for shell
- ADComputeSmallStrainCompute a small strain.
- ADComputeSmearedCrackingStressCompute stress using a fixed smeared cracking model. Uses automatic differentiation
- ADComputeStrainIncrementBasedStressCompute stress after subtracting inelastic strain increments
- ADComputeThermalExpansionEigenstrainComputes eigenstrain due to thermal expansion with a constant coefficient
- ADComputeVariableIsotropicElasticityTensorCompute an isotropic elasticity tensor for elastic constants that change as a function of material properties
- ADExponentialSofteningSoftening model with an exponential softening response upon cracking. This class is intended to be used with ADComputeSmearedCrackingStress and relies on automatic differentiation.
- ADHillCreepStressUpdateThis class uses the stress update material in a generalized radial return anisotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADHillElastoPlasticityStressUpdateThis class uses the stress update material in a radial return isotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADHillPlasticityStressUpdateThis class uses the stress update material in a radial return isotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADIsotropicPlasticityStressUpdateThis class uses the discrete material in a radial return isotropic plasticity model. This class is one of the basic radial return constitutive models, yet it can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADPorosityFromStrainPorosity calculation from the inelastic strain.
- ADPowerLawCreepStressUpdateThis class uses the stress update material in a radial return isotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADPowerLawSofteningSoftening model with an abrupt stress release upon cracking. This class is intended to be used with ADComputeSmearedCrackingStress and relies on automatic differentiation.
- ADRankTwoCartesianComponentAccess a component of a RankTwoTensor
- ADRankTwoCylindricalComponentCompute components of a rank-2 tensor in a cylindrical coordinate system
- ADRankTwoDirectionalComponentCompute a Direction scalar property of a RankTwoTensor
- ADRankTwoInvariantCompute a invariant property of a RankTwoTensor
- ADStrainEnergyRateDensityComputes the strain energy density rate using a combination of the elastic and inelastic components of the strain increment, which is a valid assumption for monotonic behavior.
- ADViscoplasticityStressUpdateThis material computes the non-linear homogenized gauge stress in order to compute the viscoplastic responce due to creep in porous materials. This material must be used in conjunction with ADComputeMultiplePorousInelasticStress
- AbaqusUMATStressCoupling material to use Abaqus UMAT models in MOOSE
- AbruptSofteningSoftening model with an abrupt stress release upon cracking. This class is intended to be used with ComputeSmearedCrackingStress.
- CappedDruckerPragerCosseratStressUpdateCapped Drucker-Prager plasticity stress calculator for the Cosserat situation where the host medium (ie, the limit where all Cosserat effects are zero) is isotropic. Note that the return-map flow rule uses an isotropic elasticity tensor built with the 'host' properties defined by the user.
- CappedDruckerPragerStressUpdateCapped Drucker-Prager plasticity stress calculator
- CappedMohrCoulombCosseratStressUpdateCapped Mohr-Coulomb plasticity stress calculator for the Cosserat situation where the host medium (ie, the limit where all Cosserat effects are zero) is isotropic. Note that the return-map flow rule uses an isotropic elasticity tensor built with the 'host' properties defined by the user.
- CappedMohrCoulombStressUpdateNonassociative, smoothed, Mohr-Coulomb plasticity capped with tensile (Rankine) and compressive caps, with hardening/softening
- CappedWeakInclinedPlaneStressUpdateCapped weak inclined plane plasticity stress calculator
- CappedWeakPlaneCosseratStressUpdateCapped weak-plane plasticity Cosserat stress calculator
- CappedWeakPlaneStressUpdateCapped weak-plane plasticity stress calculator
- CombinedScalarDamageScalar damage model which is computed as a function of multiple scalar damage models
- CompositeEigenstrainAssemble an Eigenstrain tensor from multiple tensor contributions weighted by material properties
- CompositeElasticityTensorAssemble an elasticity tensor from multiple tensor contributions weighted by material properties
- ComputeAxisymmetric1DFiniteStrainCompute a strain increment and rotation increment for finite strains in an axisymmetric 1D problem
- ComputeAxisymmetric1DIncrementalStrainCompute strain increment for small strains in an axisymmetric 1D problem
- ComputeAxisymmetric1DSmallStrainCompute a small strain in an Axisymmetric 1D problem
- ComputeAxisymmetricRZFiniteStrainCompute a strain increment for finite strains under axisymmetric assumptions.
- ComputeAxisymmetricRZIncrementalStrainCompute a strain increment and rotation increment for small strains under axisymmetric assumptions.
- ComputeAxisymmetricRZSmallStrainCompute a small strain in an Axisymmetric geometry
- ComputeBeamResultantsCompute forces and moments using elasticity
- ComputeConcentrationDependentElasticityTensorCompute concentration dependent elasticity tensor.
- ComputeCosseratElasticityTensorCompute Cosserat elasticity and flexural bending rigidity tensors
- ComputeCosseratIncrementalSmallStrainCompute incremental small Cosserat strains
- ComputeCosseratLinearElasticStressCompute Cosserat stress and couple-stress elasticity for small strains
- ComputeCosseratSmallStrainCompute small Cosserat strains
- ComputeCrackedStressComputes energy and modifies the stress for phase field fracture
- ComputeDamageStressCompute stress for damaged elastic materials in conjunction with a damage model.
- ComputeDeformGradBasedStressComputes stress based on Lagrangian strain
- ComputeDilatationThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the total dilatation as a function of temperature
- ComputeEigenstrainComputes a constant Eigenstrain
- ComputeEigenstrainBeamFromVariableComputes an eigenstrain from a set of variables
- ComputeEigenstrainFromInitialStressComputes an eigenstrain from an initial stress
- ComputeElasticityBeamComputes the equivalent of the elasticity tensor for the beam element, which are vectors of material translational and flexural stiffness.
- ComputeElasticityTensorCompute an elasticity tensor.
- ComputeElasticityTensorCPCompute an elasticity tensor for crystal plasticity.
- ComputeElasticityTensorConstantRotationCPCompute an elasticity tensor for crystal plasticity, formulated in the reference frame, with constant Euler angles.
- ComputeExtraStressConstantComputes a constant extra stress that is added to the stress calculated by the constitutive model
- ComputeExtraStressVDWGasComputes a hydrostatic stress corresponding to the pressure of a van der Waals gas that is added as an extra_stress to the stress computed by the constitutive model
- ComputeFiniteBeamStrainCompute a rotation increment for finite rotations of the beam and computes the small/large strain increments in the current rotated configuration of the beam.
- ComputeFiniteStrainCompute a strain increment and rotation increment for finite strains.
- ComputeFiniteStrainElasticStressCompute stress using elasticity for finite strains
- ComputeGlobalStrainMaterial for storing the global strain values from the scalar variable
- ComputeIncrementalBeamStrainCompute a infinitesimal/large strain increment for the beam.
- ComputeIncrementalSmallStrainCompute a strain increment and rotation increment for small strains.
- ComputeInstantaneousThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the instantaneous thermal expansion as a function of temperature
- ComputeInterfaceStressStress in the plane of an interface defined by the gradient of an order parameter
- ComputeIsotropicElasticityTensorCompute a constant isotropic elasticity tensor.
- ComputeLayeredCosseratElasticityTensorComputes Cosserat elasticity and flexural bending rigidity tensors relevant for simulations with layered materials. The layering direction is assumed to be perpendicular to the 'z' direction.
- ComputeLinearElasticPFFractureStressComputes the stress and free energy derivatives for the phase field fracture model, with small strain
- ComputeLinearElasticStressCompute stress using elasticity for small strains
- ComputeLinearViscoelasticStressDivides total strain into elastic + creep + eigenstrains
- ComputeMeanThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the mean thermal expansion as a function of temperature
- ComputeMultiPlasticityStressMaterial for multi-surface finite-strain plasticity
- ComputeMultipleCrystalPlasticityStressCrystal Plasticity base class: handles the Newton iteration over the stress residual and calculates the Jacobian based on constitutive laws from multiple material classes that are inherited from CrystalPlasticityStressUpdateBase
- ComputeMultipleInelasticCosseratStressCompute state (stress and other quantities such as plastic strains and internal parameters) using an iterative process, as well as Cosserat versions of these quantities. Only elasticity is currently implemented for the Cosserat versions.Combinations of creep models and plastic models may be used
- ComputeMultipleInelasticStressCompute state (stress and internal parameters such as plastic strains and internal parameters) using an iterative process. Combinations of creep models and plastic models may be used.
- ComputePlaneFiniteStrainCompute strain increment and rotation increment for finite strain under 2D planar assumptions.
- ComputePlaneIncrementalStrainCompute strain increment for small strain under 2D planar assumptions.
- ComputePlaneSmallStrainCompute a small strain under generalized plane strain assumptions where the out of plane strain is generally nonzero.
- ComputePlasticHeatEnergyPlastic heat energy density = stress * plastic_strain_rate
- ComputeRSphericalFiniteStrainCompute a strain increment and rotation increment for finite strains in 1D spherical symmetry problems.
- ComputeRSphericalIncrementalStrainCompute a strain increment for incremental strains in 1D spherical symmetry problems.
- ComputeRSphericalSmallStrainCompute a small strain 1D spherical symmetry case.
- ComputeReducedOrderEigenstrainaccepts eigenstrains and computes a reduced order eigenstrain for consistency in the order of strain and eigenstrains.
- ComputeSmallStrainCompute a small strain.
- ComputeSmearedCrackingStressCompute stress using a fixed smeared cracking model
- ComputeStrainIncrementBasedStressCompute stress after subtracting inelastic strain increments
- ComputeSurfaceTensionKKSSurface tension of an interface defined by the gradient of an order parameter
- ComputeThermalExpansionEigenstrainComputes eigenstrain due to thermal expansion with a constant coefficient
- ComputeThermalExpansionEigenstrainBeamComputes eigenstrain due to thermal expansion with a constant coefficient
- ComputeVariableBaseEigenStrainComputes Eigenstrain based on material property tensor base
- ComputeVariableEigenstrainComputes an Eigenstrain and its derivatives that is a function of multiple variables, where the prefactor is defined in a derivative material
- ComputeVariableIsotropicElasticityTensorCompute an isotropic elasticity tensor for elastic constants that change as a function of material properties
- ComputeVolumetricDeformGradComputes volumetric deformation gradient and adjusts the total deformation gradient
- ComputeVolumetricEigenstrainComputes an eigenstrain that is defined by a set of scalar material properties that summed together define the volumetric change. This also computes the derivatives of that eigenstrain with respect to a supplied set of variable dependencies.
- CrystalPlasticityKalidindiUpdateKalidindi version of homogeneous crystal plasticity.
- EshelbyTensorComputes the Eshelby tensor as a function of strain energy density and the first Piola-Kirchhoff stress
- ExponentialSofteningSoftening model with an exponential softening response upon cracking. This class is intended to be used with ComputeSmearedCrackingStress.
- FiniteStrainCPSlipRateResCrystal Plasticity base class: FCC system with power law flow rule implemented
- FiniteStrainCrystalPlasticityCrystal Plasticity base class: FCC system with power law flow rule implemented
- FiniteStrainHyperElasticViscoPlasticMaterial class for hyper-elastic viscoplatic flow: Can handle multiple flow models defined by flowratemodel type user objects
- FiniteStrainPlasticMaterialAssociative J2 plasticity with isotropic hardening.
- FiniteStrainUObasedCPUserObject based Crystal Plasticity system.
- FluxBasedStrainIncrementCompute strain increment based on flux
- GBRelaxationStrainIncrementCompute strain increment based on lattice relaxation at GB
- GeneralizedKelvinVoigtModelGeneralized Kelvin-Voigt model composed of a serial assembly of unit Kelvin-Voigt modules
- GeneralizedMaxwellModelGeneralized Maxwell model composed of a parallel assembly of unit Maxwell modules
- HyperElasticPhaseFieldIsoDamageComputes damaged stress and energy in the intermediate configuration assuming isotropy
- HyperbolicViscoplasticityStressUpdateThis class uses the discrete material for a hyperbolic sine viscoplasticity model in which the effective plastic strain is solved for using a creep approach.
- InclusionProperties
- IsotropicPlasticityStressUpdateThis class uses the discrete material in a radial return isotropic plasticity model. This class is one of the basic radial return constitutive models, yet it can be used in conjunction with other creep and plasticity materials for more complex simulations.
- IsotropicPowerLawHardeningStressUpdateThis class uses the discrete material in a radial return isotropic plasticity power law hardening model, solving for the yield stress as the intersection of the power law relation curve and Hooke's law. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- LinearElasticTrussComputes the linear elastic strain for a truss element
- LinearViscoelasticStressUpdateCalculates an admissible state (stress that lies on or within the yield surface, plastic strains, internal parameters, etc). This class is intended to be a parent class for classes with specific constitutive models.
- MultiPhaseStressMaterialCompute a global stress form multiple phase stresses
- PlasticTrussComputes the stress and strain for a truss element with plastic behavior defined by either linear hardening or a user-defined hardening function.
- PorosityFromStrainPorosity calculation from the inelastic strain.
- PowerLawCreepStressUpdateThis class uses the stress update material in a radial return isotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- PowerLawSofteningSoftening model with an abrupt stress release upon cracking. This class is intended to be used with ComputeSmearedCrackingStress.
- RankTwoCartesianComponentAccess a component of a RankTwoTensor
- RankTwoCylindricalComponentCompute components of a rank-2 tensor in a cylindrical coordinate system
- RankTwoDirectionalComponentCompute a Direction scalar property of a RankTwoTensor
- RankTwoInvariantCompute a invariant property of a RankTwoTensor
- SalehaniIrani3DCTraction3D Coupled (3DC) cohesive law of Salehani and Irani with no damage
- ScalarMaterialDamageScalar damage model for which the damage is prescribed by another material
- StrainEnergyDensityComputes the strain energy density using a combination of the elastic and inelastic components of the strain increment, which is a valid assumption for monotonic behavior.
- StrainEnergyRateDensityComputes the strain energy density rate using a combination of the elastic and inelastic components of the strain increment, which is a valid assumption for monotonic behavior.
- StressBasedChemicalPotentialChemical potential from stress
- SumTensorIncrementsCompute tensor property by summing tensor increments
- TemperatureDependentHardeningStressUpdateComputes the stress as a function of temperature and plastic strain from user-supplied hardening functions. This class can be used in conjunction with other creep and plasticity materials for more complex simulations
- TensileStressUpdateAssociative, smoothed, tensile (Rankine) plasticity with hardening/softening
- ThermalFractureIntegralCalculates summation of the derivative of the eigenstrains with respect to temperature.
- TwoPhaseStressMaterialCompute a global stress in a two phase model
- VolumeDeformGradCorrectedStressTransforms stress with volumetric term from previous configuration to this configuration
- XFEMApp
- ADLevelSetBiMaterialRankFourCompute a RankFourTensor material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- ADLevelSetBiMaterialRankTwoCompute a RankTwoTensor material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- ADLevelSetBiMaterialRealCompute a Real material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- ADXFEMCutSwitchingMaterialRankFourTensorSwitch the material property based on the CutSubdomainID.
- ADXFEMCutSwitchingMaterialRankThreeTensorSwitch the material property based on the CutSubdomainID.
- ADXFEMCutSwitchingMaterialRankTwoTensorSwitch the material property based on the CutSubdomainID.
- ADXFEMCutSwitchingMaterialRealSwitch the material property based on the CutSubdomainID.
- ComputeCrackTipEnrichmentSmallStrainComputes the crack tip enrichment at a point within a small strain formulation.
- LevelSetBiMaterialRankFourCompute a RankFourTensor material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- LevelSetBiMaterialRankTwoCompute a RankTwoTensor material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- LevelSetBiMaterialRealCompute a Real material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- XFEMCutSwitchingMaterialRankFourTensorSwitch the material property based on the CutSubdomainID.
- XFEMCutSwitchingMaterialRankThreeTensorSwitch the material property based on the CutSubdomainID.
- XFEMCutSwitchingMaterialRankTwoTensorSwitch the material property based on the CutSubdomainID.
- XFEMCutSwitchingMaterialRealSwitch the material property based on the CutSubdomainID.
- Misc App
- ADDensityCreates density AD material property
- DensityCreates density material property
- Black Bear App
- ConcreteASREigenstrainComputes the volumetric expansion eigenstrain due to alkali-silica reaction.
- ConcreteASRMicrocrackingDamageScalar damage model based on ASR extent
- ConcreteDryingShrinkageComputes concrete drying shrinkage
- ConcreteExpansionMicrocrackingDamageScalar damage model based on extent of internal expansion
- ConcreteLogarithmicCreepModelLogarithmic viscoelastic model for cementitious materials.
- ConcreteThermalMoistureMaterial parameters for thermal and moisture transport in concrete.
- MazarsDamageMazars scalar damage model
- NEMLStressUse a constitutive model in the NEML library to compute stress
- NEMLThermalExpansionEigenstrainUse a model in the NEML library to compute thermal expansion
- PorousMediaBaseMaterial parameters for thermal and moisture transport in concrete.
- Heat Conduction App
- ADElectricalConductivityCalculates resistivity and electrical conductivity as a function of temperature, using copper for parameter defaults.
- ADHeatConductionMaterialGeneral-purpose material model for heat conduction
- AnisoHeatConductionMaterial
- ElectricalConductivityCalculates resistivity and electrical conductivity as a function of temperature, using copper for parameter defaults.
- FunctionPathEllipsoidHeatSourceDouble ellipsoid volumetric source heat with function path.
- GapConductance
- GapConductanceConstantMaterial to compute a constant, prescribed gap conductance
- HeatConductionMaterialGeneral-purpose material model for heat conduction
- SemiconductorLinearConductivityCalculates electrical conductivity of a semiconductor from temperature
- SideSetHeatTransferMaterialThis material constructs the necessary coefficients and properties for SideSetHeatTransferKernel.
Mesh
- Moose App
- CreateDisplacedProblemActionCreate a Problem object that utilizes displacements.
- DisplayGhostingActionAction to setup AuxVariables and AuxKernels to display ghosting when running in parallel
- SetupMeshActionAdd or create Mesh object to the simulation.
- SetupMeshCompleteActionPerform operations on the mesh in preparation for a simulation.
- AddMeshGeneratorActionAdd a MeshGenerator object to the simulation.
- AllSideSetsByNormalsGeneratorAdds sidesets to the entire mesh based on unique normals.
- AnnularMeshGeneratorFor rmin>0: creates an annular mesh of QUAD4 elements. For rmin=0: creates a disc mesh of QUAD4 and TRI3 elements. Boundary sidesets are created at rmax and rmin, and given these names. If dmin!0 and dmax!360, a sector of an annulus or disc is created. In this case boundary sidesets are also created at dmin and dmax, and given these names
- BlockDeletionGeneratorMesh generator which removes elements from the specified subdomains
- BoundaryDeletionGeneratorMesh generator which removes side sets
- BoundingBoxNodeSetGeneratorAssigns all of the nodes either inside or outside of a bounding box to a new nodeset.
- BreakBoundaryOnSubdomainGeneratorBreak boundaries based on the subdomains to which their sides are attached. Naming convention for the new boundaries will be the old boundary name plus "_to_" plus the subdomain name
- BreakMeshByBlockGeneratorBreak boundaries based on the subdomains to which their sides are attached. Naming convention for the new boundaries will be the old boundary name plus "_to_" plus the subdomain name. At the momentthis only works on REPLICATED mesh
- CartesianMeshGeneratorThis CartesianMeshGenerator creates a non-uniform Cartesian mesh.
- CombinerGeneratorCombine multiple meshes (or copies of one mesh) together into one (disjoint) mesh. Can optionally translate those meshes before combining them.
- ConcentricCircleMeshGeneratorThis ConcentricCircleMeshGenerator source code is to generate concentric circle meshes.
- DistributedRectilinearMeshGeneratorCreate a line, square, or cube mesh with uniformly spaced or biased elements.
- ElementGeneratorGenerates individual elements given a list of nodal positions.
- ElementSubdomainIDGeneratorAllows the user to assign each element the subdomain ID of their choice
- ExtraNodesetGeneratorCreates a new node set and a new boundary made with the nodes the user provides.
- FancyExtruderGeneratorExtrudes a 2D mesh into 3D, can have variable a variable height for each elevation, variable number of layers within each elevation and remap subdomain_ids within each elevation
- FileMeshGeneratorRead a mesh from a file.
- GeneratedMeshGeneratorCreate a line, square, or cube mesh with uniformly spaced or biased elements.
- ImageMeshGeneratorGenerated mesh with the aspect ratio of a given image stack.
- ImageSubdomainGeneratorSamples an image at the coordinates of each element centroid, using the resulting pixel color value as each element's subdomain ID
- LowerDBlockFromSidesetGeneratorAdds lower dimensional elements on the specified sidesets.
- MeshCollectionGeneratorCollects multiple meshes into a single (unconnected) mesh.
- MeshExtruderGeneratorTakes a 1D or 2D mesh and extrudes the entire structure along the specified axis increasing the dimensionality of the mesh.
- MeshSideSetGeneratorAdd lower dimensional elements along the faces contained in a side set to set up mixed dimensional problems
- OrientedSubdomainBoundingBoxGeneratorDefines a subdomain inside or outside of a bounding box with arbitrary orientation.
- ParsedGenerateSidesetA MeshGenerator that adds element sides to a sideset if the centroid satisfies the
combinatorial_geometry
expression. Optionally, element sides are also added if they are included inincluded_subdomain_ids
and if they feature the designated normal. - ParsedSubdomainMeshGeneratorUses a parsed expression (
combinatorial_geometry
) to determine if an element (via its centroid) is inside the region defined by the expression and assigns a new block ID. - PatchMeshGeneratorCreates 2D or 3D patch meshes.
- PatternedMeshGeneratorCreates a 2D mesh from a specified set of unique 'tiles' meshes and a two-dimensional pattern.
- PlaneDeletionGeneratorRemoves elements lying 'above' the plane (in the direction of the normal).
- RenameBlockGeneratorRenameBlockGenerator re-numbers or re-names an
old_block_id
orold_block_name
with anew_block_id
ornew_block_name
. If using RenameBlockGenerator to merge blocks (by giving them the same name, for instance) it is advisable to specify all your blocks inold_blocks
to avoid inconsistencies - RenameBoundaryGeneratorChanges the boundary IDs and/or boundary names for a given set of boundaries defined by either boundary ID or boundary name. The changes are independent of ordering. The merging of boundaries is supported.
- RinglebMeshGeneratorCreates a mesh for the Ringleb problem.
- SideSetsAroundSubdomainGeneratorAdds element faces that are on the exterior of the given block to the sidesets specified
- SideSetsBetweenSubdomainsGeneratorMeshGenerator that creates a sideset composed of the nodes located between two or more subdomains.
- SideSetsFromBoundingBoxGeneratorDefines new sidesets using currently-defined sideset IDs inside or outside of a bounding box.
- SideSetsFromNormalsGeneratorAdds a new named sideset to the mesh for all faces matching the specified normal.
- SideSetsFromPointsGeneratorAdds a new sideset starting at the specified point containing all connected element faces with the same normal.
- SmoothMeshGeneratorUtilizes a simple Laplacian based smoother to attempt to improve mesh quality. Will not move boundary nodes or nodes along block/subdomain boundaries
- SpiralAnnularMeshGeneratorCreates an annular mesh based on TRI3 or TRI6 elements on several rings.
- StackGeneratorUse the supplied meshes and stitch them on top of each other
- StitchedMeshGeneratorAllows multiple mesh files to be stiched together to form a single mesh.
- SubdomainBoundingBoxGeneratorChanges the subdomain ID of elements either (XOR) inside or outside the specified box to the specified ID.
- SubdomainIDGeneratorSets all the elements of the input mesh to a unique subdomain ID.
- TiledMeshGeneratorUse the supplied mesh and create a tiled grid by repeating this mesh in the x, y, and z directions.
- TransformGeneratorApplies a linear transform to the entire mesh.
- AnnularMeshFor rmin>0: creates an annular mesh of QUAD4 elements. For rmin=0: creates a disc mesh of QUAD4 and TRI3 elements. Boundary sidesets are created at rmax and rmin, and given these names. If dmin!0 and dmax!360, a sector of an annulus or disc is created. In this case boundary sidesets are also created a dmin and dmax, and given these names
- ConcentricCircleMeshThis ConcentricCircleMesh source code is to generate concentric circle meshes.
- FileMeshRead a mesh from a file.
- GeneratedMeshCreate a line, square, or cube mesh with uniformly spaced or biased elements.
- ImageMeshGenerated mesh with the aspect ratio of a given image stack.
- MeshGeneratorMeshMesh generated from parameters
- PatternedMeshCreates a 2D mesh from a specified set of unique 'tiles' meshes and a two-dimensional pattern.
- RinglebMeshCreates a mesh for the Ringleb problem.
- SpiralAnnularMeshCreates an annual mesh based on TRI3 elements (it can also be TRI6 elements) on several rings.
- StitchedMeshReads in all of the given meshes and stitches them all together into one mesh.
- TiledMeshUse the supplied mesh and create a tiled grid by repeating this mesh in the x,y, and z directions.
- Partitioner
- Heat Conduction App
- PatchSidesetGeneratorDivides the given sideset into smaller patches of roughly equal size.
Mesh/Partitioner
- Moose App
- PartitionerActionAdd a Partitioner object to the simulation.
- BlockWeightedPartitionerPartition mesh by weighting blocks
- GridPartitionerCreate a uniform grid that overlays the mesh to be partitioned. Assign all elements within each cell of the grid to the same processor.
- HierarchicalGridPartitionerPartitions a mesh into sub-partitions for each computational node then into partitions within that node. All partitions are made using a regular grid.
- LibmeshPartitionerMesh partitioning using capabilities defined in libMesh.
- PetscExternalPartitionerPartition mesh using external packages via PETSc MatPartitioning interface
- RandomPartitionerAssigns element processor ids randomly with a given seed.
Modules
Modules/HeatConduction
Modules/HeatConduction/ThermalContact
Modules/HeatConduction/ThermalContact/BC
- Heat Conduction App
- ThermalContactActionAction that controls the creation of all of the necessary objects for calculation of Thermal Contact
Modules/TensorMechanics
Modules/TensorMechanics/CohesiveZoneMaster
- Tensor Mechanics App
- CohesiveZoneMasterActionAction to create an instance of the cohesive zone model kernel for each displacement component
Modules/TensorMechanics/GeneralizedPlaneStrain
- Tensor Mechanics App
- GeneralizedPlaneStrainActionSet up the GeneralizedPlaneStrain environment
Modules/TensorMechanics/GlobalStrain
- Tensor Mechanics App
- GlobalStrainActionSet up the GlobalStrainAction environment
Modules/TensorMechanics/LineElementMaster
- Tensor Mechanics App
- CommonLineElementActionSets up variables, stress divergence kernels and materials required for a static analysis with beam or truss elements. Also sets up aux variables, aux kernels, and consistent or nodal inertia kernels for dynamic analysis with beam elements.
- LineElementActionSets up variables, stress divergence kernels and materials required for a static analysis with beam or truss elements. Also sets up aux variables, aux kernels, and consistent or nodal inertia kernels for dynamic analysis with beam elements.
Modules/TensorMechanics/Master
- Tensor Mechanics App
- CommonTensorMechanicsActionStore common tensor mechanics parameters
- TensorMechanicsActionSet up stress divergence kernels with coordinate system aware logic
MultiApps
- Moose App
- AddMultiAppActionAdd a MultiApp object to the simulation.
- CentroidMultiAppAutomatically generates Sub-App positions from centroids of elements in the master mesh.
- FullSolveMultiAppPerforms a complete simulation during each execution.
- TransientMultiAppMultiApp for performing coupled simulations with the master and sub-application both progressing in time.
- Stochastic Tools App
- PODFullSolveMultiAppCreates a full-solve type sub-application for each row of a Sampler matrix. On second call, this object creates residuals for a PODReducedBasisTrainer with given basis functions.
- SamplerFullSolveMultiAppCreates a full-solve type sub-application for each row of each Sampler matrix.
- SamplerTransientMultiAppCreates a sub-application for each row of each Sampler matrix.
NodalKernels
- Moose App
- AddNodalKernelActionAdd a NodalKernel object to the simulation.
- ConstantRateComputes residual or the rate in a simple ODE of du/dt = rate.
- CoupledForceNodalKernelAdds a force proportional to the value of the coupled variable
- LowerBoundNodalKernelUsed to prevent a coupled variable from going below a lower bound
- PenaltyDirichletNodalKernelEnforces a Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet value on nodesets.
- ReactionNodalKernelImplements a simple consuming reaction term at nodes
- TimeDerivativeNodalKernelResidual contribution to an ODE form the time derivative acting at nodes.
- UpperBoundNodalKernelUsed to prevent a coupled variable from going above a upper bound
- UserForcingFunctionNodalKernelResidual contribution to an ODE from a source function acting at nodes.
- Tensor Mechanics App
- NodalGravityComputes the gravitational force for a given nodal mass.
- NodalRotationalInertiaCalculates the inertial torques and inertia proportional damping corresponding to the nodal rotational inertia.
- NodalTranslationalInertiaComputes the inertial forces and mass proportional damping terms corresponding to nodal mass.
NodalNormals
- Moose App
- AddNodalNormalsActionCreates Auxiliary variables and objects for computing the outward facing normal from a node.
Outputs
- Moose App
- CommonOutputActionAdds short-cut syntax and common parameters to the Outputs block.
- AddOutputActionAction responsible for creating Output objects.
- CSVOutput for postprocessors, vector postprocessors, and scalar variables using comma seperated values (CSV).
- CheckpointOutput for MOOSE recovery checkpoint files.
- ConsoleObject for screen output.
- ControlOutputOutput for displaying objects and parameters associated with the Control system.
- DOFMapOutput degree-of-freedom (DOF) map.
- ExodusObject for output data in the Exodus II format
- GMVObject for outputting data in the GMV format
- GnuplotOutput for postprocessors and scalar variables in GNU plot format.
- JSONOutput for Reporter values using JSON format.
- MaterialPropertyDebugOutputDebug output object for displaying material property information.
- NemesisObject for output data in the Nemesis (parallel ExodusII) format.
- PerfGraphOutputControls output of the PerfGraph: the performance log for MOOSE
- ReporterDebugOutputDebug output object for displaying Reporter information.
- SolutionHistoryOutputs the non-linear and linear iteration solve history.
- TecplotObject for outputting data in the Tecplot format
- TopResidualDebugOutputDebug output object for displaying the top contributing residuals.
- VTKOutput data using the Visualization Toolkit (VTK).
- VariableResidualNormsDebugOutputReports the residual norm for each variable.
- XDAObject for outputting data in the XDA/XDR format.
- XDRObject for outputting data in the XDA/XDR format.
- XMLOutputOutput for VectorPostprocessor using XML format.
- Ray Tracing App
- RayTracingExodusOutputs ray segments and data as segments using the Exodus format.
- RayTracingNemesisOutputs ray segments and data as segments using the Nemesis format.
- Stochastic Tools App
- SurrogateTrainerOutputOutput for trained surrogate model data.
Postprocessors
- Moose App
- AddPostprocessorActionAdd a Postprocessor object to the simulation.
- ADElementAverageMaterialPropertyComputes the average of a material property over a volume.
- ADElementExtremeMaterialPropertyDetermines the minimum or maximum of a material property over a volume.
- ADElementIntegralMaterialPropertyCompute the integral of the material property over the domain
- ADSideFluxAverageComputes the integral of the flux over the specified boundary
- ADSideFluxIntegralComputes the integral of the flux over the specified boundary
- AreaPostprocessorComputes the "area" or dimension - 1 "volume" of a given boundary or boundaries in your mesh.
- AverageElementSizeComputes the average element size.
- AverageNodalVariableValueComputes the average value of a field by sampling all nodal solutions on the domain or within a subdomain
- AxisymmetricCenterlineAverageValueComputes the average value of a variable on a sideset located along the centerline of an axisymmetric model.
- ChangeOverTimePostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- ChangeOverTimestepPostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- CumulativeValuePostprocessorCreates a cumulative sum of a Postprocessor value with time.
- DifferencePostprocessorComputes the difference between two postprocessors
- ElementArrayL2NormEvaluates L2-norm of a component of an array variable
- ElementAverageMaterialPropertyComputes the average of a material property over a volume.
- ElementAverageSecondTimeDerivativeComputes the element averaged second derivative of variable
- ElementAverageTimeDerivativeComputes a volume integral of the time derivative of a given variable
- ElementAverageValueComputes a volume integral of the specified variable
- ElementExtremeMaterialPropertyDetermines the minimum or maximum of a material property over a volume.
- ElementExtremeValueFinds either the min or max elemental value of a a variable over the domain.
- ElementH1ErrorComputes a volume integral of the specified variable
- ElementH1SemiErrorComputes a volume integral of the specified variable
- ElementIntegralArrayVariablePostprocessorIntegral of one component of an array variable.
- ElementIntegralMaterialPropertyCompute the integral of the material property over the domain
- ElementIntegralVariablePostprocessorComputes a volume integral of the specified variable
- ElementL1ErrorComputes L1 error between an elemental field variable and an analytical function.
- ElementL2DifferenceComputes the element-wise L2 difference between the current variable and a coupled variable.
- ElementL2ErrorComputes L2 error between a field variable and an analytical function
- ElementL2NormComputes a volume integral of the specified variable
- ElementVectorL2ErrorComputes the Vector L2 difference of up to three variables simultaneously (normally x, y, z)
- ElementW1pErrorComputes a volume integral of the specified variable
- ElementalVariableValueOutputs an elemental variable value at a particular location
- EmptyPostprocessorA postprocessor object that returns a value of zero.
- FindValueOnLineFind a specific target value along a sampling line. The variable values along the line should change monotonically. The target value is searched using a bisection algorithm.
- FunctionElementIntegralIntegrates a function over elements
- FunctionSideIntegralComputes the integral of a function over a boundary.
- FunctionValuePostprocessorComputes the value of a supplied function at a single point (scalable)
- GreaterThanLessThanPostprocessorCount number of DOFs of a non-linear variable that are greater than or less than a given threshold
- InterfaceAverageVariableValuePostprocessorComputes the average value of a variable on an interface. Note that this cannot be used on the centerline of an axisymmetric model.
- InterfaceIntegralVariableValuePostprocessorAdd access to variables and their gradient on an interface.
- LinearCombinationPostprocessorComputes a linear combination between an arbitrary number of post-processors
- MemoryUsageMemory usage statistics for the running simulation.
- NodalExtremeValueReports the minimum or maximum value of a variable.
- NodalL2ErrorThe L2-norm computed at nodes.
- NodalL2NormComputes the nodal L2-norm of the coupled variable, which is defined by summing the square of its value at every node and taking the square root.
- NodalMaxValueComputes the maximum (over all the nodal values) of a variable.
- NodalProxyMaxValueComputes the max value at a node and broadcasts it to all processors.
- NodalSumComputes the sum of all of the nodal values of the specified variable. Note: This object sets the default "unique_node_execute" flag to true to avoid double counting nodes between shared blocks.
- NodalVariableValueOutputs values of a nodal variable at a particular location
- NumDOFsReturn the number of Degrees of freedom from either the NL, Aux or both systems.
- NumElemsReturn the number of active or total elements in the simulation.
- NumLinearIterationsCompute the number of non-linear iterations.
- NumNodesReturns the total number of nodes in a simulation (works with DistributedMesh)
- NumNonlinearIterationsOutputs the number of nonlinear iterations
- NumPicardIterationsReturns the number of Picard iterations taken by the executioner.
- NumRelationshipManagersReturn the number of relationship managers active.
- NumResidualEvaluationsThe total number of Residual Evaluations performed.
- NumVarsReturn the number of variables from either the NL, Aux, or both systems.
- PercentChangePostprocessorComputes the percent change of a postprocessor value compared to the value at the previous timestep.
- PerfGraphDataRetrieves timing information from the PerfGraph.
- PerformanceDataProvides programmatic access to Performance Log Data
- PointValueCompute the value of a variable at a specified location
- PostprocessorComparisonCompares two post-processors and produces a boolean value
- ReceiverReports the value stored in this processor, which is usually filled in by another object. The Receiver does not compute its own value.
- RelativeDifferencePostprocessorComputes the absolute value of the relative difference between 2 post-processor values.
- RelativeSolutionDifferenceNormComputes the relative norm of the solution difference of two consecutive time steps.
- ResidualReport the non-linear residual.
- ScalarL2ErrorCompute L2 error of a scalar variable using analytic function.
- ScalarVariableReturns the value of a scalar variable as a postprocessor value.
- ScalePostprocessorScales a post-processor by a value
- SideAverageValueComputes the average value of a variable on a sideset. Note that this cannot be used on the centerline of an axisymmetric model.
- SideFluxAverageComputes the integral of the flux over the specified boundary
- SideFluxIntegralComputes the integral of the flux over the specified boundary
- SideIntegralVariablePostprocessorComputes a surface integral of the specified variable
- TimeExtremeValueA postprocessor for reporting the extreme value of another postprocessor over time.
- TimePostprocessorReports the current time
- TimestepSizeReports the timestep size
- TotalVariableValueIntegrate a Postprocessor value over time using trapezoidal rule.
- VariableInnerProductComputes a volume integral of the specified variable
- VariableResidualComputes the Residual of a single variable in the solution vector.
- VectorPostprocessorComparisonCompares two vector post-processors of equal size and produces a boolean value
- VectorPostprocessorComponentReturns the value of the specified component of a VectorPostprocessor
- VolumePostprocessorComputes the volume of a specified block
- Tensor Mechanics App
- ADMassComputes a volume integral of the specified variable
- ADMaterialTensorAverageComputes the average of a RankTwoTensor component over a volume.
- ADMaterialTensorIntegralThis postprocessor computes an element integral of a component of a material tensor as specified by the user-supplied indices
- ADSidesetReactionComputes the integrated reaction force in a user-specified direction on a sideset from the surface traction
- AsymptoticExpansionHomogenizationElasticConstantsPostprocessor for asymptotic expansion homogenization for elasticity
- CavityPressurePostprocessorInterfaces with the CavityPressureUserObject to store the initial number of moles of a gas contained within an internal volume.
- CrackFrontDataDetermines which nodes are along the crack front
- CriticalTimeStepComputes and reports the critical time step for the explicit solver.
- MassComputes a volume integral of the specified variable
- MaterialTensorAverageComputes the average of a RankTwoTensor component over a volume.
- MaterialTensorIntegralThis postprocessor computes an element integral of a component of a material tensor as specified by the user-supplied indices
- MaterialTimeStepPostprocessorThis postprocessor estimates a timestep that reduces the increment change in a material property below a given threshold.
- PolarMomentOfInertiaCompute the polar moment of inertia of a sideset w.r.t. a point and a direction
- SidesetReactionComputes the integrated reaction force in a user-specified direction on a sideset from the surface traction
- TorqueReactionTorqueReaction calculates the torque in 2D and 3Dabout a user-specified axis of rotation centeredat a user-specified origin.
- Misc App
- InternalVolumeComputes the volume of an enclosed area by performing an integral over a user-supplied boundary.
- Contact App
- ContactDOFSetSizeOutputs the number of dofs greater than a tolerance threshold indicating mechanical contact
- Heat Conduction App
- ADConvectiveHeatTransferSideIntegralComputes the total convective heat transfer across a boundary.
- ConvectiveHeatTransferSideIntegralComputes the total convective heat transfer across a boundary.
- GrayLambertSurfaceRadiationPPThis postprocessor allows to extract radiosity, heat flux density, and temperature from the GrayLambertSurfaceRadiationBase object.
- HomogenizedThermalConductivityPostprocessor for asymptotic expansion homogenization for thermal conductivity
- ThermalConductivityComputes the average value of a variable on a sideset. Note that this cannot be used on the centerline of an axisymmetric model.
- ViewFactorPPThis postprocessor allows to extract view factors from ViewFactor userobjects.
- Ray Tracing App
- RayDataValueObtains a value from the data or aux data of a Ray after tracing has been completed.
- RayIntegralValueObtains the integrated value accumulated into a Ray from an IntegralRayKernel-derived class.
- RayTracingStudyResultGets a result from a RayTracingStudy.
Preconditioning
- Moose App
- SetupPreconditionerActionAdd a Preconditioner object to the simulation.
- AddFieldSplitActionAdd a Split object to the simulation.
- SplitField split based preconditioner for nonlinear solver.
- FDPFinite difference preconditioner (FDP) builds a numerical Jacobian for preconditioning, only use for testing and verification.
- FSPPreconditioner designed to map onto PETSc's PCFieldSplit.
- PBPPhysics-based preconditioner (PBP) allows individual physics to have their own preconditioner.
- SMPSingle matrix preconditioner (SMP) builds a preconditioner using user defined off-diagonal parts of the Jacobian.
- Contact App
- ContactSplitSplit-based preconditioner that partitions the domain into DOFs directly involved in contact (on contact surfaces) and those that are not
Problem
- Moose App
- CreateProblemActionAdd a Problem object to the simulation.
- DynamicObjectRegistrationActionRegister MooseObjects from other applications dynamically.
- DisplacedProblemA Problem object for provided access to the displaced finite element mesh and associated variables.
- DumpObjectsProblemSingle purpose problem object that does not run the given input but allows deconstructing actions into their series of underlying Moose objects and variables.
- EigenProblemProblem object for solving Eigen value problem.
- FEProblemA normal (default) Problem object that contains a single NonlinearSystem and a single AuxiliarySystem object.
- ReferenceResidualProblemProblem that checks for convergence relative to a user-supplied reference quantity rather than the initial residual
- Contact App
- AugmentedLagrangianContactProblemManages nested solution for augmented Lagrange contact
RayBCs
- Ray Tracing App
- AddRayBCActionAdds a RayBC for use in ray tracing to the simulation.
- KillRayBCA RayBC that kills a Ray on a boundary.
- NullRayBCA RayBC that does nothing to a Ray on a boundary.
- ReflectRayBCA RayBC that reflects a Ray in a specular manner on a boundary.
- Heat Conduction App
- ViewFactorRayBCThis ray boundary condition is applied on all sidesets bounding a radiation cavity except symmetry sidesets. It kills rays that hit the sideset and scores the ray for computation of view factors.
RayKernels
- Ray Tracing App
- AddRayKernelActionAdds a RayKernel for use in ray tracing to the simulation.
- ADLineSourceRayKernelDemonstrates the multiple ways that scalar values can be introduced into RayKernels, e.g. (controllable) constants, functions, postprocessors, and data on rays. Implements the weak form along a line.
- FunctionIntegralRayKernelIntegrates a function along a Ray.
- KillRayKernelA RayKernel that kills a Ray.
- LineSourceRayKernelDemonstrates the multiple ways that scalar values can be introduced into RayKernels, e.g. (controllable) constants, functions, postprocessors, and data on rays. Implements the weak form along a line.
- MaterialIntegralRayKernelIntegrates a Material property along a Ray.
- NullRayKernelA RayKernel that does nothing.
- RayDistanceAuxAccumulates the distance traversed by each Ray segment into an aux variable for the element that the segments are in.
- VariableIntegralRayKernelIntegrates a Variable or AuxVariable along a Ray.
Reporters
- Moose App
- AddReporterActionAdd a Reporter object to the simulation.
- ConstantReporterReporter with constant values to be accessed by other objects, can be modified using transfers.
- IterationInfoReport the time and iteration information for the simulation.
- MeshInfoReport the time and iteration information for the simulation.
- Stochastic Tools App
- StatisticsReporterCompute statistical values of a given VectorPostprocessor objects and vectors.
- StochasticReporterStorage container for stochastic simulation results coming from Reporters.
Samplers
- Moose App
- AddSamplerActionAdd a Sampler object to the simulation.
- Stochastic Tools App
- CSVSamplerSampler that reads samples from CSV file.
- CartesianProductProvides complete Cartesian product for the supplied variables.
- CartesianProductSamplerProvides complete Cartesian product for the supplied variables.
- LatinHypercubeLatin Hypercube Sampler.
- MonteCarloMonte Carlo Sampler.
- MonteCarloSamplerMonte Carlo Sampler.
- QuadratureQuadrature sampler for Polynomial Chaos.
- QuadratureSamplerQuadrature sampler for Polynomial Chaos.
- SobolSobol variance-based sensitivity analysis Sampler.
- SobolSamplerSobol variance-based sensitivity analysis Sampler.
ScalarKernels
- Moose App
- AddScalarKernelActionAdd a AuxScalarKernel object to the simulation.
- AverageValueConstraintThis class is used to enforce integral of phi with a Lagrange multiplier approach.
- CoupledODETimeDerivativeResidual contribution of ODE from the time derivative of a coupled variable.
- NodalEqualValueConstraintConstrain two nodes to have identical values.
- ODETimeDerivativeReturns the time derivative contribution to the residual for a scalar variable.
- ParsedODEKernelParsed ODE function kernel.
- Tensor Mechanics App
- GeneralizedPlaneStrainGeneralized Plane Strain Scalar Kernel
- GlobalStrainScalar Kernel to solve for the global strain
StochasticTools
- Stochastic Tools App
- StochasticToolsActionAction for performing some common functions for running stochastic simulations.
Surrogates
- Stochastic Tools App
- AddSurrogateActionAdds SurrogateTrainer and SurrogateModel objects contained within the
[Trainers]
and[Surrogates]
input blocks. - GaussianProcessComputes and evaluates Gaussian Process surrogate model.
- NearestPointSurrogateSurrogate that evaluates the value from the nearest point from data in NearestPointTrainer
- PODReducedBasisSurrogateEvaluates POD-RB surrogate model with reduced operators computed from PODReducedBasisTrainer.
- PolynomialChaosComputes and evaluates polynomial chaos surrogate model.
- PolynomialRegressionSurrogateEvaluates polynomial regression model with coefficients computed from PolynomialRegressionTrainer.
ThermalContact
- Heat Conduction App
- ThermalContactActionAction that controls the creation of all of the necessary objects for calculation of Thermal Contact
Trainers
- Stochastic Tools App
- AddSurrogateActionAdds SurrogateTrainer and SurrogateModel objects contained within the
[Trainers]
and[Surrogates]
input blocks. - GaussianProcessTrainerProvides data preperation and training for a Gaussian Process surrogate model.
- NearestPointTrainerLoops over and saves sample values for NearestPointSurrogate.
- PODReducedBasisTrainerComputes the reduced subspace plus the reduced operators for POD-RB surrogate.
- PolynomialChaosTrainerComputes and evaluates polynomial chaos surrogate model.
- PolynomialRegressionTrainerComputes coefficients for polynomial regession model.
Transfers
- Moose App
- AddTransferActionAdd a Transfer object to the simulation.
- MultiAppCloneReporterTransferDeclare and transfer reporter data from sub-application(s) to main application.
- MultiAppCopyTransferCopies variables (nonlinear and auxiliary) between multiapps that have identical meshes.
- MultiAppInterpolationTransferTransfers the value to the target domain from the nearest node in the source domain.
- MultiAppMeshFunctionTransferTransfers field data at the MultiApp position using solution the finite element function from the master application, via a 'libMesh::MeshFunction' object.
- MultiAppNearestNodeTransferTransfer the value to the target domain from the nearest node in the source domain.
- MultiAppPostprocessorInterpolationTransferTransfer postprocessor data from sub-application into field data on the master application.
- MultiAppPostprocessorToAuxScalarTransferTransfers from a postprocessor to an scalar auxiliary variable.
- MultiAppPostprocessorTransferTransfers postprocessor data between the master application and sub-application(s).
- MultiAppProjectionTransferPerform a projection between a master and sub-application mesh of a field variable.
- MultiAppReporterTransferTransfers reporter data between the main application and sub-application(s).
- MultiAppScalarToAuxScalarTransferTransfers data between a scalar non-linear variable and a scalar auxiliary variable.
- MultiAppUserObjectTransferSamples a variable's value in the Master domain at the point where the MultiApp is and copies that value into a post-processor in the MultiApp
- MultiAppVariableValueSamplePostprocessorTransferTransfers the value of a variable within the master application at each sub-application position and transfers the value to a postprocessor on the sub-application(s).
- MultiAppVariableValueSampleTransferTransfers the value of a variable within the master application at each sub-application position and transfers the value to a field variable on the sub-application(s).
- MultiAppVectorPostprocessorTransferThis transfer distributes the N values of a VectorPostprocessor to Postprocessors located in N sub-apps or collects Postprocessor values from N sub-apps into a VectorPostprocessor
- Stochastic Tools App
- PODResidualTransferTransfers residual vectors from the sub-application to a a container in the Trainer object.
- PODSamplerSolutionTransferTransfers solution vectors from the sub-applications to a a container in the Trainer object and back.
- SamplerParameterTransferCopies Sampler data to a SamplerReceiver object.
- SamplerPostprocessorTransferTransfers data from Postprocessors on the sub-application to a VectorPostprocessor on the master application.
- SamplerReporterTransferTransfers data from Reporters on the sub-application to a StochasticReporter on the main application.
- SamplerTransferCopies Sampler data to a SamplerReceiver object.
UserObjects
- Moose App
- AddUserObjectActionAdd a UserObject object to the simulation.
- ADElementAverageMaterialPropertyComputes the average of a material property over a volume.
- ADElementExtremeMaterialPropertyDetermines the minimum or maximum of a material property over a volume.
- ADElementIntegralMaterialPropertyCompute the integral of the material property over the domain
- ADSideFluxAverageComputes the integral of the flux over the specified boundary
- ADSideFluxIntegralComputes the integral of the flux over the specified boundary
- ActivateElementsByPathDetermine activated elements.
- ActivateElementsCoupledDetermine activated elements.
- AreaPostprocessorComputes the "area" or dimension - 1 "volume" of a given boundary or boundaries in your mesh.
- AverageElementSizeComputes the average element size.
- AverageNodalVariableValueComputes the average value of a field by sampling all nodal solutions on the domain or within a subdomain
- AxisymmetricCenterlineAverageValueComputes the average value of a variable on a sideset located along the centerline of an axisymmetric model.
- ChangeOverTimePostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- ChangeOverTimestepPostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- CoupledVarThresholdElementSubdomainModifierModify element subdomain ID. This userobject only runs on the undisplaced mesh, and it will modify both the undisplaced and the displaced mesh.
- CumulativeValuePostprocessorCreates a cumulative sum of a Postprocessor value with time.
- DifferencePostprocessorComputes the difference between two postprocessors
- ElemSideNeighborLayersGeomTesterUser object to calculate ghosted elements on a single processor or the union across all processors.
- ElemSideNeighborLayersTesterUser object to calculate ghosted elements on a single processor or the union across all processors.
- ElementArrayL2NormEvaluates L2-norm of a component of an array variable
- ElementAverageMaterialPropertyComputes the average of a material property over a volume.
- ElementAverageSecondTimeDerivativeComputes the element averaged second derivative of variable
- ElementAverageTimeDerivativeComputes a volume integral of the time derivative of a given variable
- ElementAverageValueComputes a volume integral of the specified variable
- ElementExtremeMaterialPropertyDetermines the minimum or maximum of a material property over a volume.
- ElementExtremeValueFinds either the min or max elemental value of a a variable over the domain.
- ElementH1ErrorComputes a volume integral of the specified variable
- ElementH1SemiErrorComputes a volume integral of the specified variable
- ElementIntegralArrayVariablePostprocessorIntegral of one component of an array variable.
- ElementIntegralMaterialPropertyCompute the integral of the material property over the domain
- ElementIntegralVariablePostprocessorComputes a volume integral of the specified variable
- ElementIntegralVariableUserObjectcomputes a volume integral of a variable.
- ElementL1ErrorComputes L1 error between an elemental field variable and an analytical function.
- ElementL2DifferenceComputes the element-wise L2 difference between the current variable and a coupled variable.
- ElementL2ErrorComputes L2 error between a field variable and an analytical function
- ElementL2NormComputes a volume integral of the specified variable
- ElementQualityCheckerClass to check the quality of each element using different metrics from libmesh.
- ElementVectorL2ErrorComputes the Vector L2 difference of up to three variables simultaneously (normally x, y, z)
- ElementW1pErrorComputes a volume integral of the specified variable
- ElementalVariableValueOutputs an elemental variable value at a particular location
- EmptyPostprocessorA postprocessor object that returns a value of zero.
- FindValueOnLineFind a specific target value along a sampling line. The variable values along the line should change monotonically. The target value is searched using a bisection algorithm.
- FunctionElementIntegralIntegrates a function over elements
- FunctionSideIntegralComputes the integral of a function over a boundary.
- FunctionValuePostprocessorComputes the value of a supplied function at a single point (scalable)
- GeometrySphereSnap nodes to the surface of a sphere on adaptivity
- GhostingUserObjectCreates ghosting maps that can be queried by external objects.
- GreaterThanLessThanPostprocessorCount number of DOFs of a non-linear variable that are greater than or less than a given threshold
- InterfaceAverageVariableValuePostprocessorComputes the average value of a variable on an interface. Note that this cannot be used on the centerline of an axisymmetric model.
- InterfaceIntegralVariableValuePostprocessorAdd access to variables and their gradient on an interface.
- InterfaceQpMaterialPropertyRealUOComputes the value, rate or increment of a Real Material property across an interface. The value, rate or increment is computed according to the provided interface_value_type parameter
- InterfaceQpValueUserObjectComputes the variable value, rate or increment across an interface. The value, rate or increment is computed according to the provided interface_value_type parameter
- LayeredAveragecomputes a volume integral of a variable.
- LayeredIntegralcomputes a volume integral of a variable.
- LayeredSideAverageComputes side averages of a variable storing partial sums for the specified number of intervals in a direction (x,y,z).
- LayeredSideFluxAverageComputes the diffusive flux of a variable on layers alongside a boundary.
- LayeredSideIntegralComputes volume integral of a variable storing partial sums for the specified number of intervals in a direction (x,y,z).
- LinearCombinationPostprocessorComputes a linear combination between an arbitrary number of post-processors
- MemoryUsageMemory usage statistics for the running simulation.
- NearestPointLayeredAverageComputes averages of a variable storing partial sums for the specified number of intervals in a direction (x,y,z). Given a list of points this object computes the layered average closest to each one of those points.
- NearestPointLayeredIntegralComputes integrals of a variable storing partial sums for the specified number of intervals in a direction (x,y,z). Given a list of points this object computes the layered integral closest to each one of those points.
- NearestPointLayeredSideAverageCompute layered side averages for nearest-point based subdomains
- NearestRadiusLayeredAverageComputes averages of a variable storing partial sums for the specified number of intervals in a direction (x,y,z). Given a list of points this object computes the layered average closest to each one of those points, where the distance is computed in terms of radius (or distance to the origin in the plane perpendicular to 'direction').
- NodalExtremeValueReports the minimum or maximum value of a variable.
- NodalL2ErrorThe L2-norm computed at nodes.
- NodalL2NormComputes the nodal L2-norm of the coupled variable, which is defined by summing the square of its value at every node and taking the square root.
- NodalMaxValueComputes the maximum (over all the nodal values) of a variable.
- NodalNormalsCornerComputes nodal normals at boundary corners.
- NodalNormalsEvaluatorHelper object to compute nodal normal values via the NodalNormals input block.
- NodalNormalsPreprocessorAn object that prepares MOOSE for computing nodal normal vectors. This object is automatically created via the [NodalNormals] input block.
- NodalProxyMaxValueComputes the max value at a node and broadcasts it to all processors.
- NodalSumComputes the sum of all of the nodal values of the specified variable. Note: This object sets the default "unique_node_execute" flag to true to avoid double counting nodes between shared blocks.
- NodalVariableValueOutputs values of a nodal variable at a particular location
- NumDOFsReturn the number of Degrees of freedom from either the NL, Aux or both systems.
- NumElemsReturn the number of active or total elements in the simulation.
- NumLinearIterationsCompute the number of non-linear iterations.
- NumNodesReturns the total number of nodes in a simulation (works with DistributedMesh)
- NumNonlinearIterationsOutputs the number of nonlinear iterations
- NumPicardIterationsReturns the number of Picard iterations taken by the executioner.
- NumRelationshipManagersReturn the number of relationship managers active.
- NumResidualEvaluationsThe total number of Residual Evaluations performed.
- NumVarsReturn the number of variables from either the NL, Aux, or both systems.
- PercentChangePostprocessorComputes the percent change of a postprocessor value compared to the value at the previous timestep.
- PerfGraphDataRetrieves timing information from the PerfGraph.
- PerformanceDataProvides programmatic access to Performance Log Data
- PointValueCompute the value of a variable at a specified location
- PostprocessorComparisonCompares two post-processors and produces a boolean value
- PostprocessorSpatialUserObjectUser object (spatial) that holds a postprocessor value.
- ReceiverReports the value stored in this processor, which is usually filled in by another object. The Receiver does not compute its own value.
- RelativeDifferencePostprocessorComputes the absolute value of the relative difference between 2 post-processor values.
- RelativeSolutionDifferenceNormComputes the relative norm of the solution difference of two consecutive time steps.
- ResidualReport the non-linear residual.
- ScalarL2ErrorCompute L2 error of a scalar variable using analytic function.
- ScalarVariableReturns the value of a scalar variable as a postprocessor value.
- ScalePostprocessorScales a post-processor by a value
- SideAverageValueComputes the average value of a variable on a sideset. Note that this cannot be used on the centerline of an axisymmetric model.
- SideFluxAverageComputes the integral of the flux over the specified boundary
- SideFluxIntegralComputes the integral of the flux over the specified boundary
- SideIntegralVariablePostprocessorComputes a surface integral of the specified variable
- SolutionUserObjectReads a variable from a mesh in one simulation to another
- TerminatorRequests termination of the current solve based on the values of Postprocessor value(s) via a logical expression.
- TimeExtremeValueA postprocessor for reporting the extreme value of another postprocessor over time.
- TimePostprocessorReports the current time
- TimestepSizeReports the timestep size
- TotalVariableValueIntegrate a Postprocessor value over time using trapezoidal rule.
- VariableInnerProductComputes a volume integral of the specified variable
- VariableResidualComputes the Residual of a single variable in the solution vector.
- VectorPostprocessorComparisonCompares two vector post-processors of equal size and produces a boolean value
- VectorPostprocessorComponentReturns the value of the specified component of a VectorPostprocessor
- VerifyElementUniqueIDVerifies that all element ids are unique.
- VerifyNodalUniqueIDVerifies that all node ids are unique.
- VolumePostprocessorComputes the volume of a specified block
- Tensor Mechanics App
- ADMassComputes a volume integral of the specified variable
- ADMaterialTensorAverageComputes the average of a RankTwoTensor component over a volume.
- ADMaterialTensorIntegralThis postprocessor computes an element integral of a component of a material tensor as specified by the user-supplied indices
- ADSidesetReactionComputes the integrated reaction force in a user-specified direction on a sideset from the surface traction
- AsymptoticExpansionHomogenizationElasticConstantsPostprocessor for asymptotic expansion homogenization for elasticity
- CavityPressurePostprocessorInterfaces with the CavityPressureUserObject to store the initial number of moles of a gas contained within an internal volume.
- CavityPressureUserObjectUses the ideal gas law to compute internal pressure and an initial moles of gas quantity.
- CrackFrontDataDetermines which nodes are along the crack front
- CrackFrontDefinitionUsed to describe geometric characteristics of the crack front for fracture integral calculations
- CriticalTimeStepComputes and reports the critical time step for the explicit solver.
- CrystalPlasticitySlipRateGSSPhenomenological constitutive model slip rate class. Override the virtual functions in your class
- CrystalPlasticitySlipResistanceGSSPhenomenological constitutive models' slip resistance base class. Override the virtual functions in your class
- CrystalPlasticityStateVarRateComponentGSSPhenomenological constitutive model state variable evolution rate component base class. Override the virtual functions in your class
- CrystalPlasticityStateVarRateComponentVocePhenomenological Voce constitutive model state variable evolution rate component base class.
- CrystalPlasticityStateVariableCrystal plasticity state variable class. Override the virtual functions in your class
- ElementPropertyReadFileUser Object to read property data from an external file and assign to elements.
- EulerAngleFileReaderRead Euler angle data from a file and provide it to other objects.
- GeneralizedPlaneStrainUserObjectGeneralized plane strain UserObject to provide residual and diagonal Jacobian entries.
- GlobalStrainUserObjectGlobal Strain UserObject to provide Residual and diagonal Jacobian entry
- HEVPEqvPlasticStrainUser Object to integrate equivalent plastic strain
- HEVPEqvPlasticStrainRateUser Object computing equivalent plastic strain rate
- HEVPFlowRatePowerLawJ2User object to evaluate power law flow rate and flow direction based on J2
- HEVPLinearHardeningUser Object for linear hardening
- HEVPRambergOsgoodHardeningUser object for Ramberg-Osgood hardening power law hardening
- LinearViscoelasticityManagerManages the updating of the semi-implicit single-step first-order finite difference time-stepping scheme
- MassComputes a volume integral of the specified variable
- MaterialTensorAverageComputes the average of a RankTwoTensor component over a volume.
- MaterialTensorIntegralThis postprocessor computes an element integral of a component of a material tensor as specified by the user-supplied indices
- MaterialTimeStepPostprocessorThis postprocessor estimates a timestep that reduces the increment change in a material property below a given threshold.
- PolarMomentOfInertiaCompute the polar moment of inertia of a sideset w.r.t. a point and a direction
- SidesetReactionComputes the integrated reaction force in a user-specified direction on a sideset from the surface traction
- TensorMechanicsHardeningConstantNo hardening - the parameter is independent of the internal parameter(s)
- TensorMechanicsHardeningCubicHardening is Cubic
- TensorMechanicsHardeningCutExponentialHardening is Cut-exponential
- TensorMechanicsHardeningExponentialHardening is Exponential
- TensorMechanicsHardeningGaussianHardening is Gaussian
- TensorMechanicsHardeningPowerRuleHardening defined by power rule
- TensorMechanicsPlasticDruckerPragerNon-associative Drucker Prager plasticity with no smoothing of the cone tip.
- TensorMechanicsPlasticDruckerPragerHyperbolicNon-associative Drucker Prager plasticity with hyperbolic smoothing of the cone tip.
- TensorMechanicsPlasticIsotropicSDIsotropicSD plasticity for pressure sensitive materials and also models the strength differential effect
- TensorMechanicsPlasticJ2J2 plasticity, associative, with hardening
- TensorMechanicsPlasticMeanCapClass that limits the mean stress. Yield function = a*mean_stress - strength. mean_stress = (stress_xx + stress_yy + stress_zz)/3
- TensorMechanicsPlasticMeanCapTCAssociative mean-cap tensile and compressive plasticity with hardening/softening
- TensorMechanicsPlasticMohrCoulombNon-associative Mohr-Coulomb plasticity with hardening/softening
- TensorMechanicsPlasticMohrCoulombMultiNon-associative Mohr-Coulomb plasticity with hardening/softening
- TensorMechanicsPlasticOrthotropicOrthotropic plasticity for pressure sensitive materials and also models the strength differential effect
- TensorMechanicsPlasticSimpleTesterClass that can be used for testing multi-surface plasticity models. Yield function = a*stress_yy + b*stress_zz + c*stress_xx + d*(stress_xy + stress_yx)/2 + e*(stress_xz + stress_zx)/2 + f*(stress_yz + stress_zy)/2 - strength
- TensorMechanicsPlasticTensileAssociative tensile plasticity with hardening/softening, and tensile_strength = 1
- TensorMechanicsPlasticTensileMultiAssociative tensile plasticity with hardening/softening
- TensorMechanicsPlasticWeakPlaneShearNon-associative finite-strain weak-plane shear perfect plasticity. Here cohesion = 1, tan(phi) = 1 = tan(psi)
- TensorMechanicsPlasticWeakPlaneTensileAssociative weak-plane tensile plasticity with hardening/softening
- TensorMechanicsPlasticWeakPlaneTensileNAssociative weak-plane tensile plasticity with hardening/softening, with specified, fixed normal vector. (WeakPlaneTensile combined with specifying N in the Material might be preferable to you.)
- TorqueReactionTorqueReaction calculates the torque in 2D and 3Dabout a user-specified axis of rotation centeredat a user-specified origin.
- XFEMApp
- CircleCutUserObjectCreates a UserObject for circular cuts on 3D meshes for XFEM
- ComboCutUserObjectCombine multiple geometric cut userobjects.
- CutElementSubdomainModifierChange element subdomain based on CutSubdomainID
- EllipseCutUserObjectCreates a UserObject for elliptical cuts on 3D meshes for XFEM
- LevelSetCutUserObjectXFEM mesh cut by level set function
- LineSegmentCutSetUserObjectCreates a UserObject for a line segment cut on 2D meshes for XFEM
- LineSegmentCutUserObjectCreates a UserObject for a line segment cut on 2D meshes for XFEM
- MeshCut3DUserObjectCreates a UserObject for a mesh cutter in 3D problems
- MovingLineSegmentCutSetUserObjectCreates a UserObject for a moving line segment cut on 2D meshes for XFEM
- PointValueAtXFEMInterfaceObtain field values and gradients on the interface.
- RectangleCutUserObjectCreates a UserObject for planar cuts on 3D meshes for XFEM
- XFEMPhaseTransitionMovingInterfaceVelocitycalculate the interface velocity for a simple phase transition problem.
- XFEMRankTwoTensorMarkerUserObjectMark elements to be cut by XFEM based on a scalar extracted from a RankTwoTensor
- Misc App
- InternalVolumeComputes the volume of an enclosed area by performing an integral over a user-supplied boundary.
- RigidBodyModes3D
- Contact App
- ContactDOFSetSizeOutputs the number of dofs greater than a tolerance threshold indicating mechanical contact
- NodalAreaCompute the tributary area for nodes on a surface
- Heat Conduction App
- ADConvectiveHeatTransferSideIntegralComputes the total convective heat transfer across a boundary.
- ConstantViewFactorSurfaceRadiationConstantViewFactorSurfaceRadiation computes radiative heat transfer between side sets and the view factors are provided in the input file
- ConvectiveHeatTransferSideIntegralComputes the total convective heat transfer across a boundary.
- GrayLambertSurfaceRadiationPPThis postprocessor allows to extract radiosity, heat flux density, and temperature from the GrayLambertSurfaceRadiationBase object.
- HomogenizedThermalConductivityPostprocessor for asymptotic expansion homogenization for thermal conductivity
- RayTracingViewFactorComputes view factors for arbitrary geometries using raytracing.
- ThermalConductivityComputes the average value of a variable on a sideset. Note that this cannot be used on the centerline of an axisymmetric model.
- UnobstructedPlanarViewFactorComputes the view factors for planar faces in unubstructed radiative heat transfer.
- ViewFactorObjectSurfaceRadiationViewFactorObjectSurfaceRadiation computes radiative heat transfer between side sets and the view factors are computed by a ViewFactor object
- ViewFactorPPThis postprocessor allows to extract view factors from ViewFactor userobjects.
- ViewFactorRayStudyThis ray study is used to compute view factors in cavities with obstruction. It sends out rays from surfaces bounding the radiation cavity into a set of directions determined by an angular quadrature. The rays are tracked and view factors are computed by determining the surface where the ray dies.
- Ray Tracing App
- ConeRayStudyRay study that spawns Rays in the direction of a cone from a given set of starting points.
- RayDataValueObtains a value from the data or aux data of a Ray after tracing has been completed.
- RayIntegralValueObtains the integrated value accumulated into a Ray from an IntegralRayKernel-derived class.
- RayTracingStudyResultGets a result from a RayTracingStudy.
- RepeatableRayStudyA ray tracing study that generates rays from vector of user-input start points and end points/directions.
Variables
- Moose App
- AddVariableActionAdd a non-linear variable to the simulation.
- CopyNodalVarsActionCopies variable information from a file.
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange or Nedelec
VectorPostprocessors
- Moose App
- AddVectorPostprocessorActionAdd a VectorPostprocessor object to the simulation.
- CSVReaderConverts columns of a CSV file into vectors of a VectorPostprocessor.
- ConstantVectorPostprocessorPopulate constant VectorPostprocessorValue directly from input file.
- CylindricalAverageCompute a cylindrical average of a variableas a function of radius throughout the simulation domain.
- EigenvaluesReturns the Eigen values from the nonlinear Eigen system.
- ElementValueSamplerSamples values of elemental variable(s).
- ElementVariablesDifferenceMaxComputes the largest difference between two variable fields.
- ElementsAlongLineOutputs the IDs of every element intersected by a user-defined line
- ElementsAlongPlaneOutputs the IDs of every element intersected by a user-defined plane
- HistogramVectorPostprocessorCompute a histogram for each column of a VectorPostprocessor
- IntersectionPointsAlongLineGet the intersection points for all of the elements that are intersected by a line.
- LeastSquaresFitPerforms a polynomial least squares fit on the data contained in another VectorPostprocessor
- LeastSquaresFitHistoryPerforms a polynomial least squares fit on the data contained in another VectorPostprocessor and stores the full time history of the coefficients
- LineFunctionSamplerSample a function along a line.
- LineMaterialRealSamplerSamples real-valued material properties for all quadrature points in all elements that are intersected by a specified line
- LineValueSamplerSamples variable(s) along a specified line
- MaterialVectorPostprocessorRecords all scalar material properties of a material object on elements at the indicated execution points.
- NearestPointIntegralVariablePostprocessorCompute element variable integrals for nearest-point based subdomains
- NodalValueSamplerSamples values of nodal variable(s).
- PiecewiseFunctionTabulateTabulate the function nodes of a piecewise function, such as PiecewiseLinear or PiecewiseConstant
- PointValueSamplerSample a variable at specific points.
- SideValueSamplerSample variable along a line associated with a boundary.
- SidesetInfoVectorPostprocessorThis VectorPostprocessor collects meta data for provided sidesets.
- SphericalAverageCompute a spherical average of a variable as a function of radius throughout the simulation domain.
- VectorMemoryUsageGet memory stats for all ranks in the simulation
- VectorOfPostprocessorsOutputs the values of an arbitrary user-specified set of postprocessors as a vector in the order specified by the user
- VolumeHistogramCompute a histogram of volume fractions binned according to variable values.
- WorkBalanceComputes several metrics for workload balance per processor
- Tensor Mechanics App
- InteractionIntegralComputes the interaction integral, which is used to compute various fracture mechanics parameters at a crack tip, including KI, KII, KIII, and the T stress.
- JIntegralComputes the J-Integral, a measure of the strain energy release rate at a crack tip, which can be used as a criterion for fracture growth. It can, alternatively, compute the C(t) integral
- LineMaterialRankTwoSamplerAccess a component of a RankTwoTensor
- LineMaterialRankTwoScalarSamplerCompute a scalar property of a RankTwoTensor
- MixedModeEquivalentKComputes the mixed-mode stress intensity factor given the , , and stress intensity factors
- Heat Conduction App
- SurfaceRadiationVectorPostprocessorVectorPostprocessor for accessing information stored in surface radiation user object
- ViewfactorVectorPostprocessorVectorPostprocessor for accessing view factors from GrayLambertSurfaceRadiationBase UO
- Ray Tracing App
- PerProcessorRayTracingResultsVectorPostprocessorAccumulates ray tracing results (information about the trace) on a per-processor basis.
- Stochastic Tools App
- EvaluateGaussianProcessTool for sampling gaussian process surrogate models.
- EvaluateSurrogateTool for sampling surrogate models.
- GaussianProcessDataTool for extracting hyperparameter data from gaussian process user object and storing in VectorPostprocessor vectors.
- PolynomialChaosDataTool for extracting data from polynomial chaos user object and storing in VectorPostprocessor vectors.
- PolynomialChaosLocalSensitivityTool for calculating local sensitivity with polynomial chaos expansion.
- PolynomialChaosSobolStatisticsCompute SOBOL statistics values of a trained PolynomialChaos surrogate.
- PolynomialChaosStatisticsTool for calculating statistics with polynomial chaos expansion.
- SamplerDataTool for extracting Sampler object data and storing in VectorPostprocessor vectors.
- SobolStatisticsCompute SOBOL statistics values of a given VectorPostprocessor objects and vectors.
- StatisticsCompute statistical values of a given VectorPostprocessor objects and vectors.
- StochasticResultsStorage container for stochastic simulation results coming from a Postprocessor.
XFEM
- XFEMApp
- XFEMActionAction to input general parameters and simulation options for use in XFEM.