Complete Ferret Syntax

Adaptivity

Adaptivity/Indicators

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
  • BoundaryPreservedMarkerMarks elements for refinement or coarsening based on the provided marker value, while preserving the given boundary.
  • 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.
  • ReporterPointMarkerMarks the region inside or empty if it contains a reporter defined point for refinement or coarsening.
  • 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 refinement state based on a threshold value compared to the specified variable.
  • VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange or Nedelec
  • Ferret App
  • PolarizationNWEMarkerThe the refinement state based on a threshold value compared to the specified variable.
  • Phase Field App
  • DiscreteNucleationMarkerMark new nucleation sites for refinement

AuxKernels

  • Moose App
  • AddKernelActionAdd a Kernel object to the simulation.
  • ADDivergenceAuxComputes the divergence of a vector of functors.
  • ADFunctorElementalAuxEvaluates a functor (variable, function or functor material property) on the current element or quadrature point.
  • ADFunctorElementalGradientAuxEvaluates the gradient of a functor (variable, function or functor material property) on the current element or quadrature point.
  • ADFunctorVectorElementalAuxEvaluates a vector functor (material property usually) on the current element.For finite volume, this evaluates the vector functor at the centroid.
  • ADMaterialRankTwoTensorAuxAccess a component of a RankTwoTensor for automatic material property output
  • ADMaterialRateRealAuxOutputs element material properties rate of change
  • ADMaterialRealAuxOutputs element volume-averaged material properties
  • ADMaterialRealVectorValueAuxCapture a component of a vector material property in an auxiliary variable.
  • ADMaterialStdVectorAuxExtracts 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
  • ADVectorMaterialRealVectorValueAuxConverts a vector-quantity material property into a vector auxiliary variable
  • AdvectiveFluxAuxCompute components of flux vector for advection problems .
  • ArrayParsedAuxSets field array variable values to the evaluation of a parsed expression.
  • ArrayVarReductionAuxTakes an array variable and performs a reduction operation on it (max, min, sum, average) and stores as a standard 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
  • ContainsPointAuxComputes a binary field where the field is 1 in the elements that contain the point and 0 everywhere else
  • CopyValueAuxReturns the specified variable as an auxiliary variable with a simple copy of the variable values.
  • DebugResidualAuxPopulate an auxiliary variable with the residual contribution of a variable.
  • DiffusionFluxAuxCompute components of flux vector for diffusion problems .
  • DivergenceAuxComputes the divergence of a vector of functors.
  • 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.
  • ExtraElementIDAuxPuts element extra IDs into an aux variable.
  • ForcingFunctionAuxAuxiliary Kernel that adds a forcing function to the value of an AuxVariable from the previous time step.
  • 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.
  • FunctorADMatPropElementalAuxEvaluates a functor (variable, function or functor material property) on the current element or quadrature point.
  • FunctorElementalAuxEvaluates a functor (variable, function or functor material property) on the current element or quadrature point.
  • FunctorElementalGradientAuxEvaluates the gradient of a functor (variable, function or functor material property) on the current element or quadrature point.
  • FunctorMatPropElementalAuxEvaluates a functor (variable, function or functor material property) on the current element or quadrature point.
  • FunctorVectorElementalAuxEvaluates a vector functor (material property usually) on the current element.For finite volume, this evaluates the vector functor at the centroid.
  • 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
  • MaterialRateRealAuxOutputs element material properties rate of change
  • 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.
  • ParsedAuxSets a field variable value to the evaluation of a parsed expression.
  • ParsedVectorAuxSets a field vector variable value to the evaluation of a parsed expression.
  • PenetrationAuxAuxiliary Kernel for computing several geometry related quantities between two contacting bodies.
  • ProcessorIDAuxCreates a field showing the processors and partitioning.
  • ProjectionAuxReturns the specified variable as an auxiliary variable with a projection of the source variable. If they are the same type, this amounts to a simple copy.
  • QuotientAuxDivides two coupled variables.
  • SecondTimeDerivativeAuxReturns the second order time derivative of the specified variable as an auxiliary variable.
  • SelfAuxReturns the specified variable as an auxiliary variable with a projection of the source variable. If they are the same type, this amounts to a simple copy.
  • SolutionAuxCreates fields by using information from a SolutionUserObject.
  • SpatialUserObjectAuxPopulates an auxiliary variable with a spatial value returned from a UserObject spatialValue method.
  • TagMatrixAuxCouple the diagonal of a tag matrix, and return its nodal value
  • TagVectorArrayVariableAuxCouple a tagged vector, and return its evaluations at degree of freedom indices corresponding to the coupled array variable.
  • TagVectorArrayVariableValueAuxCouple a tagged vector, and return its array value.
  • TagVectorAuxCouple a tag vector, and return its nodal value
  • TimeDerivativeAuxReturns the time derivative of the specified variable/functor as an auxiliary variable.
  • VariableGradientComponentCreates a field consisting of one component of the gradient of a coupled variable.
  • VariableOldValueBoundsAuxUses the old variable values as the bounds for the new solve.
  • 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.
  • VolumeAuxAuxiliary Kernel that samples volumes.
  • WeightedGapAuxReturns the specified variable as an auxiliary variable with the same value.
  • Tensor Mechanics App
  • ADKineticEnergyAuxCompute the kinetic energy of continuum-based finite elements
  • 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
  • KineticEnergyAuxCompute the kinetic energy of continuum-based finite elements
  • NewmarkAccelAuxComputes the current acceleration using the Newmark method.
  • NewmarkVelAuxCalculates the current velocity using Newmark method.
  • NodalPatchRecoveryAuxThis Auxkernel solves a least squares problem at each node to fit a value from quantities defined on quadrature points.
  • 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.
  • Phase Field App
  • BndsCalcAuxCalculate location of grain boundaries in a polycrystalline sample
  • CrossTermGradientFreeEnergyFree energy contribution from the cross terms in ACMultiInterface
  • DiscreteNucleationAuxProject the DiscreteNucleationMap state onto an AuxVariable
  • EBSDReaderAvgDataAux
  • EBSDReaderPointDataAux
  • EulerAngleProvider2RGBAuxOutput RGB representation of crystal orientation from user object to an AuxVariable. The entire domain must have the same crystal structure.
  • EulerAngleVariables2RGBAux
  • FeatureFloodCountAuxFeature detection by connectivity analysis
  • GrainAdvectionAuxCalculates the advection velocity of grain due to rigid body translation and rotation
  • GrainBoundaryVelocityCompute the velocity of grain boundaries.
  • KKSGlobalFreeEnergyTotal free energy in KKS system, including chemical, barrier and gradient terms
  • KKSMultiFreeEnergyTotal free energy in multi-phase KKS system, including chemical, barrier and gradient terms
  • LinearizedInterfaceAuxCalculates the order parameter from the linearized interface function
  • OutputEulerAnglesOutput Euler angles from user object to an AuxVariable.
  • PFCEnergyDensity
  • PFCRFFEnergyDensity
  • SolutionAuxMisorientationBoundaryCalculate location of grain boundaries by using information from a SolutionUserObject.
  • TotalFreeEnergyTotal free energy (both the bulk and gradient parts), where the bulk free energy has been defined in a material
  • MatVecRealGradAuxKernel
  • MaterialVectorAuxKernel
  • MaterialVectorGradAuxKernel
  • Ferret App
  • AFDWallEnergyDensityCalculates the free energy density due to the local gradients in the antiphase tilt vector field
  • AFMEasyPlaneAnisotropyEnergyDensityCalculates the free energy density due easy-plane (or easy-axis) anisotropy
  • AFMExchangeStiffnessEnergyDensityCalculates the energy density due to inhomogeneous AFM exchange stiffness.
  • AFMSingleIonCubicSixthAnisotropyEnergyDensityCalculates the energy density due to corrections of single-ion environment of the sixth order in the spin.
  • AFMSpinCurrentLLdotCalculates the AFM spin current component corresponding to the cross product of with d/dt.
  • AFMSpinCurrentLMdotCalculates the AFM spin current component corresponding to the cross product of L with dm/dt
  • AFMSpinCurrentMLdotCalculates the AFM spin current component corresponding to the cross product of m with dL/dt
  • AFMSpinCurrentMMdotCalculates the AFM spin current component corresponding to the cross product of M with dM/dt
  • AFMSublatticeDMInteractionEnergyDensityCalculates the DM interaction free energy density (coupling AFD and magnetic ordering).
  • AFMSublatticeSuperexchangeEnergyDensityCalculates the free energy density corresponding to the AFM superexchange coupling.
  • AFMTotalEnergyDensityCalculates the sum of energy densities
  • AngleBetweenTwoVectorsUseful calculation of the angle between two vectors
  • BandGapAuxTiO2Calculates the changes to local band gap due to the elastic stress fields.
  • BandGapAuxZnOCalculates the changes to local band gap due to the elastic strain fields.
  • BandGapAuxZnOwRotCalculates the changes to local band gap due to the elastic strain fields, respecting local crystallographic orientations.
  • BirefringenceComputes the difference between refractive indices (birefringence).
  • BulkEnergyDensityCalculates the free energy density from the bulk energy (up to eighth order)
  • ChangeInRefractiveIndexCalculates the changes to local refractive index.
  • ChangeInRefractiveIndexElectroCalculates the changes to local refractive index due to the electric field.
  • ChangeInRefractiveIndexWithGCoeffPolarCalculates the changes to local refractive index due to the polar-optic effect.
  • ChangeInRefractiveIndexWithPolarCalculates the changes to local refractive index due to the polar-optic effect.
  • DemagFieldAuxConverts magnetostatic potential to the vector demagnetization field.
  • DemagFieldAuxPMLConverts magnetostatic potential to the vector demagnetization field.
  • DivPCalculates div P
  • ElasticEnergyDensityComputes the free energy density due to the local elastic interaction
  • ElastoChangeInRefractiveIndexCalculates the changes to local refractive index due to the elastooptic effect.
  • ElecFieldAuxConverts electrostatic potential to the vector electric field.
  • ElectricFluxTensorElectric flux generated
  • ElectronDensity
  • ElectrostrictiveCouplingEnergyDensityComputes the free energy density of the local electrostrictive coupling.
  • ElectrostrictiveEnergyDensityComputes the free energy density of the local electrostrictive coupling.
  • ExchangeFieldAuxComputes the exchange field
  • FourierHeatCalculates a residual contribution due to k*deltaT = 0
  • HarmonicFieldAuxCalculates a harmonic field
  • HeatFluxTensorheat flux generated
  • HoleDensityAux
  • IsotropicTEMaterialElecFluxNeeds documentation
  • IsotropicTEMaterialHeatFluxElectric potential generated due to heat flux
  • JacobiansBulkEnergyCalculates the free energy density dependent on the local polarization field.
  • JacobiansRotoBulkEnergyCalculates the jacobian entries due to the microforce from the (roto) bulk terms.
  • JacobiansRotopolarCoupledEnergyCalculates the jacobian entries for the rotopolar microforce.
  • MagneticExchangeEnergyDensityCart
  • MicroforceBulkEnergyCalculates the free energy density dependent on the local polarization field.
  • MicroforceElectrostaticEnergyComputes the microforce due to the local electrostatic coupling.
  • MicroforceElectrostrictiveCouplingEnergyComputes the free energy density of the local electrostrictive coupling.
  • MicroforceRotoBulkEnergyCalculates the free energy density dependent on the local polarization field.
  • MicroforceRotopolarCoupledDistortEnergyCalculates the free energy density dependent on the local polarization field.
  • MicroforceRotopolarCoupledPolarEnergyCalculates the free energy density dependent on the local polarization field.
  • MicroforceWallEnergy
  • PolarOpticChangeInRefractiveIndexCalculates the changes to local refractive index due to the polar-optic effect.
  • PontryaginDensity
  • QuasistaticFieldAuxConverts potential to the vector field.
  • RefractiveIndex
  • ReworkedRefractiveIndex
  • RotoBulkEnergyDensity
  • RotoPolarCouplingEnergyDensity
  • RotostrictiveCouplingEnergyDensity
  • SDBulkEnergyDensityCalculates the free energy density dependent on the local polarization field.
  • SphericalCoordinateVectorCalculates the spherical coordinates from a vector
  • SurfaceChargePCalculates P*n
  • TensorPressureAuxCalculates the value of the hydrostatic stress (which is 1/3 the minus of the stress tensor trace).
  • ThermoelectricZTAuxCalculates thermoelectric figure of merit
  • TimeDependentFieldAuxAdds time-dependence to a spatial-varying field
  • Transform111Order
  • Transformed110Order
  • Transformed111Order
  • TransformedMicroforceElectrostrictiveCouplingEnergyComputes the free energy density of the local electrostrictive coupling.
  • TransformedMicroforceRotostrictiveCouplingEnergyComputes the free energy density of the local electrostrictive coupling.
  • ValueAuxStores a variable as an Aux field
  • VectorDiffOrSumCalculates the difference or sum of a variable
  • VectorMag
  • WallEnergyDensity
  • Electromagnetics App
  • ADCurrentDensityCalculates the current density vector field (in A/m^2) when given electrostatic potential (electrostatic = true, default) or electric field.
  • CurrentDensityCalculates the current density vector field (in A/m^2) when given electrostatic potential (electrostatic = true, default) or electric field.
  • PotentialToFieldAuxAn AuxKernel that calculates the electrostatic electric field given the electrostatic potential.
  • Misc App
  • CoupledDirectionalMeshHeightInterpolationScales a variable based on position relative to the model bounds in a specified direction

AuxKernels/MatVecRealGradAuxKernel

AuxKernels/MaterialVectorAuxKernel

AuxKernels/MaterialVectorGradAuxKernel

AuxScalarKernels

AuxVariables

AuxVariables/MultiAuxVariables

  • Moose App
  • 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
  • Phase Field App
  • MultiAuxVariablesActionSet up auxvariables for components of MaterialProperty<std::vector<data_type> > for polycrystal sample.

BCs

  • Moose App
  • AddBCActionAdd a BoundaryCondition object to the simulation.
  • ADConservativeAdvectionBCBoundary condition for advection when it is integrated by parts. Supports Dirichlet (inlet-like) and implicit (outlet-like) conditions.
  • 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.
  • ADMatNeumannBCImposes the integrated boundary condition , where is a constant, is a material property, and is a coefficient defined by the kernel for .
  • ADMatchedValueBCImplements a NodalBC which equates two different Variables' values on a specified boundary.
  • 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.
  • ADVectorFunctionNeumannBCImposes the integrated boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
  • 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 Galerkin 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.
  • FunctorNeumannBCImposes the integrated boundary condition , where is a functor.
  • 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.
  • MatNeumannBCImposes the integrated boundary condition , where is a constant, is a material property, and is a coefficient defined by the kernel for .
  • 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 integral of lambda times dg 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 diffusion.
  • VectorCurlPenaltyDirichletBCEnforces a Dirichlet boundary condition for the curl of vector nonlinear variables in a weak sense by applying a penalty to the difference in the current solution and the Dirichlet data.
  • 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
  • ADPenaltyInclinedNoDisplacementBCPenalty Enforcement of an inclined boundary condition
  • 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
  • Electromagnetics App
  • EMRobinBCFirst order Robin-style Absorbing/Port BC for scalar variables, assuming plane waves.
  • VectorEMRobinBCFirst order Robin-style Absorbing/Port BC for vector variables.
  • VectorTransientAbsorbingBCFirst order transient absorbing boundary condition for vector variables.
  • Ferret App
  • CoupledDirichletBC
  • ElectronCurrentDensityBC
  • HoleCurrentDensityBC
  • HydrostaticBC
  • SurfaceMechanicsBC

BCs/CavityPressure

BCs/CoupledPressure

BCs/InclinedNoDisplacementBC

BCs/Periodic

BCs/Pressure

Bounds

  • Moose App
  • AddBoundsVectorsActionAction to add vectors to nonlinear system when using the Bounds syntax.
  • AddKernelActionAdd a Kernel object to the simulation.
  • ADFunctorElementalGradientAuxEvaluates the gradient of a functor (variable, function or functor material property) on the current element or quadrature point.
  • ADVectorMaterialRealVectorValueAuxConverts a vector-quantity material property into a vector auxiliary variable
  • ArrayParsedAuxSets field array variable values to the evaluation of a parsed expression.
  • 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.
  • FunctorElementalGradientAuxEvaluates the gradient of a functor (variable, function or functor material property) on the current element or quadrature point.
  • ParsedVectorAuxSets a field vector variable value to the evaluation of a parsed expression.
  • TagVectorArrayVariableAuxCouple a tagged vector, and return its evaluations at degree of freedom indices corresponding to the coupled array variable.
  • TagVectorArrayVariableValueAuxCouple a tagged vector, and return its array value.
  • 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
  • Electromagnetics App
  • ADCurrentDensityCalculates the current density vector field (in A/m^2) when given electrostatic potential (electrostatic = true, default) or electric field.
  • CurrentDensityCalculates the current density vector field (in A/m^2) when given electrostatic potential (electrostatic = true, default) or electric field.

Constraints

  • Moose App
  • AddConstraintActionAdd a Constraint object to the simulation.
  • ADPenaltyEqualValueConstraintPenaltyEqualValueConstraint enforces solution continuity between secondary and primary sides of a mortar interface using a penalty approach (no Lagrange multipliers needed)
  • ADPenaltyPeriodicSegmentalConstraintADPenaltyPeriodicSegmentalConstraint enforces macro-micro periodic conditions between secondary and primary sides of a mortar interface using a penalty approach (no Lagrange multipliers needed). Must be used alongside PenaltyEqualValueConstraint.
  • ADPeriodicSegmentalConstraintADPeriodicSegmentalConstraint enforces macro-micro periodic conditions between secondary and primary sides of a mortar interface using Lagrange multipliers.Must be used alongside EqualValueConstraint.
  • CoupledTiedValueConstraintRequires the value of two variables 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
  • PenaltyEqualValueConstraintPenaltyEqualValueConstraint enforces solution continuity between secondary and primary sides of a mortar interface using a penalty approach (no Lagrange multipliers needed)
  • PenaltyPeriodicSegmentalConstraintPenaltyPeriodicSegmentalConstraint enforces macro-micro periodic conditions between secondary and primary sides of a mortar interface using a penalty approach (no Lagrange multipliers needed). Must be used alongside PenaltyEqualValueConstraint.
  • PeriodicSegmentalConstraintPeriodicSegmentalConstraint enforces macro-micro periodic conditions between secondary and primary sides of a mortar interface using Lagrange multipliers.Must be used alongside EqualValueConstraint.
  • 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

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.
  • Tensor Mechanics App
  • StepPeriodControl the enabled/disabled state of objects with user-provided simulation steps.

DGKernels

  • Moose App
  • AddDGKernelActionAdd a DGKernel object to the simulation.
  • ADDGAdvectionAdds internal face advection flux contributions for discontinuous Galerkin discretizations
  • 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.
  • HFEMTestJumpImposes constraints for HFEM with side-discontinuous variables.
  • HFEMTrialJumpImposes constraints for HFEM with side-discontinuous variables.

Dampers

Debug

Debug/MaterialDerivativeTest

DeprecatedBlock

DiracKernels

Distributions

DomainIntegral

  • Tensor Mechanics App
  • DomainIntegralActionCreates the MOOSE objects needed to compute fraction domain integrals

Executioner

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

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

Executioner/TimeSteppers

Executors

FVBCs

  • Moose App
  • CheckFVBCActionCheck that boundary conditions are defined correctly for finite volume problems.
  • AddFVBCActionAdd a FVBoundaryCondition object to the simulation.
  • FVADFunctorDirichletBCUses the value of a functor to set a Dirichlet boundary value.
  • FVBoundaryIntegralValueConstraintThis class is used to enforce integral of phi = boundary area * phi_0 with a Lagrange multiplier approach.
  • FVConstantScalarOutflowBCConstant velocity scalar advection boundary conditions for finite volume method.
  • FVDirichletBCDefines a Dirichlet boundary condition for finite volume method.
  • FVFunctionDirichletBCImposes the essential boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
  • FVFunctionNeumannBCNeumann boundary condition for finite volume method.
  • FVFunctorDirichletBCUses the value of a functor to set a Dirichlet boundary value.
  • FVFunctorNeumannBCNeumann boundary condition for the finite volume method.
  • FVNeumannBCNeumann boundary condition for finite volume method.
  • FVOrthogonalBoundaryDiffusionImposes an orthogonal diffusion boundary term with specified boundary function.
  • FVPostprocessorDirichletBCDefines a Dirichlet boundary condition for finite volume method.

FVInterfaceKernels

FVKernels

  • Moose App
  • AddFVKernelActionAdd a FVKernel object to the simulation.
  • FVAdvectionResidual contribution from advection operator for finite volume method.
  • FVAnisotropicDiffusionComputes residual for anisotropic diffusion 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.
  • FVBoundedValueConstraintThis class is used to enforce a min or max value for a finite volume variable
  • FVCoupledForceImplements a source term proportional to the value of a coupled variable.
  • FVDiffusionComputes residual for diffusion operator for finite volume method.
  • FVFunctorTimeKernelResidual contribution from time derivative of an AD functor (default is the variable this kernel is acting upon if the 'functor' parameter is not supplied) for the finite volume method.
  • FVIntegralValueConstraintThis class is used to enforce integral of phi = volume * phi_0 with a Lagrange multiplier approach.
  • FVMatAdvectionComputes the residual of advective term using finite volume method.
  • FVOrthogonalDiffusionImposes an orthogonal diffusion term.
  • FVPointValueConstraintThis class is used to enforce integral of phi = volume * phi_0 with a Lagrange multiplier approach.
  • 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.

Ferret

Ferret/ABO3CoupledPhaseField

  • Ferret App
  • ABO3CoupledPhaseFieldActionSet up homogeneous or inhomogeneous ferroelectric materials problem. This can be steady-state or time-dependent. The modes of coupling can be to the inhomogeneous strain fields or renormalized in the potential.

Functions

FunctorMaterials

  • Moose App
  • AddFunctorMaterialActionAdd a Functor Material object to the simulation.
  • ADCoupledValueFunctionMaterialCompute a function value from coupled variables
  • ADDerivativeParsedMaterialParsed Function Material with automatic derivatives.
  • ADDerivativeSumMaterialMeta-material to sum up multiple derivative materials
  • ADGenericConstantFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • ADGenericConstantMaterialDeclares material properties based on names and values prescribed by input parameters.
  • ADGenericConstantRankTwoTensorObject for declaring a constant rank two tensor as a material property.
  • ADGenericConstantVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
  • ADGenericConstantVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
  • ADGenericFunctionFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • ADGenericFunctionMaterialMaterial object for declaring properties that are populated by evaluation of Function object.
  • ADGenericFunctionRankTwoTensorMaterial object for defining rank two tensor properties using functions.
  • ADGenericFunctionVectorMaterialMaterial object for declaring vector properties that are populated by evaluation of Function objects.
  • ADGenericFunctorGradientMaterialFunctorMaterial object for declaring properties that are populated by evaluation of gradients of Functors (a constant, variable, function or functor material property) objects.
  • ADGenericFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • ADGenericVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
  • ADParsedFunctorMaterialComputes a functor material from a parsed expression of other functors.
  • ADParsedMaterialParsed expression Material.
  • ADPiecewiseByBlockFunctorMaterialComputes a property value on a per-subdomain basis
  • ADPiecewiseByBlockVectorFunctorMaterialComputes a property value on a per-subdomain basis
  • ADPiecewiseConstantByBlockMaterialComputes a property value on a per-subdomain basis
  • ADPiecewiseLinearInterpolationMaterialCompute a property using a piecewise linear interpolation to define its dependence on a variable
  • ADVectorFromComponentVariablesMaterialComputes a vector material property from coupled variables
  • ADVectorMagnitudeFunctorMaterialThis class takes up to three scalar-valued functors corresponding to vector components or a single vector functor and computes the Euclidean norm.
  • CoupledValueFunctionMaterialCompute a function value from coupled variables
  • DerivativeParsedMaterialParsed Function Material with automatic derivatives.
  • DerivativeSumMaterialMeta-material to sum up multiple derivative materials
  • FVADPropValPerSubdomainMaterialComputes a property value on a per-subdomain basis
  • FVPropValPerSubdomainMaterialComputes a property value on a per-subdomain basis
  • FunctorADConverterConverts regular functors to AD functors and AD functors to regular functors
  • GenericConstant2DArrayA material evaluating one material property in type of RealEigenMatrix
  • GenericConstantArrayA material evaluating one material property in type of RealEigenVector
  • GenericConstantFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • GenericConstantMaterialDeclares material properties based on names and values prescribed by input parameters.
  • GenericConstantRankTwoTensorObject for declaring a constant rank two tensor as a material property.
  • GenericConstantVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
  • GenericConstantVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
  • GenericFunctionFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • GenericFunctionMaterialMaterial object for declaring properties that are populated by evaluation of Function object.
  • GenericFunctionRankTwoTensorMaterial object for defining rank two tensor properties using functions.
  • GenericFunctionVectorMaterialMaterial object for declaring vector properties that are populated by evaluation of Function objects.
  • GenericFunctorGradientMaterialFunctorMaterial object for declaring properties that are populated by evaluation of gradients of Functors (a constant, variable, function or functor material property) objects.
  • GenericFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • GenericVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
  • MaterialADConverterConverts regular material properties to AD properties and vice versa
  • MaterialConverterConverts regular material properties to AD properties and vice versa
  • MaterialFunctorConverterConverts functor to non-AD and AD regular material properties
  • ParsedFunctorMaterialComputes a functor material from a parsed expression of other functors.
  • ParsedMaterialParsed expression Material.
  • PiecewiseByBlockFunctorMaterialComputes a property value on a per-subdomain basis
  • PiecewiseByBlockVectorFunctorMaterialComputes a property value on a per-subdomain basis
  • PiecewiseConstantByBlockMaterialComputes a property value on a per-subdomain basis
  • PiecewiseLinearInterpolationMaterialCompute a property using a piecewise linear interpolation to define its dependence on a variable
  • RankFourTensorMaterialADConverterConverts regular material properties to AD properties and vice versa
  • RankFourTensorMaterialConverterConverts regular material properties to AD properties and vice versa
  • RankTwoTensorMaterialADConverterConverts regular material properties to AD properties and vice versa
  • RankTwoTensorMaterialConverterConverts regular material properties to AD properties and vice versa
  • VectorFromComponentVariablesMaterialComputes a vector material property from coupled variables
  • VectorFunctorADConverterConverts regular functors to AD functors and AD functors to regular functors
  • VectorMagnitudeFunctorMaterialThis class takes up to three scalar-valued functors corresponding to vector components or a single vector functor and computes the Euclidean norm.
  • VectorMaterialFunctorConverterConverts functor to non-AD and AD regular material properties
  • 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.
  • ADCZMComputeDisplacementJumpSmallStrainCompute the total displacement jump across a czm interface in local coordinates for the Small Strain kinematic formulation
  • ADCZMComputeDisplacementJumpTotalLagrangianCompute the displacement jump increment across a czm interface in local coordinates for the Total Lagrangian kinematic formulation
  • ADCZMComputeGlobalTractionSmallStrainComputes the czm traction in global coordinates for a small strain kinematic formulation
  • ADCZMComputeGlobalTractionTotalLagrangianCompute the equilibrium traction (PK1) and its derivatives for the Total Lagrangian formulation.
  • ADCombinedScalarDamageScalar damage model which is computed as a function of multiple scalar damage models
  • 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
  • ADComputeDamageStressCompute stress for damaged elastic materials in conjunction with a damage model.
  • 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
  • ADEshelbyTensorComputes the Eshelby tensor as a function of strain energy density and the first Piola-Kirchhoff stress
  • ADExponentialSofteningSoftening model with an exponential softening response upon cracking. This class is intended to be used with ADComputeSmearedCrackingStress and relies on automatic differentiation.
  • ADHillConstantsBuild and rotate the Hill Tensor. It can be used with other Hill plasticity and creep materials.
  • 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 generalized radial return for anisotropic elasto-plasticity model.This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
  • ADHillPlasticityStressUpdateThis class uses the generalized radial return for anisotropic plasticity 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.
  • ADIsotropicPowerLawHardeningStressUpdateThis 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.
  • ADLAROMANCEPartitionStressUpdateLAROMANCE base class for partitioned reduced order models
  • ADLAROMANCEStressUpdateBase class to calculate the effective creep strain based on the rates predicted by a material specific Los Alamos Reduced Order Model derived from a Visco-Plastic Self Consistent calculations.
  • ADMultiplePowerLawCreepStressUpdateThis 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.
  • ADNonlocalDamageNonlocal damage model. Given an RadialAverage UO this creates a new damage index that can be used as for ComputeDamageStress without havign to change existing local damage models.
  • 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.
  • ADPureElasticTractionSeparationPure elastic traction separation law.
  • 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
  • ADRankTwoSphericalComponentCompute components of a rank-2 tensor in a spherical coordinate system
  • ADScalarMaterialDamageScalar damage model for which the damage is prescribed by another material
  • ADStrainEnergyDensityComputes 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.
  • 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.
  • ADSymmetricFiniteStrainCompute a strain increment and rotation increment for finite strains.
  • ADSymmetricFiniteStrainElasticStressCompute stress using elasticity for finite strains
  • ADSymmetricIncrementalSmallStrainCompute a strain increment and rotation increment for small strains.
  • ADSymmetricIsotropicElasticityTensorCompute a constant isotropic elasticity tensor.
  • ADSymmetricLinearElasticStressCompute stress using elasticity for small strains
  • ADSymmetricSmallStrainCompute a small strain.
  • ADTemperatureDependentHardeningStressUpdateComputes 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
  • 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.
  • BiLinearMixedModeTractionMixed mode bilinear traction separation law.
  • CZMComputeDisplacementJumpSmallStrainCompute the total displacement jump across a czm interface in local coordinates for the Small Strain kinematic formulation
  • CZMComputeDisplacementJumpTotalLagrangianCompute the displacement jump increment across a czm interface in local coordinates for the Total Lagrangian kinematic formulation
  • CZMComputeGlobalTractionSmallStrainComputes the czm traction in global coordinates for a small strain kinematic formulation
  • CZMComputeGlobalTractionTotalLagrangianCompute the equilibrium traction (PK1) and its derivatives for the Total Lagrangian formulation.
  • CZMRealVectorCartesianComponentAccess a component of a RealVectorValue defined on a cohesive zone
  • CZMRealVectorScalarCompute the normal or tangent component of a vector quantity defined on a cohesive interface.
  • 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
  • ComputeCreepPlasticityStressCompute state (stress and internal parameters such as inelastic strains and internal parameters) using an Newton process for one creep and one plasticity model
  • ComputeCrystalPlasticityThermalEigenstrain
  • 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.
  • ComputeElasticityTensorConstantRotationCPDeprecated Class: please use ComputeElasticityTensorCP instead. Compute 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
  • ComputeHomogenizedLagrangianStrain
  • ComputeHypoelasticStVenantKirchhoffStressCalculate a small strain elastic stress that is equivalent to the hyperelastic St. Venant-Kirchhoff model if integrated using the Truesdell rate.
  • 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.
  • ComputeLagrangianLinearElasticStressStress update based on the small (engineering) stress
  • ComputeLagrangianStrainCompute strain in Cartesian coordinates.
  • ComputeLagrangianStrainAxisymmetricCylindricalCompute strain in 2D axisymmetric RZ coordinates.
  • ComputeLagrangianStrainCentrosymmetricSphericalCompute strain in centrosymmetric spherical coordinates.
  • ComputeLagrangianWPSStrainCompute strain in Cartesian coordinates.
  • ComputeLagrangianWrappedStressStress update based on the small (engineering) stress
  • 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.
  • ComputeNeoHookeanStressStress update based on the first Piola-Kirchhoff stress
  • 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.
  • ComputeSimoHughesJ2PlasticityStressThe Simo-Hughes style J2 plasticity.
  • ComputeSmallStrainCompute a small strain.
  • ComputeSmearedCrackingStressCompute stress using a fixed smeared cracking model
  • ComputeStVenantKirchhoffStressStress update based on the first Piola-Kirchhoff stress
  • 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
  • ComputeUpdatedEulerAngleThis class computes the updated Euler angle for crystal plasticity simulations. This needs to be used together with the ComputeMultipleCrystalPlasticityStress class, where the updated rotation material property is computed.
  • 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.
  • CrystalPlasticityHCPDislocationSlipBeyerleinUpdateTwo-term dislocation slip model for hexagonal close packed crystals from Beyerline and Tome
  • CrystalPlasticityKalidindiUpdateKalidindi version of homogeneous crystal plasticity.
  • CrystalPlasticityTwinningKalidindiUpdateTwinning propagation model based on Kalidindi's treatment of twinning in a FCC material
  • DensityScaling
  • 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
  • HillConstantsBuild and rotate the Hill Tensor. It can be used with other Hill plasticity and creep materials.
  • HillCreepStressUpdateThis 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.
  • HillElastoPlasticityStressUpdateThis class uses the generalized radial return for anisotropic elasto-plasticity model.This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
  • HillPlasticityStressUpdateThis class uses the generalized radial return for anisotropic plasticity model.This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
  • 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.
  • LAROMANCEPartitionStressUpdateLAROMANCE base class for partitioned reduced order models
  • LAROMANCEStressUpdateBase class to calculate the effective creep strain based on the rates predicted by a material specific Los Alamos Reduced Order Model derived from a Visco-Plastic Self Consistent calculations.
  • 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
  • NonlocalDamageNonlocal damage model. Given an RadialAverage UO this creates a new damage index that can be used as for ComputeDamageStress without havign to change existing local damage models.
  • 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.
  • PureElasticTractionSeparationPure elastic traction separation law.
  • 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
  • RankTwoSphericalComponentCompute components of a rank-2 tensor in a spherical coordinate system
  • 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
  • SymmetricIsotropicElasticityTensorCompute a constant isotropic elasticity tensor.
  • 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
  • Phase Field App
  • ADConstantAnisotropicMobilityProvide a constant mobility tensor value
  • ADGBEvolutionComputes necessary material properties for the isotropic grain growth model
  • ADInterfaceOrientationMaterial2D interfacial anisotropy
  • ADMathFreeEnergyMaterial that implements the math free energy and its derivatives:
  • AsymmetricCrossTermBarrierFunctionMaterialFree energy contribution asymmetric across interfaces between arbitrary pairs of phases.
  • BarrierFunctionMaterialHelper material to provide and its derivative in a polynomial. SIMPLE: LOW: HIGH:
  • CompositeMobilityTensorAssemble a mobility tensor from multiple tensor contributions weighted by material properties
  • ComputeGBMisorientationTypeCalculate types of grain boundaries in a polycrystalline sample
  • ComputePolycrystalElasticityTensorCompute an evolving elasticity tensor coupled to a grain growth phase field model.
  • ConstantAnisotropicMobilityProvide a constant mobility tensor value
  • CoupledValueFunctionFreeEnergyCompute a free energy from a lookup function
  • CrossTermBarrierFunctionMaterialFree energy contribution symmetric across interfaces between arbitrary pairs of phases.
  • DeformedGrainMaterial
  • DerivativeMultiPhaseMaterialTwo phase material that combines n phase materials using a switching function with and n non-conserved order parameters (to be used with SwitchingFunctionConstraint*).
  • DerivativeTwoPhaseMaterialTwo phase material that combines two single phase materials using a switching function.
  • DiscreteNucleationFree energy contribution for nucleating discrete particles
  • ElasticEnergyMaterialFree energy material for the elastic energy contributions.
  • ElectrochemicalDefectMaterialCalculates density, susceptibility, and derivatives for a defect species in the grand potential sintering model coupled with electrochemistry
  • ElectrochemicalSinteringMaterialIncludes switching and thermodynamic properties for the grand potential sintering model coupled with electrochemistry
  • ExternalForceDensityMaterialProviding external applied force density to grains
  • ForceDensityMaterialCalculating the force density acting on a grain
  • GBAnisotropy
  • GBDependentAnisotropicTensorCompute anisotropic rank two tensor based on GB phase variable
  • GBDependentDiffusivityCompute diffusivity rank two tensor based on GB phase variable
  • GBEvolutionComputes necessary material properties for the isotropic grain growth model
  • GBWidthAnisotropy
  • GrainAdvectionVelocityCalculation the advection velocity of grain due to rigid body translation and rotation
  • GrandPotentialInterfaceCalculate Grand Potential interface parameters for a specified interfacial free energy and width
  • GrandPotentialSinteringMaterialIncludes switching and thermodynamic properties for the grand potential sintering model
  • GrandPotentialTensorMaterialDiffusion and mobility parameters for grand potential model governing equations. Uses a tensor diffusivity
  • IdealGasFreeEnergyFree energy of an ideal gas.
  • InterfaceOrientationMaterial2D interfacial anisotropy
  • InterfaceOrientationMultiphaseMaterialThis Material accounts for the the orientation dependence of interfacial energy for multi-phase multi-order parameter phase-field model.
  • KKSXeVacSolidMaterialKKS Solid phase free energy for Xe,Vac in UO2. Fm(cmg,cmv)
  • LinearizedInterfaceFunctionDefines the order parameter substitution for linearized interface phase field models
  • MathEBFreeEnergyMaterial that implements the math free energy using the expression builder and automatic differentiation
  • MathFreeEnergyMaterial that implements the math free energy and its derivatives:
  • MixedSwitchingFunctionMaterialHelper material to provide h(eta) and its derivative in one of two polynomial forms. MIX234 and MIX246
  • MultiBarrierFunctionMaterialDouble well phase transformation barrier free energy contribution.
  • PFCRFFMaterial
  • PFCTradMaterialPolynomial coefficients for a phase field crystal correlation function
  • PFParamsPolyFreeEnergyPhase field parameters for polynomial free energy for single component systems
  • PhaseNormalTensorCalculate normal tensor of a phase based on gradient
  • PolycrystalDiffusivityGenerates a diffusion coefficient to distinguish between the bulk, pore, grain boundaries, and surfaces
  • PolycrystalDiffusivityTensorBaseGenerates a diffusion tensor to distinguish between the bulk, grain boundaries, and surfaces
  • PolynomialFreeEnergyPolynomial free energy for single component systems
  • RegularSolutionFreeEnergyMaterial that implements the free energy of a regular solution
  • StrainGradDispDerivativesProvide the constant derivatives of strain w.r.t. the displacement gradient components.
  • SwitchingFunction3PhaseMaterialMaterial for switching function that prevents formation of a third phase at a two-phase interface:
  • SwitchingFunctionMaterialHelper material to provide and its derivative in one of two polynomial forms. SIMPLE: HIGH:
  • SwitchingFunctionMultiPhaseMaterialCalculates the switching function for a given phase for a multi-phase, multi-order parameter model
  • ThirdPhaseSuppressionMaterialFree Energy contribution that penalizes more than two order parameters being non-zero
  • TimeStepMaterialProvide various time stepping quantities as material properties.
  • VanDerWaalsFreeEnergyFree energy of a Van der Waals gas.
  • VariableGradientMaterialCompute the norm of the gradient of a variable
  • Ferret App
  • ADThermoelectricMaterialGeneral-purpose material model for thermoelectrics
  • ComputeDeltaIndicatrixCompute the adjustments to the indicatrix (beta tensor).
  • ComputeDeltaIndicatrixElectroCompute the adjustments to the indicatrix (beta tensor).
  • ComputeElastoopticTensorCompute a photostrictive tensor.
  • ComputeElectricalConductivityTDepTensorStore a temperature dependent electrical conductivity tensor.
  • ComputeElectricalConductivityTensorStore an electric conductivity tensor
  • ComputeElectroopticTensorCompute an electrooptic tensor.
  • ComputeElectrostrictiveTensorCompute an electrostrictive tensor.
  • ComputeGCoeffTensorCompute a polar-optic (g) tensor.
  • ComputeIndicatrixCompute the impermeability tensor, or indicatrix.
  • ComputePiezoTensorCompute the converse piezoelectric tensor.
  • ComputePiezostrictiveTensorCompute a piezostrictive tensor.
  • ComputePolarOpticGCoeffTensorCompute the adjustments to the indicatrix due to the polar-optic effect with gijkl coefficients.
  • ComputePolarOpticTensorCompute the adjustments to the indicatrix (beta tensor) due to the polar-optic effect.
  • ComputeSeebeckTDepTensorCompute a Seebeck tensor.
  • ComputeSeebeckTensorCompute a Seebeck tensor.
  • ComputeThermalConductivityTDepTensorCompute a ThermalConductivity tensor.
  • ComputeThermalConductivityTensorCompute a ThermalConductivity tensor.
  • ThermoelectricMaterialGeneral-purpose material model for thermoelectrics
  • Electromagnetics App
  • WaveEquationCoefficientMaterial for use as coefficient (where a is a scalar coefficient) in standard-form Helmholtz wave equation applications with derivatives calculated using automatic differentiation.
  • Misc App
  • ADDensityCreates density material property
  • DensityCreates density material property

GlobalParams

  • Moose App
  • GlobalParamsActionAction used to aid in the application of parameters defined in the GlobalParams input block.

ICs

ICs/PolycrystalICs

ICs/PolycrystalICs/BicrystalBoundingBoxIC

  • Phase Field App
  • BicrystalBoundingBoxICActionConstructs a bicrystal, where one grain is on the inside of the box and the other grain is the outside of the box

ICs/PolycrystalICs/BicrystalCircleGrainIC

ICs/PolycrystalICs/PolycrystalColoringIC

ICs/PolycrystalICs/PolycrystalRandomIC

ICs/PolycrystalICs/PolycrystalVoronoiVoidIC

ICs/PolycrystalICs/Tricrystal2CircleGrainsIC

InterfaceKernels

  • Moose App
  • AddInterfaceKernelActionAdd an InterfaceKernel object to the simulation.
  • ADPenaltyInterfaceDiffusionA penalty-based interface condition that forcesthe continuity of variables and the flux equivalence across an interface.
  • ADVectorPenaltyInterfaceDiffusionA penalty-based interface condition that forcesthe continuity of variables and the flux equivalence across an interface.
  • InterfaceDiffusionThe kernel is utilized to establish flux equivalence on an interface for variables.
  • InterfaceEqualityThe kernel is utilized to establish equivalence on an interface for variables.
  • InterfaceReactionImplements a reaction to establish ReactionRate=k_f*u-k_b*v at interface.
  • PenaltyInterfaceDiffusionA penalty-based interface condition that forcesthe continuity of variables and the flux equivalence across an interface.
  • VectorPenaltyInterfaceDiffusionA penalty-based interface condition that forcesthe continuity of variables and the flux equivalence across an interface.
  • Tensor Mechanics App
  • ADCZMInterfaceKernelSmallStrainCZM Interface kernel to use when using the small strain kinematic formulation.
  • ADCZMInterfaceKernelTotalLagrangianCZM Interface kernel to use when using the total Lagrangian formulation.
  • CZMInterfaceKernelSmallStrainCZM Interface kernel to use when using the Small Strain kinematic formulation.
  • CZMInterfaceKernelTotalLagrangian
  • Phase Field App
  • EqualGradientLagrangeInterfaceEnforce componentwise gradient continuity between two different variables across a subdomain boundary using a Lagrange multiplier
  • EqualGradientLagrangeMultiplierLagrange multiplier kernel for EqualGradientLagrangeInterface.
  • InterfaceDiffusionBoundaryTermAdd weak form surface terms of the Diffusion equation for two different variables across a subdomain boundary
  • InterfaceDiffusionFluxMatchEnforce flux continuity between two different variables across a subdomain boundary
  • Electromagnetics App
  • ElectrostaticContactConditionInterface condition that describes the current continuity and contact conductance across a boundary formed between two dissimilar materials (resulting in a potential discontinuity). Conductivity on each side of the boundary is defined via the material properties system.
  • ParallelElectricFieldInterfaceVectorInterfaceKernel that implements the condition
  • PerpendicularElectricFieldInterfaceVectorInterfaceKernel that implements the condition

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 .
  • ADCoefReactionImplements the residual term (p*u, test)
  • ADConservativeAdvectionConservative form of which in its weak form is given by: .
  • ADCoupledForceImplements a source term proportional to the value of a coupled variable. 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
  • ADMatCoupledForceKernel representing the contribution of the PDE term , where is a material property coefficient, is a coupled scalar field variable, and Jacobian derivatives are calculated using automatic differentiation.
  • ADMatDiffusionDiffusion equation kernel that takes an isotropic diffusivity from a material property
  • ADMatReactionKernel representing the contribution of the PDE term , where is a reaction rate material property, is a scalar variable (nonlinear or coupled), and whose Jacobian contribution is calculated using automatic differentiation.
  • ADMaterialPropertyValueResidual term (u - prop) to set variable u equal to a given material property prop
  • ADReactionImplements a simple consuming reaction term with weak form .
  • ADScalarLMKernelThis class is used to enforce integral of phi = V_0 with a Lagrange multiplier approach.
  • 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 .
  • FunctionDiffusionThe Laplacian operator with a function coefficient.
  • 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 .
  • ScalarLMKernelThis class is used to enforce integral of phi = V_0 with a Lagrange multiplier approach.
  • 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.
  • ADInertialForceCalculates 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) $)
  • 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
  • ADSymmetricStressDivergenceTensorsStress 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.
  • HomogenizedTotalLagrangianStressDivergenceTotal Lagrangian stress equilibrium kernel with homogenization constraint Jacobian terms
  • 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
  • MaterialVectorBodyForceApply a body force vector to the coupled displacement component.
  • 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
  • TotalLagrangianStressDivergenceEnforce equilibrium with a total Lagrangian formulation in Cartesian coordinates.
  • TotalLagrangianStressDivergenceAxisymmetricCylindricalEnforce equilibrium with a total Lagrangian formulation in axisymmetric cylindrical coordinates.
  • TotalLagrangianStressDivergenceCentrosymmetricSphericalEnforce equilibrium with a total Lagrangian formulation in centrosymmetric spherical coordinates.
  • TotalLagrangianWeakPlaneStressPlane stress kernel to provide out-of-plane strain contribution.
  • UpdatedLagrangianStressDivergenceEnforce equilibrium with an updated Lagrangian formulation in Cartesian coordinates.
  • WeakPlaneStressPlane stress kernel to provide out-of-plane strain contribution.
  • DynamicTensorMechanics
  • PoroMechanics
  • TensorMechanics
  • Phase Field App
  • ACBarrierFunctionAllen-Cahn kernel used when 'mu' is a function of variables
  • ACGBPolyGrain-Boundary model concentration dependent residual
  • ACGrGrElasticDrivingForceAdds elastic energy contribution to the Allen-Cahn equation
  • ACGrGrMultiMulti-phase poly-crystalline Allen-Cahn Kernel
  • ACGrGrPolyGrain-Boundary model poly-crystalline interface Allen-Cahn Kernel
  • ACGrGrPolyLinearizedInterfaceGrain growth model Allen-Cahn Kernel with linearized interface variable transformation
  • ACInterfaceGradient energy Allen-Cahn Kernel
  • ACInterface2DMultiPhase1Gradient energy Allen-Cahn Kernel where the derivative of interface parameter kappa wrt the gradient of order parameter is considered.
  • ACInterface2DMultiPhase2Gradient energy Allen-Cahn Kernel where the interface parameter kappa is considered.
  • ACInterfaceChangedVariableGradient energy Allen-Cahn Kernel using a change of variable
  • ACInterfaceCleavageFractureGradient energy Allen-Cahn Kernel where crack propagation along weakcleavage plane is preferred
  • ACInterfaceKobayashi1Anisotropic gradient energy Allen-Cahn Kernel Part 1
  • ACInterfaceKobayashi2Anisotropic Gradient energy Allen-Cahn Kernel Part 2
  • ACInterfaceStressInterface stress driving force Allen-Cahn Kernel
  • ACKappaFunctionGradient energy term for when kappa as a function of the variable
  • ACMultiInterfaceGradient energy Allen-Cahn Kernel with cross terms
  • ACSEDGPolyStored Energy contribution to grain growth
  • ACSwitchingKernel for Allen-Cahn equation that adds derivatives of switching functions and energies
  • ADACInterfaceGradient energy Allen-Cahn Kernel
  • ADACInterfaceKobayashi1Anisotropic gradient energy Allen-Cahn Kernel Part 1
  • ADACInterfaceKobayashi2Anisotropic Gradient energy Allen-Cahn Kernel Part 2
  • ADAllenCahnAllen-Cahn Kernel that uses a DerivativeMaterial Free Energy
  • ADCHSoretMobilityAdds contribution due to thermo-migration to the Cahn-Hilliard equation using a concentration 'u', temperature 'T', and thermal mobility 'mobility' (in units of length squared per time).
  • ADCHSplitChemicalPotentialChemical potential kernel in Split Cahn-Hilliard that solves chemical potential in a weak form
  • ADCHSplitConcentrationConcentration kernel in Split Cahn-Hilliard that solves chemical potential in a weak form
  • ADCoefCoupledTimeDerivativeScaled time derivative Kernel that acts on a coupled variable
  • ADGrainGrowthGrain-Boundary model poly-crystalline interface Allen-Cahn Kernel
  • ADMatAnisoDiffusionDiffusion equation kernel that takes an anisotropic diffusivity from a material property
  • ADSplitCHParsedSplit formulation Cahn-Hilliard Kernel that uses a DerivativeMaterial Free Energy
  • ADSplitCHWResSplit formulation Cahn-Hilliard Kernel for the chemical potential variable with a scalar (isotropic) mobility
  • ADSplitCHWResAnisoSplit formulation Cahn-Hilliard Kernel for the chemical potential variable with a scalar (isotropic) mobility
  • AllenCahnAllen-Cahn Kernel that uses a DerivativeMaterial Free Energy
  • AllenCahnElasticEnergyOffDiagThis kernel calculates off-diagonal Jacobian of elastic energy in AllenCahn with respect to displacements
  • AntitrappingCurrentKernel that provides antitrapping current at the interface for alloy solidification
  • CHBulkPFCTradCahn-Hilliard kernel for a polynomial phase field crystal free energy.
  • CHInterfaceGradient energy Cahn-Hilliard Kernel with a scalar (isotropic) mobility
  • CHInterfaceAnisoGradient energy Cahn-Hilliard Kernel with a tensor (anisotropic) mobility
  • CHMathSimple demonstration Cahn-Hilliard Kernel using an algebraic double-well potential
  • CHPFCRFFCahn-Hilliard residual for the RFF form of the phase field crystal model
  • CHSplitChemicalPotentialChemical potential kernel in Split Cahn-Hilliard that solves chemical potential in a weak form
  • CHSplitConcentrationConcentration kernel in Split Cahn-Hilliard that solves chemical potential in a weak form
  • CHSplitFluxComputes flux as nodal variable
  • CahnHilliardCahn-Hilliard Kernel that uses a DerivativeMaterial Free Energy and a scalar (isotropic) mobility
  • CahnHilliardAnisoCahn-Hilliard Kernel that uses a DerivativeMaterial Free Energy and a tensor (anisotropic) mobility
  • ChangedVariableTimeDerivativeA modified time derivative Kernel that multiplies the time derivative bythe derivative of the nonlinear preconditioning function
  • CoefCoupledTimeDerivativeScaled time derivative Kernel that acts on a coupled variable
  • ConservedLangevinNoiseSource term for noise from a ConservedNoise userobject
  • CoupledAllenCahnCoupled Allen-Cahn Kernel that uses a DerivativeMaterial Free Energy
  • CoupledMaterialDerivativeKernel that implements the first derivative of a function material property with respect to a coupled variable.
  • CoupledSusceptibilityTimeDerivativeA modified coupled time derivative Kernel that multiplies the time derivative of a coupled variable by a generalized susceptibility
  • CoupledSwitchingTimeDerivativeCoupled time derivative Kernel that multiplies the time derivative by
  • DiscreteNucleationForceTerm for inserting grain nuclei or phases in non-conserved order parameter fields
  • GradientComponentSet the kernel variable to a specified component of the gradient of a coupled variable.
  • HHPFCRFFReaction type kernel for the RFF phase fit crystal model
  • KKSACBulkCKKS model kernel (part 2 of 2) for the Bulk Allen-Cahn. This includes all terms dependent on chemical potential.
  • KKSACBulkFKKS model kernel (part 1 of 2) for the Bulk Allen-Cahn. This includes all terms NOT dependent on chemical potential.
  • KKSCHBulkKKS model kernel for the Bulk Cahn-Hilliard term. This operates on the concentration 'c' as the non-linear variable
  • KKSMultiACBulkCMulti-phase KKS model kernel (part 2 of 2) for the Bulk Allen-Cahn. This includes all terms dependent on chemical potential.
  • KKSMultiACBulkFKKS model kernel (part 1 of 2) for the Bulk Allen-Cahn. This includes all terms NOT dependent on chemical potential.
  • KKSMultiPhaseConcentrationKKS multi-phase model kernel to enforce . The non-linear variable of this kernel is , the final phase concentration in the list.
  • KKSPhaseChemicalPotentialKKS model kernel to enforce the pointwise equality of phase chemical potentials . The non-linear variable of this kernel is .
  • KKSPhaseConcentrationKKS model kernel to enforce the decomposition of concentration into phase concentration . The non-linear variable of this kernel is .
  • KKSSplitCHCResKKS model kernel for the split Bulk Cahn-Hilliard term. This kernel operates on the physical concentration 'c' as the non-linear variable
  • LangevinNoiseSource term for non-conserved Langevin noise
  • LaplacianSplitSplit with a variable that holds the Laplacian of a phase field variable.
  • MaskedBodyForceKernel that defines a body force modified by a material mask
  • MaskedExponentialKernel to add dilute solution term to Poisson's equation for electrochemical sintering
  • MatAnisoDiffusionDiffusion equation Kernel that takes an anisotropic Diffusivity from a material property
  • MatGradSquareCoupledGradient square of a coupled variable.
  • MultiGrainRigidBodyMotionAdds rigid body motion to grains
  • SLKKSChemicalPotentialSLKKS model kernel to enforce the pointwise equality of sublattice chemical potentials in the same phase.
  • SLKKSMultiACBulkCMulti-phase SLKKS model kernel for the bulk Allen-Cahn. This includes all terms dependent on chemical potential.
  • SLKKSMultiPhaseConcentrationSLKKS multi-phase model kernel to enforce . The non-linear variable of this kernel is a phase's sublattice concentration
  • SLKKSPhaseConcentrationSublattice KKS model kernel to enforce the decomposition of concentration into phase and sublattice concentrations The non-linear variable of this kernel is a sublattice concentration of phase b.
  • SLKKSSumEnforce the sum of sublattice concentrations to a given phase concentration.
  • SimpleACInterfaceGradient energy for Allen-Cahn Kernel with constant Mobility and Interfacial parameter
  • SimpleCHInterfaceGradient energy for Cahn-Hilliard equation with constant Mobility and Interfacial parameter
  • SimpleCoupledACInterfaceGradient energy for Allen-Cahn Kernel with constant Mobility and Interfacial parameter for a coupled order parameter variable.
  • SimpleSplitCHWResGradient energy for split Cahn-Hilliard equation with constant Mobility for a coupled order parameter variable.
  • SingleGrainRigidBodyMotionAdds rigid mody motion to a single grain
  • SoretDiffusionAdd Soret effect to Split formulation Cahn-Hilliard Kernel
  • SplitCHMathSimple demonstration split formulation Cahn-Hilliard Kernel using an algebraic double-well potential
  • SplitCHParsedSplit formulation Cahn-Hilliard Kernel that uses a DerivativeMaterial Free Energy
  • SplitCHWResSplit formulation Cahn-Hilliard Kernel for the chemical potential variable with a scalar (isotropic) mobility
  • SplitCHWResAnisoSplit formulation Cahn-Hilliard Kernel for the chemical potential variable with a tensor (anisotropic) mobility
  • SusceptibilityTimeDerivativeA modified time derivative Kernel that multiplies the time derivative of a variable by a generalized susceptibility
  • SwitchingFunctionConstraintEtaLagrange multiplier kernel to constrain the sum of all switching functions in a multiphase system. This kernel acts on a non-conserved order parameter eta_i.
  • SwitchingFunctionConstraintLagrangeLagrange multiplier kernel to constrain the sum of all switching functions in a multiphase system. This kernel acts on the Lagrange multiplier variable.
  • SwitchingFunctionPenaltyPenalty kernel to constrain the sum of all switching functions in a multiphase system.
  • CHPFCRFFSplitKernel
  • HHPFCRFFSplitKernel
  • PFCRFFKernel
  • PolycrystalElasticDrivingForce
  • PolycrystalKernel
  • PolycrystalStoredEnergy
  • RigidBodyMultiKernel
  • Ferret App
  • AFDWall2EnergyDerivative
  • AFDWallEnergyDerivative
  • AFMEasyPlaneAnisotropyCalculates a residual contribution for the magnetic anisotropy energy.
  • AFMEasyPlaneAnisotropySCCalculates a residual contribution for the magnetic anisotropy energy.
  • AFMHomogeneousSublatticeExchangeCalculates a residual contribution for the sublattice exchange in an antiferromagnet
  • AFMInteractionCartLLCalculates a residual contribution for the sublattice exchange in an antiferromagnet
  • AFMInteractionCartLLHConstCalculates a residual contribution for the sublattice exchange in an antiferromagnet
  • AFMLocalSublatticeExchangeCartLLCalculates a residual contribution for the magnetic exchange energy.
  • AFMSingleIonCubicSixthAnisotropyCalculates a residual contribution for the magnetic anisotropy energy.
  • AFMSingleIonCubicSixthAnisotropySCCalculates a residual contribution for the magnetic anisotropy energy.
  • AFMSublatticeAnisotropyCalculates a residual contribution for the magnetic anisotropy energy.
  • AFMSublatticeDMInteractionCalculates a residual contribution for the DMI interaction on an AFM sublattice that supports such a thing
  • AFMSublatticeDMInteractionSCCalculates a residual contribution for the DMI interaction on an AFM sublattice that supports such a thing
  • AFMSublatticeSuperexchangeCalculates a residual contribution for the sublattice exchange in an antiferromagnet
  • AnisotropicElectrostaticsCalculates a residual contribution due to nabla squared Phi = 0
  • AnisotropyCartLLCalculates a residual contribution for the magnetic anisotropy energy.
  • BulkEnergyDerivativeEighthCalculates the residual for the local free energy which is an eighth order expansion in the polarization.
  • BulkEnergyDerivativeSixthCalculates the residual for the local free energy which is an sixth order expansion in the polarization.
  • BulkEnergyDerivativeSixthCoupledTCalculates the residual for the local free energy which is an sixth order expansion in the polarization coupled to the thermal field through the first Landau coefficient.
  • CarrierConCalculates a residual contribution due to free carriers
  • CarrierIntCalculates a residual contribution due to free carriers
  • CarrierRecCalculates a residual contribution due to free carriers
  • ConstFieldThis is just a test kernel. It is a residual contribution due to a constant electric field term along the z-direction of polarization
  • ConversePiezoelectricStrainCalculates the residual for additional piezoelectric strain arising in the conditions for mechanical equilibrium.
  • DepolEnergyCalculates a residual contribution due to an arbitrary depolarization energy adjustment to the PE term.
  • DivCurrentVCalculates a residual contribution due to modified ohm's law
  • ElecCurrentCalculates a residual contribution due to nabla squared Phi = 0
  • ElecGenCalculates a residual contribution due to nabla squared Phi = 0
  • ElectrostaticsCalculates a residual contribution due to div*Phi = 0
  • ElectrostrictiveCouplingDispDerivativeCalculates a residual contribution due to the spontaneous ferroelectric strain in the condition for mechanical equilibrium.
  • ElectrostrictiveCouplingPolarDerivativeCalculates a residual contribution due to the variation w.r.t polarization of the electrostrictive coupling energy. Note: for cubic parent phase only.
  • ElectrostrictiveCouplingPolarDerivativeTESTCalculates a residual contribution due to the variation w.r.t polarization of the electrostrictive coupling energy. Note: for cubic parent phase only only.
  • ExchangeCartLLCalculates a residual contribution due to the magnetic exchange energy.
  • FerroelectricCouplingPCalculates a residual contribution due to the variation w.r.t polarization of the electrostrictive coupling energy
  • FerroelectricCouplingXCalculates a residual contribution due to the differentiation w.r.t spartial coordinates of the ferroelectric self-strain in the condition for mechanical equilibrium.
  • FluctuationKernelCalculates a residual contribution introducing fluctuations useful in quasi-static hysteretic switching.
  • HeatFlowElectricTCalculates a residual contribution due to modified ohm's law
  • HoleCurrentCalculates a residual contribution due to nabla squared Phi = 0
  • HoleGenCalculates a residual contribution due to nabla squared Phi = 0
  • InPlaneSusceptibilityDerivativeCalculates the residual for the local free energy which is an eighth order expansion in the polarization.
  • InteractionCartLLCalculates a residual contribution - MH in the total energy, assuming H = - div * potential.
  • LocalConservedLangevinNoiseSource term for noise from a ConservedNoise userobject
  • LocalLangevinNoiseSource term for non-conserved Langevin noise
  • LongitudinalLLBCalculates a residual contribution for the magnetic anisotropy energy.
  • MagHStrongCartCalculates a residual contribution for bound magnetic charge (div M)
  • MagHStrongSublatticesCartCalculates a residual contribution for bound magnetic charge (div M1 + div M2)
  • MagneticPMLCartCalculates a residual contribution to Laplacian in a stretched region
  • MagnetostrictiveCouplingCubicHeffCalculates a residual contribution due to the magnetoelectric effective field. Note for cubic magnets only.
  • MagnetostrictiveCouplingDispDerivativeCalculates a residual contribution due to the differentiation w.r.t spartial coordinates of the magnetoelastic self-strain in the condition for mechanical equilibrium. Note for cubic magnets only.
  • MasterAnisotropyCartLLGCalculates a residual contribution for the magnetic anisotropy energy.
  • MasterExchangeCartLLGCalculates a residual contribution due to the magnetic exchange energy.
  • MasterInteractionCartLLGCalculates the Rij contribution (due to energy -M*H), assuming H = - div*Phi.
  • MasterInteractionCartLLGHConstCalculates a residual contribution - MH in the total energy, assuming H = - div * potential.
  • MasterLongitudinalLLBCalculates a residual contribution for the magnetic anisotropy energy.
  • PiezoelectricStrainChargeCalculates a residual contribution due to a charge arising via piezoelectric coupling in the Poisson equation.
  • PolarElectricEStrongCalculates a residual contribution due to divP (to be used with the electrostatics (Laplace) kernel).
  • PolarElectricPStrongCalculates a residual contribution due to -PE term in the total energy.
  • PolarElectricPStrongEConstCalculates a residual contribution due to -PE term in the total energy.
  • RotatedBulkEnergyDerivativeSixthCalculates the residual for the local free energy which is an sixth order expansion in the polarization.
  • RotoBulkEnergyDerivativeEighthAlt
  • RotoPolarCoupledEnergyDistortDerivativeAlt
  • RotoPolarCoupledEnergyPolarDerivativeAlt
  • RotostrictiveCouplingDispDerivative
  • RotostrictiveCouplingDistortDerivative
  • SeebeckEffectCalculates a contribution due to nabla.j = 0
  • TensorDivCurrentVCalculates a residual contribution due to modified ohm's law
  • TensorHeatFlowElectricTCalculates a residual contribution due to modified ohm's law
  • ThermalDiffusionCalculates a residual contribution due to ∇(k∇*T) = 0
  • TimeDerivativeScaled
  • Transformed110KernelCalculates the transformed residual for the local free energy which is an eighth order expansion in the polarization.
  • Transformed111ElectrostrictiveCouplingDispDerivativeCalculates a residual contribution due to the differentiation w.r.t spartial coordinates of the ferroelectric self-strain in the condition for mechanical equilibrium. Note for BFO only.
  • Transformed111ElectrostrictiveCouplingPolarDerivativeCalculates a residual contribution due to the variation w.r.t polarization of the electrostrictive coupling energy. Note: for cubic parent phase only only.
  • Transformed111KernelOp3Calculates the transformed residual for the local free energy which is an eighth order expansion in the polarization.
  • Transformed111KernelOp6Calculates the transformed residual for the local free energy which is an eighth order expansion in the polarization.
  • Transformed111RotostrictiveCouplingDispDerivativeCalculates a residual contribution due to the differentiation w.r.t spartial coordinates of the ferroelectric self-strain in the condition for mechanical equilibrium. Note for BFO only.
  • Transformed111RotostrictiveCouplingDistortDerivativeCalculates a residual contribution due to the variation w.r.t antiphase of the rotostrictive coupling energy. Note: for cubic parent phase only only.
  • UniaxialAFMSublatticeCalculates a residual contribution for an uniaxial AFM sublattice
  • Wall2EnergyDerivativeCalculates a residual contribution due to the variation w.r.t polarization of the gradient energy. This Kernel needs to be used in conjunction with WallEnergyDerivative!
  • WallEnergyDerivativeCalculates a residual contribution due to the variation w.r.t polarization of the gradient energy. This Kernel needs to be used in conjunction with Wall2EnergyDerivative!
  • Electromagnetics App
  • CurlCurlFieldWeak form term corresponding to .
  • VectorCurrentSourceKernel to calculate the current source term in the Helmholtz wave equation.
  • VectorFunctionReactionKernel representing the contribution of the PDE term , where is a function coefficient and is a vector variable.
  • VectorSecondTimeDerivativeThe second time derivative operator for vector variables.
  • 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.)

Kernels/CHPFCRFFSplitKernel

Kernels/DynamicTensorMechanics

Kernels/HHPFCRFFSplitKernel

Kernels/PFCRFFKernel

  • Phase Field App
  • PFCRFFKernelActionSet up kernels for the rational function fit (RFF) phase field crystal model

Kernels/PolycrystalElasticDrivingForce

Kernels/PolycrystalKernel

Kernels/PolycrystalStoredEnergy

  • Phase Field App
  • PolycrystalStoredEnergyActionAction that adds the contribution of stored energy associated with dislocations to grain growth models

Kernels/PoroMechanics

  • Tensor Mechanics App
  • PoroMechanicsActionSet up stress divergence kernels with coordinate system aware logic

Kernels/RigidBodyMultiKernel

Kernels/TensorMechanics

Materials

  • Moose App
  • AddMaterialActionAdd a Material object to the simulation.
  • ADCoupledValueFunctionMaterialCompute a function value from coupled variables
  • ADDerivativeParsedMaterialParsed Function Material with automatic derivatives.
  • ADDerivativeSumMaterialMeta-material to sum up multiple derivative materials
  • ADGenericConstantFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • ADGenericConstantMaterialDeclares material properties based on names and values prescribed by input parameters.
  • ADGenericConstantRankTwoTensorObject for declaring a constant rank two tensor as a material property.
  • ADGenericConstantVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
  • ADGenericConstantVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
  • ADGenericFunctionFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • ADGenericFunctionMaterialMaterial object for declaring properties that are populated by evaluation of Function object.
  • ADGenericFunctionRankTwoTensorMaterial object for defining rank two tensor properties using functions.
  • ADGenericFunctionVectorMaterialMaterial object for declaring vector properties that are populated by evaluation of Function objects.
  • ADGenericFunctorGradientMaterialFunctorMaterial object for declaring properties that are populated by evaluation of gradients of Functors (a constant, variable, function or functor material property) objects.
  • ADGenericFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • ADGenericVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
  • ADParsedFunctorMaterialComputes a functor material from a parsed expression of other functors.
  • ADParsedMaterialParsed expression Material.
  • ADPiecewiseByBlockFunctorMaterialComputes a property value on a per-subdomain basis
  • ADPiecewiseByBlockVectorFunctorMaterialComputes a property value on a per-subdomain basis
  • ADPiecewiseConstantByBlockMaterialComputes a property value on a per-subdomain basis
  • ADPiecewiseLinearInterpolationMaterialCompute a property using a piecewise linear interpolation to define its dependence on a variable
  • ADVectorFromComponentVariablesMaterialComputes a vector material property from coupled variables
  • ADVectorMagnitudeFunctorMaterialThis class takes up to three scalar-valued functors corresponding to vector components or a single vector functor and computes the Euclidean norm.
  • CoupledValueFunctionMaterialCompute a function value from coupled variables
  • DerivativeParsedMaterialParsed Function Material with automatic derivatives.
  • DerivativeSumMaterialMeta-material to sum up multiple derivative materials
  • FVADPropValPerSubdomainMaterialComputes a property value on a per-subdomain basis
  • FVPropValPerSubdomainMaterialComputes a property value on a per-subdomain basis
  • FunctorADConverterConverts regular functors to AD functors and AD functors to regular functors
  • GenericConstant2DArrayA material evaluating one material property in type of RealEigenMatrix
  • GenericConstantArrayA material evaluating one material property in type of RealEigenVector
  • GenericConstantFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • GenericConstantMaterialDeclares material properties based on names and values prescribed by input parameters.
  • GenericConstantRankTwoTensorObject for declaring a constant rank two tensor as a material property.
  • GenericConstantVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
  • GenericConstantVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
  • GenericFunctionFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • GenericFunctionMaterialMaterial object for declaring properties that are populated by evaluation of Function object.
  • GenericFunctionRankTwoTensorMaterial object for defining rank two tensor properties using functions.
  • GenericFunctionVectorMaterialMaterial object for declaring vector properties that are populated by evaluation of Function objects.
  • GenericFunctorGradientMaterialFunctorMaterial object for declaring properties that are populated by evaluation of gradients of Functors (a constant, variable, function or functor material property) objects.
  • GenericFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
  • GenericVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
  • MaterialADConverterConverts regular material properties to AD properties and vice versa
  • MaterialConverterConverts regular material properties to AD properties and vice versa
  • MaterialFunctorConverterConverts functor to non-AD and AD regular material properties
  • ParsedFunctorMaterialComputes a functor material from a parsed expression of other functors.
  • ParsedMaterialParsed expression Material.
  • PiecewiseByBlockFunctorMaterialComputes a property value on a per-subdomain basis
  • PiecewiseByBlockVectorFunctorMaterialComputes a property value on a per-subdomain basis
  • PiecewiseConstantByBlockMaterialComputes a property value on a per-subdomain basis
  • PiecewiseLinearInterpolationMaterialCompute a property using a piecewise linear interpolation to define its dependence on a variable
  • RankFourTensorMaterialADConverterConverts regular material properties to AD properties and vice versa
  • RankFourTensorMaterialConverterConverts regular material properties to AD properties and vice versa
  • RankTwoTensorMaterialADConverterConverts regular material properties to AD properties and vice versa
  • RankTwoTensorMaterialConverterConverts regular material properties to AD properties and vice versa
  • VectorFromComponentVariablesMaterialComputes a vector material property from coupled variables
  • VectorFunctorADConverterConverts regular functors to AD functors and AD functors to regular functors
  • VectorMagnitudeFunctorMaterialThis class takes up to three scalar-valued functors corresponding to vector components or a single vector functor and computes the Euclidean norm.
  • VectorMaterialFunctorConverterConverts functor to non-AD and AD regular material properties
  • 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.
  • ADCZMComputeDisplacementJumpSmallStrainCompute the total displacement jump across a czm interface in local coordinates for the Small Strain kinematic formulation
  • ADCZMComputeDisplacementJumpTotalLagrangianCompute the displacement jump increment across a czm interface in local coordinates for the Total Lagrangian kinematic formulation
  • ADCZMComputeGlobalTractionSmallStrainComputes the czm traction in global coordinates for a small strain kinematic formulation
  • ADCZMComputeGlobalTractionTotalLagrangianCompute the equilibrium traction (PK1) and its derivatives for the Total Lagrangian formulation.
  • ADCombinedScalarDamageScalar damage model which is computed as a function of multiple scalar damage models
  • 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
  • ADComputeDamageStressCompute stress for damaged elastic materials in conjunction with a damage model.
  • 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
  • ADEshelbyTensorComputes the Eshelby tensor as a function of strain energy density and the first Piola-Kirchhoff stress
  • ADExponentialSofteningSoftening model with an exponential softening response upon cracking. This class is intended to be used with ADComputeSmearedCrackingStress and relies on automatic differentiation.
  • ADHillConstantsBuild and rotate the Hill Tensor. It can be used with other Hill plasticity and creep materials.
  • 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 generalized radial return for anisotropic elasto-plasticity model.This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
  • ADHillPlasticityStressUpdateThis class uses the generalized radial return for anisotropic plasticity 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.
  • ADIsotropicPowerLawHardeningStressUpdateThis 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.
  • ADLAROMANCEPartitionStressUpdateLAROMANCE base class for partitioned reduced order models
  • ADLAROMANCEStressUpdateBase class to calculate the effective creep strain based on the rates predicted by a material specific Los Alamos Reduced Order Model derived from a Visco-Plastic Self Consistent calculations.
  • ADMultiplePowerLawCreepStressUpdateThis 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.
  • ADNonlocalDamageNonlocal damage model. Given an RadialAverage UO this creates a new damage index that can be used as for ComputeDamageStress without havign to change existing local damage models.
  • 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.
  • ADPureElasticTractionSeparationPure elastic traction separation law.
  • 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
  • ADRankTwoSphericalComponentCompute components of a rank-2 tensor in a spherical coordinate system
  • ADScalarMaterialDamageScalar damage model for which the damage is prescribed by another material
  • ADStrainEnergyDensityComputes 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.
  • 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.
  • ADSymmetricFiniteStrainCompute a strain increment and rotation increment for finite strains.
  • ADSymmetricFiniteStrainElasticStressCompute stress using elasticity for finite strains
  • ADSymmetricIncrementalSmallStrainCompute a strain increment and rotation increment for small strains.
  • ADSymmetricIsotropicElasticityTensorCompute a constant isotropic elasticity tensor.
  • ADSymmetricLinearElasticStressCompute stress using elasticity for small strains
  • ADSymmetricSmallStrainCompute a small strain.
  • ADTemperatureDependentHardeningStressUpdateComputes 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
  • 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.
  • BiLinearMixedModeTractionMixed mode bilinear traction separation law.
  • CZMComputeDisplacementJumpSmallStrainCompute the total displacement jump across a czm interface in local coordinates for the Small Strain kinematic formulation
  • CZMComputeDisplacementJumpTotalLagrangianCompute the displacement jump increment across a czm interface in local coordinates for the Total Lagrangian kinematic formulation
  • CZMComputeGlobalTractionSmallStrainComputes the czm traction in global coordinates for a small strain kinematic formulation
  • CZMComputeGlobalTractionTotalLagrangianCompute the equilibrium traction (PK1) and its derivatives for the Total Lagrangian formulation.
  • CZMRealVectorCartesianComponentAccess a component of a RealVectorValue defined on a cohesive zone
  • CZMRealVectorScalarCompute the normal or tangent component of a vector quantity defined on a cohesive interface.
  • 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
  • ComputeCreepPlasticityStressCompute state (stress and internal parameters such as inelastic strains and internal parameters) using an Newton process for one creep and one plasticity model
  • ComputeCrystalPlasticityThermalEigenstrain
  • 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.
  • ComputeElasticityTensorConstantRotationCPDeprecated Class: please use ComputeElasticityTensorCP instead. Compute 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
  • ComputeHomogenizedLagrangianStrain
  • ComputeHypoelasticStVenantKirchhoffStressCalculate a small strain elastic stress that is equivalent to the hyperelastic St. Venant-Kirchhoff model if integrated using the Truesdell rate.
  • 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.
  • ComputeLagrangianLinearElasticStressStress update based on the small (engineering) stress
  • ComputeLagrangianStrainCompute strain in Cartesian coordinates.
  • ComputeLagrangianStrainAxisymmetricCylindricalCompute strain in 2D axisymmetric RZ coordinates.
  • ComputeLagrangianStrainCentrosymmetricSphericalCompute strain in centrosymmetric spherical coordinates.
  • ComputeLagrangianWPSStrainCompute strain in Cartesian coordinates.
  • ComputeLagrangianWrappedStressStress update based on the small (engineering) stress
  • 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.
  • ComputeNeoHookeanStressStress update based on the first Piola-Kirchhoff stress
  • 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.
  • ComputeSimoHughesJ2PlasticityStressThe Simo-Hughes style J2 plasticity.
  • ComputeSmallStrainCompute a small strain.
  • ComputeSmearedCrackingStressCompute stress using a fixed smeared cracking model
  • ComputeStVenantKirchhoffStressStress update based on the first Piola-Kirchhoff stress
  • 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
  • ComputeUpdatedEulerAngleThis class computes the updated Euler angle for crystal plasticity simulations. This needs to be used together with the ComputeMultipleCrystalPlasticityStress class, where the updated rotation material property is computed.
  • 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.
  • CrystalPlasticityHCPDislocationSlipBeyerleinUpdateTwo-term dislocation slip model for hexagonal close packed crystals from Beyerline and Tome
  • CrystalPlasticityKalidindiUpdateKalidindi version of homogeneous crystal plasticity.
  • CrystalPlasticityTwinningKalidindiUpdateTwinning propagation model based on Kalidindi's treatment of twinning in a FCC material
  • DensityScaling
  • 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
  • HillConstantsBuild and rotate the Hill Tensor. It can be used with other Hill plasticity and creep materials.
  • HillCreepStressUpdateThis 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.
  • HillElastoPlasticityStressUpdateThis class uses the generalized radial return for anisotropic elasto-plasticity model.This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
  • HillPlasticityStressUpdateThis class uses the generalized radial return for anisotropic plasticity model.This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
  • 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.
  • LAROMANCEPartitionStressUpdateLAROMANCE base class for partitioned reduced order models
  • LAROMANCEStressUpdateBase class to calculate the effective creep strain based on the rates predicted by a material specific Los Alamos Reduced Order Model derived from a Visco-Plastic Self Consistent calculations.
  • 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
  • NonlocalDamageNonlocal damage model. Given an RadialAverage UO this creates a new damage index that can be used as for ComputeDamageStress without havign to change existing local damage models.
  • 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.
  • PureElasticTractionSeparationPure elastic traction separation law.
  • 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
  • RankTwoSphericalComponentCompute components of a rank-2 tensor in a spherical coordinate system
  • 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
  • SymmetricIsotropicElasticityTensorCompute a constant isotropic elasticity tensor.
  • 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
  • Phase Field App
  • ADConstantAnisotropicMobilityProvide a constant mobility tensor value
  • ADGBEvolutionComputes necessary material properties for the isotropic grain growth model
  • ADInterfaceOrientationMaterial2D interfacial anisotropy
  • ADMathFreeEnergyMaterial that implements the math free energy and its derivatives:
  • AsymmetricCrossTermBarrierFunctionMaterialFree energy contribution asymmetric across interfaces between arbitrary pairs of phases.
  • BarrierFunctionMaterialHelper material to provide and its derivative in a polynomial. SIMPLE: LOW: HIGH:
  • CompositeMobilityTensorAssemble a mobility tensor from multiple tensor contributions weighted by material properties
  • ComputeGBMisorientationTypeCalculate types of grain boundaries in a polycrystalline sample
  • ComputePolycrystalElasticityTensorCompute an evolving elasticity tensor coupled to a grain growth phase field model.
  • ConstantAnisotropicMobilityProvide a constant mobility tensor value
  • CoupledValueFunctionFreeEnergyCompute a free energy from a lookup function
  • CrossTermBarrierFunctionMaterialFree energy contribution symmetric across interfaces between arbitrary pairs of phases.
  • DeformedGrainMaterial
  • DerivativeMultiPhaseMaterialTwo phase material that combines n phase materials using a switching function with and n non-conserved order parameters (to be used with SwitchingFunctionConstraint*).
  • DerivativeTwoPhaseMaterialTwo phase material that combines two single phase materials using a switching function.
  • DiscreteNucleationFree energy contribution for nucleating discrete particles
  • ElasticEnergyMaterialFree energy material for the elastic energy contributions.
  • ElectrochemicalDefectMaterialCalculates density, susceptibility, and derivatives for a defect species in the grand potential sintering model coupled with electrochemistry
  • ElectrochemicalSinteringMaterialIncludes switching and thermodynamic properties for the grand potential sintering model coupled with electrochemistry
  • ExternalForceDensityMaterialProviding external applied force density to grains
  • ForceDensityMaterialCalculating the force density acting on a grain
  • GBAnisotropy
  • GBDependentAnisotropicTensorCompute anisotropic rank two tensor based on GB phase variable
  • GBDependentDiffusivityCompute diffusivity rank two tensor based on GB phase variable
  • GBEvolutionComputes necessary material properties for the isotropic grain growth model
  • GBWidthAnisotropy
  • GrainAdvectionVelocityCalculation the advection velocity of grain due to rigid body translation and rotation
  • GrandPotentialInterfaceCalculate Grand Potential interface parameters for a specified interfacial free energy and width
  • GrandPotentialSinteringMaterialIncludes switching and thermodynamic properties for the grand potential sintering model
  • GrandPotentialTensorMaterialDiffusion and mobility parameters for grand potential model governing equations. Uses a tensor diffusivity
  • IdealGasFreeEnergyFree energy of an ideal gas.
  • InterfaceOrientationMaterial2D interfacial anisotropy
  • InterfaceOrientationMultiphaseMaterialThis Material accounts for the the orientation dependence of interfacial energy for multi-phase multi-order parameter phase-field model.
  • KKSXeVacSolidMaterialKKS Solid phase free energy for Xe,Vac in UO2. Fm(cmg,cmv)
  • LinearizedInterfaceFunctionDefines the order parameter substitution for linearized interface phase field models
  • MathEBFreeEnergyMaterial that implements the math free energy using the expression builder and automatic differentiation
  • MathFreeEnergyMaterial that implements the math free energy and its derivatives:
  • MixedSwitchingFunctionMaterialHelper material to provide h(eta) and its derivative in one of two polynomial forms. MIX234 and MIX246
  • MultiBarrierFunctionMaterialDouble well phase transformation barrier free energy contribution.
  • PFCRFFMaterial
  • PFCTradMaterialPolynomial coefficients for a phase field crystal correlation function
  • PFParamsPolyFreeEnergyPhase field parameters for polynomial free energy for single component systems
  • PhaseNormalTensorCalculate normal tensor of a phase based on gradient
  • PolycrystalDiffusivityGenerates a diffusion coefficient to distinguish between the bulk, pore, grain boundaries, and surfaces
  • PolycrystalDiffusivityTensorBaseGenerates a diffusion tensor to distinguish between the bulk, grain boundaries, and surfaces
  • PolynomialFreeEnergyPolynomial free energy for single component systems
  • RegularSolutionFreeEnergyMaterial that implements the free energy of a regular solution
  • StrainGradDispDerivativesProvide the constant derivatives of strain w.r.t. the displacement gradient components.
  • SwitchingFunction3PhaseMaterialMaterial for switching function that prevents formation of a third phase at a two-phase interface:
  • SwitchingFunctionMaterialHelper material to provide and its derivative in one of two polynomial forms. SIMPLE: HIGH:
  • SwitchingFunctionMultiPhaseMaterialCalculates the switching function for a given phase for a multi-phase, multi-order parameter model
  • ThirdPhaseSuppressionMaterialFree Energy contribution that penalizes more than two order parameters being non-zero
  • TimeStepMaterialProvide various time stepping quantities as material properties.
  • VanDerWaalsFreeEnergyFree energy of a Van der Waals gas.
  • VariableGradientMaterialCompute the norm of the gradient of a variable
  • Ferret App
  • ADThermoelectricMaterialGeneral-purpose material model for thermoelectrics
  • ComputeDeltaIndicatrixCompute the adjustments to the indicatrix (beta tensor).
  • ComputeDeltaIndicatrixElectroCompute the adjustments to the indicatrix (beta tensor).
  • ComputeElastoopticTensorCompute a photostrictive tensor.
  • ComputeElectricalConductivityTDepTensorStore a temperature dependent electrical conductivity tensor.
  • ComputeElectricalConductivityTensorStore an electric conductivity tensor
  • ComputeElectroopticTensorCompute an electrooptic tensor.
  • ComputeElectrostrictiveTensorCompute an electrostrictive tensor.
  • ComputeGCoeffTensorCompute a polar-optic (g) tensor.
  • ComputeIndicatrixCompute the impermeability tensor, or indicatrix.
  • ComputePiezoTensorCompute the converse piezoelectric tensor.
  • ComputePiezostrictiveTensorCompute a piezostrictive tensor.
  • ComputePolarOpticGCoeffTensorCompute the adjustments to the indicatrix due to the polar-optic effect with gijkl coefficients.
  • ComputePolarOpticTensorCompute the adjustments to the indicatrix (beta tensor) due to the polar-optic effect.
  • ComputeSeebeckTDepTensorCompute a Seebeck tensor.
  • ComputeSeebeckTensorCompute a Seebeck tensor.
  • ComputeThermalConductivityTDepTensorCompute a ThermalConductivity tensor.
  • ComputeThermalConductivityTensorCompute a ThermalConductivity tensor.
  • ThermoelectricMaterialGeneral-purpose material model for thermoelectrics
  • Electromagnetics App
  • WaveEquationCoefficientMaterial for use as coefficient (where a is a scalar coefficient) in standard-form Helmholtz wave equation applications with derivatives calculated using automatic differentiation.
  • Misc App
  • ADDensityCreates density material property
  • DensityCreates density material property

Mesh

  • Moose App
  • CreateDisplacedProblemActionCreate a Problem object that utilizes displacements.
  • DisplayGhostingActionAction to setup AuxVariables and AuxKernels to display ghosting when running in parallel
  • ElementIDOutputActionAction for copying extra element IDs into auxiliary variables for output.
  • 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.
  • AddMetaDataGeneratorThis mesh generator assigns extraneous mesh metadata to the input mesh
  • AdvancedExtruderGeneratorExtrudes a 1D mesh into 2D, or a 2D mesh into 3D, can have a variable height for each elevation, variable number of layers within each elevation, variable growth factors of axial element sizes within each elevation and remap subdomain_ids, boundary_ids and element extra integers within each elevation as well as interface boundaries between neighboring elevation layers.
  • 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
  • BlockToMeshConverterGeneratorConverts one or more blocks (subdomains) from a mesh into a stand-alone mesh with a single block in it.
  • 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.
  • CircularBoundaryCorrectionGeneratorThis CircularBoundaryCorrectionGenerator object is designed to correct full or partial circular boundaries in a 2D mesh to preserve areas.
  • 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
  • ExplodeMeshGeneratorBreak all element-element interfaces in the specified subdomains.
  • ExtraNodesetGeneratorCreates a new node set and a new boundary made with the nodes the user provides.
  • FancyExtruderGeneratorExtrudes a 1D mesh into 2D, or a 2D mesh into 3D, can have a variable height for each elevation, variable number of layers within each elevation, variable growth factors of axial element sizes within each elevation and remap subdomain_ids, boundary_ids and element extra integers within each elevation as well as interface boundaries between neighboring elevation layers.
  • FileMeshGeneratorRead a mesh from a file.
  • FillBetweenCurvesGeneratorThis FillBetweenCurvesGenerator object is designed to generate a transition layer to connect two boundaries of two input meshes.
  • FillBetweenPointVectorsGeneratorThis FillBetweenPointVectorsGenerator object is designed to generate a transition layer with two sides containing different numbers of nodes.
  • FillBetweenSidesetsGeneratorThis FillBetweenSidesetsGenerator object is designed to generate a transition layer to connect two boundaries of two input meshes.
  • 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.
  • MeshDiagnosticsGeneratorRuns a series of diagnostics on the mesh to detect potential issues such as unsupported features
  • MeshExtruderGeneratorTakes a 1D or 2D mesh and extrudes the entire structure along the specified axis increasing the dimensionality of the mesh.
  • MeshRepairGeneratorMesh generator to perform various improvement / fixing operations on an input mesh
  • MoveNodeGeneratorModifies the position of one or more nodes
  • NodeSetsFromSideSetsGeneratorMesh generator which constructs node sets from side sets
  • OrientedSubdomainBoundingBoxGeneratorDefines a subdomain inside or outside of a bounding box with arbitrary orientation.
  • ParsedCurveGeneratorThis ParsedCurveGenerator object is designed to generate a mesh of a curve that consists of EDGE2 elements.
  • ParsedElementDeletionGeneratorRemoves elements such that the parsed expression is evaluated as strictly positive. The parameters of the parsed expression can be the X,Y,Z coordinates of the element vertex average (must be 'x','y','z' in the expression), the element volume (must be 'volume' in the expression) and the element id ('id' in the expression).
  • 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 in included_subdomain_ids and if they feature the designated normal.
  • ParsedNodeTransformGeneratorApplies a transform to a the x,y,z coordinates of a Mesh
  • 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).
  • PlaneIDMeshGeneratorAdds an extra element integer that identifies planes in a mesh.
  • PolyLineMeshGeneratorGenerates meshes from edges connecting a list of points.
  • RefineBlockGeneratorMesh generator which refines one or more blocks in an existing mesh
  • RefineSidesetGeneratorMesh generator which refines one or more sidesets
  • RenameBlockGeneratorChanges the block IDs and/or block names for a given set of blocks defined by either block ID or block name. The changes are independent of ordering. The merging of blocks is supported.
  • 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.
  • SideSetExtruderGeneratorTakes a 1D or 2D mesh and extrudes a selected sideset along the specified axis.
  • 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.
  • SideSetsFromNodeSetsGeneratorMesh generator which constructs side sets from node sets
  • 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
  • SphereMeshGeneratorGenerate a 3-D sphere mesh centered on the origin
  • 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 stitched 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.
  • SymmetryTransformGeneratorApplies a symmetry transformation to the entire mesh.
  • TiledMeshGeneratorUse the supplied mesh and create a tiled grid by repeating this mesh in the x, y, and z directions.
  • TransfiniteMeshGeneratorCreates a QUAD4 mesh given a set of corner vertices and edge types. The edge type can be either LINE, CIRCARC, DISCRETE or PARSED, with LINE as the default option. For the non-default options the user needs to specify additional parameters via the edge_parameter option as follows: for CIRCARC the deviation of the midpoint from an arccircle, for DISCRETE a set of points, or a paramterization via the PARSED option. Opposite edges may have different distributions s long as the number of points is identical. Along opposite edges a different point distribution can be prescribed via the options bias_x or bias_y for opposing edges.
  • TransformGeneratorApplies a linear transform to the entire mesh.
  • UniqueExtraIDMeshGeneratorAdd a new extra element integer ID by finding unique combinations of the existing extra element integer ID values
  • XYDelaunayGeneratorTriangulates meshes within boundaries defined by input meshes.
  • XYMeshLineCutterThis XYMeshLineCutter object is designed to trim the input mesh by removing all the elements on one side of a given straight line with special processing on the elements crossed by the cutting line to ensure a smooth cross-section.
  • 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 using mesh generators
  • 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
  • Phase Field App
  • EBSDMeshGeneratorMesh generated from a specified DREAM.3D EBSD data file.
  • SphereSurfaceMeshGeneratorGenerated sphere mesh - a two dimensional manifold embedded in three dimensional space
  • EBSDMeshMesh generated from a specified DREAM.3D EBSD data file.

Mesh/Partitioner

Modules

Modules/PhaseField

Modules/PhaseField/Conserved

  • Phase Field App
  • ConservedActionSet up the variable(s) and the kernels needed for a conserved phase field variable. Note that for a direct solve, the element family and order are overwritten with hermite and third.

Modules/PhaseField/DisplacementGradients

  • Phase Field App
  • DisplacementGradientsActionSet up variables, kernels, and materials for a the displacement gradients and their elastic free energy derivatives for non-split Cahn-Hilliard problems.

Modules/PhaseField/EulerAngles2RGB

  • Phase Field App
  • EulerAngle2RGBActionSet up auxvariables and auxkernels to output Euler angles as RGB values interpolated across inverse pole figure

Modules/PhaseField/GrainGrowth

  • Phase Field App
  • GrainGrowthActionSet up the variable and the kernels needed for a grain growth simulation

Modules/PhaseField/GrainGrowthLinearizedInterface

Modules/PhaseField/GrandPotential

Modules/PhaseField/Nonconserved

  • Phase Field App
  • NonconservedActionSet up the variable and the kernels needed for a non-conserved phase field variable

Modules/TensorMechanics

Modules/TensorMechanics/CohesiveZoneMaster

Modules/TensorMechanics/DynamicMaster

Modules/TensorMechanics/GeneralizedPlaneStrain

Modules/TensorMechanics/GlobalStrain

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

Modules/TensorMechanics/MaterialVectorBodyForce

MultiApps

  • Moose App
  • AddMultiAppActionAdd a MultiApp object to the simulation.
  • CentroidMultiAppAutomatically generates Sub-App positions from centroids of elements in the parent app mesh.
  • FullSolveMultiAppPerforms a complete simulation during each execution.
  • QuadraturePointMultiAppAutomatically generates sub-App positions from the elemental quadrature points, with the default quadrature, in the parent mesh.
  • TransientMultiAppMultiApp for performing coupled simulations with the parent and sub-application both progressing in time.

NodalKernels

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.

Positions

Postprocessors

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.
  • VCPVarialble condensation preconditioner (VCP) condenses out specified variable(s) from the Jacobian matrix and produces a system of equations with less unkowns to be solved by the underlying preconditioners.

Problem

  • Moose App
  • CreateProblemActionAdd a Problem object to the simulation.
  • DynamicObjectRegistrationActionRegister MooseObjects from other applications dynamically.
  • DisplacedProblemA Problem object for providing 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 an eigenvalue 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
  • Ferret App
  • FerretProblem

Reporters

  • Moose App
  • AddReporterActionAdd a Reporter object to the simulation.
  • AccumulateReporterReporter which accumulates the value of a inputted reporter value over time into a vector reporter value of the same type.
  • ConstantReporterReporter with constant values to be accessed by other objects, can be modified using transfers.
  • ElementVariableStatisticsElement reporter to get statistics for a coupled variable. This can be transfered to other apps.
  • ExtraIDIntegralReporterThis ExtraIDIntegralReporter source code is to integrate variables based on parsed extra IDs based on reporter system.
  • IterationInfoReport the time and iteration information for the simulation.
  • MeshInfoReport mesh information, such as the number of elements, nodes, and degrees of freedom.
  • NodalVariableStatisticsNodal reporter to get statistics for a coupled variable. This can be transfered to other apps.
  • PerfGraphReporterReports the full performance graph from the PerfGraph.
  • SolutionInvalidityReporterReports the Summary Table of Solution Invalid Counts.

Samplers

ScalarKernels

Times

Transfers

  • Moose App
  • AddTransferActionAdd a Transfer object to the simulation.
  • MultiAppAddTransferAdds variables (nonlinear and auxiliary) between multiapps that have identical meshes.
  • MultiAppCloneReporterTransferDeclare and transfer reporter data from sub-application(s) to main application.
  • MultiAppCopyTransferCopies variables (nonlinear and auxiliary) between multiapps that have identical meshes.
  • MultiAppGeneralFieldNearestLocationTransferTransfers field data at the MultiApp position by finding the value at the nearest neighbor(s) in the origin application.
  • MultiAppGeneralFieldNearestNodeTransferTransfers field data at the MultiApp position by finding the value at the nearest neighbor(s) in the origin application.
  • MultiAppGeneralFieldShapeEvaluationTransferTransfers field data at the MultiApp position using the finite element shape functions from the origin application.
  • MultiAppGeneralFieldUserObjectTransferTransfers user object spatial evaluations from an origin app onto a variable in the target application.
  • MultiAppGeometricInterpolationTransferTransfers the value to the target domain from a combination/interpolation of the values on the nearest nodes in the source domain, using coefficients based on the distance to each node.
  • MultiAppInterpolationTransferTransfers the value to the target domain from a combination/interpolation of the values on the nearest nodes in the source domain, using coefficients based on the distance to each node.
  • MultiAppMeshFunctionTransferTransfers field data at the MultiApp position using solution the finite element function from the main/parent 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 parent application.
  • MultiAppPostprocessorToAuxScalarTransferTransfers from a postprocessor to a 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 two applications.
  • MultiAppScalarToAuxScalarTransferTransfers data from a scalar variable to an auxiliary scalar variable from different applications.
  • MultiAppShapeEvaluationTransferTransfers field data at the MultiApp position using solution the finite element function from the main/parent application, via a 'libMesh::MeshFunction' object.
  • MultiAppUserObjectTransferSamples a variable's value in the Parent app domain at the point where the MultiApp is and copies that value into a post-processor in the MultiApp
  • MultiAppVariableValueSamplePostprocessorTransferSamples the value of a variable within the main application at each sub-application position and transfers the value to a postprocessor on the sub-application(s) when performing the to-multiapp transfer. Reconstructs the value of a CONSTANT MONOMIAL variable associating the value of each element to the value of the postprocessor in the closest sub-application whem performing the from-multiapp transfer.
  • 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

UserObjects

Variables

Variables/CHPFCRFFSplitVariables

Variables/HHPFCRFFSplitVariables

Variables/PFCRFFVariables

Variables/PolycrystalVariables

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
  • ExtraIDIntegralVectorPostprocessorIntegrates variables based on extra element IDs
  • 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 one or more functions 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).
  • PointValueSamplerSample a variable at specific points.
  • SideValueSamplerSample variable(s) along a sideset, internal or external.
  • SidesetInfoVectorPostprocessorThis VectorPostprocessor collects meta data for provided sidesets.
  • SpatialUserObjectVectorPostprocessorOutputs the values of a spatial user object in the order of the specified spatial points
  • SphericalAverageCompute a spherical average of a variable as a function of radius throughout the simulation domain.
  • VariableValueVolumeHistogramCompute a histogram of volume fractions binned according to variable values.
  • 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
  • ADInteractionIntegralComputes the interaction integral, which is used to compute various fracture mechanics parameters at a crack tip, including KI, KII, KIII, and the T stress.
  • 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
  • Phase Field App
  • EulerAngleUpdaterCheckProvide updated Euler angles after rigid body rotation of the grains.
  • FeatureVolumeVectorPostprocessorThis object is designed to pull information from the data structures of a "FeatureFloodCount" or derived object (e.g. individual feature volumes)
  • GrainForcesPostprocessorOutputs the values from GrainForcesPostprocessor
  • GrainTextureVectorPostprocessorGives out info on the grain boundary properties