Complete 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, Nedelec or Raviart-Thomas
  • Phase Field App
  • DiscreteNucleationMarkerMark new nucleation sites for refinement
  • Navier Stokes App
  • BernoulliPressureVariableBase class for Moose variables. This should never be the terminal object type
  • INSFVEnergyVariableBase class for Moose variables. This should never be the terminal object type
  • INSFVPressureVariableBase class for Moose variables. This should never be the terminal object type
  • INSFVScalarFieldVariableBase class for Moose variables. This should never be the terminal object type
  • INSFVVelocityVariableBase class for Moose variables. This should never be the terminal object type
  • PINSFVSuperficialVelocityVariableBase class for Moose variables. This should never be the terminal object type
  • PiecewiseConstantVariableBase class for Moose variables. This should never be the terminal object type

Application

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, quadrature point, or node.
  • 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
  • ADProjectedStatefulMaterialRankFourTensorAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
  • ADProjectedStatefulMaterialRankTwoTensorAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
  • ADProjectedStatefulMaterialRealAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
  • ADProjectedStatefulMaterialRealVectorValueAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
  • 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.
  • 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.
  • FunctorAuxEvaluates a functor (variable, function or functor material property) on the current element, quadrature point, or node.
  • FunctorElementalAuxEvaluates a functor (variable, function or functor material property) on the current element, quadrature point, or node.
  • FunctorElementalGradientAuxEvaluates the gradient of 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
  • MeshDivisionAuxReturns the value of the mesh division index for each element / node
  • 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.
  • NodalPatchRecoveryAuxThis Auxkernel solves a least squares problem at each node to fit a value from quantities defined on quadrature points.
  • 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.
  • ProjectedMaterialPropertyNodalPatchRecoveryAuxThis Auxkernel solves a least squares problem at each node to fit a value from quantities defined on quadrature points.
  • ProjectedStatefulMaterialRankFourTensorAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
  • ProjectedStatefulMaterialRankTwoTensorAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
  • ProjectedStatefulMaterialRealAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
  • ProjectedStatefulMaterialRealVectorValueAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
  • 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.
  • 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.
  • Misc App
  • CoupledDirectionalMeshHeightInterpolationScales a variable based on position relative to the model bounds in a specified direction
  • Chemical Reactions App
  • AqueousEquilibriumRxnAuxConcentration of secondary equilibrium species
  • EquilibriumConstantAuxEquilibrium constant for a given equilibrium species (in form log10(Keq))
  • KineticDisPreConcAuxConcentration of secondary kinetic species
  • KineticDisPreRateAuxKinetic rate of secondary kinetic species
  • PHAuxpH of solution
  • TotalConcentrationAuxTotal concentration of primary species (including stoichiometric contribution to secondary equilibrium species)
  • 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
  • XFEMApp
  • CutSubdomainIDAuxFill the elemental variable with CutSubdomainID
  • MeshCutLevelSetAuxCalculates signed distance from interface defined by InterfaceMeshCutUserObject.
  • XFEMCutPlaneAuxComputes the normal and origin of a cutting plane for each partial element.
  • XFEMMarkerAuxIdentify the crack tip elements.
  • XFEMVolFracAuxComputes the volume fraction of the physical material in each partial element.
  • Porous Flow App
  • ADPorousFlowDarcyVelocityComponentDarcy velocity (in m3.s-1.m-2, or m.s-1) -(k_ij * krel /mu (nabla_j P - w_j)), where k_ij is the permeability tensor, krel is the relative permeability, mu is the fluid viscosity, P is the fluid pressure, and w_j is the fluid weight.
  • ADPorousFlowPropertyAuxAuxKernel to provide access to properties evaluated at quadpoints. Note that elemental AuxVariables must be used, so that these properties are integrated over each element.
  • PorousFlowDarcyVelocityComponentDarcy velocity (in m3.s-1.m-2, or m.s-1) -(k_ij * krel /mu (nabla_j P - w_j)), where k_ij is the permeability tensor, krel is the relative permeability, mu is the fluid viscosity, P is the fluid pressure, and w_j is the fluid weight.
  • PorousFlowDarcyVelocityComponentLowerDimensionalDarcy velocity on a lower-dimensional element embedded in a higher-dimensional mesh. Units m3.s-1.m-2, or m.s-1. Darcy velocity = -(k_ij * krel /(mu * a) (nabla_j P - w_j)), where k_ij is the permeability tensor, krel is the relative permeability, mu is the fluid viscosity, P is the fluid pressure, a is the fracture aperture and w_j is the fluid weight. The difference between this AuxKernel and PorousFlowDarcyVelocity is that this one projects gravity along the element's tangent direction. NOTE! For a meaningful answer, your permeability tensor must NOT contain terms that rotate tangential vectors to non-tangential vectors.
  • PorousFlowElementLengthAuxKernel to compute the 'length' of elements along a given direction. A plane is constructed through the element's centroid, with normal equal to the direction given. The average of the distance of the nodal positions to this plane is the 'length' returned. The Variable for this AuxKernel must be an elemental Variable
  • PorousFlowElementNormalAuxKernel to compute components of the element normal. This is mostly designed for 2D elements living in 3D space, however, the 1D-element and 3D-element cases are handled as special cases. The Variable for this AuxKernel must be an elemental Variable
  • PorousFlowPropertyAuxAuxKernel to provide access to properties evaluated at quadpoints. Note that elemental AuxVariables must be used, so that these properties are integrated over each element.
  • 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.
  • Peridynamics App
  • BoundaryOffsetPDClass for output offset of PD boundary nodes compared to initial FE mesh
  • NodalRankTwoPDClass for computing and outputing components and scalar quantities of nodal rank two strain and stress tensors for bond-based and ordinary state-based peridynamic models
  • NodalVolumePDClass for output nodal area(2D) or nodal volume(3D)
  • RankTwoBasedFailureCriteriaNOSPDClass for rank two tensor based failure criteria in non-ordinary state-based model
  • StretchBasedFailureCriterionPDClass for bond stretch failure criterion in bond-based model and ordinary state-based model
  • Contact App
  • CohesiveZoneMortarUserObjectAuxPopulates an auxiliary variable with mortar cohesive zone model quantities.
  • ContactPressureAuxComputes the contact pressure from the contact force and nodal area
  • MortarArchardsLawAuxReturns the weighted gap velocity at a node. This quantity is useful for mortar contact, particularly when dual basis functions are used in contact mechanics
  • MortarFrictionalPressureVectorAuxThis class creates an auxiliary vector for outputting the mortar frictional pressure vector.
  • MortarFrictionalStateAuxThis class creates discrete states for nodes into frictional contact, including contact/no-contact and stick/slip.
  • MortarPressureComponentAuxThis class transforms the Cartesian Lagrange multiplier vector to local coordinates and outputs each individual component along the normal or tangential direction.
  • PenaltyMortarUserObjectAuxPopulates an auxiliary variable with a contact quantities from penalty mortar contact.
  • WeightedGapVelAuxReturns the weighted gap velocity at a node. This quantity is useful for mortar contact, particularly when dual basis functions are used in contact mechanics
  • Functional Expansion Tools App
  • FunctionSeriesToAuxAuxKernel to convert a functional expansion (Functions object, type = FunctionSeries) to an AuxVariable
  • Fsi App
  • WaveHeightAuxKernelCalculates the wave heights given pressures.
  • Fluid Properties App
  • FluidDensityAuxComputes density from pressure and temperature
  • PressureAuxComputes pressure given specific volume and specific internal energy
  • SaturationTemperatureAuxComputes saturation temperature from pressure and 2-phase fluid properties object
  • SpecificEnthalpyAuxComputes specific enthalpy from pressure and temperature
  • StagnationPressureAuxComputes stagnation pressure from specific volume, specific internal energy, and velocity
  • StagnationTemperatureAuxComputes stagnation temperature from specific volume, specific internal energy, and velocity
  • TemperatureAuxComputes temperature given specific volume and specific internal energy
  • Navier Stokes App
  • CourantComputes |u| dt / h_min.
  • EnthalpyAuxThis AuxKernel computes the specific enthalpy of the fluidfrom the total energy and the pressure.
  • HasPorosityJumpFaceShows whether an element has any attached porosity jump faces
  • INSCourantComputes h_min / |u|.
  • INSFVMixingLengthTurbulentViscosityAuxComputes the turbulent viscosity for the mixing length model.
  • INSQCriterionAuxThis class computes the Q criterion, a scalar whichaids in vortex identification in turbulent flows
  • INSStressComponentAuxThis class computes the stress component based on pressure and velocity for incompressible Navier-Stokes
  • InternalEnergyAuxThis AuxKernel computes the internal energy based on the equation of state / fluid properties and the local pressure and density.
  • NSInternalEnergyAuxAuxiliary kernel for computing the internal energy of the fluid.
  • NSLiquidFractionAuxComputes liquid fraction given the temperature.
  • NSMachAuxAuxiliary kernel for computing the Mach number assuming an ideal gas.
  • NSPressureAuxNodal auxiliary variable, for computing pressure at the nodes.
  • NSSpecificTotalEnthalpyAuxNodal auxiliary variable, for computing enthalpy at the nodes.
  • NSTemperatureAuxTemperature is an auxiliary value computed from the total energy based on the FluidProperties.
  • NSVelocityAuxVelocity auxiliary value.
  • PecletNumberFunctorAuxComputes the Peclet number: u*L/alpha.
  • ReynoldsNumberFunctorAuxComputes rho*u*L/mu.
  • SpecificInternalEnergyAuxThis AuxKernel computes the specific internal energy based from the total and the kinetic energy.
  • SpecificVolumeAuxThis auxkernel computes the specific volume of the fluid.
  • TurbulentConductivityAuxCalculates the turbulent heat conductivity.
  • WallDistanceMixingLengthAuxComputes the turbulent mixing length by assuming that it is proportional to the distance from the nearest wall. The mixinglength is capped at a distance proportional to inputted parameter delta.
  • WallFunctionWallShearStressAuxCalculates the wall shear stress based on algebraic standard velocity wall functions.
  • WallFunctionYPlusAuxCalculates y+ value according to the algebraic velocity standard wall function.
  • kEpsilonViscosityAuxCalculates the turbulent viscosity according to the k-epsilon model.
  • Stochastic Tools App
  • SurrogateModelArrayAuxKernelSets a value of a variable based on a surrogate model.
  • SurrogateModelAuxKernelSets a value of a variable based on a surrogate model.
  • Thermal Hydraulics App
  • ADConvectiveHeatFlux1PhaseAuxComputes convective heat flux for 1-phase flow.
  • ADVectorVelocityComponentAuxComputes the velocity from the 1D phase-fraction and area weighted momentum and density variables.
  • ConvectiveHeatFlux1PhaseAuxComputes convective heat flux for 1-phase flow.
  • MachNumberAuxComputes Mach number.
  • PrandtlNumberAuxComputes the Prandtl number for the fluid in the simulation domain
  • ReynoldsNumberAuxComputes the Reynolds number.
  • SoundSpeedAuxComputes the speed of sound.
  • SpecificTotalEnthalpyAuxCompute the specific total enthalpy
  • SumAuxSum of nonlinear or auxiliary variables
  • THMSpecificInternalEnergyAuxComputed the specific internal energy.
  • THMSpecificVolumeAuxComputes the specific volume for the phase.
  • VariableValueTransferAuxRetrieves a field value from the closest node on the paired boundary and stores it on this boundary or block.
  • VectorVelocityComponentAuxComputes the component of a vector-valued velocity field given by its magnitude and direction.
  • WeightedAverageAuxWeighted average of variables using other variables as weights
  • Geochemistry App
  • GeochemistryQuantityAuxExtracts information from the Reactor and records it in the AuxVariable
  • NodalVoidVolumeAuxExtracts information from the NodalVoidVolume UserObject and records it in the AuxVariable
  • Solid 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.
  • 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.
  • Heat Transfer App
  • JouleHeatingHeatGeneratedAuxCompute heat generated from Joule heating .

AuxKernels/MatVecRealGradAuxKernel

AuxKernels/MaterialVectorAuxKernel

AuxKernels/MaterialVectorGradAuxKernel

AuxScalarKernels

AuxVariables

AuxVariables/MultiAuxVariables

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.
  • ADCoupledVarNeumannBCImposes the integrated boundary condition , where is a variable.
  • 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.
  • ADRobinBCImposes the Robin integrated boundary condition .
  • 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.
  • ADVectorRobinBCImposes the Robin integrated boundary condition .
  • 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.
  • FunctorDirichletBCImposes the Dirichlet boundary condition , where is a functor and can have complex dependencies.
  • 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.
  • VectorDivPenaltyDirichletBCEnforces, in a weak sense, a Dirichlet boundary condition on the divergence of a nonlinear vector variable by applying a penalty to the difference between the current solution and the Dirichlet data.
  • 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
  • Scalar Transport App
  • BinaryRecombinationBCModels recombination of the variable with a coupled species at boundaries, resulting in loss
  • DissociationFluxBCModels creation of the variable at boundaries due to dissociation of a coupled variable, e.g. B -> A
  • Chemical Reactions App
  • ChemicalOutFlowBCChemical flux boundary condition
  • XFEMApp
  • CrackTipEnrichmentCutOffBCImposes the essential boundary condition , where is a constant, controllable value.
  • Navier Stokes App
  • AdvectionBCBoundary conditions for outflow/outflow of advected quantities: phi * velocity * normal, where phi is the advected quantitiy
  • EnergyFreeBCImplements free advective flow boundary conditions for the energy equation.
  • FluidWallMomentumBCImplicitly sets normal component of velocity to zero if the advection term of the momentum equation is integrated by parts
  • INSADDisplaceBoundaryBCBoundary condition for displacing a boundary
  • INSADDummyDisplaceBoundaryIntegratedBCThis object adds Jacobian entries for the boundary displacement dependence on the velocity
  • INSADMomentumNoBCBCThis class implements the 'No BC' boundary condition based on the 'Laplace' form of the viscous stress tensor.
  • INSADVaporRecoilPressureMomentumFluxBCVapor recoil pressure momentum flux
  • INSFEFluidEnergyBCSpecifies flow of energy through a boundary
  • INSFEFluidEnergyDirichletBCImposes a Dirichlet condition on temperature at inlets. Is not applied at outlets
  • INSFEFluidMassBCSpecifies flow of mass through a boundary given a velocity function or postprocessor
  • INSFEFluidMomentumBCSpecifies flow of momentum through a boundary
  • INSFEFluidWallMomentumBCImplicitly sets normal component of velocity to zero if the advection term of the momentum equation is integrated by parts
  • INSFEMomentumFreeSlipBCImplements free slip boundary conditions for the Navier Stokesmomentum equation.
  • INSMomentumNoBCBCLaplaceFormThis class implements the 'No BC' boundary condition based on the 'Laplace' form of the viscous stress tensor.
  • INSMomentumNoBCBCTractionFormThis class implements the 'No BC' boundary condition based on the 'traction' form of the viscous stress tensor.
  • INSTemperatureNoBCBCThis class implements the 'No BC' boundary condition discussed by Griffiths, Papanastiou, and others.
  • ImplicitNeumannBCThis class implements a form of the Neumann boundary condition in which the boundary term is treated 'implicitly'.
  • MDFluidEnergyBCSpecifies flow of energy through a boundary
  • MDFluidEnergyDirichletBCImposes a Dirichlet condition on temperature at inlets. Is not applied at outlets
  • MDFluidMassBCSpecifies flow of mass through a boundary given a velocity function or postprocessor
  • MDFluidMomentumBCSpecifies flow of momentum through a boundary
  • MDMomentumFreeSlipBCImplements free slip boundary conditions for the Navier Stokesmomentum equation.
  • MassFreeBCImplements free advective flow boundary conditions for the mass equation.
  • MomentumFreeBCImplements free flow boundary conditions for one of the momentum equations.
  • MomentumFreeSlipBCImplements free slip boundary conditions for the Navier Stokesmomentum equation.
  • NSEnergyInviscidSpecifiedBCThis class corresponds to the inviscid part of the 'natural' boundary condition for the energy equation.
  • NSEnergyInviscidSpecifiedDensityAndVelocityBCThis class corresponds to the inviscid part of the 'natural' boundary condition for the energy equation.
  • NSEnergyInviscidSpecifiedNormalFlowBCThis class corresponds to the inviscid part of the 'natural' boundary condition for the energy equation.
  • NSEnergyInviscidSpecifiedPressureBCThis class corresponds to the inviscid part of the 'natural' boundary condition for the energy equation.
  • NSEnergyInviscidUnspecifiedBCThis class corresponds to the inviscid part of the 'natural' boundary condition for the energy equation.
  • NSEnergyViscousBCThis class couples together all the variables for the compressible Navier-Stokes equations to allow them to be used in derived IntegratedBC classes.
  • NSEnergyWeakStagnationBCThe inviscid energy BC term with specified normal flow.
  • NSImposedVelocityBCImpose Velocity BC.
  • NSImposedVelocityDirectionBCThis class imposes a velocity direction component as a Dirichlet condition on the appropriate momentum equation.
  • NSInflowThermalBCThis class is used on a boundary where the incoming flow values (rho, u, v, T) are all completely specified.
  • NSMassSpecifiedNormalFlowBCThis class implements the mass equation boundary term with a specified value of rho*(u.n) imposed weakly.
  • NSMassUnspecifiedNormalFlowBCThis class implements the mass equation boundary term with the rho*(u.n) boundary integral computed implicitly.
  • NSMassWeakStagnationBCThe inviscid energy BC term with specified normal flow.
  • NSMomentumConvectiveWeakStagnationBCThe convective part (sans pressure term) of the momentum equation boundary integral evaluated at specified stagnation temperature, stagnation pressure, and flow direction values.
  • NSMomentumInviscidNoPressureImplicitFlowBCMomentum equation boundary condition used when pressure is not integrated by parts.
  • NSMomentumInviscidSpecifiedNormalFlowBCMomentum equation boundary condition in which pressure is specified (given) and the value of the convective part is allowed to vary (is computed implicitly).
  • NSMomentumInviscidSpecifiedPressureBCMomentum equation boundary condition in which pressure is specified (given) and the value of the convective part is allowed to vary (is computed implicitly).
  • NSMomentumPressureWeakStagnationBCThis class implements the pressure term of the momentum equation boundary integral for use in weak stagnation boundary conditions.
  • NSMomentumViscousBCThis class corresponds to the viscous part of the 'natural' boundary condition for the momentum equations.
  • NSPenalizedNormalFlowBCThis class penalizes the the value of u.n on the boundary so that it matches some desired value.
  • NSPressureNeumannBCThis kernel is appropriate for use with a 'zero normal flow' boundary condition in the context of the Euler equations.
  • NSStagnationPressureBCThis Dirichlet condition imposes the condition p_0 = p_0_desired.
  • NSStagnationTemperatureBCThis Dirichlet condition imposes the condition T_0 = T_0_desired.
  • NSThermalBCNS thermal BC.
  • Functional Expansion Tools App
  • FXFluxBCSets a flux boundary condition, evaluated using a FunctionSeries instance. This does not fix the flux, but rather 'strongly encourages' flux agreement by penalizing the differences through contributions to the residual.
  • FXValueBCImposes a fixed value boundary condition, evaluated using a FunctionSeries instance.
  • FXValuePenaltyBCSets a value boundary condition, evaluated using a FunctionSeries instance. This does not fix the value, but rather 'strongly encourages' value agreement by penalizing the differences through contributions to the residual.
  • Fsi App
  • FluidFreeSurfaceBCApplies a mixed Dirichlet-Neumann BC on the fluid surface.
  • Thermal Hydraulics App
  • ADBoundaryFlux3EqnBCBoundary conditions for the 1-D, 1-phase, variable-area Euler equations
  • ADConvectionHeatTransfer3DBCAdds a convective heat flux boundary condition between the local component heat structure and a 3D heat structure
  • ADConvectionHeatTransferBCAdds a convective heat flux boundary condition with user-specified ambient temperature and heat transfer coefficient functions
  • ADConvectionHeatTransferRZBCConvection BC for RZ domain in XY coordinate system
  • ADExternalAppConvectionHeatTransferBCConvection BC from an external application
  • ADExternalAppConvectionHeatTransferRZBCConvection BC from an external application for RZ domain in XY coordinate system
  • ADGateValve1PhaseBCAdds boundary fluxes for flow channels connected to a 1-phase gate valve
  • ADHSHeatFluxBCApplies a specified heat flux to the side of a plate heat structure
  • ADHSHeatFluxRZBCApplies a specified heat flux to the side of a cylindrical heat structure in XY coordinates
  • ADHeatFlux3EqnBCWall heat flux boundary condition for the energy equation
  • ADJunctionOneToOne1PhaseBCAdds boundary fluxes for flow channels connected to a 1-phase one-to-one junction
  • ADRadiativeHeatFluxBCRadiative heat transfer boundary condition for a plate heat structure
  • ADRadiativeHeatFluxRZBCRadiative heat transfer boundary condition for a cylindrical heat structure
  • ADVolumeJunction1PhaseBCAdds boundary fluxes for flow channels connected to a 1-phase volume junction
  • BoundaryFlux3EqnBCBoundary conditions for the 1-D, 1-phase, variable-area Euler equations
  • ConvectionHeatTransferBCAdds a convective heat flux boundary condition with user-specified ambient temperature and heat transfer coefficient functions
  • ConvectionHeatTransferRZBCConvection BC for RZ domain in XY coordinate system
  • ExternalAppConvectionHeatTransferBCConvection BC from an external application
  • ExternalAppConvectionHeatTransferRZBCConvection BC from an external application for RZ domain in XY coordinate system
  • HSCoupler2D3DBCAdds boundary heat flux terms for HSCoupler2D3D
  • HeatStructure2DCouplerBCApplies BC for HeatStructure2DCoupler for plate heat structure
  • HeatStructure2DCouplerRZBCApplies BC for HeatStructure2DCoupler for cylindrical heat structure in a XY coordinate system
  • HeatStructure2DRadiationCouplerRZBCApplies BC for HeatStructure2DRadiationCouplerRZ
  • RadiativeHeatFluxBCRadiative heat transfer boundary condition for a plate heat structure
  • RadiativeHeatFluxRZBCRadiative heat transfer boundary condition for a cylindrical heat structure in a XY coordinate system
  • Porous Flow App
  • PorousFlowEnthalpySinkApplies a source equal to the product of the mass flux and the fluid enthalpy. The enthalpy is computed at temperature T_in and pressure equal to the porepressure in the porous medium, if fluid_phase is given, otherwise at the supplied porepressure. Hence this adds heat energy to the porous medium at rate corresponding to a fluid being injected at (porepressure, T_in) at rate (-flux_function).
  • PorousFlowHalfCubicSinkApplies a flux sink to a boundary. The base flux defined by PorousFlowSink is multiplied by a cubic.
  • PorousFlowHalfGaussianSinkApplies a flux sink to a boundary. The base flux defined by PorousFlowSink is multiplied by a Gaussian.
  • PorousFlowOutflowBCApplies an 'outflow' boundary condition, which allows fluid components or heat energy to flow freely out of the boundary as if it weren't there. This is fully upwinded
  • PorousFlowPiecewiseLinearSinkApplies a flux sink to a boundary. The base flux defined by PorousFlowSink is multiplied by a piecewise linear function.
  • PorousFlowSinkApplies a flux sink to a boundary.
  • Solid 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
  • Peridynamics App
  • RBMPresetOldValuePDClass to apply a preset BC to nodes with rigid body motion (RBM).
  • 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.
  • Heat Transfer App
  • ADConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficent given by material properties.
  • ADFunctionRadiativeBCBoundary condition for radiative heat exchange where the emissivity function is supplied by a Function.
  • ADInfiniteCylinderRadiativeBCBoundary condition for radiative heat exchange with a cylinderwhere the boundary is approximated as a cylinder as well.
  • ConvectiveFluxFunctionDetermines boundary value by fluid heat transfer coefficient and far-field temperature
  • ConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficent given by material properties.
  • CoupledConvectiveFlux
  • CoupledConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficent given by auxiliary variables.
  • DirectionalFluxBCApplies a directional flux multiplied by the surface normal vector. Can utilize the self shadowing calculation from a SelfShadowSideUserObject.
  • FunctionRadiativeBCBoundary condition for radiative heat exchange where the emissivity function is supplied by a Function.
  • GapHeatTransferTransfers heat across a gap between two surfaces dependent on the gap geometry specified.
  • GaussianEnergyFluxBCDescribes an incoming heat flux beam with a Gaussian profile
  • GrayLambertNeumannBCThis BC imposes a heat flux density that is computed from the GrayLambertSurfaceRadiationBase userobject.
  • HeatConductionBC
  • InfiniteCylinderRadiativeBCBoundary condition for radiative heat exchange with a cylinderwhere the boundary is approximated as a cylinder as well.
  • Rdg App
  • AEFVBCA boundary condition kernel for the advection equation using a cell-centered finite volume method.

BCs/CavityPressure

BCs/CoupledPressure

BCs/InclinedNoDisplacementBC

BCs/Periodic

BCs/Pressure

Bounds

ChemicalComposition

Closures

Components

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.
  • Contact App
  • CartesianMortarMechanicalContactThis class is used to apply normal contact forces using lagrange multipliers
  • ComputeDynamicFrictionalForceLMMechanicalContactComputes the tangential frictional forces for dynamic simulations
  • ComputeDynamicWeightedGapLMMechanicalContactComputes the normal contact mortar constraints for dynamic simulations
  • ComputeFrictionalForceCartesianLMMechanicalContactComputes mortar frictional forces.
  • ComputeFrictionalForceLMMechanicalContactComputes the tangential frictional forces
  • ComputeWeightedGapCartesianLMMechanicalContactComputes the weighted gap that will later be used to enforce the zero-penetration mechanical contact conditions
  • ComputeWeightedGapLMMechanicalContactComputes the weighted gap that will later be used to enforce the zero-penetration mechanical contact conditions
  • ExplicitDynamicsContactConstraintApply non-penetration constraints on the mechanical deformation in explicit dynamics using a node on face formulation by solving uncoupled momentum-balance equations.
  • MechanicalContactConstraintApply non-penetration constraints on the mechanical deformation using a node on face, primary/secondary algorithm, and multiple options for the physical behavior on the interface and the mathematical formulation for constraint enforcement
  • MortarGenericTractionUsed to apply tangential stresses from frictional contact using lagrange multipliers
  • NormalMortarMechanicalContactThis class is used to apply normal contact forces using lagrange multipliers
  • RANFSNormalMechanicalContactApplies the Reduced Active Nonlinear Function Set scheme in which the secondary node's non-linear residual function is replaced by the zero penetration constraint equation when the constraint is active
  • TangentialMortarMechanicalContactUsed to apply tangential stresses from frictional contact using lagrange multipliers
  • XFEMApp
  • XFEMEqualValueAtInterfaceEnforce that the solution have the same value on opposing sides of an XFEM interface.
  • XFEMSingleVariableConstraintEnforce constraints on the value or flux associated with a variable at an XFEM interface.
  • Thermal Hydraulics App
  • MassFreeConstraintConstrains the momentum at the user-specified nodes along the user-specified normals
  • Solid Mechanics App
  • NodalFrictionalConstraintFrictional nodal constraint for contact
  • NodalStickConstraintSticky nodal constraint for contact
  • Heat Transfer App
  • ADInterfaceJouleHeatingConstraintJoule heating model, for the case of a closed gap interface, to calculate the heat flux contribution created when an electric potential difference occurs across that interface.
  • GapConductanceConstraintComputes the residual and Jacobian contributions for the 'Lagrange Multiplier' implementation of the thermal contact problem. For more information, see the detailed description here: http://tinyurl.com/gmmhbe9
  • ModularGapConductanceConstraintComputes the residual and Jacobian contributions for the 'Lagrange Multiplier' implementation of the thermal contact problem. For more information, see the detailed description here: http://tinyurl.com/gmmhbe9

Contact

  • Contact App
  • ContactActionSets up all objects needed for mechanical contact enforcement

ControlLogic

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
  • LibtorchNeuralNetControlControls the value of multiple controllable input parameters using a Libtorch-based neural network.
  • PIDTransientControlSets the value of a 'Real' input parameter (or postprocessor) based on a Proportional Integral Derivative control of a postprocessor to match a target a target value.
  • RealFunctionControlSets the value of a 'Real' input parameters to the value of a provided function.
  • TimePeriodControl the enabled/disabled state of objects with time.
  • Stochastic Tools App
  • LibtorchDRLControlSets the value of multiple 'Real' input parameters and postprocessors based on a Deep Reinforcement Learning (DRL) neural network trained using a PPO algorithm.
  • MultiAppCommandLineControlControl for modifying the command line arguments of MultiApps.
  • MultiAppSamplerControlControl for modifying the command line arguments of MultiApps.
  • SamplerReceiverControl for receiving data from a Sampler via SamplerParameterTransfer.
  • Solid Mechanics App
  • StepPeriodControl the enabled/disabled state of objects with user-provided simulation steps.

CoupledHeatTransfers

  • Thermal Hydraulics App
  • CoupledHeatTransferActionAction that creates the necessary objects, for the solid side, to couple a solid heat conduction region to a 1-D flow channel via convective heat transfer

Covariance

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.
  • Rdg App
  • AEFVKernelA dgkernel for the advection equation using a cell-centered finite volume method.
  • Thermal Hydraulics App
  • ADNumericalFlux3EqnDGKernelAdds side fluxes for the 1-D, 1-phase, variable-area Euler equations
  • NumericalFlux3EqnDGKernelAdds side fluxes for the 1-D, 1-phase, variable-area Euler equations

Dampers

Debug

Debug/MaterialDerivativeTest

DeprecatedBlock

DiracKernels

  • Moose App
  • AddDiracKernelActionAdd a DiracKernel object to the simulation.
  • ConstantPointSourceResidual contribution of a constant point source term.
  • FunctionDiracSourceResidual contribution from a point source defined by a function.
  • ReporterPointSourceApply a point load defined by Reporter.
  • VectorConstantPointSourceResidual contribution of a constant point source term.
  • Optimization App
  • ReporterTimePointSourceApply a time dependent point load defined by Reporters.
  • XFEMApp
  • XFEMPressureApplies a pressure on an interface cut by XFEM.
  • Porous Flow App
  • PorousFlowPeacemanBoreholeApproximates a borehole in the mesh using the Peaceman approach, ie using a number of point sinks with given radii whose positions are read from a file. NOTE: if you are using PorousFlowPorosity that depends on volumetric strain, you should set strain_at_nearest_qp=true in your GlobalParams, to ensure the nodal Porosity Material uses the volumetric strain at the Dirac quadpoints, and can therefore be computed
  • PorousFlowPointEnthalpySourceFromPostprocessorPoint source that adds heat energy corresponding to injection of a fluid with specified mass flux rate (specified by a postprocessor) at given temperature (specified by a postprocessor)
  • PorousFlowPointSourceFromPostprocessorPoint source (or sink) that adds (or removes) fluid at a mass flux rate specified by a postprocessor.
  • PorousFlowPolyLineSinkApproximates a polyline sink by using a number of point sinks with given weighting whose positions are read from a file. NOTE: if you are using PorousFlowPorosity that depends on volumetric strain, you should set strain_at_nearest_qp=true in your GlobalParams, to ensure the nodal Porosity Material uses the volumetric strain at the Dirac quadpoints, and can therefore be computed
  • PorousFlowSquarePulsePointSourcePoint source (or sink) that adds (removes) fluid at a constant mass flux rate for times between the specified start and end times.
  • Heat Transfer App
  • GapHeatPointSourceMaster

Distributions

DomainIntegral

  • Solid 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

  • Moose App
  • AddTimeStepperActionAdd a TimeStepper object to the simulation.
  • AB2PredictorCorrectorImplements second order Adams-Bashforth method for timestep calculation.
  • CSVTimeSequenceStepperSolves the Transient problem at a sequence of given time points read in a file.
  • CompositionDTThe time stepper takes all the other time steppers as input and returns the minimum time step size.
  • ConstantDTTimestepper that takes a constant time step size
  • ExodusTimeSequenceStepperSolves the Transient problem at a sequence of time points taken from a specified exodus file.
  • FunctionDTTimestepper whose steps vary over time according to a user-defined function
  • IterationAdaptiveDTAdjust the timestep based on the number of iterations
  • LogConstantDTTimeStepper which imposes a time step constant in the logarithmic space
  • PostprocessorDTComputes timestep based on a Postprocessor value.
  • SolutionTimeAdaptiveDTCompute simulation timestep based on actual solution time.
  • TimeSequenceFromTimesSolves the Transient problem at a sequence of time points taken from a specified Times object.
  • TimeSequenceStepperSolves the Transient problem at a sequence of given time points.
  • External Petsc Solver App
  • ExternalPetscTimeStepperTimestepper that queries the step size of the external petsc solver, and use that as the time step size.

Executioner/TimeSteppers

  • Moose App
  • ComposeTimeStepperActionAdd the composition time stepper if multiple time steppers have been created.
  • AddTimeStepperActionAdd a TimeStepper object to the simulation.
  • AB2PredictorCorrectorImplements second order Adams-Bashforth method for timestep calculation.
  • CSVTimeSequenceStepperSolves the Transient problem at a sequence of given time points read in a file.
  • CompositionDTThe time stepper takes all the other time steppers as input and returns the minimum time step size.
  • ConstantDTTimestepper that takes a constant time step size
  • ExodusTimeSequenceStepperSolves the Transient problem at a sequence of time points taken from a specified exodus file.
  • FunctionDTTimestepper whose steps vary over time according to a user-defined function
  • IterationAdaptiveDTAdjust the timestep based on the number of iterations
  • LogConstantDTTimeStepper which imposes a time step constant in the logarithmic space
  • PostprocessorDTComputes timestep based on a Postprocessor value.
  • SolutionTimeAdaptiveDTCompute simulation timestep based on actual solution time.
  • TimeSequenceFromTimesSolves the Transient problem at a sequence of time points taken from a specified Times object.
  • TimeSequenceStepperSolves the Transient problem at a sequence of given time points.
  • External Petsc Solver App
  • ExternalPetscTimeStepperTimestepper that queries the step size of the external petsc solver, and use that as the time step size.

Executors

ExplicitDynamicsContact

FVBCs

FVICs

  • Moose App
  • AddFVInitialConditionActionAdd an FVInitialCondition object to the simulation.
  • FVConstantICSets a constant field value.
  • FVFunctionICAn initial condition that uses a normal function of x, y, z to produce values (and optionally gradients) for a field variable.

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.
  • FVDivergenceComputes the residual coming from the divergence of a vector fieldthat can be represented as a functor.
  • 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.
  • FVMassMatrixComputes a 'mass matrix', which will just be a diagonal matrix for the finite volume method, meant for use in preconditioning schemes which require one
  • 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.
  • Heat Transfer App
  • FVHeatConductionTimeDerivativeAD Time derivative term of the heat equation for quasi-constant specific heat and the density .
  • Navier Stokes App
  • CNSFVFluidEnergyHLLCImplements the fluid energy flux portion of the free-flow HLLC discretization.
  • CNSFVMassHLLCImplements the mass flux portion of the free-flow HLLC discretization.
  • CNSFVMomentumHLLCImplements the momentum flux portion of the free-flow HLLC discretization.
  • FVMatPropTimeKernelReturns a material property which should correspond to a time derivative.
  • FVPorosityTimeDerivativeA time derivative multiplied by a porosity material property
  • INSFVBodyForceBody force that contributes to the Rhie-Chow interpolation
  • INSFVEnergyAdvectionAdvects energy, e.g. rho*cp*T. A user may still override what quantity is advected, but the default is rho*cp*T
  • INSFVEnergyTimeDerivativeAdds the time derivative term to the incompressible Navier-Stokes energy equation.
  • INSFVMassAdvectionObject for advecting mass, e.g. rho
  • INSFVMeshAdvectionImplements a source/sink term for this object's variable/advected-quantity proportional to the divergence of the mesh velocity
  • INSFVMixingLengthReynoldsStressComputes the force due to the Reynolds stress term in the incompressible Reynolds-averaged Navier-Stokes equations.
  • INSFVMixingLengthScalarDiffusionComputes the turbulent diffusive flux that appears in Reynolds-averaged fluid conservation equations.
  • INSFVMomentumAdvectionObject for advecting momentum, e.g. rho*u
  • INSFVMomentumBoussinesqComputes a body force for natural convection buoyancy.
  • INSFVMomentumDiffusionImplements the Laplace form of the viscous stress in the Navier-Stokes equation.
  • INSFVMomentumFrictionImplements a basic linear or quadratic friction model as a volumetric force, for example for the X-momentum equation: and for the linear and quadratic models respectively. A linear dependence is expected for laminar flow, while a quadratic dependence is more common for turbulent flow.
  • INSFVMomentumGravityComputes a body force due to gravity in Rhie-Chow based simulations.
  • INSFVMomentumMeshAdvectionImplements a momentum source/sink term proportional to the divergence of the mesh velocity
  • INSFVMomentumPressureIntroduces the coupled pressure term into the Navier-Stokes momentum equation.
  • INSFVMomentumPressureFluxMomentum pressure term eps grad_P, as a flux kernel using the divergence theoreom, in the incompressible Navier-Stokes momentum equation.
  • INSFVMomentumTimeDerivativeAdds the time derivative term to the incompressible Navier-Stokes momentum equation.
  • INSFVPumpEffective body force for a pump that contributes to the Rhie-Chow interpolation
  • INSFVScalarFieldAdvectionAdvects an arbitrary quantity, the associated nonlinear 'variable'.
  • INSFVTKEDSourceSinkElemental kernel to compute the production and destruction terms of turbulent kinetic energy dissipation (TKED).
  • INSFVTKESourceSinkElemental kernel to compute the production and destruction terms of turbulent kinetic energy (TKE).
  • INSFVTurbulentAdvectionAdvects an arbitrary turbulent quantity, the associated nonlinear 'variable'.
  • INSFVTurbulentDiffusionComputes residual for the turbulent scaled diffusion operator for finite volume method.
  • NSFVEnergyAmbientConvectionImplements a solid-fluid ambient convection volumetric term proportional to the difference between the fluid and ambient temperatures : .
  • NSFVMixturePhaseInterfaceImplements a phase-to-phase volumetric exchange.
  • NSFVPhaseChangeSourceComputes the energy source due to solidification/melting.
  • PCNSFVDensityTimeDerivativeA time derivative kernel for which the form is eps * ddt(rho*var).
  • PCNSFVFluidEnergyHLLCImplements the fluid energy flux portion of the porous HLLC discretization.
  • PCNSFVKTComputes the residual of advective term using finite volume method.
  • PCNSFVKTDCComputes the residual of advective term using finite volume method using a deferred correction approach.
  • PCNSFVMassHLLCImplements the mass flux portion of the porous HLLC discretization.
  • PCNSFVMomentumFrictionComputes a friction force term on fluid in porous media in the Navier Stokes i-th momentum equation.
  • PCNSFVMomentumHLLCImplements the momentum flux portion of the porous HLLC discretization.
  • PINSFVEnergyAdvectionAdvects energy, e.g. rho*cp*T. A user may still override what quantity is advected, but the default is rho*cp*T
  • PINSFVEnergyAmbientConvectionImplements the solid-fluid ambient convection term in the porous media Navier Stokes energy equation.
  • PINSFVEnergyAnisotropicDiffusionAnisotropic diffusion term in the porous media incompressible Navier-Stokes equations : -div(kappa grad(T))
  • PINSFVEnergyDiffusionDiffusion term in the porous media incompressible Navier-Stokes fluid energy equations :
  • PINSFVEnergyTimeDerivativeAdds the time derivative term to the Navier-Stokes energy equation: for fluids: d(eps * rho * cp * T)/dt, for solids: (1 - eps) * d(rho * cp * T)/dtMaterial property derivatives are ignored if not provided.
  • PINSFVMassAdvectionObject for advecting mass in porous media mass equation
  • PINSFVMomentumAdvectionObject for advecting superficial momentum, e.g. rho*u_d, in the porous media momentum equation
  • PINSFVMomentumBoussinesqComputes a body force for natural convection buoyancy in porous media: eps alpha (T-T_0)
  • PINSFVMomentumDiffusionViscous diffusion term, div(mu eps grad(u_d / eps)), in the porous media incompressible Navier-Stokes momentum equation.
  • PINSFVMomentumFrictionComputes a friction force term on fluid in porous media in the Navier Stokes i-th momentum equation in Rhie-Chow (incompressible) contexts.
  • PINSFVMomentumFrictionCorrectionComputes a correction term to avoid oscillations from average pressure interpolation in regions of high changes in friction coefficients.
  • PINSFVMomentumGravityComputes a body force, due to gravity on fluid in porous media in Rhie-Chow (incompressible) contexts.
  • PINSFVMomentumPressureIntroduces the coupled pressure term into the Navier-Stokes porous media momentum equation.
  • PINSFVMomentumPressureFluxMomentum pressure term eps grad_P, as a flux kernel using the divergence theoreom, in the porous media incompressible Navier-Stokes momentum equation. This kernel is also executed on boundaries.
  • PINSFVMomentumPressurePorosityGradientIntroduces the coupled pressure times porosity gradient term into the Navier-Stokes porous media momentum equation.
  • PINSFVMomentumTimeDerivativeAdds the time derivative term: d(rho u_d) / dt to the porous media incompressible Navier-Stokes momentum equation.
  • PNSFVMomentumPressureFluxRZAdds the porous term into the radial component of the Navier-Stokes momentum equation for the problems in the RZ coordinate system when integrating by parts.
  • PNSFVMomentumPressureRZAdds the porous term into the radial component of the Navier-Stokes momentum equation for the problems in the RZ coordinate system when integrating by parts.
  • PNSFVPGradEpsilonIntroduces a -p * grad_eps term.
  • PWCNSFVMassAdvectionObject for advecting mass in porous media mass equation
  • PWCNSFVMassTimeDerivativeAdds the time derivative term to the porous weakly-compressible Navier-Stokes continuity equation.
  • WCNSFV2PMomentumAdvectionSlipComputes the slip velocity advection kernel for two-phase mixture model.
  • WCNSFV2PMomentumDriftFluxImplements the drift momentum flux source.
  • WCNSFVEnergyTimeDerivativeAdds the time derivative term to the incompressible Navier-Stokes momentum equation.
  • WCNSFVMassAdvectionObject for advecting mass, e.g. rho
  • WCNSFVMassTimeDerivativeAdds the time derivative term to the weakly-compressible Navier-Stokes continuity equation.
  • WCNSFVMixingLengthEnergyDiffusionComputes the turbulent diffusive flux that appears in Reynolds-averaged fluid energy conservation equations.
  • WCNSFVMomentumTimeDerivativeAdds the time derivative term to the incompressible Navier-Stokes momentum equation.
  • Porous Flow App
  • FVPorousFlowAdvectiveFluxAdvective Darcy flux
  • FVPorousFlowDispersiveFluxAdvective Darcy flux
  • FVPorousFlowEnergyTimeDerivativeDerivative of heat energy with respect to time
  • FVPorousFlowHeatAdvectionHeat flux advected by the fluid
  • FVPorousFlowHeatConductionConductive heat flux
  • FVPorousFlowMassTimeDerivativeDerivative of fluid-component mass with respect to time

FluidProperties

FluidPropertiesInterrogator

Functions

  • Moose App
  • AddFunctionActionAdd a Function object to the simulation.
  • ADParsedFunctionFunction created by parsing a string
  • ADPiecewiseLinearLinearly interpolates between pairs of x-y data
  • Axisymmetric2D3DSolutionFunctionFunction for reading a 2D axisymmetric solution from file and mapping it to a 3D Cartesian model
  • BicubicSplineFunctionDefine a bicubic spline function from interpolated data defined by input parameters.
  • CoarsenedPiecewiseLinearPerform a point reduction of the tabulated data upon initialization, then evaluate using a linear interpolation.
  • CompositeFunctionMultiplies an arbitrary set of functions together
  • ConstantFunctionA function that returns a constant value as defined by an input parameter.
  • ImageFunctionFunction with values sampled from an image or image stack.
  • LinearCombinationFunctionReturns the linear combination of the functions
  • ParsedFunctionFunction created by parsing a string
  • ParsedGradFunctionDefines a function and its gradient using input file parameters.
  • ParsedVectorFunctionReturns a vector function based on string descriptions for each component.
  • PeriodicFunctionProvides a periodic function by repeating a user-supplied base function in time and/or any of the three Cartesian coordinate directions
  • PiecewiseBilinearInterpolates values from a csv file
  • PiecewiseConstantDefines data using a set of x-y data pairs
  • PiecewiseConstantFromCSVUses data read from CSV to assign values
  • PiecewiseLinearLinearly interpolates between pairs of x-y data
  • PiecewiseLinearFromVectorPostprocessorProvides piecewise linear interpolation of from two columns of a VectorPostprocessor
  • PiecewiseMulticonstantPiecewiseMulticonstant performs constant interpolation on 1D, 2D, 3D or 4D data. The data_file specifies the axes directions and the function values. If a point lies outside the data range, the appropriate end value is used.
  • PiecewiseMultilinearPiecewiseMultilinear performs linear interpolation on 1D, 2D, 3D or 4D data. The data_file specifies the axes directions and the function values. If a point lies outside the data range, the appropriate end value is used.
  • SolutionFunctionFunction for reading a solution from file.
  • SplineFunctionDefine a spline function from interpolated data defined by input parameters.
  • VectorPostprocessorFunctionProvides piecewise linear interpolation of from two columns of a VectorPostprocessor
  • Optimization App
  • NearestReporterCoordinatesFunctionThis Function finds the nearest point in the specified vectors of coordinates and returns the values specified in the vector of values at the index of the nearest point. All the vectors must be specified using either vector postprocessors or reporter vectors. This function interpolates linearly in time with transient data.
  • ParameterMeshFunctionOptimization function with parameters represented by a mesh and finite-element shape functions.
  • ParsedOptimizationFunctionFunction used for optimization that uses a parsed expression with parameter dependence.
  • Reactor App
  • MultiControlDrumFunctionA function that returns an absorber fraction for multiple control drums application.
  • Level Set App
  • LevelSetOlssonBubbleImplementation of 'bubble' ranging from 0 to 1.
  • LevelSetOlssonPlaneImplementation of a level set function to represent a plane.
  • LevelSetOlssonVortexA function for creating vortex velocity fields for level set equation benchmark problems.
  • Functional Expansion Tools App
  • FunctionSeriesThis function uses a convolution of functional series (functional expansion or FX) to create a 1D, 2D, or 3D function
  • Phase Field App
  • FourierNoiseGenerate noise from a fourier series
  • Stochastic Tools App
  • ScaledAbsDifferenceDRLRewardFunctionEvaluates a scaled absolute difference reward function for a process which is controlled by a Deep Reinforcement Learning based surrogate.
  • Thermal Hydraulics App
  • CircularAreaHydraulicDiameterFunctionComputes hydraulic diameter for a circular area from its area function
  • CosineHumpFunctionComputes a cosine hump of a user-specified width and height
  • CosineTransitionFunctionComputes a cosine transtition of a user-specified width between two values
  • CubicTransitionFunctionComputes a cubic polynomial transition between two functions
  • GeneralizedCircumferenceComputes a generalized circumference from a function providing the area.
  • PiecewiseFunctionFunction which provides a piecewise representation of arbitrary functions
  • TimeRampFunctionRamps up to a value from another value over time.
  • Porous Flow App
  • MovingPlanarFrontThis function defines the position of a moving front. The front is an infinite plane with normal pointing from start_posn to end_posn. The front's distance from start_posn is defined by 'distance', so if the 'distance' function is time dependent, the front's position will change with time. Roughly speaking, the function returns true_value for points lying in between start_posn and start_posn + distance. Precisely speaking, two planes are constructed, both with normal pointing from start_posn to end_posn. The first plane passes through start_posn; the second plane passes through end_posn. Given a point p and time t, this function returns false_value if ANY of the following are true: (a) t<activation_time; (b) t>=deactivation_time; (c) p is 'behind' start_posn (ie, p lies on one side of the start_posn plane and end_posn lies on the other side); (d) p is 'ahead' of the front (ie, p lies one one side of the front and start_posn lies on the other side); (e) the distance between p and the front is greater than active_length. Otherwise, the point is 'in the active zone' and the function returns true_value.
  • Fluid Properties App
  • SaturationDensityFunctionComputes saturation density from temperature function
  • SaturationPressureFunctionComputes saturation pressure from temperature function and 2-phase fluid properties object
  • SaturationTemperatureFunctionComputes saturation temperature from pressure function and 2-phase fluid properties object

FunctorMaterials

GeochemicalModelInterrogator

GlobalParams

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

GrayDiffuseRadiation

  • Heat Transfer App
  • RadiationTransferActionThis action sets up the net radiation calculation between specified sidesets.

HeatStructureMaterials

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.
  • 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.
  • 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
  • Fsi App
  • ADPenaltyVelocityContinuityEnforces continuity of flux and continuity of solution via penalty across an interface.
  • CoupledPenaltyInterfaceDiffusionEnforces continuity of flux and continuity of solution via penalty across an interface.
  • StructureAcousticInterfaceEnforces displacement and stress/pressure continuity between the fluid and structural domains. Element is always the structure and neighbor is always the fluid.
  • Solid 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
  • 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
  • Heat Transfer App
  • ConjugateHeatTransferThis InterfaceKernel models conjugate heat transfer. Fluid side must be primary side and solid side must be secondary side. T_fluid is provided in case that variable ( fluid energy variable) is not temperature but e.g. internal energy.
  • SideSetHeatTransferKernelModeling conduction, convection, and radiation across internal side set.
  • ThinLayerHeatTransferModel heat transfer across a thin domain with an interface.

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.
  • ArrayCoupledTimeDerivativeTime derivative Array Kernel that acts on a coupled variable. Weak form: . The coupled variable andthe variable must have the same dimensionality
  • 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 .
  • DivFieldTakes the divergence of a vector field, optionally scaled by a constant scalar coefficient.
  • FunctionDiffusionThe Laplacian operator with a function coefficient.
  • GradFieldTakes the gradient of a scalar field, optionally scaled by a constant scalar 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 .
  • MassMatrixComputes a finite element mass matrix meant for use in preconditioning schemes which require one
  • 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 .
  • VectorFunctionReactionKernel representing the contribution of the PDE term , where is a function coefficient and is a vector variable.
  • VectorTimeDerivativeThe time derivative operator with the weak form of .
  • Scalar Transport App
  • BodyForceLMImposes a body force onto a Lagrange multiplier constrained primal equation
  • CoupledForceLMAdds a coupled force term to a Lagrange multiplier constrained primal equation
  • LMDiffusionAdds a diffusion term to a Lagrange multiplier constrained primal equation
  • TimeDerivativeLMAdds a time derivative term to a Lagrange multiplier constrained primal equation
  • 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.)
  • Chemical Reactions App
  • CoupledBEEquilibriumSubDerivative of equilibrium species concentration wrt time
  • CoupledBEKineticDerivative of kinetic species concentration wrt time
  • CoupledConvectionReactionSubConvection of equilibrium species
  • CoupledDiffusionReactionSubDiffusion of equilibrium species
  • DarcyFluxPressureDarcy flux: - cond * (Grad P - rho * g) where cond is the hydraulic conductivity, P is fluid pressure, rho is fluid density and g is gravity
  • DesorptionFromMatrixMass flow rate from the matrix to the porespace. Add this to TimeDerivative kernel to get complete DE for the fluid adsorbed in the matrix
  • DesorptionToPorespaceMass flow rate to the porespace from the matrix. Add this to the other kernels for the porepressure variable to form the complete DE
  • PrimaryConvectionConvection of primary species
  • PrimaryDiffusionDiffusion of primary species
  • PrimaryTimeDerivativeDerivative of primary species concentration wrt time
  • 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
  • ADACBarrierFunctionAllen-Cahn kernel used when 'mu' is a function of variables
  • ADACGrGrMultiMulti-phase poly-crystalline Allen-Cahn Kernel
  • ADACInterfaceGradient energy Allen-Cahn Kernel
  • ADACInterfaceKobayashi1Anisotropic gradient energy Allen-Cahn Kernel Part 1
  • ADACInterfaceKobayashi2Anisotropic Gradient energy Allen-Cahn Kernel Part 2
  • ADACKappaFunctionGradient energy term for when kappa as a function of the variable
  • ADACSwitchingKernel for Allen-Cahn equation that adds derivatives of switching functions and energies
  • 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
  • ADCoupledSwitchingTimeDerivativeCoupled time derivative Kernel that multiplies the time derivative by
  • 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
  • ADSusceptibilityTimeDerivativeA modified time derivative Kernel that multiplies the time derivative of a variable by a generalized susceptibility
  • 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
  • NestedKKSACBulkCKKS model kernel (part 2 of 2) for the Bulk Allen-Cahn. This includes all terms dependent on chemical potential.
  • NestedKKSACBulkFKKS model kernel (part 1 of 2) for the Bulk Allen-Cahn. This includes all terms NOT dependent on chemical potential.
  • NestedKKSSplitCHCResKKS model kernel for the split Bulk Cahn-Hilliard term. This kernel operates on the physical concentration 'c' as the non-linear variable.
  • 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
  • XFEMApp
  • CrackTipEnrichmentStressDivergenceTensorsEnrich stress divergence kernel for small-strain simulations
  • Porous Flow App
  • FluxLimitedTVDAdvectionConservative form of (advection), using the Flux Limited TVD scheme invented by Kuzmin and Turek
  • PorousFlowAdvectiveFluxFully-upwinded advective flux of the component given by fluid_component
  • PorousFlowBasicAdvectionAdvective flux of a Variable using the Darcy velocity of the fluid phase
  • PorousFlowDesorpedMassTimeDerivativeDesorped component mass derivative wrt time.
  • PorousFlowDesorpedMassVolumetricExpansionDesorped_mass * rate_of_solid_volumetric_expansion
  • PorousFlowDispersiveFluxDispersive and diffusive flux of the component given by fluid_component in all phases
  • PorousFlowEffectiveStressCouplingImplements the weak form of the expression biot_coefficient * grad(effective fluid pressure)
  • PorousFlowEnergyTimeDerivativeDerivative of heat-energy-density wrt time
  • PorousFlowExponentialDecayResidual = rate * (variable - reference). Useful for modelling exponential decay of a variable
  • PorousFlowFluxLimitedTVDAdvectionAdvective flux of fluid species or heat using the Flux Limited TVD scheme invented by Kuzmin and Turek
  • PorousFlowFullySaturatedAdvectiveFluxFully-upwinded advective flux of the fluid component given by fluid_component, in a single-phase fluid
  • PorousFlowFullySaturatedDarcyBaseDarcy flux suitable for models involving a fully-saturated, single phase, single component fluid. No upwinding is used
  • PorousFlowFullySaturatedDarcyFlowDarcy flux suitable for models involving a fully-saturated single phase, multi-component fluid. No upwinding is used
  • PorousFlowFullySaturatedHeatAdvectionHeat flux that arises from the advection of a fully-saturated single phase fluid. No upwinding is used
  • PorousFlowFullySaturatedMassTimeDerivativeFully-saturated version of the single-component, single-phase fluid mass derivative wrt time
  • PorousFlowFullySaturatedUpwindHeatAdvectionHeat advection by a fluid. The fluid is assumed to have a single phase, and the advection is fully upwinded
  • PorousFlowHeatAdvectionFully-upwinded heat flux, advected by the fluid
  • PorousFlowHeatConductionHeat conduction in the Porous Flow module
  • PorousFlowHeatMassTransferCalculate heat or mass transfer from a coupled variable v to the variable u. No mass lumping is performed here.
  • PorousFlowHeatVolumetricExpansionEnergy-density*rate_of_solid_volumetric_expansion. The energy-density is lumped to the nodes
  • PorousFlowMassRadioactiveDecayRadioactive decay of a fluid component
  • PorousFlowMassTimeDerivativeDerivative of fluid-component mass with respect to time. Mass lumping to the nodes is used.
  • PorousFlowMassVolumetricExpansionComponent_mass*rate_of_solid_volumetric_expansion. This Kernel lumps the component mass to the nodes.
  • PorousFlowPlasticHeatEnergyPlastic heat energy density source = (1 - porosity) * coeff * stress * plastic_strain_rate
  • PorousFlowPreDisPrecipitation-dissolution of chemical species
  • Electromagnetics App
  • CurlCurlFieldWeak form term corresponding to .
  • VectorCurrentSourceKernel to calculate the current source term in the Helmholtz wave equation.
  • VectorSecondTimeDerivativeThe second time derivative operator for vector variables.
  • Level Set App
  • LevelSetAdvectionImplements the level set advection equation: , where the weak form is .
  • LevelSetAdvectionSUPGSUPG stablization term for the advection portion of the level set equation.
  • LevelSetForcingFunctionSUPGThe SUPG stablization term for a forcing function.
  • LevelSetOlssonReinitializationThe re-initialization equation defined by Olsson et. al. (2007).
  • LevelSetTimeDerivativeSUPGSUPG stablization terms for the time derivative of the level set equation.
  • Peridynamics App
  • ForceStabilizedSmallStrainMechanicsNOSPDClass for calculating the residual and Jacobian for the force-stabilized peridynamic correspondence model under small strain assumptions
  • GeneralizedPlaneStrainOffDiagNOSPDClass for calculating the off-diagonal Jacobian of the coupling between displacements (or temperature) with scalar out-of-plane strain for the generalized plane strain using the H1NOSPD formulation
  • GeneralizedPlaneStrainOffDiagOSPDClass for calculating the off-diagonal Jacobian corresponding to coupling between displacements (or temperature) and the scalar out-of-plane strain for the generalized plane strain using the OSPD formulation
  • HeatConductionBPDClass for calculating the residual and Jacobian for the bond-based peridynamic heat conduction formulation
  • HeatSourceBPDClass for calculating the residual from heat source for the bond-based peridynamic heat conduction formulation
  • HorizonStabilizedFormIFiniteStrainMechanicsNOSPDClass for calculating the residual and the Jacobian for Form I of the horizon-stabilized peridynamic correspondence model under finite strain assumptions
  • HorizonStabilizedFormIIFiniteStrainMechanicsNOSPDClass for calculating the residual and the Jacobian for Form II of the horizon-stabilized peridynamic correspondence model under finite strain assumptions
  • HorizonStabilizedFormIISmallStrainMechanicsNOSPDClass for calculating the residual and the Jacobian for Form II of the horizon-stabilized peridynamic correspondence model under small strain assumptions
  • HorizonStabilizedFormISmallStrainMechanicsNOSPDClass for calculating the residual and the Jacobian for Form I of the horizon-stabilizedperidynamic correspondence model under small strain assumptions
  • MechanicsBPDClass for calculating the residual and Jacobian for the bond-based peridynamic mechanics formulation
  • MechanicsOSPDClass for calculating the residual and Jacobian for the ordinary state-based peridynamic mechanics formulation
  • WeakPlaneStressNOSPDClass for calculating the residual and the Jacobian for the peridynamic plane stress model using weak formulation based on peridynamic correspondence models
  • Fsi App
  • AcousticInertiaCalculates the residual for the inertial force which is the double time derivative of pressure.
  • ConvectedMeshCorrects the convective derivative for situations in which the fluid mesh is dynamic.
  • ConvectedMeshPSPGCorrects the convective derivative for situations in which the fluid mesh is dynamic.
  • Navier Stokes App
  • DistributedForceImplements a force term in the Navier Stokes momentum equation.
  • DistributedPowerImplements the power term of a specified force in the Navier Stokes energy equation.
  • INSADBoussinesqBodyForceComputes a body force for natural convection buoyancy.
  • INSADEnergyAdvectionThis class computes the residual and Jacobian contributions for temperature advection for a divergence free velocity field.
  • INSADEnergyAmbientConvectionComputes a heat source/sink due to convection from ambient surroundings.
  • INSADEnergyMeshAdvectionThis class computes the residual and Jacobian contributions for temperature advection from mesh velocity in an ALE simulation.
  • INSADEnergySUPGAdds the supg stabilization to the INS temperature/energy equation
  • INSADEnergySourceComputes an arbitrary volumetric heat source (or sink).
  • INSADGravityForceComputes a body force due to gravity.
  • INSADHeatConductionTimeDerivativeAD Time derivative term of the heat equation for quasi-constant specific heat and the density .
  • INSADMassThis class computes the mass equation residual and Jacobian contributions (the latter using automatic differentiation) for the incompressible Navier-Stokes equations.
  • INSADMassPSPGThis class adds PSPG stabilization to the mass equation, enabling use of equal order shape functions for pressure and velocity variables
  • INSADMomentumAdvectionAdds the advective term to the INS momentum equation
  • INSADMomentumCoupledForceComputes a body force due to a coupled vector variable or a vector function
  • INSADMomentumMeshAdvectionCorrects the convective derivative for situations in which the fluid mesh is dynamic.
  • INSADMomentumPressureAdds the pressure term to the INS momentum equation
  • INSADMomentumSUPGAdds the supg stabilization to the INS momentum equation
  • INSADMomentumTimeDerivativeThis class computes the time derivative for the incompressible Navier-Stokes momentum equation.
  • INSADMomentumViscousAdds the viscous term to the INS momentum equation
  • INSADSmagorinskyEddyViscosityComputes eddy viscosity term using Smagorinky's LES model
  • INSChorinCorrectorThis class computes the 'Chorin' Corrector equation in fully-discrete (both time and space) form.
  • INSChorinPredictorThis class computes the 'Chorin' Predictor equation in fully-discrete (both time and space) form.
  • INSChorinPressurePoissonThis class computes the pressure Poisson solve which is part of the 'split' scheme used for solving the incompressible Navier-Stokes equations.
  • INSCompressibilityPenaltyThe penalty term may be used when Dirichlet boundary condition is applied to the entire boundary.
  • INSFEFluidEnergyKernelAdds advection, diffusion, and heat source terms to energy equation, potentially with stabilization
  • INSFEFluidMassKernelAdds advective term of mass conservation equation along with pressure-stabilized Petrov-Galerkin terms
  • INSFEFluidMomentumKernelAdds advection, viscous, pressure, friction, and gravity terms to the Navier-Stokes momentum equation, potentially with stabilization
  • INSMassThis class computes the mass equation residual and Jacobian contributions for the incompressible Navier-Stokes momentum equation.
  • INSMassRZThis class computes the mass equation residual and Jacobian contributions for the incompressible Navier-Stokes momentum equation in RZ coordinates.
  • INSMomentumLaplaceFormThis class computes momentum equation residual and Jacobian viscous contributions for the 'Laplacian' form of the governing equations.
  • INSMomentumLaplaceFormRZThis class computes additional momentum equation residual and Jacobian contributions for the incompressible Navier-Stokes momentum equation in RZ (axisymmetric cylindrical) coordinates, using the 'Laplace' form of the governing equations.
  • INSMomentumTimeDerivativeThis class computes the time derivative for the incompressible Navier-Stokes momentum equation.
  • INSMomentumTractionFormThis class computes momentum equation residual and Jacobian viscous contributions for the 'traction' form of the governing equations.
  • INSMomentumTractionFormRZThis class computes additional momentum equation residual and Jacobian contributions for the incompressible Navier-Stokes momentum equation in RZ (axisymmetric cylindrical) coordinates.
  • INSPressurePoissonThis class computes the pressure Poisson solve which is part of the 'split' scheme used for solving the incompressible Navier-Stokes equations.
  • INSProjectionThis class computes the 'projection' part of the 'split' method for solving incompressible Navier-Stokes.
  • INSSplitMomentumThis class computes the 'split' momentum equation residual.
  • INSTemperatureThis class computes the residual and Jacobian contributions for the incompressible Navier-Stokes temperature (energy) equation.
  • INSTemperatureTimeDerivativeThis class computes the time derivative for the incompressible Navier-Stokes momentum equation.
  • MDFluidEnergyKernelAdds advection, diffusion, and heat source terms to energy equation, potentially with stabilization
  • MDFluidMassKernelAdds advective term of mass conservation equation along with pressure-stabilized Petrov-Galerkin terms
  • MDFluidMomentumKernelAdds advection, viscous, pressure, friction, and gravity terms to the Navier-Stokes momentum equation, potentially with stabilization
  • MassConvectiveFluxImplements the advection term for the Navier Stokes mass equation.
  • MomentumConvectiveFluxImplements the advective term of the Navier Stokes momentum equation.
  • NSEnergyInviscidFluxThis class computes the inviscid part of the energy flux.
  • NSEnergyThermalFluxThis class is responsible for computing residuals and Jacobian terms for the k * grad(T) * grad(phi) term in the Navier-Stokes energy equation.
  • NSEnergyViscousFluxViscous flux terms in energy equation.
  • NSGravityForceThis class computes the gravity force contribution.
  • NSGravityPowerThis class computes the momentum contributed by gravity.
  • NSMassInviscidFluxThis class computes the inviscid flux in the mass equation.
  • NSMomentumInviscidFluxThe inviscid flux (convective + pressure terms) for the momentum conservation equations.
  • NSMomentumInviscidFluxWithGradPThis class computes the inviscid flux with pressure gradient in the momentum equation.
  • NSMomentumViscousFluxDerived instance of the NSViscousFluxBase class for the momentum equations.
  • NSSUPGEnergyCompute residual and Jacobian terms form the SUPG terms in the energy equation.
  • NSSUPGMassCompute residual and Jacobian terms form the SUPG terms in the mass equation.
  • NSSUPGMomentumCompute residual and Jacobian terms form the SUPG terms in the momentum equation.
  • NSTemperatureL2This class was originally used to solve for the temperature using an L2-projection.
  • PINSFEFluidPressureTimeDerivativeAdds the transient term of the porous-media mass conservation equation
  • PINSFEFluidTemperatureTimeDerivativeThe time derivative operator with the weak form of .
  • PINSFEFluidVelocityTimeDerivativeThe time derivative operator with the weak form of .
  • PMFluidPressureTimeDerivativeAdds the transient term of the porous-media mass conservation equation
  • PMFluidTemperatureTimeDerivativeThe time derivative operator with the weak form of .
  • PMFluidVelocityTimeDerivativeThe time derivative operator with the weak form of .
  • PressureGradientImplements the pressure gradient term for one of the Navier Stokes momentum equations.
  • TotalEnergyConvectiveFluxImplements the advection term for the Navier Stokes energy equation.
  • VectorMassMatrixComputes a finite element mass matrix meant for use in preconditioning schemes which require one
  • Thermal Hydraulics App
  • ADHeatConductionRZAdds a heat conduction term in XY coordinates interpreted as cylindrical coordinates
  • ADHeatConductionTimeDerivativeRZAdds a time derivative term for the energy equation in XY coordinates interpreted as cylindrical coordinates
  • ADHeatStructureHeatSourceAdds a heat source term for the energy equation
  • ADHeatStructureHeatSourceRZAdds a heat source term in XY coordinates interpreted as cylindrical coordinates
  • ADOneD3EqnEnergyGravityComputes the gravity term for the energy equation in 1-phase flow
  • ADOneD3EqnEnergyHeatFluxComputes a heat flux term for the energy equation in a flow channel
  • ADOneD3EqnEnergyHeatFluxFromHeatStructure3DComputes a heat flux term from a 3D heat structure in the energy equation for 1-phase flow
  • ADOneD3EqnMomentumAreaGradientComputes the area gradient term in the momentum equation for single phase flow.
  • ADOneD3EqnMomentumFormLossComputes a volumetric form loss for the momentum equation for 1-phase flow
  • ADOneD3EqnMomentumFrictionComputes wall friction term for single phase flow.
  • ADOneD3EqnMomentumGravityComputes gravity term for the momentum equation for 1-phase flow
  • ADOneDEnergyWallHeatFluxComputes a heat flux term for the energy equation
  • ADOneDEnergyWallHeatingComputes a convective heat flux term for the energy equation for 1-phase flow
  • CoupledForceRZAdds a coupled force term in XY coordinates interpreted as cylindrical coordinates
  • OneD3EqnEnergyFluxComputes an energy flux for single phase flow
  • OneD3EqnEnergyGravityComputes a gravity term for the energy equation in 1-phase flow
  • OneD3EqnEnergyHeatSourceComputes a volumetric heat source for 1-phase flow channel
  • OneD3EqnMomentumAreaGradientComputes the area gradient term in the momentum equation for single phase flow.
  • OneD3EqnMomentumFluxComputes a momentum flux term for 1-phase flow
  • OneD3EqnMomentumFormLossComputes a form loss term for the momentum equation for 1-phase flow
  • OneD3EqnMomentumFrictionComputes wall friction term for single phase flow.
  • OneD3EqnMomentumGravityComputes gravity term for the momentum equation for 1-phase flow
  • OneDEnergyWallHeatFluxAdds a heat flux along the local heated perimeter
  • OneDEnergyWallHeatingAdds a convective heat flux term from a wall temperature
  • Geochemistry App
  • GeochemistryDispersionKernel describing grad(porosity * tensor_coeff * grad(concentration)), where porosity is an AuxVariable (or just a real number), tensor_coeff is the hydrodynamic dispersion tensor and concentration is the 'variable' for this Kernel
  • GeochemistryTimeDerivativeKernel describing porosity * d(concentration)/dt, where porosity is an AuxVariable (or just a real number) and concentration is the 'variable' for this Kernel. This Kernel should not be used if porosity is time-dependent. Mass lumping is employed for numerical stability
  • Solid 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.
  • DynamicSolidMechanics
  • DynamicTensorMechanics
  • PoroMechanics
  • SolidMechanics
  • TensorMechanics
  • Heat Transfer App
  • ADHeatConductionSame as Diffusion in terms of physics/residual, but the Jacobian is computed using forward automatic differentiation
  • ADHeatConductionTimeDerivativeAD Time derivative term of the heat equation for quasi-constant specific heat and the density .
  • ADJouleHeatingSourceCalculates the heat source term corresponding to electrostatic Joule heating, with Jacobian contributions calculated using the automatic differentiation system.
  • ADMatHeatSourceForce term in thermal transport to represent a heat source
  • AnisoHeatConductionAnisotropic HeatConduction kernel with weak form given by .
  • AnisoHomogenizedHeatConductionKernel for asymptotic expansion homogenization for thermal conductivity when anisotropic thermal conductivities are used
  • HeatCapacityConductionTimeDerivativeTime derivative term of the heat equation with the heat capacity as an argument.
  • HeatConductionComputes residual/Jacobian contribution for term.
  • HeatConductionTimeDerivativeTime derivative term of the heat equation for quasi-constant specific heat and the density .
  • HeatSourceDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
  • HomogenizedHeatConductionKernel for asymptotic expansion homogenization for thermal conductivity
  • JouleHeatingSourceCalculates the heat source term corresponding to electrostatic Joule heating.
  • SpecificHeatConductionTimeDerivativeTime derivative term of the heat equation with the specific heat and the density as arguments.
  • TrussHeatConductionComputes conduction term in heat equation for truss elements, taking cross-sectional area into account
  • TrussHeatConductionTimeDerivativeComputes time derivative term in heat equation for truss elements, taking cross-sectional area into account

Kernels/CHPFCRFFSplitKernel

Kernels/DynamicSolidMechanics

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

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

Kernels/RigidBodyMultiKernel

Kernels/SolidMechanics

Kernels/TensorMechanics

Likelihood

  • Stochastic Tools App
  • AddLikelihoodActionAdds Likelihood objects.
  • ExtremeValueGeneralized extreme value likelihood function evaluating the model goodness against experiments.
  • GaussianGaussian likelihood function evaluating the model goodness against experiments.
  • TruncatedGaussianTruncatedGaussian likelihood function evaluating the model goodness against experiments.

Materials

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 the mesh at interfaces between blocks. New nodes will be generated so elements on each side of the break are no longer connected. At the moment, this only works on a REPLICATED mesh
  • BreakMeshByElementGeneratorBreak all element-element interfaces in the specified subdomains.
  • 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.
  • CoarsenBlockGeneratorMesh generator which coarsens one or more blocks in an existing mesh. The coarsening algorithm works best for regular meshes.
  • 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.
  • CutMeshByPlaneGeneratorThis CutMeshByPlaneGenerator object is designed to trim the input mesh by removing all the elements on one side of a given plane with special processing on the elements crossed by the cutting line to ensure a smooth cross-section. The output mesh only consists of TET4 elements.
  • 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
  • ElementsToTetrahedronsConverterThis ElementsToTetrahedronsConverter object is designed to convert all the elements in a 3D mesh consisting only linear elements into TET4 elements.
  • 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.
  • FlipSidesetGeneratorA Mesh Generator which flips a given sideset
  • 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.
  • OverlayMeshGeneratorCreates a Cartesian mesh overlaying the input mesh region.
  • 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
  • StitchBoundaryMeshGeneratorAllows a pair of boundaries to be stitched together.
  • 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.
  • SubdomainPerElementGeneratorAllows the user to assign each element the subdomain ID of their choice
  • 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
  • Reactor App
  • AdvancedConcentricCircleGeneratorThis AdvancedConcentricCircleGenerator object is designed to mesh a concentric circular geometry.
  • AssemblyMeshGeneratorThis AssemblyMeshGenerator object is designed to generate assembly-like structures, with IDs, from a reactor geometry. The assembly-like structures must consist of a full pattern of equal sized pins from PinMeshGeneratorA hexagonal assembly will be placed inside of a bounding hexagon consisting of a background region and, optionally, duct regions.
  • AzimuthalBlockSplitGeneratorThis AzimuthalBlockSplitGenerator object takes in a polygon/hexagon concentric circle mesh and renames blocks on a user-defined azimuthal segment / wedge of the mesh.
  • CartesianConcentricCircleAdaptiveBoundaryMeshGeneratorThis CartesianConcentricCircleAdaptiveBoundaryMeshGenerator object is designed to generate square meshes with adaptive boundary to facilitate stitching.
  • CartesianIDPatternedMeshGeneratorGenerate Certesian lattice meshes with reporting ID assignment that indentifies individual components of lattice.
  • CartesianMeshTrimmerThis CartesianMeshTrimmer object performs peripheral and/or across-center (0, 0, 0) trimming for assembly or core 2D meshes generated by PatternedCartesianMG.
  • CoarseMeshExtraElementIDGeneratorAssign coarse element IDs for elements on a mesh based on a coarse mesh.
  • CoreMeshGeneratorThis CoreMeshGenerator object is designed to generate a core-like structure, with IDs, from a reactor geometry. The core-like structure consists of a pattern of assembly-like structures generated with AssemblyMeshGenerator and is permitted to have "empty" locations. The size and spacing of the assembly-like structures is defined, and enforced by declaration in the ReactorMeshParams.
  • DepletionIDGeneratorThis DepletionIDGenerator source code is to assign depletion IDs for elements on a mesh based on material and other extra element IDs.
  • ExtraElementIDCopyGeneratorCopy an extra element ID to other extra element IDs.
  • FlexiblePatternGeneratorThis FlexiblePatternGenerator object is designed to generate a mesh with a background region with dispersed unit meshes in it and distributed based on a series of flexible patterns.
  • HexIDPatternedMeshGeneratorThis PatternedHexMeshGenerator source code assembles hexagonal meshes into a hexagonal grid and optionally forces the outer boundary to be hexagonal and/or adds a duct.
  • HexagonConcentricCircleAdaptiveBoundaryMeshGeneratorThis HexagonConcentricCircleAdaptiveBoundaryMeshGenerator object is designed to generate hexagonal meshes with adaptive boundary to facilitate stitching.
  • HexagonMeshTrimmerThis HexagonMeshTrimmer object performs peripheral and/or across-center (0, 0, 0) trimming for assembly or core 2D meshes generated by PatternedHexMG.
  • PatternedCartesianMeshGeneratorThis PatternedCartesianMeshGenerator source code assembles square meshes into a square grid and optionally forces the outer boundary to be square and/or adds a duct.
  • PatternedCartesianPeripheralModifierPatternedPolygonPeripheralModifierBase is the base class for PatternedCartPeripheralModifier and PatternedHexPeripheralModifier.
  • PatternedHexMeshGeneratorThis PatternedHexMeshGenerator source code assembles hexagonal meshes into a hexagonal grid and optionally forces the outer boundary to be hexagonal and/or adds a duct.
  • PatternedHexPeripheralModifierPatternedPolygonPeripheralModifierBase is the base class for PatternedCartPeripheralModifier and PatternedHexPeripheralModifier.
  • PeripheralRingMeshGeneratorThis PeripheralRingMeshGenerator object adds a circular peripheral region to the input mesh.
  • PeripheralTriangleMeshGeneratorThis PeripheralTriangleMeshGenerator object is designed to generate a triangulated mesh between a generated outer circle boundary and a provided inner mesh.
  • PinMeshGeneratorThis PinMeshGenerator object is designed to generate pin-like structures, with IDs, from a reactor geometry. Whether it be a square or hexagonal pin, they are divided into three substructures - the innermost radial pin regions, the single bridging background region, and the square or hexagonal ducts regions.
  • PolygonConcentricCircleMeshGeneratorThis PolygonConcentricCircleMeshGenerator object is designed to mesh a polygon geometry with optional rings centered inside.
  • ReactorMeshParamsThis ReactorMeshParams object acts as storage for persistent information about the reactor geometry.
  • SimpleHexagonGeneratorThis SimpleHexagonGenerator object is designed to generate a simple hexagonal mesh that only contains six simple azimuthal triangular elements, two quadrilateral elements, or six central azimuthal triangular elements plus a several layers of quadrilateral elements.
  • SubdomainExtraElementIDGeneratorAssign extra element IDs for elements on a mesh based on mesh subdomains.
  • TriPinHexAssemblyGeneratorThis TriPinHexAssemblyGenerator object generates a hexagonal assembly mesh with three circular pins in a triangle at the center.
  • 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.
  • Peridynamics App
  • MeshGeneratorPDMesh generator class to convert FE mesh to PD mesh
  • PeridynamicsMeshMesh class to store and return peridynamics specific mesh data
  • Thermal Hydraulics App
  • THMMeshCreates a mesh (nodes and elements) for the Components
  • External Petsc Solver App
  • PETScDMDAMeshCreate a square mesh from PETSc DMDA.
  • Heat Transfer App
  • PatchSidesetGeneratorDivides the given sideset into smaller patches of roughly equal size.

Mesh/Partitioner

MeshDivisions

  • Moose App
  • AddMeshDivisionActionAdd a MeshDivision object to the simulation.
  • CartesianGridDivisionDivide the mesh along a Cartesian grid. Numbering increases from bottom to top and from left to right and from back to front. The inner ordering is X, then Y, then Z
  • CylindricalGridDivisionDivide the mesh along a cylindrical grid. The innermost numbering of divisions is the radial bins, then comes the azimuthal bins, then the axial bins
  • ExtraElementIntegerDivisionDivide the mesh by increasing extra element IDs. The division will be contiguously numbered even if the extra element ids are not
  • FunctorBinnedValuesDivisionDivide the mesh along based on uniformly binned values of a functor.
  • NearestPositionsDivisionDivide the mesh using a nearest-point / voronoi algorithm, with the points coming from a Positions object
  • NestedDivisionDivide the mesh using nested divisions objects
  • SphericalGridDivisionDivide the mesh along a spherical grid.
  • SubdomainsDivisionDivide the mesh by increasing subdomain ids. The division will be contiguously numbered even if the subdomain ids are not
  • Reactor App
  • HexagonalGridDivisionDivide the mesh along a hexagonal grid. Numbering of pin divisions increases first counterclockwise, then expanding outwards from the inner ring, then axially. Inner-numbering is within a radial ring, outer-numbering is axial divisions

Modules

Modules/CompressibleNavierStokes

  • Navier Stokes App
  • CNSActionThis class allows us to have a section of the input file like the following which automatically adds Kernels and AuxKernels for all the required nonlinear and auxiliary variables.

Modules/FluidProperties

Modules/HeatTransfer

Modules/HeatTransfer/ThermalContact

Modules/HeatTransfer/ThermalContact/BC
  • Heat Transfer App
  • ThermalContactActionAction that controls the creation of all of the necessary objects for calculation of Thermal Contact

Modules/IncompressibleNavierStokes

  • Navier Stokes App
  • INSActionThis class allows us to have a section of the input file for setting up incompressible Navier-Stokes equations.

Modules/NavierStokesFV

  • Navier Stokes App
  • NSFVActionThis class allows us to set up Navier-Stokes equations for porous medium or clean fluid flows using incompressible or weakly compressible approximations with a finite volume discretization.

Modules/Peridynamics

Modules/Peridynamics/Mechanics

Modules/Peridynamics/Mechanics/GeneralizedPlaneStrain
  • Peridynamics App
  • GeneralizedPlaneStrainActionPDClass for setting up the Kernel, ScalarKernel, and UserObject for peridynamic generalized plane strain model
Modules/Peridynamics/Mechanics/Master

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/PorousFlow

Modules/PorousFlow/BCs

  • Porous Flow App
  • PorousFlowAddBCActionAction that allows adding BCs using proxy classes.
  • PorousFlowSinkBCBC corresponding to hot/cold fluid injection. This BC is only valid for single-phase, non-isothermal simulations using (P, T) variables. This BC adds fluid mass and heat energy. It is only meaningful if flux_function <= 0

Modules/SolidProperties

Modules/TensorMechanics

Modules/TensorMechanics/CohesiveZoneMaster

Modules/TensorMechanics/DynamicMaster

Modules/TensorMechanics/GeneralizedPlaneStrain

Modules/TensorMechanics/GlobalStrain

Modules/TensorMechanics/LineElementMaster

  • Solid 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

MortarGapHeatTransfer

  • Heat Transfer App
  • MortarGapHeatTransferActionAction that controls the creation of all of the necessary objects for calculation of heat transfer through an open/closed gap using a mortar formulation and a modular design approach

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.
  • Stochastic Tools App
  • PODFullSolveMultiAppCreates a full-solve type sub-application for each row of a Sampler matrix. On second call, this object creates residuals for a PODReducedBasisTrainer with given basis functions.
  • SamplerFullSolveMultiAppCreates a full-solve type sub-application for each row of each Sampler matrix.
  • SamplerTransientMultiAppCreates a sub-application for each row of each Sampler matrix.
  • Level Set App
  • LevelSetReinitializationMultiAppMultiApp capable of performing repeated complete solves for level set reinitialization.

NEML2

  • Solid Mechanics App
  • NEML2ActionParse and set up NEML2 objects

NodalKernels

  • Moose App
  • AddNodalKernelActionAdd a NodalKernel object to the simulation.
  • ConstantRateComputes residual or the rate in a simple ODE of du/dt = rate.
  • CoupledForceNodalKernelAdds a force proportional to the value of the coupled variable
  • LowerBoundNodalKernelUsed to prevent a coupled variable from going below a lower bound
  • PenaltyDirichletNodalKernelEnforces a Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet value on nodesets.
  • ReactionNodalKernelImplements a simple consuming reaction term at nodes
  • TimeDerivativeNodalKernelForms the contribution to the residual and jacobian of the time derivative term from an ODE being solved at all nodes.
  • UpperBoundNodalKernelUsed to prevent a coupled variable from going above a upper bound
  • UserForcingFunctionNodalKernelResidual contribution to an ODE from a source function acting at nodes.
  • Solid Mechanics App
  • NodalGravityComputes the gravitational force for a given nodal mass.
  • NodalRotationalInertiaCalculates the inertial torques and inertia proportional damping corresponding to the nodal rotational inertia.
  • NodalTranslationalInertiaComputes the inertial forces and mass proportional damping terms corresponding to nodal mass.
  • Peridynamics App
  • PenaltyDirichletOldValuePDEnforces a Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the old solution for transient problems.

NodalNormals

  • Moose App
  • AddNodalNormalsActionCreates Auxiliary variables and objects for computing the outward facing normal from a node.

Optimization

  • Optimization App
  • OptimizationActionAction for performing some common functions for running optimization simulations.

OptimizationReporter

  • Optimization App
  • AddOptimizationReporterActionAdds OptimizationReporter objects for optimization routines.
  • GeneralOptimizationReporter that provides TAO with the objective, gradient, and constraint data, which are supplied by the reporters and postprocessors from the forward and adjoint subapps.
  • OptimizationReporterComputes objective function, gradient and contains reporters for communicating between optimizeSolve and subapps
  • ParameterMeshOptimizationComputes objective function, gradient and contains reporters for communicating between optimizeSolve and subapps using mesh-based parameter definition.

Outputs

ParameterStudy

Physics

Physics/Diffusion

Physics/Diffusion/ContinuousGalerkin

  • Moose App
  • DiffusionCGDiscretizes a diffusion equation with the continuous Galerkin finite element method

Physics/Diffusion/FiniteVolume

  • Moose App
  • DiffusionFVAdd diffusion physics discretized with cell-centered finite volume

Physics/HeatConduction

Physics/HeatConduction/FiniteElement

  • Heat Transfer App
  • HeatConductionFECreates the heat conduction equation discretized with CG

Physics/SolidMechanics

Physics/SolidMechanics/CohesiveZone

Physics/SolidMechanics/Dynamic

Physics/SolidMechanics/GeneralizedPlaneStrain

Physics/SolidMechanics/GlobalStrain

Physics/SolidMechanics/LineElement

Physics/SolidMechanics/LineElement/QuasiStatic
  • Solid 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.

Physics/SolidMechanics/MaterialVectorBodyForce

Physics/SolidMechanics/QuasiStatic

PorousFlowBasicTHM

  • Porous Flow App
  • PorousFlowBasicTHMAdds Kernels and fluid-property Materials necessary to simulate a single-phase, single-component fully-saturated flow problem. No upwinding and no mass lumping of the fluid mass are used (the stabilization input parameter is ignored). The fluid-mass time derivative is close to linear, and is perfectly linear if multiply_by_density=false. These features mean the results may differ slightly from the Unsaturated Action case. To run a simulation you will also need to provide various other Materials for each mesh block, depending on your simulation type, viz: permeability, constant Biot modulus, constant thermal expansion coefficient, porosity, elasticity tensor, strain calculator, stress calculator, matrix internal energy, thermal conductivity, diffusivity

PorousFlowFullySaturated

  • Porous Flow App
  • PorousFlowFullySaturatedAdds Kernels and fluid-property Materials necessary to simulate a single-phase fully-saturated flow problem. Numerical stabilization options for the fluid and heat flow are: no upwinding, full-upwinding or KT stabilization. No Kernels for diffusion and dispersion of fluid components are added. To run a simulation you will also need to provide various other Materials for each mesh block, depending on your simulation type, viz: permeability, porosity, elasticity tensor, strain calculator, stress calculator, matrix internal energy, thermal conductivity, diffusivity

PorousFlowUnsaturated

  • Porous Flow App
  • PorousFlowUnsaturatedAdds Kernels and fluid-property Materials necessary to simulate a single-phase saturated-unsaturated flow problem. The saturation is computed using van Genuchten's expression. No Kernels for diffusion and dispersion of fluid components are added. To run a simulation you will also need to provide various other Materials for each mesh block, depending on your simulation type, viz: permeability, porosity, elasticity tensor, strain calculator, stress calculator, matrix internal energy, thermal conductivity, diffusivity

Positions

  • Moose App
  • AddPositionsActionAdd a Positions object to the simulation.
  • DistributedPositionsDistribute positions, using translations, over one or more positions
  • ElementCentroidPositionsPositions of element centroids.
  • ElementGroupCentroidPositionsGets the Positions of the centroid of groups of elements. Groups may be defined using subdomains or element extra ids.
  • FilePositionsImport positions from one or more files.
  • FunctorPositionsImport positions from one or more reporters, for example other Positions
  • InputPositionsPositions set directly from a user parameter in the input file
  • MultiAppPositionsObtain positions from MultiApps. This may only be used to set the positions of those same multiapps if an 'initial_positions' parameter is used.
  • ReporterPositionsImport positions from one or more reporters, for example other Positions
  • TransformedPositionsTransform, with a linear transformation, positions from another Positions object
  • Reactor App
  • CartesianGridPositionsCreate positions along a Cartesian grid.
  • HexagonalGridPositionsCreate positions along a hexagonal grid. Numbering of positions increases first counterclockwise, then expanding outwards from the inner ring, then axially. Inner-numbering is within a radial ring, outer-numbering is axial divisions

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.
  • Contact App
  • ContactSplitSplit-based preconditioner that partitions the domain into DOFs directly involved in contact (on contact surfaces) and those that are not

Problem

  • Moose App
  • CreateProblemActionAdd a Problem object to the simulation.
  • DynamicObjectRegistrationActionRegister MooseObjects from other applications dynamically.
  • DisplacedProblemA Problem object for 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
  • Contact App
  • AugmentedLagrangianContactFEProblemManages nested solution for augmented Lagrange contact
  • AugmentedLagrangianContactProblemManages nested solution for augmented Lagrange contact
  • Level Set App
  • LevelSetProblemA specilized problem class that adds a custom call to MultiAppTransfer execution to transfer adaptivity for the level set reinitialization.
  • LevelSetReinitializationProblemA specialied problem that has a method for resetting time for level set reinitialization execution.
  • Navier Stokes App
  • NavierStokesProblemA problem that handles Schur complement preconditioning of the incompressible Navier-Stokes equations
  • Thermal Hydraulics App
  • THMProblemSpecialization of FEProblem to run with component subsystem
  • External Petsc Solver App
  • ExternalPETScProblemProblem extension point for wrapping external applications

ProjectedStatefulMaterialStorage

RayBCs

  • Heat Transfer App
  • ViewFactorRayBCThis ray boundary condition is applied on all sidesets bounding a radiation cavity except symmetry sidesets. It kills rays that hit the sideset and scores the ray for computation of view factors.
  • Ray Tracing App
  • AddRayBCActionAdds a RayBC for use in ray tracing to the simulation.
  • KillRayBCA RayBC that kills a Ray on a boundary.
  • NullRayBCA RayBC that does nothing to a Ray on a boundary.
  • ReflectRayBCA RayBC that reflects a Ray in a specular manner on a boundary.

RayKernels

  • Ray Tracing App
  • AddRayKernelActionAdds a RayKernel for use in ray tracing to the simulation.
  • ADLineSourceRayKernelDemonstrates the multiple ways that scalar values can be introduced into RayKernels, e.g. (controllable) constants, functions, postprocessors, and data on rays. Implements the weak form along a line.
  • FunctionIntegralRayKernelIntegrates a function along a Ray.
  • KillRayKernelA RayKernel that kills a Ray.
  • LineSourceRayKernelDemonstrates the multiple ways that scalar values can be introduced into RayKernels, e.g. (controllable) constants, functions, postprocessors, and data on rays. Implements the weak form along a line.
  • MaterialIntegralRayKernelIntegrates a Material property along a Ray.
  • NullRayKernelA RayKernel that does nothing.
  • RayDistanceAuxAccumulates the distance traversed by each Ray segment into an aux variable for the element that the segments are in.
  • VariableIntegralRayKernelIntegrates a Variable or AuxVariable along a Ray.

ReactionNetwork

ReactionNetwork/AqueousEquilibriumReactions

ReactionNetwork/SolidKineticReactions

Reporters

Samplers

ScalarKernels

SolidProperties

SpatialReactionSolver

  • Geochemistry App
  • AddSpatialReactionSolverActionAction that sets up a spatially-dependent reaction solver. This creates creates a spatial geochemistry solver, and adds AuxVariables corresonding to the molalities, etc

StochasticTools

  • Stochastic Tools App
  • StochasticToolsActionAction for performing some common functions for running stochastic simulations.

Surrogates

ThermalContact

  • Heat Transfer App
  • ThermalContactActionAction that controls the creation of all of the necessary objects for calculation of Thermal Contact

TimeDependentReactionSolver

  • Geochemistry App
  • AddTimeDependentReactionSolverActionAction that sets up a time-dependent equilibrium reaction solver. This creates creates a time-dependent geochemistry solver, and adds AuxVariables corresonding to the molalities, etc

TimeIndependentReactionSolver

  • Geochemistry App
  • AddTimeIndependentReactionSolverActionAction that sets up a time-dependent equilibrium reaction solver. This creates creates a time-dependent geochemistry solver, and adds AuxVariables corresonding to the molalities, etc

Times

Trainers

Transfers

  • Moose App
  • AddTransferActionAdd a Transfer object to the simulation.
  • MultiAppCloneReporterTransferDeclare and transfer reporter data from sub-application(s) to main application.
  • MultiAppCopyTransferCopies variables (nonlinear and auxiliary) between multiapps that have identical meshes.
  • 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
  • Stochastic Tools App
  • LibtorchNeuralNetControlTransferCopies a neural network from a trainer object on the main app to a LibtorchNeuralNetControl object on the subapp.
  • PODResidualTransferTransfers residual vectors from the sub-application to a a container in the Trainer object.
  • PODSamplerSolutionTransferTransfers solution vectors from the sub-applications to a a container in the Trainer object and back.
  • SamplerParameterTransferCopies Sampler data to a SamplerReceiver object.
  • SamplerPostprocessorTransferTransfers data from Postprocessors on the sub-application to a VectorPostprocessor on the master application.
  • SamplerReporterTransferTransfers data from Reporters on the sub-application to a StochasticReporter on the main application.
  • SamplerTransferCopies Sampler data to a SamplerReceiver object.
  • SerializedSolutionTransferSerializes and transfers solution vectors for given variables from sub-applications.
  • Level Set App
  • LevelSetMeshRefinementTransferTransfers the mesh from the master application to the sub application for the purposes of level set reinitialization problems with mesh adaptivity.
  • Functional Expansion Tools App
  • MultiAppFXTransferTransfers coefficient arrays between objects that are derived from MutableCoefficientsInterface; currently includes the following types: FunctionSeries, FXBoundaryUserObject, and FXVolumeUserObject

UserObjects

VariableMappings

  • Stochastic Tools App
  • AddVariableMappingActionAdds Mapping objects from a VariableMappings block.
  • PODMappingClass which provides a Proper Orthogonal Decomposition-based mapping between full-order and reduced-order spaces.

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.
  • CSVReaderVectorPostprocessorConverts 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.
  • MeshDivisionFunctorReductionVectorPostprocessorPerform reductions on functors based on a per-mesh-division basis
  • NearestPointIntegralVariablePostprocessorCompute element variable integrals for nearest-point based subdomains
  • NodalValueSamplerSamples values of nodal variable(s).
  • PointValueSamplerSample a variable at specific points.
  • PositionsFunctorValueSamplerSample one or more functors at points specified by a Positions object.
  • 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
  • Optimization App
  • ElementOptimizationDiffusionCoefFunctionInnerProductCompute the gradient for material inversion by taking the inner product of gradients of the forward and adjoint variables with material gradient
  • ElementOptimizationSourceFunctionInnerProductComputes the inner product of variable with parameterized source function for optimization gradient computation.
  • SideOptimizationNeumannFunctionInnerProductComputes the inner product of variable with parameterized Neumann function for optimization gradient computation.
  • 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
  • Navier Stokes App
  • WaveSpeedVPPExtracts wave speeds from HLLC userobject for a given face
  • Stochastic Tools App
  • GaussianProcessDataTool for extracting hyperparameter data from gaussian process user object and storing in VectorPostprocessor vectors.
  • SamplerDataTool for extracting Sampler object data and storing in VectorPostprocessor vectors.
  • SobolStatisticsCompute SOBOL statistics values of a given VectorPostprocessor objects and vectors.
  • StatisticsCompute statistical values of a given VectorPostprocessor objects and vectors.
  • StochasticResultsStorage container for stochastic simulation results coming from a Postprocessor.
  • Thermal Hydraulics App
  • ADSampler1DRealSamples material properties at all quadrature points in mesh block(s)
  • Sampler1DRealSamples material properties at all quadrature points in mesh block(s)
  • Sampler1DVectorSamples a single component of array material properties at all quadrature points in mesh block(s)
  • Solid 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.
  • AverageSectionValueSamplerCompute the section's variable average in three-dimensions given a user-defined definition of the cross section.
  • InteractionIntegralComputes the interaction integral, which is used to compute various fracture mechanics parameters at a crack tip, including KI, KII, KIII, and the T stress.
  • JIntegralComputes the J-Integral, a measure of the strain energy release rate at a crack tip, which can be used as a criterion for fracture growth. It can, alternatively, compute the C(t) integral
  • LineMaterialRankTwoSamplerAccess a component of a RankTwoTensor
  • LineMaterialRankTwoScalarSamplerCompute a scalar property of a RankTwoTensor
  • MixedModeEquivalentKComputes the mixed-mode stress intensity factor given the , , and stress intensity factors
  • Heat Transfer App
  • SurfaceRadiationVectorPostprocessorVectorPostprocessor for accessing information stored in surface radiation user object
  • ViewfactorVectorPostprocessorVectorPostprocessor for accessing view factors from GrayLambertSurfaceRadiationBase UO
  • Ray Tracing App
  • PerProcessorRayTracingResultsVectorPostprocessorAccumulates ray tracing results (information about the trace) on a per-processor basis.

XFEM

  • XFEMApp
  • XFEMActionAction to input general parameters and simulation options for use in XFEM.