Complete Syntax
ActionComponents
- Moose App
- CombineComponentsMeshesCombines meshes generated by disjoined components.
- CreateMeshSetupActionsForComponentsAdds the SetupMesh-Actions to the simulation, if they are not created by the Mesh block.
- AddActionComponentActionAction responsible for creating component actions. A component action is a component derived from an Action base class
- CylinderComponentCylindrical component.
- MeshGeneratorComponentComponent with a mesh coming from a mesh generator.
Adaptivity
- Moose App
- SetAdaptivityOptionsActionAction for defining adaptivity parameters.
- Indicators
- Markers
Adaptivity/Indicators
- Moose App
- AddElementalFieldActionAdds elemental auxiliary variable for adaptivity system.
- AddIndicatorActionAdd an Indicator object to a simulation.
- AnalyticalIndicatorCompute the square of the error as the difference between an unknown variable and an analytical solution.
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- GradientJumpIndicatorCompute the jump of the solution gradient across element boundaries.
- LaplacianJumpIndicatorCompute the jump of the solution laplacian across element bondaries.
- MFEMVariableClass for adding MFEM variables to the problem (mfem::ParGridFunctions).
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- ValueJumpIndicatorCompute the jump of the solution across element bondaries.
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- VectorValueJumpIndicatorCompute the jump of the solution across element bondaries.
- 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
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.
- MFEMVariableClass for adding MFEM variables to the problem (mfem::ParGridFunctions).
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- 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
- 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
- Phase Field App
- DiscreteNucleationMarkerMark new nucleation sites for refinement
Application
- Moose App
- CreateApplicationBlockActionAdds application and application related parameters.
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.
- ADFunctorMaterialRealAuxOutputs element volume-averaged material properties
- ADFunctorMaterialRealVectorValueAuxCapture a component of a vector material property in an auxiliary variable.
- ADFunctorVectorElementalAuxEvaluates a vector functor (material property usually) on the current element.For finite volume, this evaluates the vector functor at the centroid.
- ADMaterialRankFourTensorAuxAccess a component of a RankFourTensor for automatic material property output
- ADMaterialRankTwoTensorAuxAccess a component of a RankTwoTensor for automatic material property output
- ADMaterialRateRealAuxOutputs element material properties rate of change
- ADMaterialRealAuxOutputs element volume-averaged material properties
- ADMaterialRealTensorValueAuxObject for extracting a component of a rank two tensor material property to populate an auxiliary variable.
- 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
- ADMaterialSymmetricRankFourTensorAuxAccess a component of a RankTwoTensor for automatic material property output
- ADMaterialSymmetricRankTwoTensorAuxCapture a component of a vector material property in an auxiliary variable.
- 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.
- ElementAdaptivityLevelAuxstores the element hierarchy in a 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.
- FunctorCoordinatesFunctionAuxAuxiliary Kernel that creates and updates a field variable by sampling a function with functors (variables, functions, others) as the coordinates.
- 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.
- FunctorMaterialRealAuxOutputs element volume-averaged material properties
- FunctorMaterialRealVectorValueAuxCapture a component of a vector material property in an auxiliary variable.
- 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.
- GhostingFromUOAuxColors 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.
- MFEMCurlAuxCalculates the curl of an H(curl) conforming ND source variable and stores the result on an H(div) conforming RT result auxvariable
- MFEMDivAuxCalculates the divergence of an H(div) conforming RT source variable and stores the result on an L2 conforming result auxvariable
- MFEMGradAuxCalculates the gradient of an H1 conforming source variable and stores the result on an H(curl) conforming ND result auxvariable
- MFEMScalarProjectionAuxProjects a scalar coefficient onto a scalar MFEM auxvariable
- MFEMScalarTimeAverageAuxCalculates a running time average of a scalar MFEM variable projected onto an auxvariable
- MFEMSumAuxCalculates the sum of two variables sharing an FE space, each optionally scaled by a real constant, and stores the result in a third.
- MFEMVectorProjectionAuxProjects a vector coefficient onto a vector MFEM auxvariable.
- 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
- MaterialSymmetricRankFourTensorAuxAccess a component of a RankTwoTensor for automatic material property output
- MaterialSymmetricRankTwoTensorAuxCapture a component of a vector material property in an auxiliary variable.
- 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.
- TagVectorAuxExtract DOF values from a tagged vector into an AuxVariable
- 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.
- 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
- Fsi App
- WaveHeightAuxKernelCalculates the wave heights given pressures.
- Functional Expansion Tools App
- FunctionSeriesToAuxAuxKernel to convert a functional expansion (Functions object, type = FunctionSeries) to an AuxVariable
- 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.
- 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.
- Sub Channel App
- BlockedMassFlowRateAuxComputes inlet mass flow rate BCs, from specified mass flux and cross-sectional area and applies blocked inlet conditions
- FlatMassFlowRateAuxComputes a uniform mass flow rate at the inlet
- MassFlowRateAuxComputes mass flow rate from specified mass flux and subchannel cross-sectional area. Can read either PostprocessorValue or Real
- QuadPowerAuxComputes axial power rate (W/m) that goes into the subchannel cells or is assigned to the fuel pins, in a quadrilateral lattice arrangement
- RZPinQPrimeAuxAxial heat rate on pin surface for a 2D-RZ axi-symmetric fuel pin model
- SCMBlockedMassFlowRateAuxComputes inlet mass flow rate BCs, from specified mass flux and cross-sectional area and applies blocked inlet conditions
- SCMFlatMassFlowRateAuxComputes a uniform mass flow rate at the inlet
- SCMMassFlowRateAuxComputes mass flow rate from specified mass flux and subchannel cross-sectional area. Can read either PostprocessorValue or Real
- SCMQuadPowerAuxComputes axial power rate (W/m) that goes into the subchannel cells or is assigned to the fuel pins, in a quadrilateral lattice arrangement
- SCMRZPinQPrimeAuxAxial heat rate on pin surface for a 2D-RZ axi-symmetric fuel pin model
- SCMTriPowerAuxComputes axial power rate (W/m) that goes into the subchannel cells or is assigned to the fuel pins, in a triangular lattice arrangement
- TriPowerAuxComputes axial power rate (W/m) that goes into the subchannel cells or is assigned to the fuel pins, in a triangular lattice arrangement
- 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
- Misc App
- CoupledDirectionalMeshHeightInterpolationScales a variable based on position relative to the model bounds in a specified direction
- 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
- 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
- Heat Transfer App
- JouleHeatingHeatGeneratedAuxCompute heat generated from Joule heating.
- 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.
- Electromagnetics App
- ADCurrentDensityCalculates the current density vector field (in A/m^2) when given electrostatic potential (electrostatic = true, default) or electric field.
- AzimuthMagneticTimeDerivRZComputes the time derivative of the azimuthal component of the magnetic field assuming cylindrical electric field. The electric field can be supplied as a vector or scalar components.
- CurrentDensityCalculates the current density vector field (in A/m^2) when given electrostatic potential (electrostatic = true, default) or electric field.
- EMJouleHeatingHeatGeneratedAuxComputes the heating due to the electic field in the form of
- PotentialToFieldAuxAn AuxKernel that calculates the electrostatic electric field given the electrostatic potential.
- SourceCurrentHeatingComputes the heating due to the electic field in the form of
- 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)
- 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.
- FlowModelGasMixAuxComputes various quantities for FlowModelGasMix.
- MachNumberAuxComputes Mach number.
- PrandtlNumberAuxComputes the Prandtl number for the fluid in the simulation domain
- ReynoldsNumberAuxComputes the Reynolds number.
- ShaftConnectedCompressor1PhaseAuxComputes various quantities for a ShaftConnectedCompressor1Phase.
- ShaftConnectedPump1PhaseAuxComputes various quantities for a ShaftConnectedPump1Phase.
- ShaftConnectedTurbine1PhaseAuxComputes various quantities for a ShaftConnectedTurbine1Phase.
- SimpleTurbinePowerFieldAuxComputes turbine power for 1-phase flow for a simple on/off turbine
- 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.
- VolumeJunction1PhaseAuxComputes various quantities for a VolumeJunction1Phase.
- WeightedAverageAuxWeighted average of variables using other variables as weights
- 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
- EBSDReaderAvgDataAuxOutputs the requested EBSD reader average data, for a given phase if specified, for the grain at the local node/element.
- EBSDReaderPointDataAuxOutputs the requested EBSD reader point data.
- EulerAngleProvider2RGBAuxOutput RGB representation of crystal orientation from user object to an AuxVariable. The entire domain must have the same crystal structure.
- EulerAngleVariables2RGBAuxOutputs one color or a scalar for the RGB-encoding of the local Euler angles for the grain orientation
- 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.
- PFCEnergyDensityComputes the crystal free energy density
- PFCRFFEnergyDensityComputes the crystal free energy density for the RFF form of the phase field crystal model
- 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
- 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
- AccumulateAuxAccumulates one or more variables and this auxiliary variable into this auxiliary variable
- 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
- ReactionForceAuxExtract the value of the residual from an appropriately formed tag vector and save those values as reaction forces in an AuxVariable
- RotationAngleCompute the field of angular rotations of points around an axis defined by an origin point and a direction vector
- ShellLocalCoordinatesAuxThis AuxKernel stores a specific component of a shell element's local coordinate vector in an auxiliary variable.
- ShellResultantsAuxComputes the local forces, bending moments and shear forces acting on shell elements
- TestNewmarkTIAssigns the velocity/acceleration calculated by time integrator to the velocity/acceleration auxvariable.
- 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.
- RANSYPlusAuxCalculates non-dimensional wall distance (y+) value.
- 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.
AuxKernels/MatVecRealGradAuxKernel
- Phase Field App
- MatVecRealGradAuxKernelActionOutputs all components of the gradient of the real standard vector-valued properties specified
AuxKernels/MaterialVectorAuxKernel
- Phase Field App
- MaterialVectorAuxKernelActionOutputs all components of the standard vector-valued properties specified
AuxKernels/MaterialVectorGradAuxKernel
- Phase Field App
- MaterialVectorGradAuxKernelActionOutputs all components of the gradient of the real standard vector-valued properties specified
AuxScalarKernels
- Moose App
- AddScalarKernelActionAdd a AuxScalarKernel object to the simulation.
- ConstantScalarAuxSets an auxiliary field variable to a controllable constant value.
- FunctionScalarAuxSets a value of a scalar variable based on a function.
- QuotientScalarAuxCompute the ratio of two scalar variables.
- ScalarTagMatrixAuxCouple a tag matrix, and return its nodal value
- ScalarTagVectorAuxCouple a tag vector, and return its value
- SolutionScalarAuxSets scalar variable by using information from a SolutionUserObject.
- Solid Mechanics App
- GeneralizedPlaneStrainReferenceResidualGeneralized Plane Strain Reference Residual Scalar Kernel
- Stochastic Tools App
- SurrogateModelScalarAuxSets a value of a scalar variable based on a surrogate model.
- Thermal Hydraulics App
- SimpleTurbinePowerAuxComputes turbine power for 1-phase flow for a simple on/off turbine
- SimpleTurbinePowerScalarAuxComputes turbine power for 1-phase flow for a simple on/off turbine
AuxVariables
- Moose App
- AddAuxVariableActionAdd auxiliary variable to the simulation.
- CopyNodalVarsActionCopies variable information from a file.
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MFEMVariableClass for adding MFEM variables to the problem (mfem::ParGridFunctions).
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- 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
AuxVariables/MultiAuxVariables
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MFEMVariableClass for adding MFEM variables to the problem (mfem::ParGridFunctions).
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- 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
- Phase Field App
- MultiAuxVariablesActionSet up auxvariables for components of MaterialProperty<std::vector<data_type> > for polycrystal sample.
BCs
- Moose App
- AddBCActionAdd a BoundaryCondition object to the simulation.
- ADConservativeAdvectionBCBoundary condition for advection when it is integrated by parts. Supports Dirichlet (inlet-like) and implicit (outlet-like) conditions.
- 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 .
- AdvectionIPHDGDirichletBCWeakly imposes Dirichlet boundary conditions for a hybridized discretization of an advection equation
- AdvectionIPHDGOutflowBCImplements an outflow boundary condition for use with a hybridized discretization of the advection equation
- AdvectionIPHDGPrescribedFluxBCImplements a prescribed flux condition for use with a hybridized discretization of the advection equation
- 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 .
- ConservativeAdvectionBCBoundary condition for advection when it is integrated by parts. Supports Dirichlet (inlet-like) and implicit (outlet-like) conditions.
- 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.
- DiffusionIPHDGDirichletBCWeakly imposes Dirichlet boundary conditions for a hybridized discretization of a diffusion equation
- DiffusionIPHDGPrescribedFluxBCImplements a flux boundary condition for use with a hybridized discretization of the diffusion equation
- DiffusionLHDGDirichletBCWeakly imposes Dirichlet boundary conditions for a hybridized discretization of a diffusion equation
- DiffusionLHDGPrescribedGradientBCImplements a flux boundary condition for use with a hybridized discretization of the diffusion equation
- DirectionalNeumannBCImposes the integrated boundary condition , where is a user-defined, constant 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.
- MFEMBoundaryIntegratedBCAdds the boundary integrator to an MFEM problem for the linear form arising from the weak form of the forcing term .
- MFEMBoundaryNormalIntegratedBCAdds the boundary integrator to an MFEM problem for the linear form
- MFEMConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficent given by material properties to add to MFEM problems.
- MFEMScalarDirichletBCApplies a Dirichlet condition to a scalar variable.
- MFEMVectorBoundaryIntegratedBCAdds the boundary integrator to an MFEM problem for the linear form
- MFEMVectorDirichletBCApplies a Dirichlet condition to all components of a vector variable.
- MFEMVectorFEBoundaryFluxIntegratedBCAdds the boundary integrator to an MFEM problem for the linear form
- MFEMVectorNormalDirichletBCApplies a Dirichlet condition to the normal components of a vector variable.
- MFEMVectorTangentialDirichletBCApplies a Dirichlet condition to the tangential components of a vector variable.
- 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
- 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.
- Peridynamics App
- RBMPresetOldValuePDClass to apply a preset BC to nodes with rigid body motion (RBM).
- Fsi App
- FluidFreeSurfaceBCApplies a mixed Dirichlet-Neumann BC on the fluid surface.
- 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
- DashpotBCModel a dashpot boundary condition where the traction is proportional to the normal velocity.
- DirectDirichletBCImposes the essential boundary condition , where is a constant, controllable value.
- DirectFunctionDirichletBCImposes the essential boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- DisplacementAboutAxisImplements a boundary condition that enforces rotationaldisplacement around an axis on a boundary
- ExplicitDirichletBCImposes the essential boundary condition , where is a constant, controllable value.
- ExplicitFunctionDirichletBCImposes the essential boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- 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.
- PresetVelocitySets the boundary displacements through time from an imposed velocity
- 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
- 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.
- INSADSurfaceTensionBCSurface tension stresses.
- 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.
- MassFluxPenaltyBCAdds the exterior boundary contribution of penalized jumps in the velocity variable in one component of the momentum equations.
- MassFreeBCImplements free advective flow boundary conditions for the mass equation.
- MassMatrixIntegratedBCComputes a finite element mass matrix meant for use in preconditioning schemes which require one
- 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.
- NavierStokesLHDGOutflowBCImplements an outflow boundary condition for use with a hybridized discretization of the incompressible Navier-Stokes equations
- NavierStokesLHDGVelocityDirichletBCWeakly imposes Dirichlet boundary conditions for the velocity for a hybridized discretization of the Navier-Stokes equations
- NavierStokesStressIPHDGDirichletBCWeakly imposes Dirichlet boundary conditions for a hybridized discretization of a Navier-Stokes equation stress term
- 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.
- Rdg App
- AEFVBCA boundary condition kernel for the advection equation using a cell-centered finite volume method.
- 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.
- XFEMApp
- CrackTipEnrichmentCutOffBCImposes the essential boundary condition , where is a constant, controllable value.
- Chemical Reactions App
- ChemicalOutFlowBCChemical flux boundary condition
- 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
- 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
- BoundaryFluxGasMixBCBoundary conditions for a FlowChannelGasMix using a boundary flux object.
- 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
- HSCoupler2D2DRadiationRZBCAdds boundary heat flux terms for HSCoupler2D2DRadiation
- 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
- Heat Transfer App
- ADConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficient 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.
- CoupledConvectiveFluxIntegrated boundary condition for modeling a convective heat flux.
- 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.
- GapPerfectConductanceEnforces equal temperatures across the gap.
- GaussianEnergyFluxBCDescribes an incoming heat flux beam with a Gaussian profile
- GrayLambertNeumannBCThis BC imposes a heat flux density that is computed from the GrayLambertSurfaceRadiationBase userobject.
- HeatConductionBCBoundary condition for a diffusive heat flux.
- InfiniteCylinderRadiativeBCBoundary condition for radiative heat exchange with a cylinderwhere the boundary is approximated as a cylinder as well.
- Phase Field App
- ADPhaseFieldContactAngleBCEnforce contact angle BC using phase field variable
BCs/CavityPressure
- Solid Mechanics App
- CavityPressureActionAction to setup cavity pressure boundary condition
- CavityPressurePPActionThis Action creates a CavityPressurePostprocessor.
- CavityPressureUOActionAction to add user objects for cavity pressure
BCs/CoupledPressure
- Solid Mechanics App
- CoupledPressureActionSet up pressure boundary condition using the CoupledPressureBC object.
BCs/InclinedNoDisplacementBC
- Solid Mechanics App
- InclinedNoDisplacementBCActionSet up inclined no displacement boundary conditions
BCs/Periodic
- Moose App
- AddPeriodicBCActionAction that adds periodic boundary conditions
BCs/Pressure
- Solid Mechanics App
- PressureActionSet up pressure boundary condition using the Pressure object.
Bounds
- Moose App
- AddBoundsVectorsActionAction to add vectors to nonlinear system when using the Bounds syntax.
- AddBoundActionAdd a Kernel object to the simulation.
- ConstantBoundsProvides constant bound of a variable for the PETSc's variational inequalities solver
- ConstantBoundsAuxProvides constant bound of a variable for the PETSc's variational inequalities solver
- VariableOldValueBoundsUses the old variable values as the bounds for the new solve.
- VariableOldValueBoundsAuxUses the old variable values as the bounds for the new solve.
ChainControls
- Moose App
- AddChainControlActionAdds a ChainControl to the control warehouse.
- GetFunctionValueChainControlCreates a control data and populates it by evaluating a Function.
- GetPostprocessorChainControlCopies a post-processor value into a ChainControlData.
- LimitChainControlLimits a control value by a range.
- PIDChainControlImplements a proportional-integral-derivative (PID) controller.
- ParsedChainControlParses and evaluates a function expression to populate a control value.
- RealToBoolChainControlConverts a Real-valued chain control data to boolean.
- ScaleOldChainControlScales an old control value by another control value.
- SetBoolValueChainControlSets parameter(s) of type 'bool' to a control data value of type 'bool'.
- SetRealValueChainControlSets parameter(s) of type 'double' to a control data value of type 'double'.
- SmootherChainControlComputes a moving average of the input control with a user-specified number of points to average.
- TerminateChainControlTerminates the simulation when a boolean chain control data has a certain value.
- UnitTripChainControlTrips a boolean value if an input boolean value is a certain value.
ChemicalComposition
- Chemical Reactions App
- CommonChemicalCompositionActionStore common ChemicalComposition action parameters
- ChemicalCompositionActionSets up the thermodynamic model and variables for the thermochemistry solve using Thermochimica.
Closures
- Thermal Hydraulics App
- AddClosuresActionAdds a Closures object.
- Closures1PhaseNoneNo 1-phase closures. Useful for testing with one-time correlations.
- Closures1PhaseSimpleSimple 1-phase closures
- Closures1PhaseTHMClosures for 1-phase flow channels
- FunctorClosuresCreates arbitrary closures from functors.
- WallTemperature1PhaseClosuresAdds wall temperature material for single-phase flow.
Components
- Thermal Hydraulics App
- THMCreateMeshActionAction that creates an empty mesh (in case one was not already created) and also builds THMProblem (same).
- AddComponentActionBase class for all the actions creating a MOOSE object
- ComponentGroupGroup of components. Used only for parsing input files.
- ElbowPipe1PhaseBent pipe for 1-phase flow
- FileMeshComponentLoads a mesh from an ExodusII file without adding physics.
- FileMeshPhysicsComponentComponent using a mesh from a file with one or more Physics active on it.
- FlowChannel1Phase1-phase 1D flow channel
- FlowChannelGasMixSingle-phase flow channel with a binary gas mixture
- FormLossFromExternalApp1PhaseApply a distributed form loss over a 1-phase flow channel computed by an external application.
- FormLossFromFunction1PhasePrescribe a form loss over a 1-phase flow channel given by a function
- FreeBoundaryComponent to create a free flow boundary for 1D flow. This component is deprecated.
- FreeBoundary1PhaseComponent to create a free flow boundary for single-phase flow.
- GateValveGate valve component
- GateValve1PhaseGate valve component for 1-phase flow
- HSBoundaryAmbientConvectionApplies a convective boundary condition to a heat structure
- HSBoundaryExternalAppConvectionHeat structure boundary condition to perform convective heat transfer with an external application
- HSBoundaryExternalAppHeatFluxHeat structure boundary condition to apply a heat flux transferred from another application.
- HSBoundaryExternalAppTemperatureHeat structure boundary condition to set temperature values computed by an external application
- HSBoundaryHeatFluxApplies a specified heat flux to a heat structure boundary
- HSBoundaryRadiationRadiative heat transfer boundary condition for heat structure
- HSBoundarySpecifiedTemperatureApplies Dirichlet boundary conditions on a heat structure
- HSCoupler2D2DRadiationCouples boundaries of multiple 2D heat structures via radiation
- HSCoupler2D3DCouples a 2D heat structure boundary to a 3D heat structure boundary using gap heat transfer.
- HeatGenerationSpecify a heat source in a heat structure. This component is deprecated.
- HeatSourceFromPowerDensityHeat source from power density
- HeatSourceFromTotalPowerHeat generation from total power
- HeatSourceVolumetricVolumetric heat source applied on a flow channel
- HeatSourceVolumetric1PhaseVolumetric heat source applied on a flow channel
- HeatStructure2DCouplerCouples boundaries of two 2D heat structures via a heat transfer coefficient
- HeatStructure2DRadiationCouplerRZCouples boundaries of two 2D cylindrical heat structures via radiation
- HeatStructureCylindricalCylindrical heat structure
- HeatStructureFromFile3DHeat structure component that loads a 3D mesh from an ExodusII file
- HeatStructurePlatePlate heat structure
- HeatTransferFromExternalAppHeatFlux1PhaseHeat transfer specified by heat flux provided by an external application going into 1-phase flow channel.
- HeatTransferFromExternalAppTemperature1PhaseHeat transfer into 1-phase flow channel from temperature provided by an external application
- HeatTransferFromHeatFlux1PhaseHeat transfer specified by heat flux going into 1-phase flow channel.
- HeatTransferFromHeatStructure1PhaseConnects a 1-phase flow channel and a heat structure
- HeatTransferFromHeatStructure3D1PhaseConnects multiple 1-phase flow channels and a 3D heat structure
- HeatTransferFromSpecifiedTemperature1PhaseHeat transfer connection from a fixed temperature function for 1-phase flow
- InletDensityVelocity1PhaseBoundary condition with prescribed density and velocity for 1-phase flow channels.
- InletMassFlowRateTemperature1PhaseBoundary condition with prescribed mass flow rate and temperature for 1-phase flow channels.
- InletStagnationEnthalpyMomentum1PhaseBoundary condition with prescribed stagnation enthalpy and momentum for 1-phase flow channels.
- InletStagnationPressureTemperature1PhaseBoundary condition with prescribed stagnation pressure and temperature for 1-phase flow channels.
- InletVelocityTemperature1PhaseBoundary condition with prescribed velocity and temperature for 1-phase flow channels.
- JunctionOneToOneJunction connecting one flow channel to one other flow channel
- JunctionOneToOne1PhaseJunction connecting one flow channel to one other flow channel for 1-phase flow
- JunctionParallelChannels1PhaseJunction between 1-phase flow channels that are parallel
- Outlet1PhaseBoundary condition with prescribed pressure for 1-phase flow channels.
- PrescribedReactorPowerSpecifies the total power of a component. This component is deprecated
- Pump1PhasePump between two 1-phase flow channels that has a non-zero volume
- ShaftComponent that connects torque of turbomachinery components
- ShaftConnectedCompressor1Phase1-phase compressor that must be connected to a Shaft component. Compressor speed is controlled by the connected shaft; Isentropic/Dissipation torque and delta_p are computed by user input functions of inlet flow rate and shaft speed
- ShaftConnectedMotorMotor to drive a shaft component
- ShaftConnectedPump1Phase1-phase pump that must be connected to a Shaft component. Pump speed is controlled by the connected shaft; Hydraulic torque and head are computed by user input functions of inlet flow rate and shaft speed
- ShaftConnectedTurbine1Phase1-phase turbine that must be connected to a Shaft component. Turbine speed is controlled by the connected shaft; Driving torque and delta_p are computed by user input functions of inlet flow rate (flow coefficient aux variable) and shaft speed
- SimpleTurbine1PhaseSimple turbine model that extracts prescribed power from the working fluid
- SolidWallAdds the boundary condition for a wall. This component is deprecated.
- SolidWall1PhaseAdds the boundary condition for a wall in single phase flow
- SolidWallGasMixWall boundary condition component for FlowChannelGasMix.
- SupersonicInletDeprecated component to add a supersonic flow inlet
- TotalPowerPrescribes total power via a user supplied value
- VolumeJunction1PhaseJunction between 1-phase flow channels that has a non-zero volume
Constraints
- Moose App
- AddConstraintActionAdd a Constraint object to the simulation.
- ADEqualValueEmbeddedConstraintThis is a constraint enforcing overlapping portions of two blocks to have the same variable value
- 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
- Solid Mechanics App
- NodalFrictionalConstraintFrictional nodal constraint for contact
- NodalStickConstraintSticky nodal constraint for contact
- XFEMApp
- XFEMEqualValueAtInterfaceEnforce that the solution have the same value on opposing sides of an XFEM interface.
- XFEMSingleVariableConstraintEnforce constraints on the value or flux associated with a variable at an XFEM interface.
- Thermal Hydraulics App
- MassFreeConstraintConstrains the momentum at the user-specified nodes along the user-specified normals
- 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
- Thermal Hydraulics App
- THMAddControlActionAdds Controls from the ControlLogic block.
- CopyPostprocessorValueControlForwards the value of a postprocessor to a ControlData named with the name of the postprocessor.
- DelayControlTime delay control
- GetFunctionValueControlSets a ControlData named 'value' with the value of a function
- PIDControlDeclares a control data named 'output' and uses Proportional Integral Derivative logic on the 'value' control data to set it.
- ParsedFunctionControlControl that evaluates a parsed function
- SetBoolValueControlControl object that reads a boolean value computed by the control logic system and sets it into a specified MOOSE object parameter(s)
- SetComponentBoolValueControlControl to set a boolean value of a component parameter with control data boolean
- SetComponentRealValueControlControl to set a floating point (Real) value of a component parameter with control data boolean
- SetRealValueControlControl object that reads a Real value computed by the control logic system and sets it into a specified MOOSE object parameter(s)
- SmootherControlComputes a moving average value of the input control with a user-specified number of points to average. The output control value is named 'name:value', where 'name' is the name of the control object.
- THMSolvePostprocessorControlControl the solve based on a postprocessor value
- TerminateControlTerminates the simulation when a THMControl boolean data becomes true
- TimeFunctionComponentControlControls a parameter in a Component using a function
- UnitTripControlTrips a boolean based on the evaluation of a parsed condition expression
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.
- TimesEnableControlControl for enabling/disabling objects when a certain time is reached.
- WebServerControlStarts a webserver for sending/receiving JSON messages to get data and control a running MOOSE calculation
- Solid Mechanics App
- AnalysisStepPeriodControl the enabled/disabled state of objects with user-provided analysis steps.
- 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.
Convergence
- Moose App
- AddConvergenceActionAdd a Convergence object to the simulation.
- DefaultMultiAppFixedPointConvergenceDefault fixed point convergence criteria.
- DefaultNonlinearConvergenceDefault convergence criteria for FEProblem.
- DefaultSteadyStateConvergenceDefault convergence criteria for steady-state detection in a transient simulation.
- IterationCountConvergenceChecks the iteration count.
- ParsedConvergenceEvaluates convergence from a parsed expression.
- PostprocessorConvergenceCompares the absolute value of a post-processor to a tolerance.
- ReferenceResidualConvergenceCheck the convergence of a problem with respect to a user-supplied reference solution. Replaces ReferenceResidualProblem, currently still used in conjunction with it.
- Contact App
- AugmentedLagrangianContactFEProblemConvergenceConvergence for augmented Lagrangian contact
- AugmentedLagrangianContactReferenceConvergenceConvergence for augmented Lagrangian contact
Correctors
- Moose App
- AddCorrectorActionAdd a Corrector object to the simulation.
- PointwiseRenormalizeVectorPointwise renormalize the solution of a set of variables comprising a vector
- Navier Stokes App
- NSFVPressurePinPins the pressure after a solve
- NSPressurePinPins the pressure after a solve
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
- Stochastic Tools App
- AddCovarianceActionAdds Covariance objects contained within the [Trainers]and[Surrogates]input blocks.
- ExponentialCovarianceExponential covariance function.
- LMCCovariance function for multioutput Gaussian Processes based on the Linear Model of Coregionalization (LMC).
- MaternHalfIntCovarianceMatern half-integer covariance function.
- SquaredExponentialCovarianceSquared Exponential covariance function.
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
- MassDiffusionEnergyGasMixDGKernelAdds mass diffusion to the energy equation for FlowChannelGasMix.
- MassDiffusionSpeciesGasMixDGKernelAdds mass diffusion to the species equation for FlowChannelGasMix.
- NumericalFlux3EqnDGKernelAdds side fluxes for the 1-D, 1-phase, variable-area Euler equations
- NumericalFluxGasMixDGKernelAdds side fluxes from NumericalFluxGasMixBase objects.
- Navier Stokes App
- MassFluxPenaltyIntroduces a jump correction on internal faces for grad-div stabilization for discontinuous Galerkin methods. Because this is derived from DGKernel this class executes once per face.
- MassMatrixDGKernelComputes a finite element mass matrix on internal faces meant for use in preconditioning schemes which require one
Dampers
- Moose App
- AddDamperActionAdd a Damper object to the simulation.
- BoundingValueElementDamperThis class implements a damper that limits the value of a variable to be within user-specified bounds.
- BoundingValueNodalDamperLimits the value of a variable to be within user-specified bounds.
- ConstantDamperModifies the non-linear step by applying a constant damping factor.
- MaxIncrementLimits a variable's update by some max fraction
- Contact App
- ContactSlipDamperDamp the iterative solution to minimize oscillations in frictional contact constriants between nonlinear iterations
- Solid Mechanics App
- ElementJacobianDamperDamper that limits the change in element Jacobians
- ReferenceElementJacobianDamperDamper that limits the change in element Jacobians
Debug
- Moose App
- SetupDebugActionAdds various debugging type output to the simulation system.
- SetupResidualDebugActionAdds the necessary objects for computing the residuals for individual variables.
- MaterialDerivativeTest
- Thermal Hydraulics App
- AddIterationCountPostprocessorsActionAdds postprocessors for linear and nonlinear iterations
- THMDebugActionAdd specific THM debugging option.
- THMPrintComponentLoopsActionPrints the component loops
Debug/MaterialDerivativeTest
- Moose App
- MaterialDerivativeTestActionAction for setting up the necessary objects for debugging material property derivatives.
DeprecatedBlock
- Moose App
- DeprecatedBlockActionTool for marking input syntax as deprecated.
DiracKernels
- Moose App
- AddDiracKernelActionAdd a DiracKernel object to the simulation.
- ConstantPointSourceResidual contribution of a constant point source term.
- FunctionDiracSourceResidual contribution from a point source defined by a function.
- 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.
- 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.
- XFEMApp
- XFEMPressureApplies a pressure on an interface cut by XFEM.
- Heat Transfer App
- GapHeatPointSourceMasterDirac kernel to create a heat source on the primary contact surface in thermal contact.
Distributions
- Moose App
- AddDistributionActionAdd a Distribution object to the simulation.
- Stochastic Tools App
- BetaBeta distribution
- FDistributionF-distribution or Fisher-Snedecor distribution
- GammaGamma distribution
- JohnsonSBJohnson Special Bounded (SB) distribution.
- KernelDensity1DKernelDensity1D distribution
- LogisticLogistic distribution.
- LognormalLognormal distribution
- NormalNormal distribution
- StudentTStudent t-distribution
- TruncatedNormalTruncated normal distribution
- UniformContinuous uniform distribution.
- WeibullThree-parameter Weibull distribution.
DomainIntegral
- Solid Mechanics App
- DomainIntegralActionCreates the MOOSE objects needed to compute fraction domain integrals
Executioner
- Moose App
- CreateExecutionerActionAdd an Executioner object to the simulation.
- EigenvalueEigenvalue solves a standard/generalized linear or nonlinear eigenvalue problem
- InversePowerMethodInverse power method for eigenvalue problems.
- MFEMSteadyExecutioner for steady state MFEM problems.
- MFEMTransientExecutioner for transient MFEM problems.
- NonlinearEigenExecutioner for eigenvalue problems.
- SteadyExecutioner for steady-state simulations.
- TransientExecutioner for time varying simulations.
- Adaptivity
- Predictor
- Quadrature
- TimeIntegrator
- TimeIntegrators
- TimeStepper
- TimeSteppers
- Navier Stokes App
- PIMPLESolves the transient Navier-Stokes equations using the PIMPLE algorithm and linear finite volume variables.
- SIMPLESolves the Navier-Stokes equations using the SIMPLE algorithm and linear finite volume variables.
- SIMPLENonlinearAssemblySolves the Navier-Stokes equations using the SIMPLENonlinearAssembly algorithm.
- Optimization App
- OptimizeExecutioner for optimization problems.
- SteadyAndAdjointExecutioner for evaluating steady-state simulations and their adjoint.
- TransientAndAdjointExecutioner for evaluating transient simulations and their adjoint.
Executioner/Adaptivity
- Moose App
- AdaptivityActionAdd libMesh based adaptation schemes via the Executioner/Adaptivity input syntax.
Executioner/Predictor
- Moose App
- SetupPredictorActionAdd a Predictor object to the simulation.
- AdamsPredictorImplements an explicit Adams predictor based on two old solution vectors.
- SimplePredictorAlgorithm that will predict the next solution based on previous solutions.
Executioner/Quadrature
- Moose App
- SetupQuadratureActionSets the quadrature type for the simulation.
Executioner/TimeIntegrator
- Moose App
- SetupTimeIntegratorActionAdd a TimeIntegrator object to the simulation.
- AStableDirk4Fourth-order diagonally implicit Runge Kutta method (Dirk) with three stages plus an update.
- ActuallyExplicitEulerImplementation of Explicit/Forward Euler without invoking any of the nonlinear solver
- BDF2Second order backward differentiation formula time integration scheme.
- CentralDifferenceImplementation of explicit, Central Difference integration without invoking any of the nonlinear solver
- CrankNicolsonCrank-Nicolson time integrator.
- ExplicitEulerTime integration using the explicit Euler method.
- ExplicitMidpointTime integration using the explicit midpoint method.
- ExplicitSSPRungeKuttaExplicit strong stability preserving Runge-Kutta methods
- ExplicitTVDRK2Explicit TVD (total-variation-diminishing) second-order Runge-Kutta time integration method.
- HeunHeun's (aka improved Euler) time integration method.
- ImplicitEulerTime integration using the implicit Euler method.
- ImplicitMidpointSecond-order Runge-Kutta (implicit midpoint) time integration.
- LStableDirk2Second order diagonally implicit Runge Kutta method (Dirk) with two stages.
- LStableDirk3Third order diagonally implicit Runge Kutta method (Dirk) with three stages.
- LStableDirk4Fourth-order diagonally implicit Runge Kutta method (Dirk) with five stages.
- NewmarkBetaComputes the first and second time derivative of variable using Newmark-Beta method.
- RalstonRalston's time integration method.
- Solid Mechanics App
- DirectCentralDifferenceImplementation of explicit time integration without invoking any of the nonlinear solver.
- ExplicitMixedOrderImplementation of explicit time integration without invoking any of the nonlinear solver.
Executioner/TimeIntegrators
- 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.
- Solid Mechanics App
- DirectCentralDifferenceImplementation of explicit time integration without invoking any of the nonlinear solver.
- ExplicitMixedOrderImplementation of explicit time integration without invoking any of the nonlinear solver.
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.
- FixedPointIterationAdaptiveDTComputes time step size based on a target number of fixed point iterations
- 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.
- FixedPointIterationAdaptiveDTComputes time step size based on a target number of fixed point iterations
- 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
- Moose App
- ReadExecutorParamsActionAdd an Executor object to the simulation.
- NullExecutorDummy executor that does nothing. Useful for testing among other things.
ExplicitDynamicsContact
- Contact App
- ExplicitDynamicsContactActionSets up all objects needed for mechanical contact enforcement in explicit dynamics simulations.
FESpaces
- Moose App
- AddMFEMFESpaceActionAdd a MFEM FESpace object to the simulation.
- MFEMGenericFESpaceClass for creating arbitrary MFEM finite element spaces. It requires the user to have some knowledge of how MFEM works.
- MFEMScalarFESpaceConvenience class to construct scalar finite element spaces.
- MFEMVectorFESpaceConvenience class to construct vector finite element spaces, abstracting away some of the mathematical complexity of specifying the dimensions.
FVBCs
- Moose App
- CheckFVBCActionCheck that boundary conditions are defined correctly for finite volume problems.
- AddFVBCActionAdd a FVBoundaryCondition object to the simulation.
- FVADFunctorDirichletBCUses the value of a functor to set a Dirichlet boundary value.
- FVBoundaryIntegralValueConstraintThis class is used to enforce integral of phi = boundary area * phi_0 with a Lagrange multiplier approach.
- FVConstantScalarOutflowBCConstant velocity scalar advection boundary conditions for finite volume method.
- FVDirichletBCDefines a Dirichlet boundary condition for finite volume method.
- FVFunctionDirichletBCImposes the essential boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- FVFunctionNeumannBCNeumann boundary condition for finite volume method.
- FVFunctorDirichletBCUses the value of a functor to set a Dirichlet boundary value.
- FVFunctorNeumannBCNeumann boundary condition for the finite volume method.
- FVNeumannBCNeumann boundary condition for finite volume method.
- FVOrthogonalBoundaryDiffusionImposes an orthogonal diffusion boundary term with specified boundary function.
- FVPostprocessorDirichletBCDefines a Dirichlet boundary condition for finite volume method.
- Navier Stokes App
- CNSFVHLLCFluidEnergyImplicitBCImplements an implicit advective boundary flux for the fluid energy equation for an HLLC discretization
- CNSFVHLLCFluidEnergyStagnationInletBCAdds the boundary fluid energy flux for HLLC when provided stagnation temperature and pressure
- CNSFVHLLCMassImplicitBCImplements an implicit advective boundary flux for the mass equation for an HLLC discretization
- CNSFVHLLCMassStagnationInletBCAdds the boundary mass flux for HLLC when provided stagnation temperature and pressure
- CNSFVHLLCMomentumImplicitBCImplements an implicit advective boundary flux for the momentum equation for an HLLC discretization
- CNSFVHLLCMomentumSpecifiedPressureBCImplements an HLLC boundary condition for the momentum conservation equation in which the pressure is specified.
- CNSFVHLLCMomentumStagnationInletBCAdds the boundary momentum flux for HLLC when provided stagnation temperature and pressure
- CNSFVHLLCSpecifiedMassFluxAndTemperatureFluidEnergyBCImplements the fluid energy boundary flux portion of the free-flow HLLC discretization given specified mass fluxes and fluid temperature
- CNSFVHLLCSpecifiedMassFluxAndTemperatureMassBCImplements the mass boundary flux portion of the free-flow HLLC discretization given specified mass fluxes and fluid temperature
- CNSFVHLLCSpecifiedMassFluxAndTemperatureMomentumBCImplements the momentum boundary flux portion of the free-flow HLLC discretization given specified mass fluxes and fluid temperature
- CNSFVHLLCSpecifiedPressureFluidEnergyBCImplements the fluid energy boundary flux portion of the free-flow HLLC discretization given specified pressure
- CNSFVHLLCSpecifiedPressureMassBCImplements the mass boundary flux portion of the free-flow HLLC discretization given specified pressure
- CNSFVHLLCSpecifiedPressureMomentumBCImplements the momentum boundary flux portion of the free-flow HLLC discretization given specified pressure
- CNSFVMomImplicitPressureBCAdds an implicit pressure flux contribution on the boundary using interior cell information
- FVSpecificEnthalpyFromPressureTemperatureDirichletBCComputes the specific enthalpy at the boundary from the pressure and temperature.
- INSFVAveragePressureValueBCThis class is used to enforce integral of phi = boundary area * phi_0 with a Lagrange multiplier approach.
- INSFVInletIntensityTKEBCAdds inlet boudnary conditon for the turbulent kinetic energy based on turbulent intensity.
- INSFVInletVelocityBCUses the value of a functor to set a Dirichlet boundary value.
- INSFVMassAdvectionOutflowBCOutflow boundary condition for advecting mass.
- INSFVMixingLengthTKEDBCAdds inlet boundary condition for the turbulent kinetic energy dissipation rate based on characteristic length.
- INSFVMomentumAdvectionOutflowBCFully developed outflow boundary condition for advecting momentum. This will impose a zero normal gradient on the boundary velocity.
- INSFVNaturalFreeSlipBCImplements a free slip boundary condition naturally.
- INSFVNoSlipWallBCImplements a no slip boundary condition.
- INSFVOutletPressureBCDefines a Dirichlet boundary condition for finite volume method.
- INSFVScalarFieldSeparatorBCA separator boundary condition that prevents any type of scalar flux and can be used within the domain.
- INSFVSwitchableOutletPressureBCAdds switchable pressure-outlet boundary condition
- INSFVSymmetryPressureBCThough not applied to velocity, this object ensures that the flux (velocity times the advected quantity) into a symmetry boundary is zero. When applied to pressure for the mass equation, this makes the normal velocity zero since density is constant
- INSFVSymmetryScalarBCThough not applied to velocity, this object ensures that the flux (velocity times the advected quantity) into a symmetry boundary is zero. When applied to pressure for the mass equation, this makes the normal velocity zero since density is constant
- INSFVSymmetryVelocityBCImplements a symmetry boundary condition for the velocity.
- INSFVTKEDWallFunctionBCAdds Reichardt extrapolated wall values to set up directly theDirichlet BC for the turbulent kinetic energy dissipation rate.
- INSFVTurbulentTemperatureWallFunctionAdds turbulent temperature wall function.
- INSFVTurbulentViscosityWallFunctionAdds Dirichlet BC for wall values of the turbulent viscosity.
- INSFVVaporRecoilPressureMomentumFluxBCImparts a surface recoil force on the momentum equation due to liquid phase evaporation
- INSFVVelocityHydraulicSeparatorBCA separator boundary condition that prevents any type of momentum flux and can be used within the domain.
- INSFVWallFunctionBCImplements a wall shear BC for the momentum equation based on algebraic standard velocity wall functions.
- NSFVFunctorHeatFluxBCConstant heat flux boundary condition with phase splitting for fluid and solid energy equations
- NSFVHeatFluxBCConstant heat flux boundary condition with phase splitting for fluid and solid energy equations
- NSFVOutflowTemperatureBCOutflow velocity temperature advection boundary conditions for finite volume method allowing for thermal backflow.
- PCNSFVHLLCSpecifiedMassFluxAndTemperatureFluidEnergyBCImplements the fluid energy boundary flux portion of the porous HLLC discretization given specified mass fluxes and fluid temperature
- PCNSFVHLLCSpecifiedMassFluxAndTemperatureMassBCImplements the mass boundary flux portion of the porous HLLC discretization given specified mass fluxes and fluid temperature
- PCNSFVHLLCSpecifiedMassFluxAndTemperatureMomentumBCImplements the momentum boundary flux portion of the porous HLLC discretization given specified mass fluxes and fluid temperature
- PCNSFVHLLCSpecifiedPressureFluidEnergyBCImplements the fluid energy boundary flux portion of the porous HLLC discretization given specified pressure
- PCNSFVHLLCSpecifiedPressureMassBCImplements the mass boundary flux portion of the porous HLLC discretization given specified pressure
- PCNSFVHLLCSpecifiedPressureMomentumBCImplements the momentum boundary flux portion of the porous HLLC discretization given specified pressure
- PCNSFVImplicitMomentumPressureBCSpecifies an implicit pressure at a boundary for the momentum equations.
- PCNSFVStrongBCComputes the residual of advective term using finite volume method.
- PINSFVMomentumAdvectionOutflowBCOutflow boundary condition for advecting momentum in the porous media momentum equation. This will impose a zero normal gradient on the boundary velocity.
- PINSFVSymmetryVelocityBCImplements a symmetry boundary condition for the velocity.
- PWCNSFVMomentumFluxBCFlux boundary conditions for porous momentum advection.
- WCNSFVEnergyFluxBCFlux boundary conditions for energy advection.
- WCNSFVInletTemperatureBCDefines a Dirichlet boundary condition for finite volume method.
- WCNSFVInletVelocityBCDefines a Dirichlet boundary condition for finite volume method.
- WCNSFVMassFluxBCFlux boundary conditions for mass advection.
- WCNSFVMomentumFluxBCFlux boundary conditions for momentum advection.
- WCNSFVScalarFluxBCFlux boundary conditions for scalar quantity advection.
- WCNSFVSwitchableInletVelocityBCAdds switchable inlet-velocity boundary conditionfor weakly compressible flows.
- Porous Flow App
- FVPorousFlowAdvectiveFluxBCAdvective Darcy flux boundary condition
- Heat Transfer App
- FVFunctorConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficient given by functors.
- FVFunctorRadiativeBCBoundary condition for radiative heat exchange where the emissivity function is supplied by a Function.
- FVGaussianEnergyFluxBCDescribes an incoming heat flux beam with a Gaussian profile
- FVInfiniteCylinderRadiativeBCBoundary condition for radiative heat exchange with a cylinder where the boundary is approximated as a cylinder as well.
- FVMarshakRadiativeBCMarshak boundary condition for radiative heat flux.
- FVThermalResistanceBCThermal resistance Heat flux boundary condition for the fluid and solid energy equations
- FunctorThermalResistanceBCThermal resistance heat flux boundary condition for the fluid and solid energy equations
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
- Moose App
- AddFVInterfaceKernelActionAdd a FVInterfaceKernel object to the simulation.
- FVDiffusionInterfaceComputes the residual for diffusion operator across an interface for the finite volume method.
- FVOneVarDiffusionInterfaceComputes residual for diffusion operator across an interface for finite volume method.
- FVTwoVarContinuityConstraintForces two variables to be equal on an interface for the finite volume method.
- Navier Stokes App
- FVConvectionCorrelationInterfaceComputes the residual for a convective heat transfer across an interface for the finite volume method, using a correlation for the heat transfer coefficient.
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.
- 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.
- 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.
- PINSFVScalarFieldAdvectionAdvects an arbitrary quantity, the associated nonlinear 'variable' in porous medium.
- 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.
- WCNSFV2PInterfaceAreaSourceSinkSource and sink of interfacial area for two-phase flow mixture model.
- 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
- Heat Transfer App
- FVFunctorHeatConductionTimeDerivativeAD Time derivative term of the heat equation for quasi-constant specific heat and the density .
- FVHeatConductionTimeDerivativeAD Time derivative term of the heat equation for quasi-constant specific heat and the density .
- FVThermalRadiationSourceSinkImplements the source and the sink terms for radiation heat transfer.
FluidProperties
- Sodium App
- SodiumLiquidFluidPropertiesFluid properties of sodium vapor.
- SodiumTwoPhaseFluidPropertiesTwo-phase sodium fluid properties
- SodiumVaporFluidPropertiesFluid properties of sodium vapor.
- Air App
- AirSBTLFluidPropertiesFluid properties of air (gas phase).
- Nitrogen App
- NitrogenSBTLFluidPropertiesFluid properties of nitrogen (gas phase).
- Potassium App
- PotassiumLiquidFluidPropertiesFluid properties of potassium vapor.
- PotassiumTwoPhaseFluidPropertiesTwo-phase potassium fluid properties
- PotassiumVaporFluidPropertiesFluid properties of potassium vapor.
- Carbon Dioxide App
- CarbonDioxideHEMFluidPropertiesFluid properties of carbon dioxide for the homogeneous equilibrium model.
- CarbonDioxideLiquidFluidPropertiesFluid properties of liquid carbon dioxide (meta stable).
- CarbonDioxideTwoPhaseFluidPropertiesTwo-phase carbon dioxide fluid properties
- CarbonDioxideVaporFluidPropertiesFluid properties of steam (meta stable).
- Thermal Hydraulics App
- LinearFluidPropertiesFluid properties for a fluid with density linearly dependent on temperature and pressure
- Fluid Properties App
- AddFluidPropertiesActionAdd a UserObject object to the simulation.
- BrineFluidPropertiesFluid properties for brine
- CO2FluidPropertiesFluid properties for carbon dioxide (CO2) using the Span & Wagner EOS
- CaloricallyImperfectGasFluid properties for an ideal gas with imperfect caloric behavior.
- FlibeFluidPropertiesFluid properties for flibe
- FlinakFluidPropertiesFluid properties for flinak
- HeliumFluidPropertiesFluid properties for helium
- HydrogenFluidPropertiesFluid properties for Hydrogen (H2)
- IdealGasFluidPropertiesFluid properties for an ideal gas
- IdealGasMixtureFluidPropertiesClass for fluid properties of an ideal gas mixture
- IdealRealGasMixtureFluidPropertiesClass for fluid properties of an arbitrary vapor mixture
- LeadBismuthFluidPropertiesFluid properties for Lead Bismuth eutectic 2LiF-BeF2
- LeadFluidPropertiesFluid properties for Lead
- LeadLithiumFluidPropertiesFluid properties for Lead Lithium eutectic (83% Pb, 17% Li)
- MethaneFluidPropertiesFluid properties for methane (CH4)
- NaClFluidPropertiesFluid properties for NaCl
- NaKFluidPropertiesFluid properties for NaK
- NitrogenFluidPropertiesFluid properties for Nitrogen (N2)
- SalineMoltenSaltFluidPropertiesMolten salt fluid properties using Saline
- SimpleFluidPropertiesFluid properties for a simple fluid with a constant bulk density
- SodiumPropertiesFluid properties for sodium
- SodiumSaturationFluidPropertiesFluid properties for liquid sodium at saturation conditions
- StiffenedGasFluidPropertiesFluid properties for a stiffened gas
- StiffenedGasTwoPhaseFluidPropertiesTwo-phase stiffened gas fluid properties
- TabulatedBicubicFluidPropertiesFluid properties using bicubic interpolation on tabulated values provided
- TabulatedFluidPropertiesFluid properties using bicubic interpolation on tabulated values provided
- TemperaturePressureFunctionFluidPropertiesSingle-phase fluid properties that allows to provide thermal conductivity, density, and viscosity as functions of temperature and pressure.
- TwoPhaseFluidPropertiesIndependent2-phase fluid properties for 2 independent single-phase fluid properties
- TwoPhaseNCGPartialPressureFluidPropertiesTwo-phase fluid with single NCG using partial pressure mixture model
- Water97FluidPropertiesFluid properties for water and steam (H2O) using IAPWS-IF97
- Sub Channel App
- PBSodiumFluidPropertiesClass that provides the methods that realize the equations of state for Liquid Sodium
- Helium App
- HeliumSBTLFluidPropertiesFluid properties of nirtogen (gas phase).
FluidPropertiesInterrogator
- Fluid Properties App
- AddFluidPropertiesInterrogatorActionAction that sets up the fluid properties interrogator
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.
- 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
- 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.
- 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.
- Functional Expansion Tools App
- FunctionSeriesThis function uses a convolution of functional series (functional expansion or FX) to create a 1D, 2D, or 3D function
- 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
- TwoPhaseNCGPartialPressureFunctionComputes a property from a TwoPhaseNCGPartialPressureFluidProperties object.
- 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.
- Stochastic Tools App
- ScaledAbsDifferenceDRLRewardFunctionEvaluates a scaled absolute difference reward function for a process which is controlled by a Deep Reinforcement Learning based surrogate.
- Phase Field App
- FourierNoiseGenerate noise from a fourier series
FunctorMaterials
- Moose App
- AddFunctorMaterialActionAdd a Functor Material object to the simulation.
- ADFunctorChangeFunctorMaterialAdds a functor material property that computes the change in a functor value over a time step, fixed point iteration, or nonlinear iteration.
- ADGenericConstantFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- ADGenericConstantVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- ADGenericFunctionFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- ADGenericFunctorGradientMaterialFunctorMaterial object for declaring properties that are populated by evaluation of gradients of Functors (a constant, variable, function or functor material property) objects.
- ADGenericFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- ADGenericFunctorTimeDerivativeMaterialFunctorMaterial object for declaring properties that are populated by evaluation of time derivatives of Functors objects. (such as variables, constants, postprocessors). The time derivative is only returned if the 'dot' functor routine is implemented.
- ADGenericVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- ADParsedFunctorMaterialComputes a functor material from a parsed expression of other functors.
- ADPiecewiseByBlockFunctorMaterialComputes a property value on a per-subdomain basis
- ADPiecewiseByBlockVectorFunctorMaterialComputes a property value on a per-subdomain basis
- ADVectorMagnitudeFunctorMaterialThis class takes up to three scalar-valued functors corresponding to vector components or a single vector functor and computes the Euclidean norm.
- FVADPropValPerSubdomainMaterialComputes a property value on a per-subdomain basis
- FVPropValPerSubdomainMaterialComputes a property value on a per-subdomain basis
- FunctorADConverterConverts regular functors to AD functors and AD functors to regular functors
- FunctorChangeFunctorMaterialAdds a functor material property that computes the change in a functor value over a time step, fixed point iteration, or nonlinear iteration.
- FunctorSmootherCreates smoother functor(s) using various averaging techniques
- GenericConstantFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- GenericConstantVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- GenericFunctionFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- GenericFunctorGradientMaterialFunctorMaterial object for declaring properties that are populated by evaluation of gradients of Functors (a constant, variable, function or functor material property) objects.
- GenericFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- GenericFunctorTimeDerivativeMaterialFunctorMaterial object for declaring properties that are populated by evaluation of time derivatives of Functors objects. (such as variables, constants, postprocessors). The time derivative is only returned if the 'dot' functor routine is implemented.
- GenericVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- MFEMGenericFunctorMaterialDeclares material scalar properties based on names and coefficients prescribed by input parameters.
- MFEMGenericFunctorVectorMaterialDeclares material vector properties based on names and coefficients prescribed by input parameters.
- ParsedFunctorMaterialComputes a functor material from a parsed expression of other functors.
- PiecewiseByBlockFunctorMaterialComputes a property value on a per-subdomain basis
- PiecewiseByBlockVectorFunctorMaterialComputes a property value on a per-subdomain basis
- VectorFunctorADConverterConverts regular functors to AD functors and AD functors to regular functors
- VectorMagnitudeFunctorMaterialThis class takes up to three scalar-valued functors corresponding to vector components or a single vector functor and computes the Euclidean norm.
- Navier Stokes App
- ADDittusBoelterFunctorMaterialComputes wall heat transfer coefficient using Dittus-Boelter equation
- DittusBoelterFunctorMaterialComputes wall heat transfer coefficient using Dittus-Boelter equation
- ExponentialFrictionFunctorMaterialComputes a Reynolds number-exponential friction factor.
- ExponentialFrictionMaterialComputes a Reynolds number-exponential friction factor.
- FunctorErgunDragCoefficientsMaterial providing linear and quadratic drag coefficients based on the correlation developed by Ergun.
- FunctorKappaFluidZero-thermal dispersion conductivity
- GeneralFunctorFluidPropsCreates functor fluid properties using a (P, T) formulation
- INSFVEnthalpyFunctorMaterialThis is the material class used to compute enthalpy for the incompressible/weakly-compressible finite-volume implementation of the Navier-Stokes equations.
- INSFVEnthalpyMaterialThis is the material class used to compute enthalpy for the incompressible/weakly-compressible finite-volume implementation of the Navier-Stokes equations.
- INSFVMushyPorousFrictionFunctorMaterialComputes the mushy zone porous resistance for solidification/melting problems.
- INSFVMushyPorousFrictionMaterialComputes the mushy zone porous resistance for solidification/melting problems.
- INSFVkEpsilonViscosityFunctorMaterialComputes the turbulent dynamic viscosity given k and epsilon.
- INSFVkEpsilonViscosityMaterialComputes the turbulent dynamic viscosity given k and epsilon.
- LinearFVEnthalpyFunctorMaterialCreates functors for conversions between specific enthalpy and temperature
- LinearFrictionFactorFunctorMaterialMaterial class used to compute a friction factor of the form A * f(r, t) + B * g(r, t) * |v_I| with A, B vector constants, f(r, t) and g(r, t) functors of space and time, and |v_I| the interstitial speed
- MixingLengthTurbulentViscosityFunctorMaterialComputes the material property corresponding to the total viscositycomprising the mixing length model turbulent total_viscosityand the molecular viscosity.
- MixingLengthTurbulentViscosityMaterialComputes the material property corresponding to the total viscositycomprising the mixing length model turbulent total_viscosityand the molecular viscosity.
- NSFVDispersePhaseDragFunctorMaterialComputes drag coefficient for dispersed phase.
- NSFVFrictionFlowDiodeFunctorMaterialIncreases the anistropic friction coefficients, linear or quadratic, by K_i * |direction_i| when the diode is turned on with a boolean
- NSFVFrictionFlowDiodeMaterialIncreases the anistropic friction coefficients, linear or quadratic, by K_i * |direction_i| when the diode is turned on with a boolean
- NSFVMixtureFunctorMaterialCompute the arithmetic mean of material properties using a phase fraction.
- NSFVMixtureMaterialCompute the arithmetic mean of material properties using a phase fraction.
- NSFVPumpFunctorMaterialComputes the effective pump body force.
- NSFVPumpMaterialComputes the effective pump body force.
- NonADGeneralFunctorFluidPropsCreates functor fluid properties using a (P, T) formulation
- PINSFVSpeedFunctorMaterialThis is the material class used to compute the interstitial velocity norm for the incompressible and weakly compressible primitive superficial finite-volume implementation of porous media equations.
- ReynoldsNumberFunctorMaterialComputes a Reynolds number.
- RhoFromPTFunctorMaterialComputes the density from coupled pressure and temperature functors (variables, functions, functor material properties
- ThermalDiffusivityFunctorMaterialComputes the thermal diffusivity given the thermal conductivity, specific heat capacity, and fluid density.
- WCNSFV2PSlipVelocityFunctorMaterialComputes the slip velocity for two-phase mixture model.
- WCNSLinearFVMixtureFunctorMaterialCompute the arithmetic mean of material properties using a phase fraction.
- Thermal Hydraulics App
- ADConjugateHTNumbersFunctorMaterialComputes several non-dimensional numbers for conjugate heat transfer.
- ConjugateHTNumbersFunctorMaterialComputes several non-dimensional numbers for conjugate heat transfer.
- Heat Transfer App
- ADChurchillChuHTCFunctorMaterialComputes a heat transfer coefficient using the Churchill-Chu correlation for natural convection.
- ADConvectionHeatFluxFunctorMaterialComputes a convection heat flux from a solid surface to a fluid.
- ADCylindricalGapHeatFluxFunctorMaterialComputes cylindrical gap heat flux due to conduction and radiation.
- ADFinEfficiencyFunctorMaterialComputes fin efficiency.
- ADFinEnhancementFactorFunctorMaterialComputes a heat transfer enhancement factor for fins.
- ADRadiativeP1DiffusionCoefficientMaterialComputes the P1 diffusion coefficient from the opacity and effective scattering cross section.
- ChurchillChuHTCFunctorMaterialComputes a heat transfer coefficient using the Churchill-Chu correlation for natural convection.
- ConvectionHeatFluxFunctorMaterialComputes a convection heat flux from a solid surface to a fluid.
- CylindricalGapHeatFluxFunctorMaterialComputes cylindrical gap heat flux due to conduction and radiation.
- FinEfficiencyFunctorMaterialComputes fin efficiency.
- FinEnhancementFactorFunctorMaterialComputes a heat transfer enhancement factor for fins.
- RadiativeP1DiffusionCoefficientMaterialComputes the P1 diffusion coefficient from the opacity and effective scattering cross section.
- Solid Properties App
- ThermalSolidPropertiesFunctorMaterialComputes solid thermal properties as a function of temperature
GeochemicalModelInterrogator
- Geochemistry App
- AddGeochemicalModelInterrogatorActionAction that sets up the geochemical model interrogator
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.
HDGKernels
- Moose App
- AddHDGKernelActionAdd a hybridized kernel object to the simulation.
- AdvectionIPHDGKernelAdds element and interior face integrals for a hybridized interior penalty discontinuous Galerkin discretization of an advection term.
- DiffusionIPHDGKernelAdds the element and interior face weak forms for a hybridized interior penalty discontinuous Galerkin discretization of a diffusion term.
- DiffusionLHDGKernelAdds the element and interior face weak forms for a hybridized local discontinuous Galerkin discretization of a diffusion term.
- Navier Stokes App
- MassFluxPenaltyIPHDGintroduces a jump correction on internal faces for grad-div stabilization for discontinuous Galerkin methods. Because this is derived from HDGKernel this class executes twice per face.
- MassMatrixHDGComputes a finite element mass matrix on internal faces (element by element!) meant for use in preconditioning schemes which require one
- NavierStokesLHDGKernelImplements the steady incompressible Navier-Stokes equations for a hybridized discretization
- NavierStokesStressIPHDGKernelAdds viscous and pressure stress terms for element interiors and interior faces
HeatStructureMaterials
- Thermal Hydraulics App
- AddHeatStructureMaterialActionAdds HeatStructureMaterials to the Problem
- SolidMaterialPropertiesUser object to compute solid material properties using functions of temperature
ICs
- Moose App
- AddInitialConditionActionAdd an InitialCondition object to the simulation.
- ArrayConstantICSets constant component values for an array field variable.
- ArrayFunctionICAn initial condition that uses a normal function of x, y, z to produce values (and optionally gradients) for a field variable.
- BoundingBoxICBoundingBoxIC allows setting the initial condition of a value inside and outside of a specified box. The box is aligned with the x, y, z axes
- ConstantICSets a constant field value.
- FunctionICAn initial condition that uses a normal function of x, y, z to produce values (and optionally gradients) for a field variable.
- FunctionScalarICInitializes a scalar variable using a function.
- FunctorICAn initial condition that uses a normal function of x, y, z to produce values (and optionally gradients) for a field variable.
- IntegralPreservingFunctionICFunction initial condition that preserves an integral
- MFEMScalarBoundaryICSets the initial values of an MFEM scalar variable from a user-specified scalar coefficient.
- MFEMScalarICSets the initial values of an MFEM scalar variable from a user-specified scalar coefficient.
- MFEMVectorICSets the initial values of an MFEM vector variable from a user-specified vector coefficient.
- RandomICInitialize a variable with randomly generated numbers following either a uniform distribution or a user-defined distribution
- ScalarComponentICInitial condition to set different values on each component of scalar variable.
- ScalarConstantICInitalize a scalar variable with a constant value prescribed by an input parameter.
- ScalarSolutionICSets the initial condition from a scalar variable stored in an Exodus file, retrieved by a SolutionUserObject
- ScalarSolutionInitialConditionSets the initial condition from a scalar variable stored in an Exodus file, retrieved by a SolutionUserObject
- SolutionICSets the initial condition from a field variable stored in an Exodus file, retrieved by a SolutionUserObject
- SolutionInitialConditionSets the initial condition from a field variable stored in an Exodus file, retrieved by a SolutionUserObject
- VectorConstantICSets constant component values for a vector field variable.
- VectorFunctionICSets component values for a vector field variable based on a vector function.
- Navier Stokes App
- NSFunctionInitialConditionSets intial values for all variables.
- NSInitialConditionNSInitialCondition sets intial constant values for all variables.
- PNSInitialConditionPNSInitialCondition sets intial constant values for any porous flow variable.
- Solid Mechanics App
- VolumeWeightedWeibullInitialize a variable with randomly generated numbers following a volume-weighted Weibull distribution
- Porous Flow App
- PorousFlowFluidPropertyICAn initial condition to calculate one fluid property (such as enthalpy) from pressure and temperature
- PorousFlowFluidStateICAn initial condition to calculate z from saturation
- Fluid Properties App
- RhoFromPressureTemperatureICComputes the density from pressure and temperature.
- RhoVaporMixtureFromPressureTemperatureICComputes the density of a vapor mixture from pressure and temperature.
- SpecificEnthalpyFromPressureTemperatureICComputes the specific enthalpy from pressure and temperature.
- Thermal Hydraulics App
- FlowModelGasMixICIC for the solution variables of FlowModelGasMix.
- FunctionNodalAverageICInitial conditions for an elemental variable from a function using nodal average.
- RhoEAFromPressureTemperatureFunctionVelocityICSet the initial condition for rho*E*A from pressure and temperature variables and a velocity scalar function
- RhoEAFromPressureTemperatureVelocityICSet the initial condition for rho*E*A from pressure, temperature and a scalarfield velocity variable
- SpecificInternalEnergyICSets the initial condition for the specific internal energy of a phase
- SpecificTotalEnthalpyICSets the initial condition for the special total enthalpy of a phase
- SpecificVolumeICSets an initial condition for the specific volume of a phase
- SumICSets the initial condition as the sum of other variables
- VariableFunctionProductICSets the initial condition as the product of a variable and a function
- VariableProductICSets the initial condition as the product of several variables
- VectorVelocityICComputes velocity in the direction of a 1-D element from a vector velocity function
- VolumeJunction1PhaseICIC for junction variables in VolumeJunction1Phase.
- Sub Channel App
- FCTFdisplacementICThis class calculates the displacement of the duct for the areva FCTF
- MarvelTriFlowAreaICComputes flow area of subchannels in a triangular lattice arrangement in a MARVEL-type micro-reactor
- MarvelTriWettedPerimICComputes wetted perimeter of subchannels in a triangular lattice arrangement in a MARVEL-type micro-reactor
- MassFlowRateICComputes mass float rate from specified mass flux and cross-sectional area
- QuadFlowAreaICComputes subchannel flow area in the square lattice subchannel arrangement
- QuadPowerICComputes axial heat rate (W/m) that goes into the subchannel cells or is assigned to the fuel pins, in a square lattice arrangement
- QuadWettedPerimICComputes wetted perimeter of subchannels in a square lattice arrangement
- SCMMassFlowRateICComputes mass float rate from specified mass flux and cross-sectional area
- SCMQuadFlowAreaICComputes subchannel flow area in the square lattice subchannel arrangement
- SCMQuadPowerICComputes axial heat rate (W/m) that goes into the subchannel cells or is assigned to the fuel pins, in a square lattice arrangement
- SCMQuadWettedPerimICComputes wetted perimeter of subchannels in a square lattice arrangement
- SCMTriFlowAreaICComputes flow area of subchannels in a triangular lattice arrangement
- SCMTriPowerICComputes axial power rate (W/m) that goes into the subchannel cells or is assigned to the fuel pins, in a triangular lattice arrangement
- SCMTriWettedPerimICComputes wetted perimeter of subchannels in a triangular lattice arrangement
- TriFlowAreaICComputes flow area of subchannels in a triangular lattice arrangement
- TriPowerICComputes axial power rate (W/m) that goes into the subchannel cells or is assigned to the fuel pins, in a triangular lattice arrangement
- TriWettedPerimICComputes wetted perimeter of subchannels in a triangular lattice arrangement
- ViscosityICComputes viscosity from specified pressure and temperature
- Phase Field App
- BimodalInverseSuperellipsoidsICBimodal size distribution of large particles (specified in input file, value invalue) and small particles (placed randomly inside the larger particles, value outvalue)
- BimodalSuperellipsoidsICBimodal size distribution of large particles (specified in input file) and small particles (placed randomly outside the larger particles)
- BndsCalcICInitialize the location of grain boundaries in a polycrystalline sample
- ClosePackICClose packed arrangement of smooth circles
- CoupledValueFunctionICInitialize the variable from a lookup function
- CrossICCross-shaped initial condition
- IsolatedBoundingBoxICSpecify variable values inside and outside a list of isolated boxes shaped axis-aligned regions defined by pairs of opposing corners
- LatticeSmoothCircleICPerturbed square lattice of smooth circles
- MultiBoundingBoxICAllows setting the initial condition of a value of a field inside and outside multiple bounding boxes.
- MultiSmoothCircleICRandom distribution of smooth circles with given minimum spacing
- MultiSmoothSuperellipsoidICRandom distribution of smooth ellipse with given minimum spacing
- NestedBoundingBoxICSpecify variable values inside a list of nested boxes shaped axis-aligned regions defined by pairs of opposing corners
- PFCFreezingICBase class for generating a random field for a variable.
- PolycrystalColoringICRandom Voronoi tesselation polycrystal (used by PolycrystalVoronoiICAction)
- PolycrystalColoringICLinearizedInterfaceSets up polycrystal initial conditions from user objects for transformed linearized interface
- PolycrystalRandomICRandom initial condition for a polycrystalline material
- PolycrystalVoronoiVoidICRandom distribution of smooth circles with given minimum spacing
- RampICLinear ramp along the x-axis with given values at the left and right extreme points.
- ReconPhaseVarICSets the initial condition of the phase weights from the EBSD reader
- RndBoundingBoxICRandom noise with different min/max inside/outside of a bounding box
- RndSmoothCircleICRandom noise with different min/max inside/outside of a smooth circle
- SmoothCircleFromFileICMultiple smooth circles read from a text file
- SmoothCircleICCircle with a smooth interface
- SmoothCircleICLinearizedInterfaceCircle with a smooth interface transformed using the linearized interface function
- SmoothSuperellipsoidICSuperellipsoid with a smooth interface
- SpecifiedSmoothCircleICMultiple smooth circles with manually specified radii and center points
- SpecifiedSmoothSuperellipsoidICMultiple smooth superellipsoids with manually specified center points; semiaxes a,b,c; and exponents n
- ThumbICThumb shaped bicrystal for grain boundary mobility tests
- Tricrystal2CircleGrainsICTricrystal with two circles/bubbles
- TricrystalTripleJunctionICTricrystal with a triple junction
- PolycrystalICs
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
- Phase Field App
- BicrystalCircleGrainICActionBicrystal with a circular grain and an embedding outer grain
ICs/PolycrystalICs/PolycrystalColoringIC
- Phase Field App
- PolycrystalColoringICActionAction to create ICs for polycrystal variables from a UserObject
ICs/PolycrystalICs/PolycrystalRandomIC
- Phase Field App
- PolycrystalRandomICActionSets random polycrystal initial conditions for each order parameter
ICs/PolycrystalICs/PolycrystalVoronoiVoidIC
- Phase Field App
- PolycrystalVoronoiVoidICActionSets polycrystal Voronoi void initial conditions for each order parameter
ICs/PolycrystalICs/Tricrystal2CircleGrainsIC
- Phase Field App
- Tricrystal2CircleGrainsICActionSets initial conditions for the order parameters representing the tri-crystal grain structure
InterfaceKernels
- Moose App
- AddInterfaceKernelActionAdd an InterfaceKernel object to the simulation.
- ADMatInterfaceReactionImplements a reaction to establish ReactionRate=k_f*u-k_b*v at interface.
- 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.
- 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
- Fsi App
- ADPenaltyVelocityContinuityEnforces continuity of flux and continuity of solution via penalty across an interface.
- ADPenaltyVelocityContinuityNewmarkBetaEnforces continuity of flux and continuity of solution via penalty across an interface with the solid velocity computed via the Newmark-Beta method.
- 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.
- CZMInterfaceKernelTotalLagrangianCalculate residual contribution for balancing the traction across an interface (used in the cohesive zone method).
- 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.
- 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
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: . Velocity can be given as 1) a variable, for which the gradient is automatically taken, 2) a vector variable, or a 3) vector material.
- 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 Diffusionin terms of physics/residual, but the Jacobian is computed using forward automatic differentiation
- ADFluxDivergenceComputes divergence of a flux vector provided by a material.
- ADMatBodyForceKernel that defines a body force modified by a material property
- 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.
- ADScaledCoupledTimeDerivativeExtension of the ADCoupledTimeDerivative kernel that calculates the time derivative of a coupled variable scaled by a material property.
- 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 and the 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: . Velocity can be given as 1) a variable, for which the gradient is automatically taken, 2) a vector variable, or a 3) vector material.
- 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 .
- DivFieldThe divergence operator optionally scaled by a constant scalar coefficient. Weak form: .
- FunctionDiffusionDiffusion with a function coefficient.
- FunctorKernelAdds a term from a functor.
- GradFieldThe gradient operator optionally scaled by a constant scalar coefficient. Weak form: .
- MFEMCurlCurlKernelAdds the domain integrator to an MFEM problem for the bilinear form arising from the weak form of the curl curl operator .
- MFEMDiffusionKernelAdds the domain integrator to an MFEM problem for the bilinear form arising from the weak form of the Laplacian operator .
- MFEMDivDivKernelAdds the domain integrator to an MFEM problem for the bilinear form arising from the weak form of the grad-div operator .
- MFEMDomainLFKernelAdds the domain integrator to an MFEM problem for the linear form arising from the weak form of the forcing term .
- MFEMLinearElasticityKernelThe isotropic linear elasticity operator with weak form , to be added to an MFEM problem, where is the isotropic elasticity tensor, , is the first Lame parameter, , is the second Lame parameter, , where is Young's modulus and is Poisson's ratio.
- MFEMMassKernelAdds the domain integrator to an MFEM problem for the bilinear form arising from the weak form of the mass operator .
- MFEMMixedGradGradKernelAdds the domain integrator to an MFEM problem for the mixed bilinear form .
- MFEMMixedScalarCurlKernelAdds the domain integrator to an MFEM problem for the bilinear form arising from the weak form of the scalar curl operator . The vector must be 2D.
- MFEMMixedVectorGradientKernelAdds the domain integrator to an MFEM problem for the mixed bilinear form arising from the weak form of the gradient operator .
- MFEMMixedVectorMassKernelAdds the domain integrator to an MFEM problem for the mixed bilinear form .
- MFEMTimeDerivativeMassKernelAdds the domain integrator to an MFEM problem for the bilinear form arising from the weak form of the operator .
- MFEMTimeDerivativeVectorFEMassKernelAdds the domain integrator to an MFEM problem for the bilinear form arising from the weak form of the operator .
- MFEMVectorDomainLFKernelAdds the domain integrator to an MFEM problem for the linear form arising from the weak form of the forcing term .
- MFEMVectorFEDivergenceKernelAdds the domain integrator to an MFEM problem for the mixed bilinear form arising from the weak form of the divergence operator .
- MFEMVectorFEDomainLFKernelAdds the domain integrator to an MFEM problem for the linear form arising from the weak form of the forcing term .
- MFEMVectorFEMassKernelAdds the domain integrator to an MFEM problem for the bilinear form arising from the weak form of the mass operator .
- MFEMVectorFEWeakDivergenceKernelAdds the domain integrator to an MFEM problem for the mixed bilinear form arising from the weak form of the divergence operator .
- 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
- MatBodyForceKernel that defines a body force modified by a material property
- 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 .
- 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.
- 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
- XFEMApp
- CrackTipEnrichmentStressDivergenceTensorsEnrich stress divergence kernel for small-strain simulations
- Misc App
- ADThermoDiffusionCalculates diffusion due to temperature gradient and Soret Coefficient
- CoefDiffusionKernel for diffusion with diffusivity = coef + function
- ThermoDiffusionKernel for thermo-diffusion (Soret effect, thermophoresis, etc.)
- 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
- 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
- Heat Transfer App
- ADHeatConductionSame as Diffusionin 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 or electromagnetic Joule heating, with Jacobian contributions calculated using the automatic differentiation system.
- ADMatHeatSourceForce term in thermal transport to represent a heat source
- AnisoHeatConductionAnisotropic diffusive heat conduction term of the thermal energy conservation equation
- 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.
- HeatConductionDiffusive heat conduction term of the thermal energy conservation equation
- HeatConductionTimeDerivativeTime derivative term of the thermal energy conservation equation.
- 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
- Electromagnetics App
- ADConductionCurrentCalculates the current source term in the Helmholtz wave equation using the conduction formulation of the current.
- ADCurlCurlFieldWeak form term corresponding to .
- ADMatWaveReactionCalculates the current source term in the Helmholtz wave equation using the dielectric formulation of the current.
- CurlCurlFieldWeak form term corresponding to .
- EMJouleHeatingSourceSupplies the heating due to the electic field in the form of
- VectorCurrentSourceKernel to calculate the current source term in the Helmholtz wave equation.
- VectorSecondTimeDerivativeThe second time derivative operator for vector variables.
- 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
- 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
- ADOneD3EqnEnergyHeatSourceComputes a volumetric heat source for 1-phase flow channel
- 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
- ADVolumeJunctionAdvectionKernelAdds advective fluxes for the junction variables for a volume junction
- CoupledForceRZAdds a coupled force term in XY coordinates interpreted as cylindrical coordinates
- OneDEnergyWallHeatFluxAdds a heat flux along the local heated perimeter
- OneDEnergyWallHeatingAdds a convective heat flux term from a wall temperature
- 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
- ADLaplacianSplitSplit with a variable that holds the Laplacian of a phase field variable.
- ADMatAnisoDiffusionDiffusion equation kernel that takes an anisotropic diffusivity from a material property
- ADPhaseFieldAdvectionImplements the phasefield advection equation: , where the weak form is .
- ADPhaseFieldAdvectionSUPGSUPG stablization term for the advection portion of the level set equation.
- ADPhaseFieldCoupledDoubleWellPotentialDouble well potential for Cahn-Hilliard advection.
- ADPhaseFieldForcingFunctionSUPGThe SUPG stablization term for a forcing function.
- ADPhaseFieldTimeDerivativeSUPGSUPG stablization terms for the time derivative of the level set equation.
- ADPhaseFieldTwoPhaseSurfaceTensionPhase field surface tension force for the Navier-Stokes equations.
- ADPrefactorLaplacianSplitLaplacian split with a prefactor.
- 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
- DoubleWellPotentialSimple demonstration Allen-Cahn Kernel using an algebraic double-well potential
- 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.
- MaskedBodyForceCustomization of MatBodForce which uses a material property, scalar, and/or postprocessor to provide a source term PDE contribution.
- 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.
- NestedKKSMultiACBulkCMulti-phase KKS model kernel (part 2 of 2) for the Bulk Allen-Cahn. This includes all terms dependent on chemical potential.
- NestedKKSMultiACBulkFKKS model kernel (part 1 of 2) for the Bulk Allen-Cahn. This includes all terms NOT dependent on chemical potential.
- NestedKKSMultiSplitCHCResKKS model kernel for the split Bulk Cahn-Hilliard term. This kernel operates on the physical concentration 'c' as the non-linear variable.
- NestedKKSSplitCHCResKKS model kernel for the split Bulk Cahn-Hilliard term. This kernel operates on the physical concentration 'c' as the non-linear variable.
- PolycrystalMatAnisoDiffusionDiffusion equation Kernel that takes an anisotropic Diffusivity from a material property
- PolycrystalMatDiffusionDiffusion equation Kernel that takes an isotropic Diffusivity from a material property
- 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
- 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.
- Solid Mechanics App
- ADDistributedLoadShellApplies a distributed load (specified in units of force per area) on the shell plane in a given direction (e.g. self_weight, wind load) or normal to the shell plan (e.g. pressure loads)
- 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 tensor with the additional Jacobian terms for the Cosserat rotation variables.
- 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.
- MomentBalancingBalance of momentum for three-dimensional Cosserat media, notably in a Cosserat layered elasticity model.
- 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
- 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.
- GradDivAdds grad-div stabilization for scalar field velocity component Navier-Stokes implementations.
- 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
- INSADMomentumGradDivAdds grad-div stabilization to the INS momentum equation
- 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
- PINSFEFluidTemperatureTimeDerivativeAdds the transient term of the porous media energy conservation equation
- PINSFEFluidVelocityTimeDerivativeAdd the transient term for one component of the porous media momentum conservation equation
- PMFluidPressureTimeDerivativeAdds the transient term of the porous-media mass conservation equation
- PMFluidTemperatureTimeDerivativeAdds the transient term of the porous media energy conservation equation
- PMFluidVelocityTimeDerivativeAdd the transient term for one component of the porous media momentum conservation equation
- 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
Kernels/CHPFCRFFSplitKernel
- Phase Field App
- CHPFCRFFSplitKernelActionCreates the kernels for the transient Cahn-Hilliard equation for the RFF form of the phase field crystal model
Kernels/DynamicSolidMechanics
- Solid Mechanics App
- LegacyDynamicTensorMechanicsActionSet up dynamic stress divergence kernels
Kernels/DynamicTensorMechanics
- Solid Mechanics App
- LegacyDynamicTensorMechanicsActionSet up dynamic stress divergence kernels
Kernels/HHPFCRFFSplitKernel
- Phase Field App
- HHPFCRFFSplitKernelActionSet up kernels for the rational function fit (RFF) phase field crystal model
Kernels/PFCRFFKernel
- Phase Field App
- PFCRFFKernelActionSet up kernels for the rational function fit (RFF) phase field crystal model
Kernels/PolycrystalElasticDrivingForce
- Phase Field App
- PolycrystalElasticDrivingForceActionAction that adds the elastic driving force for each order parameter
Kernels/PolycrystalKernel
- Phase Field App
- PolycrystalKernelActionSet up ACGrGrPoly, ACInterface, TimeDerivative, and ACGBPoly kernels
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
- PoroMechanicsActionAdds the poro-mechanics coupling term
Kernels/RigidBodyMultiKernel
- Phase Field App
- RigidBodyMultiKernelActionAction for applying Allen-Cahn equations and SingleGrainRigidBodyMotion to grains
Kernels/SolidMechanics
- Solid Mechanics App
- LegacyTensorMechanicsActionSet up stress divergence kernels with coordinate system aware logic
Kernels/TensorMechanics
- Solid Mechanics App
- LegacyTensorMechanicsActionSet up stress divergence kernels with coordinate system aware logic
KokkosAuxKernels
- Moose App
- AddKokkosKernelActionAdd a Kokkos Kernel object to the simulation.
- KokkosConstantAuxCreates a constant field in the domain.
- KokkosCopyValueAuxReturns the specified variable as an auxiliary variable with a simple copy of the variable values.
- KokkosMaterialRealAuxOutputs element volume-averaged material properties
- KokkosTagVectorAuxExtract DOF values from a tagged vector into an AuxVariable
- KokkosVariableTimeIntegrationAuxIntegrates a field variable in time.
KokkosBCs
- Moose App
- AddKokkosBCActionAdd a Kokkos BoundaryCondition object to the simulation.
- KokkosCoupledVarNeumannBCImposes the integrated boundary condition , where is a variable.
- KokkosDirichletBCImposes the essential boundary condition , where is a constant, controllable value.
- KokkosMatchedValueBCImplements a NodalBC which equates two different Variables' values on a specified boundary.
- KokkosNeumannBCImposes the integrated boundary condition , where is a constant, controllable value.
- KokkosPostprocessorNeumannBCNeumann boundary condition with value prescribed by a Postprocessor value.
- KokkosVacuumBCVacuum boundary condition for diffusion.
- Thermal Hydraulics App
- KokkosRadiativeHeatFluxBCRadiative heat transfer boundary condition for a plate heat structure
- Heat Transfer App
- KokkosConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficent given by material properties.
- KokkosCoupledConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficent given by auxiliary variables.
KokkosKernels
- Moose App
- AddKokkosKernelActionAdd a Kokkos Kernel object to the simulation.
- KokkosBodyForceDemonstrates the two ways that scalar values can be introduced into kernels, e.g. (controllable) constants and postprocessors. Implements the weak form .
- KokkosCoupledForceImplements a source term proportional to the value of a coupled variable. Weak form: .
- KokkosCoupledTimeDerivativeTime derivative Kernel that acts on a coupled variable. Weak form: .
- KokkosDiffusionThe Laplacian operator (), with the weak form of .
- KokkosMatCoupledForceImplements 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.
- KokkosReactionImplements a simple consuming reaction term with weak form .
- KokkosTimeDerivativeThe time derivative operator with the weak form of .
- Heat Transfer App
- KokkosHeatConductionDiffusive heat conduction term of the thermal energy conservation equation
KokkosMaterials
- Moose App
- AddKokkosMaterialActionAdd a Kokkos Material object to the simulation.
- KokkosGenericConstantMaterialDeclares material properties based on names and values prescribed by input parameters.
- Heat Transfer App
- KokkosHeatConductionMaterialGeneral-purpose material model for heat conduction
KokkosNodalKernels
- Moose App
- AddKokkosNodalKernelActionAdd a Kokkos NodalKernel object to the simulation.
- KokkosConstantRateComputes residual or the rate in a simple ODE of du/dt = rate.
- KokkosCoupledForceNodalKernelAdds a force proportional to the value of the coupled variable
- KokkosLowerBoundNodalKernelUsed to prevent a coupled variable from going below a lower bound
- KokkosReactionNodalKernelImplements a simple consuming reaction term at nodes
- KokkosTimeDerivativeNodalKernelForms the contribution to the residual and jacobian of the time derivative term from an ODE being solved at all nodes.
- KokkosUpperBoundNodalKernelUsed to prevent a coupled variable from going above a upper bound
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.
LinearFVBCs
- Moose App
- AddLinearFVBCActionAdd a LinearFVBoundaryCondition object to the simulation.
- LinearFVAdvectionDiffusionExtrapolatedBCAdds a boundary condition which calculates the face values and face gradients assuming one or two term expansions from the cell centroid. This kernel is only compatible with advection-diffusion problems.
- LinearFVAdvectionDiffusionFunctorDirichletBCAdds a dirichlet BC which can be used for the assembly of linear finite volume system and whose face values are determined using a functor. This kernel is only designed to work with advection-diffusion problems.
- LinearFVAdvectionDiffusionFunctorNeumannBCAdds a fixed diffusive flux BC which can be used for the assembly of linear finite volume system and whose normal face gradient values are determined using a functor. This kernel is only designed to work with advection-diffusion problems.
- LinearFVAdvectionDiffusionFunctorRobinBCAdds a Robin BC of the form \alpha * \nabla \phi*n + \beta * \phi = \gamma, which can be used for the assembly of linear finite volume system and whose face values are determined using three functors. This kernel is only designed to work with advection-diffusion problems.
- LinearFVAdvectionDiffusionOutflowBCAdds a boundary condition which represents a surface with outflowing material with a constant velocity. This kernel is only compatible with advection-diffusion problems.
- Navier Stokes App
- LinearFVConvectiveHeatTransferBCClass describing a convective heat transfer between two domains.
- LinearFVDirichletCHTBCConjugate heat transfer BC for Dirichlet boundary condition-based coupling.
- LinearFVExtrapolatedPressureBCAdds a boundary condition which can be used to extrapolate pressure values to the boundary using either a two-term or a one-term expansion.
- LinearFVPressureFluxBCAdds a fixed diffusive flux BC which can be used for the assembly of linear finite volume system and whose normal face gradient values are determined using the H/A flux. This kernel is only designed to work with advection-diffusion problems.
- LinearFVRobinCHTBCConjugate heat transfer BC for Robin boundary condition-based coupling.
- LinearFVTurbulentViscosityWallFunctionBCAdds Dirichlet BC for wall values of the turbulent viscosity.
LinearFVKernels
- Moose App
- AddLinearFVKernelActionAdd a LinearFVKernel object to the simulation.
- LinearFVAdvectionRepresents the matrix and right hand side contributions of an advection term in a partial differential equation.
- LinearFVAnisotropicDiffusionRepresents the matrix and right hand side contributions of a diffusion term in a partial differential equation.
- LinearFVDiffusionRepresents the matrix and right hand side contributions of a diffusion term in a partial differential equation.
- LinearFVReactionRepresents the matrix and right hand side contributions of a reaction term () in a partial differential equation.
- LinearFVSourceRepresents the matrix and right hand side contributions of a solution-independent source term in a partial differential equation.
- LinearFVTimeDerivativeRepresents the matrix and right hand side contributions of a time derivative term in a partial differential equation.
- Navier Stokes App
- LinearFVDivergenceRepresents a divergence term. Note, this term does not contribute to the system matrix, only takes the divergence of a face flux field and adds it to the right hand side of the linear system.
- LinearFVEnergyAdvectionRepresents the matrix and right hand side contributions of an advection term for the energy e.g. h=int(cp dT). A user may still override what quantity is advected, but the default is temperature.
- LinearFVMomentumBoussinesqRepresents the Boussinesq term in the Navier Stokes momentum equations, added to the right hand side.
- LinearFVMomentumBuoyancyRepresents the buoyancy term in the Navier Stokes momentum equations, added to the right hand side.
- LinearFVMomentumFrictionComputes a Darcy friction force term on fluid in the Navier Stokes i-th momentum equation.
- LinearFVMomentumPressureRepresents the pressure gradient term in the Navier Stokes momentum equations, added to the right hand side.
- LinearFVScalarAdvectionRepresents the matrix and right hand side contributions of an advection term for a passive scalar.
- LinearFVTKEDSourceSinkElemental kernel to compute the production and destruction terms of turbulent kinetic energy dissipation (TKED).
- LinearFVTKESourceSinkElemental kernel to compute the production and destruction terms of turbulent kinetic energy (TKE).
- LinearFVTurbulentAdvectionRepresents the matrix and right hand side contributions of an advection term for a turbulence variable.
- LinearFVTurbulentDiffusionRepresents the matrix and right hand side contributions of a diffusion term for a turbulent variable in a partial differential equation.
- LinearFVVolumetricHeatTransferRepresents a heat transfer term between the fluid and a homogenized structure.
- LinearWCNSFV2PMomentumDriftFluxImplements the drift momentum flux source.
- LinearWCNSFVMomentumFluxRepresents the matrix and right hand side contributions of the stress and advection terms of the momentum equation.
Materials
- Moose App
- AddMaterialActionAdd a Material object to the simulation.
- ADCoupledGradientMaterialCreates a gradient material equal to the gradient of the coupled variable times a scalar material property.
- ADCoupledValueFunctionMaterialCompute a function value from coupled variables
- ADDerivativeParsedMaterialParsed Function Material with automatic derivatives.
- ADDerivativeSumMaterialMeta-material to sum up multiple derivative materials
- ADFluxFromGradientMaterialComputes a flux vector material property based on the gradient of a coupled variable and a scalar diffusivity.
- ADFunctorChangeFunctorMaterialAdds a functor material property that computes the change in a functor value over a time step, fixed point iteration, or nonlinear iteration.
- ADGenericConstantFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- ADGenericConstantMaterialDeclares material properties based on names and values prescribed by input parameters.
- ADGenericConstantRankTwoTensorObject for declaring a constant rank two tensor as a material property.
- ADGenericConstantRealVectorValueObject for declaring a constant 3-vector as a material property.
- ADGenericConstantStdVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
- ADGenericConstantSymmetricRankTwoTensorObject for declaring a constant symmetric rank two tensor as a material property.
- ADGenericConstantVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- ADGenericConstantVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
- ADGenericFunctionFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- ADGenericFunctionMaterialMaterial object for declaring properties that are populated by evaluation of Function object.
- ADGenericFunctionRankTwoTensorMaterial object for defining rank two tensor properties using functions.
- ADGenericFunctionVectorMaterialMaterial object for declaring vector properties that are populated by evaluation of Function objects.
- ADGenericFunctorGradientMaterialFunctorMaterial object for declaring properties that are populated by evaluation of gradients of Functors (a constant, variable, function or functor material property) objects.
- ADGenericFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- ADGenericFunctorTimeDerivativeMaterialFunctorMaterial object for declaring properties that are populated by evaluation of time derivatives of Functors objects. (such as variables, constants, postprocessors). The time derivative is only returned if the 'dot' functor routine is implemented.
- ADGenericVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- ADParsedFunctorMaterialComputes a functor material from a parsed expression of other functors.
- ADParsedMaterialParsed expression Material.
- ADPiecewiseByBlockFunctorMaterialComputes a property value on a per-subdomain basis
- ADPiecewiseByBlockVectorFunctorMaterialComputes a property value on a per-subdomain basis
- ADPiecewiseConstantByBlockMaterialComputes a property value on a per-subdomain basis
- ADPiecewiseLinearInterpolationMaterialCompute a property using a piecewise linear interpolation to define its dependence on a variable
- ADVectorFromComponentVariablesMaterialComputes a vector material property from coupled variables
- ADVectorMagnitudeFunctorMaterialThis class takes up to three scalar-valued functors corresponding to vector components or a single vector functor and computes the Euclidean norm.
- CoupledGradientMaterialCreates a gradient material equal to the gradient of the coupled variable times a scalar material property.
- CoupledValueFunctionMaterialCompute a function value from coupled variables
- DerivativeParsedMaterialParsed Function Material with automatic derivatives.
- DerivativeSumMaterialMeta-material to sum up multiple derivative materials
- FVADPropValPerSubdomainMaterialComputes a property value on a per-subdomain basis
- FVPropValPerSubdomainMaterialComputes a property value on a per-subdomain basis
- FunctorADConverterConverts regular functors to AD functors and AD functors to regular functors
- FunctorChangeFunctorMaterialAdds a functor material property that computes the change in a functor value over a time step, fixed point iteration, or nonlinear iteration.
- FunctorSmootherCreates smoother functor(s) using various averaging techniques
- GenericConstant2DArrayA material evaluating one material property in type of RealEigenMatrix
- GenericConstantArrayA material evaluating one material property in type of RealEigenVector
- GenericConstantFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- GenericConstantMaterialDeclares material properties based on names and values prescribed by input parameters.
- GenericConstantRankTwoTensorObject for declaring a constant rank two tensor as a material property.
- GenericConstantRealVectorValueObject for declaring a constant 3-vector as a material property.
- GenericConstantStdVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
- GenericConstantSymmetricRankTwoTensorObject for declaring a constant symmetric rank two tensor as a material property.
- GenericConstantVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- GenericConstantVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
- GenericFunctionFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- GenericFunctionMaterialMaterial object for declaring properties that are populated by evaluation of Function object.
- GenericFunctionRankTwoTensorMaterial object for defining rank two tensor properties using functions.
- GenericFunctionVectorMaterialMaterial object for declaring vector properties that are populated by evaluation of Function objects.
- GenericFunctorGradientMaterialFunctorMaterial object for declaring properties that are populated by evaluation of gradients of Functors (a constant, variable, function or functor material property) objects.
- GenericFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- GenericFunctorTimeDerivativeMaterialFunctorMaterial object for declaring properties that are populated by evaluation of time derivatives of Functors objects. (such as variables, constants, postprocessors). The time derivative is only returned if the 'dot' functor routine is implemented.
- GenericVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- InterpolatedStatefulMaterialRankFourTensorAccess old state from projected data.
- InterpolatedStatefulMaterialRankTwoTensorAccess old state from projected data.
- InterpolatedStatefulMaterialRealAccess old state from projected data.
- InterpolatedStatefulMaterialRealVectorValueAccess old state from projected data.
- MFEMGenericFunctorMaterialDeclares material scalar properties based on names and coefficients prescribed by input parameters.
- MFEMGenericFunctorVectorMaterialDeclares material vector properties based on names and coefficients prescribed by input parameters.
- MaterialADConverterConverts regular material properties to AD properties and vice versa
- MaterialConverterConverts regular material properties to AD properties and vice versa
- MaterialFunctorConverterConverts functor to non-AD and AD regular material properties
- NEML2ToMOOSERankFourTensorMaterialPropertyProvide an output (or its derivative) from a NEML2 model as a MOOSE material property of type RankFourTensorTempl<double>.
- NEML2ToMOOSERankTwoTensorMaterialPropertyProvide an output (or its derivative) from a NEML2 model as a MOOSE material property of type RankTwoTensorTempl<double>.
- NEML2ToMOOSERealMaterialPropertyProvide an output (or its derivative) from a NEML2 model as a MOOSE material property of type double.
- NEML2ToMOOSERealVectorValueMaterialPropertyProvide an output (or its derivative) from a NEML2 model as a MOOSE material property of type libMesh::VectorValue<double>.
- NEML2ToMOOSESymmetricRankFourTensorMaterialPropertyProvide an output (or its derivative) from a NEML2 model as a MOOSE material property of type SymmetricRankFourTensorTempl<double>.
- NEML2ToMOOSESymmetricRankTwoTensorMaterialPropertyProvide an output (or its derivative) from a NEML2 model as a MOOSE material property of type SymmetricRankTwoTensorTempl<double>.
- ParsedFunctorMaterialComputes a functor material from a parsed expression of other functors.
- ParsedMaterialParsed expression Material.
- PiecewiseByBlockFunctorMaterialComputes a property value on a per-subdomain basis
- PiecewiseByBlockVectorFunctorMaterialComputes a property value on a per-subdomain basis
- PiecewiseConstantByBlockMaterialComputes a property value on a per-subdomain basis
- PiecewiseLinearInterpolationMaterialCompute a property using a piecewise linear interpolation to define its dependence on a variable
- RankFourTensorMaterialADConverterConverts regular material properties to AD properties and vice versa
- RankFourTensorMaterialConverterConverts regular material properties to AD properties and vice versa
- RankTwoTensorMaterialADConverterConverts regular material properties to AD properties and vice versa
- RankTwoTensorMaterialConverterConverts regular material properties to AD properties and vice versa
- TorchScriptMaterialMaterial object which relies on the evaluation of a TorchScript module.
- VectorFromComponentVariablesMaterialComputes a vector material property from coupled variables
- VectorFunctorADConverterConverts regular functors to AD functors and AD functors to regular functors
- VectorMagnitudeFunctorMaterialThis class takes up to three scalar-valued functors corresponding to vector components or a single vector functor and computes the Euclidean norm.
- VectorMaterialFunctorConverterConverts functor to non-AD and AD regular material properties
- Peridynamics App
- ComputeFiniteStrainNOSPDClass for computing nodal quantities for residual and jacobian calculation for peridynamic correspondence models under finite strain assumptions
- ComputePlaneFiniteStrainNOSPDClass for computing nodal quantities for residual and jacobian calculation for peridynamic correspondence models under planar finite strain assumptions
- ComputePlaneSmallStrainNOSPDClass for computing nodal quantities for residual and jacobian calculation for peridynamic correspondence models under planar small strain assumptions
- ComputeSmallStrainConstantHorizonMaterialBPDClass for computing peridynamic micro elastic modulus for bond-based model using regular uniform mesh
- ComputeSmallStrainConstantHorizonMaterialOSPDClass for computing peridynamic micro elastic moduli for ordinary state-based model using regular uniform mesh
- ComputeSmallStrainNOSPDClass for computing nodal quantities for the residual and Jacobian calculation for the peridynamic correspondence models under small strain assumptions
- ComputeSmallStrainVariableHorizonMaterialBPDClass for computing peridynamic micro elastic modulus for bond-based model using irregular mesh
- ComputeSmallStrainVariableHorizonMaterialOSPDClass for computing peridynamic micro elastic moduli for ordinary state-based model using irregular mesh
- ThermalConstantHorizonMaterialBPDClass for computing peridynamic micro conductivity for bond-based model using regular uniform mesh
- ThermalVariableHorizonMaterialBPDClass for computing peridynamic micro conductivity for bond-based model using irregular mesh
- Porous Flow App
- PorousFlowAddMaterialActionMakes sure that the correct nodal and/or qp materials are added for each property
- PorousFlowAddMaterialJoinerAdds PorousFlowJoiner materials as required for each phase-dependent property
- ADPorousFlow1PhaseFullySaturatedThis Material is used for the fully saturated single-phase situation where porepressure is the primary variable
- ADPorousFlow1PhasePThis Material is used for the partially saturated single-phase situation where porepressure is the primary variable
- ADPorousFlow2PhasePPThis Material calculates the 2 porepressures and the 2 saturations in a 2-phase situation, and derivatives of these with respect to the PorousFlowVariables
- ADPorousFlow2PhasePSThis Material calculates the 2 porepressures and the 2 saturations in a 2-phase situation, and derivatives of these with respect to the PorousFlowVariables.
- ADPorousFlowDiffusivityConstThis Material provides constant tortuosity and diffusion coefficients
- ADPorousFlowDiffusivityMillingtonQuirkThis Material provides saturation-dependent diffusivity using the Millington-Quirk model
- ADPorousFlowEffectiveFluidPressureThis Material calculates an effective fluid pressure: effective_stress = total_stress + biot_coeff*effective_fluid_pressure. The effective_fluid_pressure = sum_{phases}(S_phase * P_phase)
- ADPorousFlowFluidStateClass for fluid state calculations using persistent primary variables and a vapor-liquid flash
- ADPorousFlowFluidStateSingleComponentClass for single component multiphase fluid state calculations using pressure and enthalpy
- ADPorousFlowJoinerThis Material forms a std::vector of properties, old properties (optionally), and derivatives, out of the individual phase properties
- ADPorousFlowMassFractionThis Material forms a std::vector<std::vector ...> of mass-fractions out of the individual mass fractions
- ADPorousFlowMatrixInternalEnergyThis Material calculates the internal energy of solid rock grains, which is specific_heat_capacity * density * temperature. Kernels multiply this by (1 - porosity) to find the energy density of the porous rock in a rock-fluid system
- ADPorousFlowMultiComponentFluidThis Material calculates fluid properties for a multicomponent fluid
- ADPorousFlowPermeabilityConstThis Material calculates the permeability tensor assuming it is constant
- ADPorousFlowPermeabilityConstFromVarThis Material calculates the permeability tensor given by the input variables
- ADPorousFlowPermeabilityExponentialThis Material calculates the permeability tensor from an exponential function of porosity: k = k_ijk * BB exp(AA phi), where k_ijk is a tensor providing the anisotropy, phi is porosity, and AA and BB are empirical constants. The user can provide input for the function expressed in ln k, log k or exponential forms (see poroperm_function).
- ADPorousFlowPermeabilityKozenyCarmanThis Material calculates the permeability tensor from a form of the Kozeny-Carman equation based on the spatially constant initial permeability and porosity or grain size.
- ADPorousFlowPermeabilityKozenyCarmanFromVarThis Material calculates the permeability tensor from the Kozeny-Carman equation for spatially varying initial properties.
- ADPorousFlowPermeabilityTensorFromVarThis Material calculates the permeability tensor from a coupled variable multiplied by a tensor
- ADPorousFlowPorosityConstThis Material calculates the porosity assuming it is constant
- ADPorousFlowRelativePermeabilityBCBrooks-Corey relative permeability
- ADPorousFlowRelativePermeabilityBWBroadbridge-White form of relative permeability
- ADPorousFlowRelativePermeabilityConstThis class sets the relative permeability to a constant value (default = 1)
- ADPorousFlowRelativePermeabilityCoreyThis Material calculates relative permeability of the fluid phase, using the simple Corey model ((S-S_res)/(1-sum(S_res)))^n
- ADPorousFlowRelativePermeabilityFLACThis Material calculates relative permeability of a phase using a model inspired by FLAC
- ADPorousFlowRelativePermeabilityVGThis Material calculates relative permeability of a phase using the van Genuchten model
- ADPorousFlowSingleComponentFluidThis Material calculates fluid properties at the quadpoints or nodes for a single component fluid
- ADPorousFlowTemperatureMaterial to provide temperature at the quadpoints or nodes and derivatives of it with respect to the PorousFlow variables
- ADPorousFlowThermalConductivityFromPorosityThis Material calculates rock-fluid combined thermal conductivity for the single phase, fully saturated case by using a linear weighted average. Thermal conductivity = phi * lambda_f + (1 - phi) * lambda_s, where phi is porosity, and lambda_f, lambda_s are thermal conductivities of the fluid and solid (assumed constant)
- ADPorousFlowThermalConductivityIdealThis Material calculates rock-fluid combined thermal conductivity by using a weighted sum. Thermal conductivity = dry_thermal_conductivity + S^exponent * (wet_thermal_conductivity - dry_thermal_conductivity), where S is the aqueous saturation
- PorousFlow1PhaseFullySaturatedThis Material is used for the fully saturated single-phase situation where porepressure is the primary variable
- PorousFlow1PhaseHysPThis Material is used for unsaturated single-phase situations where porepressure is the primary variable and the capillary pressure is hysteretic. The hysteretic formulation assumes that the single phase is a liquid
- PorousFlow1PhaseMD_GaussianThis Material is used for the single-phase situation where log(mass-density) is the primary variable. calculates the 1 porepressure and the 1 saturation in a 1-phase situation, and derivatives of these with respect to the PorousFlowVariables. A gaussian capillary function is assumed
- PorousFlow1PhasePThis Material is used for the partially saturated single-phase situation where porepressure is the primary variable
- PorousFlow2PhaseHysPPThis Material is used for 2-phase situations. It calculates the 2 saturations given the 2 porepressures, assuming the capillary pressure is hysteretic. Derivatives of these quantities are also computed
- PorousFlow2PhaseHysPSThis Material is used for 2-phase situations. It calculates the 2 saturations and 2 porepressures, assuming the capillary pressure is hysteretic. Derivatives of these quantities are also computed
- PorousFlow2PhasePPThis Material calculates the 2 porepressures and the 2 saturations in a 2-phase situation, and derivatives of these with respect to the PorousFlowVariables
- PorousFlow2PhasePSThis Material calculates the 2 porepressures and the 2 saturations in a 2-phase situation, and derivatives of these with respect to the PorousFlowVariables.
- PorousFlowAqueousPreDisChemistryThis Material forms a std::vector of mineralisation reaction rates (L(precipitate)/L(solution)/s) appropriate to the aqueous precipitation-dissolution system provided. Note: the PorousFlowTemperature must be measured in Kelvin.
- PorousFlowAqueousPreDisMineralThis Material forms a std::vector of mineral concentrations (volume-of-mineral/volume-of-material) appropriate to the aqueous precipitation-dissolution system provided.
- PorousFlowBrineThis Material calculates fluid properties for brine at the quadpoints or nodes
- PorousFlowConstantBiotModulusComputes the Biot Modulus, which is assumed to be constant for all time. Sometimes 1 / BiotModulus is called storativity
- PorousFlowConstantThermalExpansionCoefficientComputes the effective thermal expansion coefficient, (biot_coeff - porosity) * drained_coefficient + porosity * fluid_coefficient.
- PorousFlowDarcyVelocityMaterialThis Material calculates the Darcy velocity for all phases
- PorousFlowDiffusivityConstThis Material provides constant tortuosity and diffusion coefficients
- PorousFlowDiffusivityMillingtonQuirkThis Material provides saturation-dependent diffusivity using the Millington-Quirk model
- PorousFlowEffectiveFluidPressureThis Material calculates an effective fluid pressure: effective_stress = total_stress + biot_coeff*effective_fluid_pressure. The effective_fluid_pressure = sum_{phases}(S_phase * P_phase)
- PorousFlowFluidStateClass for fluid state calculations using persistent primary variables and a vapor-liquid flash
- PorousFlowFluidStateSingleComponentClass for single component multiphase fluid state calculations using pressure and enthalpy
- PorousFlowHysteresisOrderComputes hysteresis order for use in hysteretic capillary pressures and relative permeabilities
- PorousFlowHystereticCapillaryPressureThis Material computes information that is required for the computation of hysteretic capillary pressures in single and multi phase situations
- PorousFlowHystereticInfoThis Material computes capillary pressure or saturation, etc. It is primarily of use when users desire to compute hysteretic quantities such as capillary pressure for visualisation purposes. The result is written into PorousFlow_hysteretic_info_nodal or PorousFlow_hysteretic_info_qp (depending on the at_nodes flag). It does not compute porepressure and should not be used in simulations that employ PorousFlow*PhaseHys* Materials.
- PorousFlowHystereticRelativePermeabilityGasPorousFlow material that computes relative permeability of the gas phase in 1-phase or 2-phase models that include hysteresis. You should ensure that the 'phase' for this Material does indeed represent the gas phase
- PorousFlowHystereticRelativePermeabilityLiquidPorousFlow material that computes relative permeability of the liquid phase in 1-phase or 2-phase models that include hysteresis. You should ensure that the 'phase' for this Material does indeed represent the liquid phase
- PorousFlowJoinerThis Material forms a std::vector of properties, old properties (optionally), and derivatives, out of the individual phase properties
- PorousFlowMassFractionThis Material forms a std::vector<std::vector ...> of mass-fractions out of the individual mass fractions
- PorousFlowMassFractionAqueousEquilibriumChemistryThis Material forms a std::vector<std::vector ...> of mass-fractions (total concentrations of primary species (m{3}(primary species)/m{3}(solution)) and since this is for an aqueous system only, mass-fraction equals volume-fraction) corresponding to an aqueous equilibrium chemistry system. The first mass fraction is the concentration of the first primary species, etc, and the last mass fraction is the concentration of H2O.
- PorousFlowMatrixInternalEnergyThis Material calculates the internal energy of solid rock grains, which is specific_heat_capacity * density * temperature. Kernels multiply this by (1 - porosity) to find the energy density of the porous rock in a rock-fluid system
- PorousFlowMultiComponentFluidThis Material calculates fluid properties for a multicomponent fluid
- PorousFlowNearestQpProvides the nearest quadpoint to a node in each element
- PorousFlowPermeabilityConstThis Material calculates the permeability tensor assuming it is constant
- PorousFlowPermeabilityConstFromVarThis Material calculates the permeability tensor given by the input variables
- PorousFlowPermeabilityExponentialThis Material calculates the permeability tensor from an exponential function of porosity: k = k_ijk * BB exp(AA phi), where k_ijk is a tensor providing the anisotropy, phi is porosity, and AA and BB are empirical constants. The user can provide input for the function expressed in ln k, log k or exponential forms (see poroperm_function).
- PorousFlowPermeabilityKozenyCarmanThis Material calculates the permeability tensor from a form of the Kozeny-Carman equation based on the spatially constant initial permeability and porosity or grain size.
- PorousFlowPermeabilityKozenyCarmanFromVarThis Material calculates the permeability tensor from the Kozeny-Carman equation for spatially varying initial properties.
- PorousFlowPermeabilityTensorFromVarThis Material calculates the permeability tensor from a coupled variable multiplied by a tensor
- PorousFlowPorosityThis Material calculates the porosity PorousFlow simulations
- PorousFlowPorosityConstThis Material calculates the porosity assuming it is constant
- PorousFlowPorosityHMBiotModulusThis Material calculates the porosity for hydro-mechanical simulations, assuming that the Biot modulus and the fluid bulk modulus are both constant. This is useful for comparing with solutions from poroelasticity theory, but is less accurate than PorousFlowPorosity
- PorousFlowPorosityLinearThis Material calculates the porosity in PorousFlow simulations using the relationship porosity_ref + P_coeff * (P - P_ref) + T_coeff * (T - T_ref) + epv_coeff * (epv - epv_ref), where P is the effective porepressure, T is the temperature and epv is the volumetric strain
- PorousFlowRelativePermeabilityBCBrooks-Corey relative permeability
- PorousFlowRelativePermeabilityBWBroadbridge-White form of relative permeability
- PorousFlowRelativePermeabilityConstThis class sets the relative permeability to a constant value (default = 1)
- PorousFlowRelativePermeabilityCoreyThis Material calculates relative permeability of the fluid phase, using the simple Corey model ((S-S_res)/(1-sum(S_res)))^n
- PorousFlowRelativePermeabilityFLACThis Material calculates relative permeability of a phase using a model inspired by FLAC
- PorousFlowRelativePermeabilityVGThis Material calculates relative permeability of a phase using the van Genuchten model
- PorousFlowSingleComponentFluidThis Material calculates fluid properties at the quadpoints or nodes for a single component fluid
- PorousFlowTemperatureMaterial to provide temperature at the quadpoints or nodes and derivatives of it with respect to the PorousFlow variables
- PorousFlowThermalConductivityFromPorosityThis Material calculates rock-fluid combined thermal conductivity for the single phase, fully saturated case by using a linear weighted average. Thermal conductivity = phi * lambda_f + (1 - phi) * lambda_s, where phi is porosity, and lambda_f, lambda_s are thermal conductivities of the fluid and solid (assumed constant)
- PorousFlowThermalConductivityIdealThis Material calculates rock-fluid combined thermal conductivity by using a weighted sum. Thermal conductivity = dry_thermal_conductivity + S^exponent * (wet_thermal_conductivity - dry_thermal_conductivity), where S is the aqueous saturation
- PorousFlowTotalGravitationalDensityFullySaturatedFromPorosityThis Material calculates the porous medium density from the porosity, solid density (assumed constant) and fluid density, for the fully-saturated single fluid phase case, using a linear weighted average. density = phi * rho_f + (1 - phi) * rho_s, where phi is porosity and rho_f, rho_s are the densities of the fluid and solid phases.
- PorousFlowVolumetricStrainCompute volumetric strain and the volumetric_strain rate, for use in PorousFlow.
- XFEMApp
- ADLevelSetBiMaterialRankFourCompute a RankFourTensor material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- ADLevelSetBiMaterialRankTwoCompute a RankTwoTensor material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- ADLevelSetBiMaterialRealCompute a Real material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- ADXFEMCutSwitchingMaterialRankFourTensorSwitch the material property based on the CutSubdomainID.
- ADXFEMCutSwitchingMaterialRankThreeTensorSwitch the material property based on the CutSubdomainID.
- ADXFEMCutSwitchingMaterialRankTwoTensorSwitch the material property based on the CutSubdomainID.
- ADXFEMCutSwitchingMaterialRealSwitch the material property based on the CutSubdomainID.
- ComputeCrackTipEnrichmentSmallStrainComputes the crack tip enrichment at a point within a small strain formulation.
- LevelSetBiMaterialRankFourCompute a RankFourTensor material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- LevelSetBiMaterialRankTwoCompute a RankTwoTensor material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- LevelSetBiMaterialRealCompute a Real material property for bi-materials problem (consisting of two different materials) defined by a level set function.
- XFEMCutSwitchingMaterialRankFourTensorSwitch the material property based on the CutSubdomainID.
- XFEMCutSwitchingMaterialRankThreeTensorSwitch the material property based on the CutSubdomainID.
- XFEMCutSwitchingMaterialRankTwoTensorSwitch the material property based on the CutSubdomainID.
- XFEMCutSwitchingMaterialRealSwitch the material property based on the CutSubdomainID.
- Fluid Properties App
- ADSaturationPressureMaterialComputes saturation pressure at some temperature.
- ADSaturationTemperatureMaterialComputes saturation temperature at some pressure
- ADSurfaceTensionMaterialComputes surface tension at some temperature
- FluidPropertiesMaterialComputes fluid properties using (specific internal energy, specific volume) formulation
- FluidPropertiesMaterialPTFluid properties using the (pressure, temperature) formulation
- FluidPropertiesMaterialVEComputes fluid properties using (specific internal energy, specific volume) formulation
- SaturationPressureMaterialComputes saturation pressure at some temperature.
- SodiumPropertiesMaterialMaterial properties for liquid sodium sampled from SodiumProperties.
- Misc App
- ADArrheniusMaterialPropertyArbitrary material property of the sum of an arbitary number () of Arrhenius functions , where is the frequency factor, is the activation energy, and is the gas constant.
- ADDensityCreates density material property. This class is deprecated, and its functionalityis replaced by StrainAdjustedDensity for cases when the density should be adjustedto account for material deformation. If it is not desired to adjust the density fordeformation, a variety of general-purpose Materials, such as GenericConstantMaterialor ParsedMaterial can be used to define the density.
- ArrheniusMaterialPropertyArbitrary material property of the sum of an arbitary number () of Arrhenius functions , where is the frequency factor, is the activation energy, and is the gas constant.
- DensityCreates density material property. This class is deprecated, and its functionalityis replaced by StrainAdjustedDensity for cases when the density should be adjustedto account for material deformation. If it is not desired to adjust the density fordeformation, a variety of general-purpose Materials, such as GenericConstantMaterialor ParsedMaterial can be used to define the density.
- Optimization App
- ADMisfitReporterOffsetFunctionMaterialComputes the misfit and misfit gradient materials for inverse optimizations problems.
- ADReporterOffsetFunctionMaterialCompute the sum of a function offset by a set of points.
- CostSensitivityComputes cost sensitivity needed for multimaterial SIMP method.
- MisfitReporterOffsetFunctionMaterialComputes the misfit and misfit gradient materials for inverse optimizations problems.
- ReporterOffsetFunctionMaterialCompute the sum of a function offset by a set of points.
- Heat Transfer App
- ADAnisoHeatConductionMaterialGeneral-purpose material model for anisotropic heat conduction
- ADChurchillChuHTCFunctorMaterialComputes a heat transfer coefficient using the Churchill-Chu correlation for natural convection.
- ADConvectionHeatFluxFunctorMaterialComputes a convection heat flux from a solid surface to a fluid.
- ADCylindricalGapHeatFluxFunctorMaterialComputes cylindrical gap heat flux due to conduction and radiation.
- ADElectricalConductivityCalculates resistivity and electrical conductivity as a function of temperature, using copper for parameter defaults.
- ADFinEfficiencyFunctorMaterialComputes fin efficiency.
- ADFinEnhancementFactorFunctorMaterialComputes a heat transfer enhancement factor for fins.
- ADHeatConductionMaterialGeneral-purpose material model for heat conduction
- ADRadiativeP1DiffusionCoefficientMaterialComputes the P1 diffusion coefficient from the opacity and effective scattering cross section.
- AnisoHeatConductionMaterialGeneral-purpose material model for anisotropic heat conduction
- ChurchillChuHTCFunctorMaterialComputes a heat transfer coefficient using the Churchill-Chu correlation for natural convection.
- ConvectionHeatFluxFunctorMaterialComputes a convection heat flux from a solid surface to a fluid.
- CylindricalGapHeatFluxFunctorMaterialComputes cylindrical gap heat flux due to conduction and radiation.
- ElectricalConductivityCalculates resistivity and electrical conductivity as a function of temperature, using copper for parameter defaults.
- ElectromagneticHeatingMaterialMaterial class used to provide the electric field as a material property and computes the residual contributions for electromagnetic/electrostatic heating objects.
- FinEfficiencyFunctorMaterialComputes fin efficiency.
- FinEnhancementFactorFunctorMaterialComputes a heat transfer enhancement factor for fins.
- FunctionPathEllipsoidHeatSourceDouble ellipsoid volumetric source heat with function path.
- GapConductanceMaterial to compute an effective gap conductance based on the thermal conductivity of the gap and diffusive approximation to the radiative heat transfer.
- GapConductanceConstantMaterial to compute a constant, prescribed gap conductance
- HeatConductionMaterialGeneral-purpose material model for heat conduction
- RadiativeP1DiffusionCoefficientMaterialComputes the P1 diffusion coefficient from the opacity and effective scattering cross section.
- SemiconductorLinearConductivityCalculates electrical conductivity of a semiconductor from temperature
- SideSetHeatTransferMaterialThis material constructs the necessary coefficients and properties for SideSetHeatTransferKernel.
- ThermalComplianceComputes cost sensitivity needed for multimaterial SIMP method.
- ThermalSensitivityComputes cost sensitivity needed for multimaterial SIMP method.
- Electromagnetics App
- WaveEquationCoefficientMaterial for use as coefficient (where a is a scalar coefficient) in standard-form Helmholtz wave equation applications with derivatives calculated using automatic differentiation.
- Rdg App
- AEFVMaterialA material kernel for the advection equation using a cell-centered finite volume method.
- Chemical Reactions App
- LangmuirMaterialMaterial type that holds info regarding Langmuir desorption from matrix to porespace and viceversa
- MollifiedLangmuirMaterialMaterial type that holds info regarding MollifiedLangmuir desorption from matrix to porespace and viceversa
- Thermal Hydraulics App
- ADAverageWallTemperature3EqnMaterialWeighted average wall temperature from multiple sources for 1-phase flow
- ADConjugateHTNumbersFunctorMaterialComputes several non-dimensional numbers for conjugate heat transfer.
- ADConstantMaterialDefines a constant AD material property
- ADConvectionHeatFluxHSMaterialComputes heat flux from convection with heat structure for a given fluid phase.
- ADConvectionHeatFluxMaterialComputes heat flux from convection for a given fluid phase.
- ADConvectiveHeatTransferCoefficientMaterialComputes convective heat transfer coefficient from Nusselt number
- ADCoupledVariableValueMaterialStores values of a variable into material properties
- ADDynamicViscosityMaterialComputes dynamic viscosity as a material property
- ADFluidProperties3EqnMaterialDefines material properties from fluid properties to serve in the 3-equation model
- ADHydraulicDiameterCircularMaterialDefines a circular-equivalent hydraulic diameter from the local area
- ADMaterialFunctionProductMaterialComputes the product of a material property and a function.
- ADPrandtlNumberMaterialComputes Prandtl number as material property
- ADRDG3EqnMaterialReconstructed solution values for the 1-D, 1-phase, variable-area Euler equations
- ADReynoldsNumberMaterialComputes Reynolds number as a material property
- ADSolidMaterialComputes solid thermal properties as a function of temperature
- ADTemperatureWall3EqnMaterialComputes the wall temperature from the fluid temperature, the heat flux and the heat transfer coefficient
- ADWallFrictionChengMaterialComputes wall friction factor using the Cheng-Todreas correlation for interior, edge and corner channels.
- ADWallFrictionChurchillMaterialComputes the Darcy friction factor using the Churchill correlation.
- ADWallFrictionFunctionMaterialDefines a Darcy friction factor equal to the value of the function at the local coordinates and time
- ADWallHTCGnielinskiAnnularMaterialComputes wall heat transfer coefficient for gases and water in an annular flow channel using the Gnielinski correlation
- ADWallHeatTransferCoefficient3EqnDittusBoelterMaterialComputes wall heat transfer coefficient using Dittus-Boelter equation
- ADWallHeatTransferCoefficientGnielinskiMaterialComputes wall heat transfer coefficient for gases and water using the Gnielinski correlation
- ADWallHeatTransferCoefficientKazimiMaterial Computes wall heat transfer coefficient for liquid sodium using Kazimi-Carelli correlation
- ADWallHeatTransferCoefficientLyonMaterialComputes wall heat transfer coefficient for liquid sodium using Lyon correlation
- ADWallHeatTransferCoefficientMikityukMaterialComputes wall heat transfer coefficient for liquid sodium using Mikityuk correlation
- ADWallHeatTransferCoefficientSchadMaterialComputes wall heat transfer coefficient for liquid sodium using Schad-modified correlation
- ADWallHeatTransferCoefficientWeismanMaterialComputes wall heat transfer coefficient for water using the Weisman correlation
- ADWallHeatTransferCoefficientWolfMcCarthyMaterialComputes wall heat transfer coefficient using Wolf-McCarthy correlation
- ADWeightedAverageMaterialWeighted average of material properties using variables as weights
- AverageWallTemperature3EqnMaterialWeighted average wall temperature from multiple sources for 1-phase flow
- BinaryDiffusionCoefMaterialComputes the Stefan-Maxwell binary diffusion coefficient.
- ConjugateHTNumbersFunctorMaterialComputes several non-dimensional numbers for conjugate heat transfer.
- ConstantMaterialDefines a single constant material property, along with zero derivative material properties for user-defined variables
- ConvectiveHeatTransferCoefficientMaterialComputes convective heat transfer coefficient from Nusselt number
- CoupledVariableValueMaterialStores values of a variable into material properties
- DirectionMaterialComputes the direction of 1D elements
- DynamicViscosityMaterialComputes the dynamic viscosity as a material property
- FluidProperties3EqnMaterialDefines material properties from fluid properties to serve in the 3-equation model
- FluidPropertiesGasMixMaterialComputes various fluid properties for FlowModelGasMix.
- HydraulicDiameterCircularMaterialDefines a circular-equivalent hydraulic diameter from the local area
- MeshAlignmentVariableTransferMaterialCreates an AD material property for a variable transferred from the boundary of a 2D mesh onto a 1D mesh.
- PrandtlNumberMaterialComputes the Prandtl number as a material property
- RDG3EqnMaterialReconstructed solution values for the 1-D, 1-phase, variable-area Euler equations
- ReynoldsNumberMaterialComputes Reynolds number as a material property
- SlopeReconstructionGasMixMaterialComputes reconstructed solution values for FlowModelGasMix.
- TemperatureWall3EqnMaterialComputes the wall temperature from the fluid temperature, the heat flux and the heat transfer coefficient
- WallFrictionChurchillMaterialComputes the Darcy friction factor using the Churchill correlation.
- WallFrictionFunctionMaterialDefines a Darcy friction factor equal to the value of the function at the local coordinates and time
- WallHeatTransferCoefficient3EqnDittusBoelterMaterialComputes wall heat transfer coefficient using Dittus-Boelter equation
- WeightedAverageMaterialWeighted average of material properties using variables as weights
- Phase Field App
- ADConstantAnisotropicMobilityProvide a constant mobility tensor value
- ADGBEvolutionComputes necessary material properties for the isotropic grain growth model
- ADInterfaceOrientationMaterial2D interfacial anisotropy
- ADMathCTDFreeEnergyMaterial that implements the math free energy using the expression builder and automatic differentiation
- ADMathFreeEnergyMaterial that implements the math free energy and its derivatives:
- ADPhaseFieldTwoPhaseMaterialMaterial that assigns properties based on the phase field variable.
- ADSwitchingFunctionMultiPhaseMaterialCalculates the switching function for a given phase for a multi-phase, multi-order parameter model
- AsymmetricCrossTermBarrierFunctionMaterialFree energy contribution asymmetric across interfaces between arbitrary pairs of phases.
- BarrierFunctionMaterialHelper material to provide and its derivative in a polynomial. SIMPLE: LOW: HIGH:
- CompositeMobilityTensorAssemble a mobility tensor from multiple tensor contributions weighted by material properties
- ComputeGBMisorientationTypeCalculate types of grain boundaries in a polycrystalline sample
- ComputePolycrystalElasticityTensorCompute an evolving elasticity tensor coupled to a grain growth phase field model.
- ConstantAnisotropicMobilityProvide a constant mobility tensor value
- CoupledValueFunctionFreeEnergyCompute a free energy from a lookup function
- CrossTermBarrierFunctionMaterialFree energy contribution symmetric across interfaces between arbitrary pairs of phases.
- DeformedGrainMaterialComputes scaled grain material properties
- DerivativeMultiPhaseMaterialTwo phase material that combines n phase materials using a switching function with and n non-conserved order parameters (to be used with SwitchingFunctionConstraint*).
- DerivativeTwoPhaseMaterialTwo phase material that combines two single phase materials using a switching function.
- DiscreteNucleationFree energy contribution for nucleating discrete particles
- ElasticEnergyMaterialFree energy material for the elastic energy contributions.
- ElectrochemicalDefectMaterialCalculates density, susceptibility, and derivatives for a defect species in the grand potential sintering model coupled with electrochemistry
- ElectrochemicalSinteringMaterialIncludes switching and thermodynamic properties for the grand potential sintering model coupled with electrochemistry
- ExternalForceDensityMaterialProviding external applied force density to grains
- ForceDensityMaterialCalculating the force density acting on a grain
- GBAnisotropyA material to compute anisotropic grain boundary energies and mobilities.
- GBDependentAnisotropicTensorCompute anisotropic rank two tensor based on GB phase variable
- GBDependentDiffusivityCompute diffusivity rank two tensor based on GB phase variable
- GBEvolutionComputes necessary material properties for the isotropic grain growth model
- GBWidthAnisotropyA material to compute anisotropic grain boundary energies and mobilities with user-specified grain boundary widths, independently for each interface between grains
- GrainAdvectionVelocityCalculation the advection velocity of grain due to rigid body translation and rotation
- GrandPotentialInterfaceCalculate Grand Potential interface parameters for a specified interfacial free energy and width
- GrandPotentialSinteringMaterialIncludes switching and thermodynamic properties for the grand potential sintering model
- GrandPotentialTensorMaterialDiffusion and mobility parameters for grand potential model governing equations. Uses a tensor diffusivity
- IdealGasFreeEnergyFree energy of an ideal gas.
- InterfaceOrientationMaterial2D interfacial anisotropy
- InterfaceOrientationMultiphaseMaterialThis Material accounts for the the orientation dependence of interfacial energy for multi-phase multi-order parameter phase-field model.
- KKSPhaseConcentrationDerivativesComputes the KKS phase concentration derivatives wrt global concentrations and order parameters, which are used in the chain rules in the KKS kernels. This class is intended to be used with KKSPhaseConcentrationMaterial.
- KKSPhaseConcentrationMaterialComputes the KKS phase concentrations by using nested Newton iteration to solve the equal chemical potential and concentration conservation equations. This class is intended to be used with KKSPhaseConcentrationDerivatives.
- KKSPhaseConcentrationMultiPhaseDerivativesComputes the KKS phase concentration derivatives wrt global concentrations and order parameters, which are used for the chain rule in the KKS kernels. This class is intended to be used with KKSPhaseConcentrationMultiPhaseMaterial.
- KKSPhaseConcentrationMultiPhaseMaterialComputes the KKS phase concentrations by using a nested Newton iteration to solve the equal chemical potential and concentration conservation equations for multiphase systems. This class is intented to be used with KKSPhaseConcentrationMultiPhaseDerivatives.
- KKSXeVacSolidMaterialKKS Solid phase free energy for Xe,Vac in UO2. Fm(cmg,cmv)
- LinearizedInterfaceFunctionDefines the order parameter substitution for linearized interface phase field models
- MathCTDFreeEnergyMaterial that implements the math free energy using the expression builder and automatic differentiation
- MathEBFreeEnergyMaterial that implements the math free energy using the expression builder and automatic differentiation
- MathFreeEnergyMaterial that implements the math free energy and its derivatives:
- MixedSwitchingFunctionMaterialHelper material to provide h(eta) and its derivative in one of two polynomial forms. MIX234 and MIX246
- MultiBarrierFunctionMaterialDouble well phase transformation barrier free energy contribution.
- PFCRFFMaterialDefined the mobility, alpha and A constants for the RFF form of the phase field crystal model
- PFCTradMaterialPolynomial coefficients for a phase field crystal correlation function
- PFParamsPolyFreeEnergyPhase field parameters for polynomial free energy for single component systems
- PhaseNormalTensorCalculate normal tensor of a phase based on gradient
- PolycrystalDiffusivityGenerates a diffusion coefficient to distinguish between the bulk, pore, grain boundaries, and surfaces
- PolycrystalDiffusivityTensorBaseGenerates a diffusion tensor to distinguish between the bulk, grain boundaries, and surfaces
- PolynomialFreeEnergyPolynomial free energy for single component systems
- RegularSolutionFreeEnergyMaterial that implements the free energy of a regular solution
- StrainGradDispDerivativesProvide the constant derivatives of strain w.r.t. the displacement gradient components.
- SwitchingFunction3PhaseMaterialMaterial for switching function that prevents formation of a third phase at a two-phase interface:
- SwitchingFunctionMaterialHelper material to provide and its derivative in one of two polynomial forms. SIMPLE: HIGH:
- SwitchingFunctionMultiPhaseMaterialCalculates the switching function for a given phase for a multi-phase, multi-order parameter model
- ThirdPhaseSuppressionMaterialFree Energy contribution that penalizes more than two order parameters being non-zero
- TimeStepMaterialProvide various time stepping quantities as material properties.
- VanDerWaalsFreeEnergyFree energy of a Van der Waals gas.
- VariableGradientMaterialCompute the norm of the gradient of a variable
- Solid Mechanics App
- ADAbruptSofteningSoftening model with an abrupt stress release upon cracking. This class relies on automatic differentiation and is intended to be used with ADComputeSmearedCrackingStress.
- ADCZMComputeDisplacementJumpSmallStrainCompute the total displacement jump across a czm interface in local coordinates for the Small Strain kinematic formulation
- ADCZMComputeDisplacementJumpTotalLagrangianCompute the displacement jump increment across a czm interface in local coordinates for the Total Lagrangian kinematic formulation
- ADCZMComputeGlobalTractionSmallStrainComputes the czm traction in global coordinates for a small strain kinematic formulation
- ADCZMComputeGlobalTractionTotalLagrangianCompute the equilibrium traction (PK1) and its derivatives for the Total Lagrangian formulation.
- ADCombinedNonlinearHardeningPlasticityCombined isotropic and kinematic plasticity model with nonlinear hardening rules, including a Voce model for isotropic hardening and an Armstrong-Fredrick model for kinematic hardening.
- ADCombinedScalarDamageScalar damage model which is computed as a function of multiple scalar damage models
- ADCompositePowerLawCreepStressUpdateThis class uses the stress update material in a radial return isotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations. This class is an extension to include multi-phase capability.
- ADComputeAxisymmetricRZFiniteStrainCompute a strain increment for finite strains under axisymmetric assumptions.
- ADComputeAxisymmetricRZIncrementalStrainCompute a strain increment and rotation increment for finite strains under axisymmetric assumptions.
- ADComputeAxisymmetricRZSmallStrainCompute a small strain in an Axisymmetric geometry
- ADComputeDamageStressCompute stress for damaged elastic materials in conjunction with a damage model.
- ADComputeDilatationThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the total dilatation as a function of temperature
- ADComputeEigenstrainComputes a constant Eigenstrain
- ADComputeElasticityTensorCompute an elasticity tensor.
- ADComputeFiniteShellStrainCompute a large strain increment for the shell.
- ADComputeFiniteStrainCompute a strain increment and rotation increment for finite strains.
- ADComputeFiniteStrainElasticStressCompute stress using elasticity for finite strains
- ADComputeGreenLagrangeStrainCompute a Green-Lagrange strain.
- ADComputeIncrementalShellStrainCompute a small strain increment for the shell.
- ADComputeIncrementalSmallStrainCompute a strain increment and rotation increment for small strains.
- ADComputeIncrementalStrainCompute a strain increment and rotation increment for small strains.
- ADComputeInstantaneousThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the instantaneous thermal expansion as a function of temperature
- ADComputeIsotropicElasticityTensorCompute a constant isotropic elasticity tensor.
- ADComputeIsotropicElasticityTensorShellCompute a plane stress isotropic elasticity tensor.
- ADComputeLinearElasticStressCompute stress using elasticity for small strains
- ADComputeMeanThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the mean thermal expansion as a function of temperature
- ADComputeMultipleInelasticStressCompute state (stress and internal parameters such as plastic strains and internal parameters) using an iterative process. Combinations of creep models and plastic models may be used.
- ADComputeMultiplePorousInelasticStressCompute state (stress and internal parameters such as plastic strains and internal parameters) using an iterative process. A porosity material property is defined and is calculated from the trace of inelastic strain increment.
- ADComputePlaneFiniteStrainCompute strain increment and rotation increment for finite strain under 2D planar assumptions.
- ADComputePlaneIncrementalStrainCompute strain increment for small strain under 2D planar assumptions.
- ADComputePlaneSmallStrainCompute a small strain under generalized plane strain assumptions where the out of plane strain is generally nonzero.
- ADComputeRSphericalFiniteStrainCompute a strain increment and rotation increment for finite strains in 1D spherical symmetry problems.
- ADComputeRSphericalIncrementalStrainCompute a strain increment for incremental strains in 1D spherical symmetry problems.
- ADComputeRSphericalSmallStrainCompute a small strain 1D spherical symmetry case.
- ADComputeShellStressCompute in-plane stress using elasticity for shell
- ADComputeSmallStrainCompute a small strain.
- ADComputeSmearedCrackingStressCompute stress using a fixed smeared cracking model. Uses automatic differentiation
- ADComputeStrainIncrementBasedStressCompute stress after subtracting inelastic strain increments
- ADComputeThermalExpansionEigenstrainComputes eigenstrain due to thermal expansion with a constant coefficient
- ADComputeVariableIsotropicElasticityTensorCompute an isotropic elasticity tensor for elastic constants that change as a function of material properties
- ADComputeVolumetricEigenstrainComputes an eigenstrain that is defined by a set of scalar material properties that summed together define the volumetric change.
- ADEigenDecompositionMaterialEmits material properties for the eigenvalues and eigenvectors of a symmetric rank two tensor.
- ADEshelbyTensorComputes the Eshelby tensor as a function of strain energy density and the first Piola-Kirchhoff stress
- ADExponentialSofteningSoftening model with an exponential softening response upon cracking. This class is intended to be used with ADComputeSmearedCrackingStress and relies on automatic differentiation.
- ADHillConstantsBuild and rotate the Hill Tensor. It can be used with other Hill plasticity and creep materials.
- ADHillCreepStressUpdateThis class uses the stress update material in a generalized radial return anisotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADHillElastoPlasticityStressUpdateThis class uses the generalized radial return for anisotropic elasto-plasticity model.This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADHillPlasticityStressUpdateThis class uses the generalized radial return for anisotropic plasticity model.This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADIsotropicPlasticityStressUpdateThis class uses the discrete material in a radial return isotropic plasticity model. This class is one of the basic radial return constitutive models, yet it can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADIsotropicPowerLawHardeningStressUpdateThis class uses the discrete material in a radial return isotropic plasticity power law hardening model, solving for the yield stress as the intersection of the power law relation curve and Hooke's law. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADLAROMANCEPartitionStressUpdateLAROMANCE base class for partitioned reduced order models
- ADLAROMANCEStressUpdateBase class to calculate the effective creep strain based on the rates predicted by a material specific Los Alamos Reduced Order Model derived from a Visco-Plastic Self Consistent calculations.
- ADMultiplePowerLawCreepStressUpdateThis class uses the stress update material in a radial return isotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADNonlocalDamageNonlocal damage model. Given an RadialAverage UO this creates a new damage index that can be used as for ComputeDamageStress without havign to change existing local damage models.
- ADPorosityFromStrainPorosity calculation from the inelastic strain.
- ADPowerLawCreepStressUpdateThis class uses the stress update material in a radial return isotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- ADPowerLawSofteningSoftening model with an abrupt stress release upon cracking. This class is intended to be used with ADComputeSmearedCrackingStress and relies on automatic differentiation.
- ADPureElasticTractionSeparationPure elastic traction separation law.
- ADRankTwoCartesianComponentAccess a component of a RankTwoTensor
- ADRankTwoCylindricalComponentCompute components of a rank-2 tensor in a cylindrical coordinate system
- ADRankTwoDirectionalComponentCompute a Direction scalar property of a RankTwoTensor
- ADRankTwoInvariantCompute a invariant property of a RankTwoTensor
- ADRankTwoSphericalComponentCompute components of a rank-2 tensor in a spherical coordinate system
- ADScalarMaterialDamageScalar damage model for which the damage is prescribed by another material
- ADStrainAdjustedDensityCreates density material property
- ADStrainEnergyDensityComputes the strain energy density using a combination of the elastic and inelastic components of the strain increment, which is a valid assumption for monotonic behavior.
- ADStrainEnergyRateDensityComputes the strain energy density rate using a combination of the elastic and inelastic components of the strain increment, which is a valid assumption for monotonic behavior.
- ADSymmetricFiniteStrainCompute a strain increment and rotation increment for finite strains.
- ADSymmetricFiniteStrainElasticStressCompute stress using elasticity for finite strains
- ADSymmetricIsotropicElasticityTensorCompute a constant isotropic elasticity tensor.
- ADSymmetricLinearElasticStressCompute stress using elasticity for small strains
- ADSymmetricSmallStrainCompute a small strain.
- ADTemperatureDependentHardeningStressUpdateComputes the stress as a function of temperature and plastic strain from user-supplied hardening functions. This class can be used in conjunction with other creep and plasticity materials for more complex simulations
- ADViscoplasticityStressUpdateThis material computes the non-linear homogenized gauge stress in order to compute the viscoplastic responce due to creep in porous materials. This material must be used in conjunction with ADComputeMultiplePorousInelasticStress
- AbaqusUMATStressCoupling material to use Abaqus UMAT models in MOOSE
- AbruptSofteningSoftening model with an abrupt stress release upon cracking. This class is intended to be used with ComputeSmearedCrackingStress.
- BiLinearMixedModeTractionMixed mode bilinear traction separation law.
- CZMComputeDisplacementJumpSmallStrainCompute the total displacement jump across a czm interface in local coordinates for the Small Strain kinematic formulation
- CZMComputeDisplacementJumpTotalLagrangianCompute the displacement jump increment across a czm interface in local coordinates for the Total Lagrangian kinematic formulation
- CZMComputeGlobalTractionSmallStrainComputes the czm traction in global coordinates for a small strain kinematic formulation
- CZMComputeGlobalTractionTotalLagrangianCompute the equilibrium traction (PK1) and its derivatives for the Total Lagrangian formulation.
- CZMRealVectorCartesianComponentAccess a component of a RealVectorValue defined on a cohesive zone
- CZMRealVectorScalarCompute the normal or tangent component of a vector quantity defined on a cohesive interface.
- CappedDruckerPragerCosseratStressUpdateCapped Drucker-Prager plasticity stress calculator for the Cosserat situation where the host medium (ie, the limit where all Cosserat effects are zero) is isotropic. Note that the return-map flow rule uses an isotropic elasticity tensor built with the 'host' properties defined by the user.
- CappedDruckerPragerStressUpdateCapped Drucker-Prager plasticity stress calculator
- CappedMohrCoulombCosseratStressUpdateCapped Mohr-Coulomb plasticity stress calculator for the Cosserat situation where the host medium (ie, the limit where all Cosserat effects are zero) is isotropic. Note that the return-map flow rule uses an isotropic elasticity tensor built with the 'host' properties defined by the user.
- CappedMohrCoulombStressUpdateNonassociative, smoothed, Mohr-Coulomb plasticity capped with tensile (Rankine) and compressive caps, with hardening/softening
- CappedWeakInclinedPlaneStressUpdateCapped weak inclined plane plasticity stress calculator
- CappedWeakPlaneCosseratStressUpdateCapped weak-plane plasticity Cosserat stress calculator
- CappedWeakPlaneStressUpdateCapped weak-plane plasticity stress calculator
- CombinedNonlinearHardeningPlasticityCombined isotropic and kinematic plasticity model with nonlinear hardening rules, including a Voce model for isotropic hardening and an Armstrong-Fredrick model for kinematic hardening.
- CombinedScalarDamageScalar damage model which is computed as a function of multiple scalar damage models
- ComplianceSensitivityComputes compliance sensitivity needed for SIMP method.
- CompositeEigenstrainAssemble an Eigenstrain tensor from multiple tensor contributions weighted by material properties
- CompositeElasticityTensorAssemble an elasticity tensor from multiple tensor contributions weighted by material properties
- CompositePowerLawCreepStressUpdateThis class uses the stress update material in a radial return isotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations. This class is an extension to include multi-phase capability.
- ComputeAxisymmetric1DFiniteStrainCompute a strain increment and rotation increment for finite strains in an axisymmetric 1D problem
- ComputeAxisymmetric1DIncrementalStrainCompute strain increment for small strains in an axisymmetric 1D problem
- ComputeAxisymmetric1DSmallStrainCompute a small strain in an Axisymmetric 1D problem
- ComputeAxisymmetricRZFiniteStrainCompute a strain increment for finite strains under axisymmetric assumptions.
- ComputeAxisymmetricRZIncrementalStrainCompute a strain increment and rotation increment for small strains under axisymmetric assumptions.
- ComputeAxisymmetricRZSmallStrainCompute a small strain in an Axisymmetric geometry
- ComputeBeamResultantsCompute forces and moments using elasticity
- ComputeConcentrationDependentElasticityTensorCompute concentration dependent elasticity tensor.
- ComputeCosseratElasticityTensorCompute Cosserat elasticity and flexural bending rigidity tensors
- ComputeCosseratIncrementalSmallStrainCompute incremental small Cosserat strains
- ComputeCosseratLinearElasticStressCompute Cosserat stress and couple-stress elasticity for small strains
- ComputeCosseratSmallStrainCompute small Cosserat strains
- ComputeCrackedStressComputes energy and modifies the stress for phase field fracture
- ComputeCreepPlasticityStressCompute state (stress and internal parameters such as inelastic strains and internal parameters) using an Newton process for one creep and one plasticity model
- ComputeCrystalPlasticityThermalEigenstrainComputes the deformation gradient associated with the linear thermal expansion in a crystal plasticity simulation
- ComputeCrystalPlasticityVolumetricEigenstrainComputes the deformation gradient from the volumetric eigenstrain due to spherical voids in a crystal plasticity simulation
- ComputeDamageStressCompute stress for damaged elastic materials in conjunction with a damage model.
- ComputeDeformGradBasedStressComputes stress based on Lagrangian strain
- ComputeDilatationThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the total dilatation as a function of temperature
- ComputeEigenstrainComputes a constant Eigenstrain
- ComputeEigenstrainBeamFromVariableComputes an eigenstrain from a set of variables
- ComputeEigenstrainFromInitialStressComputes an eigenstrain from an initial stress
- ComputeElasticityBeamComputes the equivalent of the elasticity tensor for the beam element, which are vectors of material translational and flexural stiffness.
- ComputeElasticityTensorCompute an elasticity tensor.
- ComputeElasticityTensorCPCompute an elasticity tensor for crystal plasticity.
- ComputeExtraStressConstantComputes a constant extra stress that is added to the stress calculated by the constitutive model
- ComputeExtraStressVDWGasComputes a hydrostatic stress corresponding to the pressure of a van der Waals gas that is added as an extra_stress to the stress computed by the constitutive model
- ComputeFiniteBeamStrainCompute a rotation increment for finite rotations of the beam and computes the small/large strain increments in the current rotated configuration of the beam.
- ComputeFiniteStrainCompute a strain increment and rotation increment for finite strains.
- ComputeFiniteStrainElasticStressCompute stress using elasticity for finite strains
- ComputeGlobalStrainMaterial for storing the global strain values from the scalar variable
- ComputeHomogenizedLagrangianStrainCalculate eigenstrain-like contribution from the homogenization strain used to satisfy the homogenization constraints.
- ComputeHypoelasticStVenantKirchhoffStressCalculate a small strain elastic stress that is equivalent to the hyperelastic St. Venant-Kirchhoff model if integrated using the Truesdell rate.
- ComputeIncrementalBeamStrainCompute a infinitesimal/large strain increment for the beam.
- ComputeIncrementalSmallStrainCompute a strain increment and rotation increment for small strains.
- ComputeIncrementalStrainCompute a strain increment and rotation increment for small strains.
- ComputeInstantaneousThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the instantaneous thermal expansion as a function of temperature
- ComputeInterfaceStressStress in the plane of an interface defined by the gradient of an order parameter
- ComputeIsotropicElasticityTensorCompute a constant isotropic elasticity tensor.
- ComputeLagrangianCauchyCustomStressCustom stress update providing the Cauchy stress
- ComputeLagrangianLinearElasticStressStress update based on the small (engineering) stress
- ComputeLagrangianObjectiveCustomStressStress update based on the small (engineering) stress
- ComputeLagrangianObjectiveCustomSymmetricStressStress update based on the small (engineering) stress
- ComputeLagrangianStrainCompute strain in Cartesian coordinates.
- ComputeLagrangianStrainAxisymmetricCylindricalCompute strain in 2D axisymmetric RZ coordinates.
- ComputeLagrangianStrainCentrosymmetricSphericalCompute strain in centrosymmetric spherical coordinates.
- ComputeLagrangianStressCustomPK2Stress update based on the first Piola-Kirchhoff stress
- ComputeLagrangianWPSStrainCompute strain in Cartesian coordinates.
- ComputeLagrangianWrappedStressStress update based on the small (engineering) stress
- ComputeLayeredCosseratElasticityTensorComputes Cosserat elasticity and flexural bending rigidity tensors relevant for simulations with layered materials. The layering direction is assumed to be perpendicular to the 'z' direction.
- ComputeLinearElasticPFFractureStressComputes the stress and free energy derivatives for the phase field fracture model, with small strain
- ComputeLinearElasticStressCompute stress using elasticity for small strains
- ComputeLinearViscoelasticStressDivides total strain into elastic + creep + eigenstrains
- ComputeMeanThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the mean thermal expansion as a function of temperature
- ComputeMultiPlasticityStressMaterial for multi-surface finite-strain plasticity
- ComputeMultipleCrystalPlasticityStressCrystal Plasticity base class: handles the Newton iteration over the stress residual and calculates the Jacobian based on constitutive laws from multiple material classes that are inherited from CrystalPlasticityStressUpdateBase
- ComputeMultipleInelasticCosseratStressCompute state (stress and other quantities such as plastic strains and internal parameters) using an iterative process, as well as Cosserat versions of these quantities. Only elasticity is currently implemented for the Cosserat versions. Combinations of creep models and plastic models may be used
- ComputeMultipleInelasticStressCompute state (stress and internal parameters such as plastic strains and internal parameters) using an iterative process. Combinations of creep models and plastic models may be used.
- ComputeNeoHookeanStressStress update based on the first Piola-Kirchhoff stress
- ComputePlaneFiniteStrainCompute strain increment and rotation increment for finite strain under 2D planar assumptions.
- ComputePlaneIncrementalStrainCompute strain increment for small strain under 2D planar assumptions.
- ComputePlaneSmallStrainCompute a small strain under generalized plane strain assumptions where the out of plane strain is generally nonzero.
- ComputePlasticHeatEnergyPlastic heat energy density = stress * plastic_strain_rate
- ComputeRSphericalFiniteStrainCompute a strain increment and rotation increment for finite strains in 1D spherical symmetry problems.
- ComputeRSphericalIncrementalStrainCompute a strain increment for incremental strains in 1D spherical symmetry problems.
- ComputeRSphericalSmallStrainCompute a small strain 1D spherical symmetry case.
- ComputeReducedOrderEigenstrainaccepts eigenstrains and computes a reduced order eigenstrain for consistency in the order of strain and eigenstrains.
- ComputeSimoHughesJ2PlasticityStressThe Simo-Hughes style J2 plasticity.
- ComputeSmallStrainCompute a small strain.
- ComputeSmearedCrackingStressCompute stress using a fixed smeared cracking model
- ComputeStVenantKirchhoffStressStress update based on the first Piola-Kirchhoff stress
- ComputeStrainIncrementBasedStressCompute stress after subtracting inelastic strain increments
- ComputeSurfaceTensionKKSSurface tension of an interface defined by the gradient of an order parameter
- ComputeThermalExpansionEigenstrainComputes eigenstrain due to thermal expansion with a constant coefficient
- ComputeThermalExpansionEigenstrainBeamComputes eigenstrain due to thermal expansion with a constant coefficient
- ComputeUpdatedEulerAngleThis class computes the updated Euler angle for crystal plasticity simulations. This needs to be used together with the ComputeMultipleCrystalPlasticityStress class, where the updated rotation material property is computed.
- ComputeVariableBaseEigenStrainComputes Eigenstrain based on material property tensor base
- ComputeVariableEigenstrainComputes an Eigenstrain and its derivatives that is a function of multiple variables, where the prefactor is defined in a derivative material
- ComputeVariableIsotropicElasticityTensorCompute an isotropic elasticity tensor for elastic constants that change as a function of material properties
- ComputeVolumetricDeformGradComputes volumetric deformation gradient and adjusts the total deformation gradient
- ComputeVolumetricEigenstrainComputes an eigenstrain that is defined by a set of scalar material properties that summed together define the volumetric change. This also computes the derivatives of that eigenstrain with respect to a supplied set of variable dependencies.
- CrystalPlasticityHCPDislocationSlipBeyerleinUpdateTwo-term dislocation slip model for hexagonal close packed crystals from Beyerline and Tome
- CrystalPlasticityKalidindiUpdateKalidindi version of homogeneous crystal plasticity.
- CrystalPlasticityTwinningKalidindiUpdateTwinning propagation model based on Kalidindi's treatment of twinning in a FCC material
- DensityScalingAutomatically scale the material density to achieve the desired time step size to satisfy CFL conditions.
- EigenDecompositionMaterialEmits material properties for the eigenvalues and eigenvectors of a symmetric rank two tensor.
- EshelbyTensorComputes the Eshelby tensor as a function of strain energy density and the first Piola-Kirchhoff stress
- ExponentialSofteningSoftening model with an exponential softening response upon cracking. This class is intended to be used with ComputeSmearedCrackingStress.
- FiniteStrainCPSlipRateResDeprecated class: please use CrystalPlasticityKalidindiUpdate and ComputeMultipleCrystalPlasticityStress instead.
- FiniteStrainCrystalPlasticityDeprecated class: please use CrystalPlasticityKalidindiUpdate and ComputeMultipleCrystalPlasticityStress instead. Crystal Plasticity base class: FCC system with power law flow rule implemented
- FiniteStrainHyperElasticViscoPlasticMaterial class for hyper-elastic viscoplatic flow: Can handle multiple flow models defined by flowratemodel type user objects
- FiniteStrainPlasticMaterialAssociative J2 plasticity with isotropic hardening.
- FiniteStrainUObasedCPUserObject based Crystal Plasticity system.
- FluxBasedStrainIncrementCompute strain increment based on flux
- GBRelaxationStrainIncrementCompute strain increment based on lattice relaxation at grain boundaries
- GeneralizedKelvinVoigtModelGeneralized Kelvin-Voigt model composed of a serial assembly of unit Kelvin-Voigt modules
- GeneralizedMaxwellModelGeneralized Maxwell model composed of a parallel assembly of unit Maxwell modules
- HillConstantsBuild and rotate the Hill Tensor. It can be used with other Hill plasticity and creep materials.
- HillCreepStressUpdateThis class uses the stress update material in a generalized radial return anisotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- HillElastoPlasticityStressUpdateThis class uses the generalized radial return for anisotropic elasto-plasticity model.This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- HillPlasticityStressUpdateThis class uses the generalized radial return for anisotropic plasticity model.This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- HyperElasticPhaseFieldIsoDamageComputes damaged stress and energy in the intermediate configuration assuming isotropy
- HyperbolicViscoplasticityStressUpdateThis class uses the discrete material for a hyperbolic sine viscoplasticity model in which the effective plastic strain is solved for using a creep approach.
- InclusionPropertiesCalculate quantities used to define the analytical elasticity solution to the inclusion problem.
- IsotropicPlasticityStressUpdateThis class uses the discrete material in a radial return isotropic plasticity model. This class is one of the basic radial return constitutive models, yet it can be used in conjunction with other creep and plasticity materials for more complex simulations.
- IsotropicPowerLawHardeningStressUpdateThis class uses the discrete material in a radial return isotropic plasticity power law hardening model, solving for the yield stress as the intersection of the power law relation curve and Hooke's law. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- LAROMANCEPartitionStressUpdateLAROMANCE base class for partitioned reduced order models
- LAROMANCEStressUpdateBase class to calculate the effective creep strain based on the rates predicted by a material specific Los Alamos Reduced Order Model derived from a Visco-Plastic Self Consistent calculations.
- LinearElasticTrussComputes the linear elastic strain for a truss element
- LinearViscoelasticStressUpdateCalculates an admissible state (stress that lies on or within the yield surface, plastic strains, internal parameters, etc). This class is intended to be a parent class for classes with specific constitutive models.
- MultiPhaseStressMaterialCompute a global stress from multiple phase stresses
- NonlocalDamageNonlocal damage model. Given an RadialAverage UO this creates a new damage index that can be used as for ComputeDamageStress without havign to change existing local damage models.
- PlasticTrussComputes the stress and strain for a truss element with plastic behavior defined by either linear hardening or a user-defined hardening function.
- PorosityFromStrainPorosity calculation from the inelastic strain.
- PowerLawCreepStressUpdateThis class uses the stress update material in a radial return isotropic power law creep model. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- PowerLawSofteningSoftening model with an abrupt stress release upon cracking. This class is intended to be used with ComputeSmearedCrackingStress.
- PureElasticTractionSeparationPure elastic traction separation law.
- RankFourTensorToSymmetricRankFourTensorConverts material property of type RankFourTensorTempl<double> to type SymmetricRankFourTensorTempl<double>
- RankTwoCartesianComponentAccess a component of a RankTwoTensor
- RankTwoCylindricalComponentCompute components of a rank-2 tensor in a cylindrical coordinate system
- RankTwoDirectionalComponentCompute a Direction scalar property of a RankTwoTensor
- RankTwoInvariantCompute a invariant property of a RankTwoTensor
- RankTwoSphericalComponentCompute components of a rank-2 tensor in a spherical coordinate system
- RankTwoTensorToSymmetricRankTwoTensorConverts material property of type RankTwoTensorTempl<double> to type SymmetricRankTwoTensorTempl<double>
- SalehaniIrani3DCTraction3D Coupled (3DC) cohesive law of Salehani and Irani with no damage
- ScalarMaterialDamageScalar damage model for which the damage is prescribed by another material
- StrainAdjustedDensityCreates density material property
- StrainEnergyDensityComputes the strain energy density using a combination of the elastic and inelastic components of the strain increment, which is a valid assumption for monotonic behavior.
- StrainEnergyRateDensityComputes the strain energy density rate using a combination of the elastic and inelastic components of the strain increment, which is a valid assumption for monotonic behavior.
- StressBasedChemicalPotentialChemical potential from stress
- SumTensorIncrementsCompute tensor property by summing tensor increments
- SymmetricIsotropicElasticityTensorCompute a constant isotropic elasticity tensor.
- SymmetricRankFourTensorToRankFourTensorConverts material property of type SymmetricRankFourTensorTempl<double> to type RankFourTensorTempl<double>
- SymmetricRankTwoTensorToRankTwoTensorConverts material property of type SymmetricRankTwoTensorTempl<double> to type RankTwoTensorTempl<double>
- TemperatureDependentHardeningStressUpdateComputes the stress as a function of temperature and plastic strain from user-supplied hardening functions. This class can be used in conjunction with other creep and plasticity materials for more complex simulations
- TensileStressUpdateAssociative, smoothed, tensile (Rankine) plasticity with hardening/softening
- ThermalFractureIntegralCalculates summation of the derivative of the eigenstrains with respect to temperature.
- TwoPhaseStressMaterialCompute a global stress in a two phase model
- VolumeDeformGradCorrectedStressTransforms stress with volumetric term from previous configuration to this configuration
- WaveSpeedCalculate the wave speed as where is the effective stiffness, and is the material density.
- Navier Stokes App
- ADDittusBoelterFunctorMaterialComputes wall heat transfer coefficient using Dittus-Boelter equation
- AirAir.
- ConservedVarValuesMaterialProvides access to variables for a conserved variable set of density, total fluid energy, and momentum
- DittusBoelterFunctorMaterialComputes wall heat transfer coefficient using Dittus-Boelter equation
- ExponentialFrictionFunctorMaterialComputes a Reynolds number-exponential friction factor.
- ExponentialFrictionMaterialComputes a Reynolds number-exponential friction factor.
- FunctorErgunDragCoefficientsMaterial providing linear and quadratic drag coefficients based on the correlation developed by Ergun.
- FunctorKappaFluidZero-thermal dispersion conductivity
- GeneralFluidPropsComputes fluid properties using a (P, T) formulation
- GeneralFunctorFluidPropsCreates functor fluid properties using a (P, T) formulation
- GenericPorousMediumMaterialComputes generic material properties related to simulation of fluid flow in a porous medium
- INSAD3EqnThis material computes properties needed for stabilized formulations of the mass, momentum, and energy equations.
- INSADMaterialThis is the material class used to compute some of the strong residuals for the INS equations.
- INSADStabilized3EqnThis is the material class used to compute the stabilization parameter tau for momentum and tau_energy for the energy equation.
- INSADTauMaterialThis is the material class used to compute the stabilization parameter tau.
- INSFEMaterialComputes generic material properties related to simulation of fluid flow
- INSFVEnthalpyFunctorMaterialThis is the material class used to compute enthalpy for the incompressible/weakly-compressible finite-volume implementation of the Navier-Stokes equations.
- INSFVEnthalpyMaterialThis is the material class used to compute enthalpy for the incompressible/weakly-compressible finite-volume implementation of the Navier-Stokes equations.
- INSFVMushyPorousFrictionFunctorMaterialComputes the mushy zone porous resistance for solidification/melting problems.
- INSFVMushyPorousFrictionMaterialComputes the mushy zone porous resistance for solidification/melting problems.
- INSFVkEpsilonViscosityFunctorMaterialComputes the turbulent dynamic viscosity given k and epsilon.
- INSFVkEpsilonViscosityMaterialComputes the turbulent dynamic viscosity given k and epsilon.
- LinearFVEnthalpyFunctorMaterialCreates functors for conversions between specific enthalpy and temperature
- LinearFrictionFactorFunctorMaterialMaterial class used to compute a friction factor of the form A * f(r, t) + B * g(r, t) * |v_I| with A, B vector constants, f(r, t) and g(r, t) functors of space and time, and |v_I| the interstitial speed
- MDFluidMaterialComputes generic material properties related to simulation of fluid flow
- MixingLengthTurbulentViscosityFunctorMaterialComputes the material property corresponding to the total viscositycomprising the mixing length model turbulent total_viscosityand the molecular viscosity.
- MixingLengthTurbulentViscosityMaterialComputes the material property corresponding to the total viscositycomprising the mixing length model turbulent total_viscosityand the molecular viscosity.
- NSFVDispersePhaseDragFunctorMaterialComputes drag coefficient for dispersed phase.
- NSFVFrictionFlowDiodeFunctorMaterialIncreases the anistropic friction coefficients, linear or quadratic, by K_i * |direction_i| when the diode is turned on with a boolean
- NSFVFrictionFlowDiodeMaterialIncreases the anistropic friction coefficients, linear or quadratic, by K_i * |direction_i| when the diode is turned on with a boolean
- NSFVMixtureFunctorMaterialCompute the arithmetic mean of material properties using a phase fraction.
- NSFVMixtureMaterialCompute the arithmetic mean of material properties using a phase fraction.
- NSFVPumpFunctorMaterialComputes the effective pump body force.
- NSFVPumpMaterialComputes the effective pump body force.
- NonADGeneralFunctorFluidPropsCreates functor fluid properties using a (P, T) formulation
- PINSFEMaterialComputes generic material properties related to simulation of fluid flow in a porous medium
- PINSFVSpeedFunctorMaterialThis is the material class used to compute the interstitial velocity norm for the incompressible and weakly compressible primitive superficial finite-volume implementation of porous media equations.
- PorousConservedVarMaterialProvides access to variables for a conserved variable set of density, total fluid energy, and momentum
- PorousMixedVarMaterialProvides access to variables for a primitive variable set of pressure, temperature, and superficial velocity
- PorousPrimitiveVarMaterialProvides access to variables for a primitive variable set of pressure, temperature, and superficial velocity
- ReynoldsNumberFunctorMaterialComputes a Reynolds number.
- RhoFromPTFunctorMaterialComputes the density from coupled pressure and temperature functors (variables, functions, functor material properties
- SoundspeedMatComputes the speed of sound
- ThermalDiffusivityFunctorMaterialComputes the thermal diffusivity given the thermal conductivity, specific heat capacity, and fluid density.
- WCNSFV2PSlipVelocityFunctorMaterialComputes the slip velocity for two-phase mixture model.
- WCNSLinearFVMixtureFunctorMaterialCompute the arithmetic mean of material properties using a phase fraction.
- Solid Properties App
- ADConstantDensityThermalSolidPropertiesMaterialComputes solid thermal properties as a function of temperature but with a constant density.
- ADThermalSolidPropertiesMaterialComputes solid thermal properties as a function of temperature
- ADTungstenThermalPropertiesMaterialComputes tungsten thermal properties as a function of temperature
- ConstantDensityThermalSolidPropertiesMaterialComputes solid thermal properties as a function of temperature but with a constant density.
- ThermalSolidPropertiesFunctorMaterialComputes solid thermal properties as a function of temperature
- ThermalSolidPropertiesMaterialComputes solid thermal properties as a function of temperature
- TungstenThermalPropertiesMaterialComputes tungsten thermal properties as a function of temperature
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.
- Boundary2DDelaunayGeneratorMesh generator that convert a 2D surface given as one or a few boundaries of a 3D mesh into a 2D mesh using Delaunay triangulation.
- BoundaryDeletionGeneratorMesh generator which removes side sets
- BoundaryElementConversionGeneratorConvert the elements involved in a set of external boundaries to ensure that the boundary set only contains TRI3 elements
- BoundaryLayerSubdomainGeneratorChanges the subdomain ID of elements near the specified boundary(ies).
- 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.
- CutMeshByLevelSetGeneratorThis CutMeshByLevelSetGenerator object is designed to trim the input mesh by removing all the elements on outside the give level set with special processing on the elements crossed by the cutting surface to ensure a smooth cross-section. The output mesh only consists of TET4 elements.
- 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 plane 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.
- ElementOrderConversionGeneratorMesh generator which converts orders of elements
- ElementSubdomainIDGeneratorAllows the user to assign each element the subdomain ID of their choice
- ElementsToSimplicesConverterSplits all non-simplex elements in a mesh into simplices.
- ElementsToTetrahedronsConverterThis ElementsToTetrahedronsConverter object is designed to convert all the elements in a 3D mesh consisting only linear elements into TET4 elements.
- ExamplePatchMeshGeneratorCreates 2D or 3D patch meshes.
- 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, EDGE3, or EDGE4 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).
- ParsedExtraElementIDGeneratorUses a parsed expression to set an extra element id for elements (via their centroids).
- ParsedGenerateNodesetA MeshGenerator that adds nodes to a nodeset if the node satisfies the expressionexpression.
- ParsedGenerateSidesetA MeshGenerator that adds element sides to a sideset if the centroid of the side satisfies the combinatorial_geometryexpression.
- ParsedNodeTransformGeneratorApplies a transform to a the x,y,z coordinates of a Mesh
- ParsedSubdomainIDsGeneratorUses a parsed expression to determine the subdomain ids of included elements.
- 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.
- StitchMeshGeneratorAllows multiple mesh files to be stitched together to form a single mesh.
- 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.
- XYZDelaunayGeneratorCreates tetrahedral 3D meshes within boundaries defined by input meshes.
- 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.
- MFEMMeshClass to read in and store an mfem::ParMesh from file.
- 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.
- BatchMeshGeneratorAction
- Partitioner
- Peridynamics App
- MeshGeneratorPDMesh generator class to convert FE mesh to PD mesh
- PeridynamicsMeshMesh class to store and return peridynamics specific mesh data
- 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 PinMeshGenerator. A 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.
- ControlDrumMeshGeneratorThis ControlDrumMeshGenerator object is designed to generate drum-like structures, with IDs, from a reactor geometry. These structures can be used directly within CoreMeshGenerator to stitchcontrol drums into a core lattice alongside AssemblyMeshGenerator structures
- 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/or ControlDrumMeshGenerator 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 an extra element integer for elements on a mesh based on material and other extra element IDs that is typically used for depletion.
- 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.
- RevolveGeneratorThis RevolveGenerator object is designed to revolve a 1D mesh into 2D, or a 2D mesh into 3D based on an axis.
- 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.
- External Petsc Solver App
- PETScDMDAMeshCreate a square mesh from PETSc DMDA.
- Thermal Hydraulics App
- THMMeshCreates a mesh (nodes and elements) for the Components
- Heat Transfer App
- PatchSidesetGeneratorDivides the given sideset into smaller patches of roughly equal size.
- Sub Channel App
- DetailedQuadPinMeshGeneratorCreates a detailed mesh of fuel pins in a square lattice arrangement
- DetailedQuadSubChannelMeshGeneratorCreates a detailed mesh of subchannels in a square lattice arrangement
- DetailedTriPinMeshGeneratorCreates a detailed mesh of fuel pins in a triangular lattice arrangement
- DetailedTriSubChannelMeshGeneratorCreates a detailed mesh of subchannels in a triangular lattice arrangement
- QuadPinMeshGeneratorCreates a mesh of 1D fuel pins in a square lattice arrangement
- QuadSubChannelMeshGeneratorCreates a mesh of 1D subchannels in a square lattice arrangement
- SCMDetailedQuadPinMeshGeneratorCreates a detailed mesh of fuel pins in a square lattice arrangement
- SCMDetailedQuadSubChannelMeshGeneratorCreates a detailed mesh of subchannels in a square lattice arrangement
- SCMDetailedTriPinMeshGeneratorCreates a detailed mesh of fuel pins in a triangular lattice arrangement
- SCMDetailedTriSubChannelMeshGeneratorCreates a detailed mesh of subchannels in a triangular lattice arrangement
- SCMQuadPinMeshGeneratorCreates a mesh of 1D fuel pins in a square lattice arrangement
- SCMQuadSubChannelMeshGeneratorCreates a mesh of 1D subchannels in a square lattice arrangement
- SCMTriDuctMeshGeneratorCreates a mesh of 1D duct cells around a triangular lattice subassembly
- SCMTriPinMeshGeneratorCreates a mesh of 1D fuel pins in a triangular lattice arrangement
- SCMTriSubChannelMeshGeneratorCreates a mesh of 1D subchannels in a triangular lattice arrangement
- TriDuctMeshGeneratorCreates a mesh of 1D duct cells around a triangular lattice subassembly
- TriPinMeshGeneratorCreates a mesh of 1D fuel pins in a triangular lattice arrangement
- TriSubChannelMeshGeneratorCreates a mesh of 1D subchannels in a triangular lattice arrangement
- QuadSubChannelMeshCreates an subchannel mesh container for a square lattice arrangement
- TriSubChannelMeshCreates an subchannel mesh container for a triangular lattice arrangement
- Phase Field App
- EBSDMeshGeneratorMesh generated from a specified DREAM.3D EBSD data file.
- SphereSurfaceMeshGeneratorGenerated sphere mesh - a two dimensional manifold embedded in three dimensional space
- EBSDMeshMesh generated from a specified DREAM.3D EBSD data file.
Mesh/BatchMeshGeneratorAction
- Moose App
- BatchMeshGeneratorActionBatch generate meshes using actions.
Mesh/Partitioner
- Moose App
- PartitionerActionAdd a Partitioner object to the simulation.
- BlockWeightedPartitionerPartition mesh by weighting blocks
- CopyMeshPartitionerAssigns element to match the partitioning of another mesh. If in a child application, defaults to the parent app mesh if the other mesh is not specified programmatically.
- GridPartitionerCreate a uniform grid that overlays the mesh to be partitioned. Assign all elements within each cell of the grid to the same processor.
- HierarchicalGridPartitionerPartitions a mesh into sub-partitions for each computational node then into partitions within that node. All partitions are made using a regular grid.
- LibmeshPartitionerMesh partitioning using capabilities defined in libMesh.
- PetscExternalPartitionerPartition mesh using external packages via PETSc MatPartitioning interface
- RandomPartitionerAssigns element processor ids randomly with a given seed.
- SingleRankPartitionerAssigns element processor ids to a single MPI rank.
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
MeshModifiers
- Moose App
- AddMeshModifiersActionAdd a MeshModifier object to the simulation.
- ActivateElementsByPathDetermine activated elements.
- ActivateElementsCoupledDetermine activated elements.
- CoupledVarThresholdElementSubdomainModifierModify the element subdomain ID if a coupled variable satisfies the criterion for the threshold (above, equal, or below)
- SidesetAroundSubdomainUpdaterSets up a boundary between inner_subdomains and outer_subdomains
- TimedSubdomainModifierModify element subdomain ID of entire subdomains for given points in time. This mesh modifier only runs on the undisplaced mesh, and it will modify both the undisplaced and the displaced mesh.
- VariableValueElementSubdomainModifierModify the element subdomain ID based on the provided variable value.
- XFEMApp
- CutElementSubdomainModifierChange element subdomain based on CutSubdomainID
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
- Sodium App
- SodiumLiquidFluidPropertiesFluid properties of sodium vapor.
- SodiumTwoPhaseFluidPropertiesTwo-phase sodium fluid properties
- SodiumVaporFluidPropertiesFluid properties of sodium vapor.
- Air App
- AirSBTLFluidPropertiesFluid properties of air (gas phase).
- Nitrogen App
- NitrogenSBTLFluidPropertiesFluid properties of nitrogen (gas phase).
- Potassium App
- PotassiumLiquidFluidPropertiesFluid properties of potassium vapor.
- PotassiumTwoPhaseFluidPropertiesTwo-phase potassium fluid properties
- PotassiumVaporFluidPropertiesFluid properties of potassium vapor.
- Carbon Dioxide App
- CarbonDioxideHEMFluidPropertiesFluid properties of carbon dioxide for the homogeneous equilibrium model.
- CarbonDioxideLiquidFluidPropertiesFluid properties of liquid carbon dioxide (meta stable).
- CarbonDioxideTwoPhaseFluidPropertiesTwo-phase carbon dioxide fluid properties
- CarbonDioxideVaporFluidPropertiesFluid properties of steam (meta stable).
- Thermal Hydraulics App
- LinearFluidPropertiesFluid properties for a fluid with density linearly dependent on temperature and pressure
- Fluid Properties App
- AddFluidPropertiesDeprecatedActionAdd a UserObject object to the simulation.
- BrineFluidPropertiesFluid properties for brine
- CO2FluidPropertiesFluid properties for carbon dioxide (CO2) using the Span & Wagner EOS
- CaloricallyImperfectGasFluid properties for an ideal gas with imperfect caloric behavior.
- FlibeFluidPropertiesFluid properties for flibe
- FlinakFluidPropertiesFluid properties for flinak
- HeliumFluidPropertiesFluid properties for helium
- HydrogenFluidPropertiesFluid properties for Hydrogen (H2)
- IdealGasFluidPropertiesFluid properties for an ideal gas
- IdealGasMixtureFluidPropertiesClass for fluid properties of an ideal gas mixture
- IdealRealGasMixtureFluidPropertiesClass for fluid properties of an arbitrary vapor mixture
- LeadBismuthFluidPropertiesFluid properties for Lead Bismuth eutectic 2LiF-BeF2
- LeadFluidPropertiesFluid properties for Lead
- LeadLithiumFluidPropertiesFluid properties for Lead Lithium eutectic (83% Pb, 17% Li)
- MethaneFluidPropertiesFluid properties for methane (CH4)
- NaClFluidPropertiesFluid properties for NaCl
- NaKFluidPropertiesFluid properties for NaK
- NitrogenFluidPropertiesFluid properties for Nitrogen (N2)
- SalineMoltenSaltFluidPropertiesMolten salt fluid properties using Saline
- SimpleFluidPropertiesFluid properties for a simple fluid with a constant bulk density
- SodiumPropertiesFluid properties for sodium
- SodiumSaturationFluidPropertiesFluid properties for liquid sodium at saturation conditions
- StiffenedGasFluidPropertiesFluid properties for a stiffened gas
- StiffenedGasTwoPhaseFluidPropertiesTwo-phase stiffened gas fluid properties
- TabulatedBicubicFluidPropertiesFluid properties using bicubic interpolation on tabulated values provided
- TabulatedFluidPropertiesFluid properties using bicubic interpolation on tabulated values provided
- TemperaturePressureFunctionFluidPropertiesSingle-phase fluid properties that allows to provide thermal conductivity, density, and viscosity as functions of temperature and pressure.
- TwoPhaseFluidPropertiesIndependent2-phase fluid properties for 2 independent single-phase fluid properties
- TwoPhaseNCGPartialPressureFluidPropertiesTwo-phase fluid with single NCG using partial pressure mixture model
- Water97FluidPropertiesFluid properties for water and steam (H2O) using IAPWS-IF97
- Sub Channel App
- PBSodiumFluidPropertiesClass that provides the methods that realize the equations of state for Liquid Sodium
- Helium App
- HeliumSBTLFluidPropertiesFluid properties of nirtogen (gas phase).
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
- NSFVActionDeprecationHelper class to smooth the deprecation of the NSFV Action
- WCNSFVFlowPhysicsDefine the Navier Stokes weakly-compressible mass and momentum equations
- WCNSFVFluidHeatTransferPhysicsDefine the Navier Stokes weakly-compressible energy equation
- WCNSFVScalarTransportPhysicsDefine the Navier Stokes weakly-compressible scalar field transport equation(s) using the nonlinear finite volume discretization
- WCNSFVTurbulencePhysicsDefine a turbulence model for a incompressible or weakly-compressible Navier Stokes flow 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
- Peridynamics App
- MechanicsActionPDClass for setting up peridynamic kernels
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
- Phase Field App
- GrainGrowthLinearizedInterfaceActionSet up the variable and the kernels needed for a grain growth simulation with a linearized interface
Modules/PhaseField/GrandPotential
- Phase Field App
- GrandPotentialKernelActionAutomatically generate most or all of the kernels for the grand potential model
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
- Solid Properties App
- AddSolidPropertiesDeprecatedActionAdd a UserObject object to the simulation.
- ThermalCompositeSiCPropertiesComposite silicon carbide thermal properties.
- ThermalFunctionSolidPropertiesFunction-based thermal properties.
- ThermalGraphitePropertiesGraphite thermal properties.
- ThermalMonolithicSiCPropertiesMonolithic silicon carbide thermal properties.
- ThermalSS316PropertiesStainless steel 316 thermal properties.
- ThermalUCPropertiesUranium Carbide (UC) thermal properties (SI units).
Modules/TensorMechanics
Modules/TensorMechanics/CohesiveZoneMaster
- Solid Mechanics App
- CommonCohesiveZoneActionStore common cohesive zone paramters
- CohesiveZoneActionAction to create an instance of the cohesive zone model kernel for each displacement component
Modules/TensorMechanics/DynamicMaster
- Solid Mechanics App
- CommonSolidMechanicsActionStore common solid mechanics parameters
- DynamicSolidMechanicsPhysicsSet up dynamic stress divergence kernels
Modules/TensorMechanics/GeneralizedPlaneStrain
- Solid Mechanics App
- GeneralizedPlaneStrainActionSet up the GeneralizedPlaneStrain environment
Modules/TensorMechanics/GlobalStrain
- Solid Mechanics App
- GlobalStrainActionSet up the GlobalStrainAction environment
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
- Solid Mechanics App
- CommonSolidMechanicsActionStore common solid mechanics parameters
- QuasiStaticSolidMechanicsPhysicsSet up stress divergence kernels with coordinate system aware logic
Modules/TensorMechanics/MaterialVectorBodyForce
- Solid Mechanics App
- MaterialVectorBodyForceActionSet up volumetric body force kernels
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
- Moose App
- NEML2ActionCommonParse a NEML2 input file
- NEML2ActionSet up the NEML2 material model
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.
- UserForcingFunctorNodalKernelResidual contribution to an ODE from a source functor acting at nodes.
- 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.
- 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.
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
- Moose App
- AutoCheckpointActionAction to create shortcut syntax-specified checkpoints and automatic checkpoints.
- CommonOutputActionAdds short-cut syntax and common parameters to the Outputs block.
- MaterialOutputActionOutputs material properties to various Outputs objects, based on the parameters set in each Material
- AddOutputActionAction responsible for creating Output objects.
- BlockRestrictionDebugOutputDebug output object for displaying information regarding block-restriction of objects.
- CSVOutput for postprocessors, vector postprocessors, and scalar variables using comma seperated values (CSV).
- CheckpointOutput for MOOSE recovery checkpoint files.
- ConsoleObject for screen output.
- ControlOutputOutput for displaying objects and parameters associated with the Control system.
- DOFMapOutput degree-of-freedom (DOF) map.
- ExodusObject for output data in the Exodus format
- GMVObject for outputting data in the GMV format
- GnuplotOutput for postprocessors and scalar variables in GNU plot format.
- JSONOutput for Reporter values using JSON format.
- MFEMConduitDataCollectionOutput for controlling MFEMConduitDataCollection inherited data.
- MFEMParaViewDataCollectionOutput for controlling export to an mfem::ParaViewDataCollection.
- MFEMVisItDataCollectionOutput for controlling export to an mfem::VisItDataCollection.
- MaterialPropertyDebugOutputDebug output object for displaying material property information.
- NemesisObject for output data in the Nemesis (parallel ExodusII) format.
- PNGOutputOutput data in the PNG format
- PerfGraphOutputControls output of the PerfGraph: the performance log for MOOSE
- ProgressOutput a simulation time progress bar on the console.
- ReporterDebugOutputDebug output object for displaying Reporter information.
- SolutionHistoryOutputs the non-linear and linear iteration solve history.
- SolutionInvalidityOutputControls output of the time history of solution invalidity object
- TecplotObject for outputting data in the Tecplot format
- TopResidualDebugOutputDebug output object for displaying the top contributing residuals.
- VTKOutput data using the Visualization Toolkit (VTK).
- VariableResidualNormsDebugOutputReports the residual norm for each variable.
- XDAObject for outputting data in the XDA/XDR format.
- XDRObject for outputting data in the XDA/XDR format.
- XMLOutputOutput for VectorPostprocessor using XML format.
- Optimization App
- ExodusOptimizationSteadyObject for output data in the Exodus format
- XFEMApp
- XFEMCutMeshOutputOutputs XFEM MeshCutUserObjectBase cutter mesh in Exodus format.
- Stochastic Tools App
- MappingOutputOutput for mapping model data.
- SurrogateTrainerOutputOutput for trained surrogate model data.
- Thermal Hydraulics App
- THMOutputVectorVelocityActionLets the user specify the variable type for the velocity output
- THMSetupOutputActionSets up output for THM.
- ParaviewComponentAnnotationMapBase class for all file-based output
- Geochemistry App
- GeochemicalModelInterrogatorPerforming simple manipulations of and querying a geochemical model
- GeochemistryConsoleOutputOutputs results from a GeochemistryReactor at a particular point
- Sub Channel App
- QuadSubChannelNormalSliceValuesPrints out a user selected value at a user selected axial height in a matrix format to be used for post-processing
- Ray Tracing App
- RayTracingExodusOutputs ray segments and data as segments using the Exodus format.
- RayTracingNemesisOutputs ray segments and data as segments using the Nemesis format.
ParameterStudy
- Stochastic Tools App
- ParameterStudyActionBuilds objects to set up a basic parameter study.
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
- HeatConductionCGCreates the heat conduction equation discretized with CG
Physics/HeatConduction/FiniteVolume
- Heat Transfer App
- HeatConductionFVCreates the heat conduction equation discretized with nonlinear finite volume
Physics/MultiSpeciesDiffusion
Physics/MultiSpeciesDiffusion/ContinuousGalerkin
- Scalar Transport App
- MultiSpeciesDiffusionCGDiscretizes diffusion equations for several species with the continuous Galerkin finite element method
Physics/NavierStokes
Physics/NavierStokes/Flow
- Navier Stokes App
- WCNSFVFlowPhysicsDefine the Navier Stokes weakly-compressible mass and momentum equations
Physics/NavierStokes/FlowSegregated
- Navier Stokes App
- WCNSLinearFVFlowPhysicsDefine the Navier Stokes weakly-compressible equations with the linear solver implementation of the SIMPLE scheme
Physics/NavierStokes/FluidHeatTransfer
- Navier Stokes App
- WCNSFVFluidHeatTransferPhysicsDefine the Navier Stokes weakly-compressible energy equation
Physics/NavierStokes/FluidHeatTransferSegregated
- Navier Stokes App
- WCNSLinearFVFluidHeatTransferPhysicsDefine the Navier Stokes weakly-compressible energy equation
Physics/NavierStokes/ScalarTransport
- Navier Stokes App
- WCNSFVScalarTransportPhysicsDefine the Navier Stokes weakly-compressible scalar field transport equation(s) using the nonlinear finite volume discretization
Physics/NavierStokes/ScalarTransportSegregated
- Navier Stokes App
- WCNSLinearFVScalarTransportPhysicsDefine the Navier Stokes weakly-compressible scalar field transport equation(s) using the linear finite volume discretization
Physics/NavierStokes/SolidHeatTransfer
- Navier Stokes App
- PNSFVSolidHeatTransferPhysicsDefine the Navier Stokes porous media solid energy equation
Physics/NavierStokes/Turbulence
- Navier Stokes App
- WCNSFVTurbulencePhysicsDefine a turbulence model for a incompressible or weakly-compressible Navier Stokes flow with a finite volume discretization
Physics/NavierStokes/TwoPhaseMixture
- Navier Stokes App
- WCNSFVTwoPhaseMixturePhysicsDefine the additional terms for a mixture model for the two phase weakly-compressible Navier Stokes equations
Physics/NavierStokes/TwoPhaseMixtureSegregated
- Navier Stokes App
- WCNSLinearFVTwoPhaseMixturePhysicsDefine the additional terms for a mixture model for the two phase weakly-compressible Navier Stokes equations using the linearized segregated finite volume discretization
Physics/SolidMechanics
Physics/SolidMechanics/CohesiveZone
- Solid Mechanics App
- CommonCohesiveZoneActionStore common cohesive zone paramters
- CohesiveZoneActionAction to create an instance of the cohesive zone model kernel for each displacement component
Physics/SolidMechanics/Dynamic
- Solid Mechanics App
- CommonSolidMechanicsActionStore common solid mechanics parameters
- DynamicSolidMechanicsPhysicsSet up dynamic stress divergence kernels
Physics/SolidMechanics/GeneralizedPlaneStrain
- Solid Mechanics App
- GeneralizedPlaneStrainActionSet up the GeneralizedPlaneStrain environment
Physics/SolidMechanics/GlobalStrain
- Solid Mechanics App
- GlobalStrainActionSet up the GlobalStrainAction environment
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
- Solid Mechanics App
- MaterialVectorBodyForceActionSet up volumetric body force kernels
Physics/SolidMechanics/QuasiStatic
- Solid Mechanics App
- CommonSolidMechanicsActionStore common solid mechanics parameters
- QuasiStaticSolidMechanicsPhysicsSet up stress divergence kernels with coordinate system aware logic
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.
- FunctorExtremaPositionsSearches the geometry for the extrema of the functors
- FunctorPositionsComputes positions from groups of three functors specified by the user
- 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.
- NodePositionsPositions of element nodes.
- ParsedDownSelectionPositionsExamines input positions object(s) to find all positions matching a user-specifed parsed expression criterion. The order of the positions in the input is kept.
- QuadraturePointsPositionsPositions of element quadrature points.
- ReporterPositionsImport positions from one or more reporters, for example other Positions
- TransformedPositionsTransform, with a linear transformation, positions from another Positions object
- Sub Channel App
- SCMPinPositionsCreate positions at the pin positions in the SubChannel mesh.
- 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. Inner-numbering is within a radial ring.
Postprocessors
- Moose App
- AddPostprocessorActionAdd a Postprocessor object to the simulation.
- ADElementAverageMaterialPropertyComputes the average of a material property over a volume.
- ADElementExtremeFunctorValueFinds either the min or max elemental value of a functor over the domain.
- ADElementExtremeMaterialPropertyDetermines the minimum or maximum of a material property over a volume.
- ADElementIntegralFunctorPostprocessorComputes a volume integral of the specified functor
- ADElementIntegralMaterialPropertyCompute the integral of the material property over the domain
- ADElementL2FunctorErrorComputes L2 error between an 'approximate' functor and an 'exact' functor
- ADInterfaceDiffusiveFluxAverageComputes the diffusive flux on the interface.
- ADInterfaceDiffusiveFluxIntegralComputes the diffusive flux on the interface.
- ADSideAdvectiveFluxIntegralComputes the volumetric advected quantity through a sideset.
- ADSideAverageMaterialPropertyComputes the average of a material property over a side set.
- ADSideDiffusiveFluxAverageComputes the integral of the diffusive flux over the specified boundary
- ADSideDiffusiveFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- ADSideFluxAverageComputes the integral of the diffusive flux over the specified boundary
- ADSideFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- ADSideIntegralFunctorPostprocessorComputes a surface integral of the specified functor, using the single-sided face argument, which usually means that the functor will be evaluated from a single side of the surface, not interpolated between both sides.
- ADSideIntegralMaterialPropertyCompute the integral of a scalar material property component over the domain.
- ADSideVectorDiffusivityFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- AreaPostprocessorComputes the "area" or dimension - 1 "volume" of a given boundary or boundaries in your mesh.
- AverageElementSizeComputes the average element size.
- AverageNodalVariableValueComputes the average value of a field by sampling all nodal solutions on the domain or within a subdomain
- AverageVariableChangeComputes the volume-weighted L1 or L2 norm of the change of a variable over a time step or between nonlinear iterations.
- AxisymmetricCenterlineAverageValueComputes the average value of a variable on a sideset located along the centerline of an axisymmetric model.
- ChainControlDataPostprocessorGets a Real or bool chain control value.
- ChangeOverFixedPointPostprocessorComputes the change or relative change in a post-processor value over a single or multiple fixed point iterations
- ChangeOverTimePostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- ChangeOverTimestepPostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- ConstantPostprocessorPostprocessor that holds a constant value
- CumulativeValuePostprocessorCreates a cumulative sum of a Postprocessor value with time.
- DifferencePostprocessorComputes the difference between two postprocessors
- DiscreteVariableResidualNormComputes a discrete norm for a block-restricted variable residual.
- ElementArrayL2NormEvaluates L2-norm of a component of an array variable
- ElementAverageMaterialPropertyComputes the average of a material property over a volume.
- ElementAverageSecondTimeDerivativeComputes the element averaged second derivative of variable
- ElementAverageTimeDerivativeComputes a volume integral of the time derivative of a given variable
- ElementAverageValueComputes the volumetric average of a variable
- ElementExtremeFunctorValueFinds either the min or max elemental value of a functor over the domain.
- ElementExtremeMaterialPropertyDetermines the minimum or maximum of a material property over a volume.
- ElementExtremeValueFinds either the min or max elemental value of a variable over the domain.
- ElementH1ErrorComputes the H1 error between a variable and a function
- ElementH1SemiErrorReturns the gradient difference norm part of the H1 error
- ElementHCurlErrorReturns the H(curl)-norm of the difference between a pair of computed and analytical vector-valued solutions.
- ElementHCurlSemiErrorReturns the H(curl)-seminorm of the difference between a pair of computed and analytical vector-valued solutions.
- ElementHDivErrorReturns the H(div)-norm of the difference between a pair of computed and analytical vector-valued solutions.
- ElementHDivSemiErrorReturns the H(div)-seminorm of the difference between a pair of computed and analytical vector-valued solutions.
- ElementIntegralArrayVariablePostprocessorIntegral of one component of an array variable.
- ElementIntegralFunctorPostprocessorComputes a volume integral of the specified functor
- ElementIntegralMaterialPropertyCompute the integral of the material property over the domain
- ElementIntegralVariablePostprocessorComputes a volume integral of the specified variable
- ElementL1ErrorComputes L1 error between an elemental field variable and an analytical function.
- ElementL2DifferenceComputes the element-wise L2 difference between the current variable and a coupled variable.
- ElementL2ErrorComputes L2 error between a field variable and an analytical function
- ElementL2FunctorErrorComputes L2 error between an 'approximate' functor and an 'exact' functor
- ElementL2NormComputes a volume integral of the specified variable
- ElementMaxLevelPostProcessorComputes the maximum element adaptivity level (for either h or p refinement).
- ElementSidesL2NormComputes the L2 norm of a variable over element sides.
- ElementVectorL2ErrorReturns the L2-norm of the difference between a pair of computed and analytical vector-valued solutions.
- ElementW1pErrorComputes the W1p norm of the difference between a variable and an analytic solution, as a function
- ElementalVariableValueOutputs an elemental variable value at a particular location
- EmptyPostprocessorA postprocessor object that returns a value of zero.
- FindValueOnLineFind a specific target value along a sampling line. The variable values along the line should change monotonically. The target value is searched using a bisection algorithm.
- FunctionElementAverageComputes the average of a function over a volume.
- FunctionElementIntegralIntegrates a function over elements
- FunctionSideAverageComputes the average of a function over a boundary.
- FunctionSideIntegralComputes the integral of a function over a boundary.
- FunctionValuePostprocessorComputes the value of a supplied function at a single point (scalable)
- GreaterThanLessThanPostprocessorCount number of DOFs of a non-linear variable that are greater than or less than a given threshold
- InterfaceAverageVariableValuePostprocessorComputes the average value of a variable on an interface. Note that this cannot be used on the centerline of an axisymmetric model.
- InterfaceDiffusiveFluxAverageComputes the diffusive flux on the interface.
- InterfaceDiffusiveFluxIntegralComputes the diffusive flux on the interface.
- InterfaceIntegralVariableValuePostprocessorAdd access to variables and their gradient on an interface.
- InternalSideIntegralVariablePostprocessorComputes an integral on internal sides of the specified variable
- LibtorchControlValuePostprocessorReports the value stored in given controlled parameters.
- LinearCombinationPostprocessorComputes a linear combination between an arbitrary number of post-processors
- MFEML2ErrorComputes L2 error for gridfunctions using H1 or L2 elements.
- MFEMVectorFEInnerProductIntegralPostprocessorCalculates the total flux of a vector field through an interface
- MFEMVectorL2ErrorComputes L2 error for vector gridfunctions.
- MatrixSymmetryCheckReport whether a matrix is symmetric or not.
- MemoryUsageMemory usage statistics for the running simulation.
- NearestNodeNumberOutputs the nearest node number to a point
- NodalExtremeValueFinds either the min or max elemental value of a variable over the domain.
- NodalL2ErrorThe L2-norm of the difference between a variable and a function computed at nodes.
- NodalL2NormComputes the nodal L2-norm of the coupled variable, which is defined by summing the square of its value at every node and taking the square root.
- NodalMaxValueComputes the maximum (over all the nodal values) of a variable.
- NodalMaxValueIdFinds the node id with the maximum nodal value across all postprocessors.
- NodalProxyMaxValueFinds the node id with the maximum nodal value across all postprocessors.
- NodalSumComputes the sum of all of the nodal values of the specified variable. Note: This object sets the default "unique_node_execute" flag to true to avoid double counting nodes between shared blocks.
- NodalVariableValueOutputs values of a nodal variable at a particular location
- NumDOFsReturn the number of Degrees of freedom from either the NL, Aux or both systems.
- NumElementsReturn the number of active or total elements in the simulation.
- NumElemsReturn the number of active or total elements in the simulation.
- NumFailedTimeStepsCollects the number of failed time steps from the time stepper.
- NumFixedPointIterationsReturns the number of fixed point iterations taken by the executioner.
- NumLinearIterationsCompute the number of linear iterations.
- NumMeshDivisionsReturn the number of divisions/regions from a MeshDivision object.
- NumNodesReturns the total number of nodes in a simulation (works with DistributedMesh)
- NumNonlinearIterationsOutputs the number of nonlinear iterations
- NumPicardIterationsReturns the number of fixed point iterations taken by the executioner.
- NumPositionsReturn the number of Positions from a Positions object.
- NumRelationshipManagersReturn the number of relationship managers active.
- NumResidualEvaluationsReturns the total number of residual evaluations performed.
- NumTimeStepsReports the timestep number
- NumVarsReturn the number of variables from either the NL, Aux, or both systems.
- ParsedPostprocessorComputes a parsed expression with post-processors
- PercentChangePostprocessorComputes the percent change of a postprocessor value compared to the value at the previous timestep.
- PerfGraphDataRetrieves performance information about a section from the PerfGraph.
- PointValueCompute the value of a variable at a specified location
- PostprocessorComparisonCompares two post-processors and produces a boolean value
- PseudoTimestepComputes pseudo-time steps for obtaining steady-state solutions through a pseudo transient process.
- ReceiverReports the value stored in this processor, which is usually filled in by another object. The Receiver does not compute its own value.
- RelativeDifferencePostprocessorComputes the absolute value of the relative difference between 2 post-processor values.
- RelativeSolutionDifferenceNormComputes the relative norm of the solution difference of two consecutive time steps.
- ResidualReport the non-linear residual.
- ScalarL2ErrorCompute L2 error of a scalar variable using analytic function.
- ScalarVariableReturns the value of a scalar variable as a postprocessor value.
- ScalePostprocessorScales a post-processor by a value
- SideAdvectiveFluxIntegralComputes the volumetric advected quantity through a sideset.
- SideAverageFunctorPostprocessorComputes the average of a functor over a side set.
- SideAverageMaterialPropertyComputes the average of a material property over a side set.
- SideAverageValueComputes the average value of a variable on a sideset. Note that this cannot be used on the centerline of an axisymmetric model.
- SideDiffusiveFluxAverageComputes the integral of the diffusive flux over the specified boundary
- SideDiffusiveFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- SideExtremeValueFinds either the min or max variable value of a variable over a boundary.
- SideFVFluxBCIntegralComputes the side integral of different finite volume flux boundary conditions.
- SideFluxAverageComputes the integral of the diffusive flux over the specified boundary
- SideFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- SideIntegralFunctorPostprocessorComputes a surface integral of the specified functor, using the single-sided face argument, which usually means that the functor will be evaluated from a single side of the surface, not interpolated between both sides.
- SideIntegralMaterialPropertyCompute the integral of a scalar material property component over the domain.
- SideIntegralVariablePostprocessorComputes a surface integral of the specified variable
- SideVectorDiffusivityFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- TagVectorSumComputes the sum of components of the requested tagged vector
- TimeExtremeValueA postprocessor for reporting the extreme value of another postprocessor over time.
- TimeIntegratedPostprocessorIntegrate a Postprocessor value over time using trapezoidal rule.
- TimePostprocessorReports the current time
- TimestepSizeReports the timestep size
- TotalVariableValueIntegrate a Postprocessor value over time using trapezoidal rule.
- VariableInnerProductComputes a volume integral of the specified variable
- VariableResidualComputes the L2 norm of the residual of a single variable in the solution vector.
- VectorPostprocessorComparisonCompares two vector post-processors of equal size and produces a boolean value
- VectorPostprocessorComponentReturns the value of the specified component of a VectorPostprocessor
- VectorPostprocessorReductionValueTakes a VectorPostprocessor and performs a reduction operation on it (max, min, sum, average) and stores as postprocessor.
- VolumePostprocessorComputes the volume of a specified block
- Peridynamics App
- BondStatusConvergedPostprocessorPDPostprocessor to check whether the bond status is converged within a time step
- NodalDisplacementDifferenceL2NormPDClass for computing the L2 norm of the difference between displacements and their analytic solutions
- NodalFunctionsL2NormPDClass for computing the L2 norm of functions
- NodalVariableIntegralPDClass for calculating the domain integral of nodal variables
- Porous Flow App
- ADPorousFlowFluidMassCalculates the mass of a fluid component in a region
- FVPorousFlowFluidMassCalculates the mass of a fluid component in a region
- PorousFlowFluidMassCalculates the mass of a fluid component in a region
- PorousFlowHeatEnergyCalculates the sum of heat energy of fluid phase(s) and/or the porous skeleton in a region
- PorousFlowPlotQuantityExtracts the value from the PorousFlowSumQuantity UserObject
- XFEMApp
- ParisLawComputes the crack extension size at all active crack front points.
- Sub Channel App
- PinSurfaceTemperatureReturns the surface temperature of a specific fuel pin at a user defined height. Applies a linear reconstruction for the temperature.
- PlanarMeanCalculates an mass-flow-rate averaged mean of the chosen variable on a z-plane at a user defined height over all subchannels
- SCMDuctHeatRatePostprocessorCalculates the heat flow that goes into the coolant through the duct based on aux variable duct_heat_flux
- SCMPinPowerPostprocessorCalculates the total heat rate that goes into the coolant from all the heated fuel-pins based on aux variable q_prime
- SCMPinSurfaceTemperatureReturns the surface temperature of a specific fuel pin at a user defined height. Applies a linear reconstruction for the temperature.
- SCMPlanarMeanCalculates an mass-flow-rate averaged mean of the chosen variable on a z-plane at a user defined height over all subchannels
- SCMTHPowerPostprocessorCalculates the total power of the subchannel assembly via the thermal-hydraulic enthalpy flow rate balance between inlet and outlet.
- SubChannelDeltaCalculates an absolute overall inlet-mass-flow-rate weighted difference, of a chosen variable, for the whole subchannel assembly, from inlet to outlet
- SubChannelPointValuePrints out a user selected value of a specified subchannel at a user selected axial height
- Misc App
- GeneralSensorPostprocessorThis is a GeneralSensorPostprocessor, and functions as a base class for other sensor postprocessors
- InternalVolumeComputes the volume of an enclosed area by performing an integral over a user-supplied boundary.
- ThermocoupleSensorPostprocessorThis is a ThermocoupleSensorPostprocessor for various classes of thermocouples, described by the 'thermocouple_type' parameter
- Contact App
- ContactDOFSetSizeOutputs the number of dofs greater than a tolerance threshold indicating mechanical contact
- NumAugmentedLagrangeIterationsGet the number of extra augmented Lagrange loops around the non-linear solve.
- Stochastic Tools App
- AdaptiveSamplingCompletedPostprocessorInforms whether a sampler has finished its sampling (1 = completed, 0 otherwise).
- LibtorchDRLLogProbabilityPostprocessorComputes the logarithmic probability of the action in a given LibtorchDRLController.
- Heat Transfer App
- ADConvectiveHeatTransferSideIntegralComputes the total convective heat transfer across a boundary.
- ConvectiveHeatTransferSideIntegralComputes the total convective heat transfer across a boundary.
- ExposedSideAverageValueComputes the average value of a variable on the exposed portion of a sideset. Note that this cannot be used on the centerline of an axisymmetric model.
- GrayLambertSurfaceRadiationPPThis postprocessor allows to extract radiosity, heat flux density, and temperature from the GrayLambertSurfaceRadiationBase object.
- HomogenizedThermalConductivityPostprocessor for asymptotic expansion homogenization for thermal conductivity
- ThermalConductivityComputes the effective thermal conductivity averaged on a boundary.
- ViewFactorPPThis postprocessor allows to extract view factors from ViewFactor userobjects.
- Solid Properties App
- ThermalSolidPropertiesPostprocessorComputes a property from a ThermalSolidProperties object.
- Electromagnetics App
- ReflectionCoefficientCURRENTLY ONLY FOR 1D PLANE WAVE SOLVES. Calculate power reflection coefficient for impinging wave on a surface. Assumes that wave of form F = F_incoming + R*F_reflected
- Rdg App
- BoundaryFluxPostprocessorComputes the side integral of a flux entry from a BoundaryFluxBase user object
- RDGBoundaryFluxPostprocessorComputes the side integral of a flux entry from a BoundaryFluxBase user object
- Chemical Reactions App
- TotalMineralVolumeFractionTotal volume fraction of coupled mineral species
- Thermal Hydraulics App
- PostprocessorAsControlActionThis action adds a control object that copies a postprocessor value into the control system so that users can work with the postprocessor name directly.
- ADElementIntegralMaterialPropertyRZComputes the volume integral of a material property for an RZ geometry.
- ADFlowBoundaryFlux1PhaseRetrieves an entry of a flux vector for a connection attached to a 1-phase junction
- ADFlowJunctionFlux1PhaseRetrieves an entry of a flux vector for a connection attached to a 1-phase junction
- ADHeatRateConvection1PhaseComputes convective heat rate into a 1-phase flow channel
- ADHeatRateDirectFlowChannelComputes the heat rate into a flow channel from heat flux material property
- ADHeatStructureEnergyComputes the total energy for a plate heat structure.
- ADHeatStructureEnergy3DComputes the total energy for a 3D heat structure.
- ADHeatStructureEnergyRZComputes the total energy for a cylindrical heat structure.
- ADSideFluxIntegralRZIntegrates a diffusive flux over a boundary of a 2D RZ domain.
- ADSpecificImpulse1PhaseEstimates specific impulse from fluid state at a boundary
- BoolComponentParameterValuePostprocessorPostprocessor for reading a boolean value from the control logic system.
- BoolControlDataValuePostprocessorOutput the value of a boolean ControlData as a postprocessor
- EnergyFluxIntegralComputes the integral of the energy flux over a boundary
- FunctionElementIntegralRZIntegrates a function over elements for RZ geometry modeled by XY domain
- FunctionSideIntegralRZIntegrates a function over sides for RZ geometry modeled by XY domain
- HeatRateConductionRZIntegrates a conduction heat flux over an RZ boundary.
- HeatRateConvectionIntegrates a convective heat flux over a boundary.
- HeatRateConvection1PhaseComputes convective heat rate into a 1-phase flow channel
- HeatRateConvectionRZIntegrates a cylindrical heat structure boundary convective heat flux
- HeatRateDirectFlowChannelComputes the heat rate into a flow channel from heat flux material property
- HeatRateExternalAppConvectionRZIntegrates a cylindrical heat structure boundary convective heat flux from an external application
- HeatRateHeatFluxIntegrates a heat flux function over a boundary
- HeatRateHeatFluxRZIntegrates a heat flux function over a cylindrical boundary in a XYZ coordinate system.
- HeatRateRadiationIntegrates a radiative heat flux over a boundary.
- HeatRateRadiationRZIntegrates a cylindrical heat structure boundary radiative heat flux
- HeatStructureEnergyComputes the total energy for a plate heat structure.
- HeatStructureEnergy3DComputes the total energy for a 3D heat structure.
- HeatStructureEnergyRZComputes the total energy for a cylindrical heat structure.
- MassFluxIntegralComputes the integral of the mass flux over a boundary
- MomentumFluxIntegralComputes the integral of the momentum flux over a boundary
- NodalEnergyFluxPostprocessorCompute the energy flux from the sum of the nodal energy fluxes
- RealComponentParameterValuePostprocessorPostprocessor for reading a Real (floating point) value from the control logic system.
- RealControlDataValuePostprocessorOutputs the value of a ControlData as a postprocessor
- ShaftConnectedComponentPostprocessorGets torque or moment of inertia for a shaft-connected component.
- ShaftConnectedCompressor1PhasePostprocessorGets various quantities for a ShaftConnectedCompressor1Phase
- SideFluxIntegralRZIntegrates a diffusive flux over a boundary of a 2D RZ domain.
- SpecificImpulse1PhaseEstimates specific impulse from fluid state at a boundary
- SumPostprocessorSums the values of several postprocessors
- Ray Tracing App
- RayDataValueObtains a value from the data or aux data of a Ray after tracing has been completed.
- RayIntegralValueObtains the integrated value accumulated into a Ray from an IntegralRayKernel-derived class.
- RayTracingStudyResultGets a result from a RayTracingStudy.
- Phase Field App
- AverageGrainVolumeCalculate average grain area in a polycrystal
- DiscreteNucleationDataOutput diagnostic data on a DiscreteNucleationInserter
- DiscreteNucleationTimeStepReturn a time step limit for nucleation event to be used by IterationAdaptiveDT
- FauxGrainTrackerFake grain tracker object for cases where the number of grains is equal to the number of order parameters.
- FauxPolycrystalVoronoiRandom Voronoi tessellation polycrystal when the number of order parameters equal to the number of grains
- FeatureFloodCountThe object is able to find and count "connected components" in any solution field or number of solution fields. A primary example would be to count "bubbles".
- FeatureVolumeFractionComputes the total feature volume fraction from a vectorpostprocessor computing the feature volume
- GrainBoundaryAreaCalculate total grain boundary length in 2D and area in 3D
- GrainTrackerGrain Tracker object for running reduced order parameter simulations without grain coalescence.
- GrainTrackerElasticityGrain Tracker object for running reduced order parameter simulations without grain coalescence.
- ObtainAvgContactAngleObtain contact angle
- PFCElementEnergyIntegralComputes the integral of the energy from the temperature. Note that the kb factor is missing.
- PolycrystalCirclesPolycrystal circles generated from a vector input or read from a file
- PolycrystalEBSDObject for setting up a polycrystal structure from an EBSD Datafile
- PolycrystalHexPerturbed hexagonal polycrystal
- PolycrystalVoronoiRandom Voronoi tessellation polycrystal (used by PolycrystalVoronoiAction)
- WeightedVariableAverageAverage a variable value using a weight mask given by a material property.
- Level Set App
- LevelSetCFLConditionCompute the minimum timestep from the Courant-Friedrichs-Lewy (CFL) condition for the level-set equation.
- LevelSetVolumeCompute the area or volume of the region inside or outside of a level set contour.
- Solid Mechanics App
- ADMassComputes the mass of the solid as the integral of the density material property
- ADMaterialTensorAverageComputes the average of a RankTwoTensor component over a volume.
- ADMaterialTensorIntegralThis postprocessor computes an element integral of a component of a material tensor as specified by the user-supplied indices
- ADSidesetReactionComputes the integrated reaction force in a user-specified direction on a sideset from the surface traction
- AnalysisStepNumberOutputs the current analysis step number.
- AsymptoticExpansionHomogenizationElasticConstantsPostprocessor for asymptotic expansion homogenization for elasticity
- CavityPressurePostprocessorInterfaces with the CavityPressureUserObject to store the initial number of moles of a gas contained within an internal volume.
- CrackFrontDataDetermines which nodes are along the crack front
- CriticalTimeStepComputes and reports the critical time step for the explicit solver.
- MassComputes the mass of the solid as the integral of the density material property
- MaterialTensorAverageComputes the average of a RankTwoTensor component over a volume.
- MaterialTensorIntegralThis postprocessor computes an element integral of a component of a material tensor as specified by the user-supplied indices
- MaterialTimeStepPostprocessorThis postprocessor estimates a timestep that reduces the increment change in a material property below a given threshold.
- NormalBoundaryDisplacementThis postprocessor computes the normal displacement on a given set of boundaries.
- PolarMomentOfInertiaCompute the polar moment of inertia of a sideset w.r.t. a point and a direction
- SidesetReactionComputes the integrated reaction force in a user-specified direction on a sideset from the surface traction
- TorqueReactionTorqueReaction calculates the torque in 2D and 3Dabout a user-specified axis of rotation centeredat a user-specified origin.
- Navier Stokes App
- ADCFLTimeStepSizeComputes a time step size based on a user-specified CFL number
- CFLTimeStepSizeComputes a time step size based on a user-specified CFL number
- INSADElementIntegralEnergyAdvectionComputes the net volumetric balance of energy transported by advection
- INSElementIntegralEnergyAdvectionComputes the net volumetric balance of energy transported by advection
- INSExplicitTimestepSelectorPostprocessor that computes the minimum value of h_min/|u|, where |u| is coupled in as an aux variable.
- IntegralDirectedSurfaceForceComputes the directed force coming from friction and pressure differences on a surface. One can use this object for the computation of the drag and lift coefficient as well.
- MassFluxWeightedFlowRateComputes the mass flux weighted average of the quantity provided by advected_quantity over a boundary.
- MatrixEigenvalueCheckReport the number of zero eigenvalues of a matrix.
- MatrixEqualityCheckReport whether two matrices are the same or not.
- MfrPostprocessorObject for outputting boundary mass fluxes in conjunction with FVFluxBC derived objects that support it
- NSEntropyErrorComputes entropy error.
- PressureDropComputes the pressure drop between an upstream and a downstream boundary.
- RayleighNumberPostprocessor that computes the Rayleigh number for free flow with natural circulation
- VolumetricFlowRateComputes the volumetric flow rate of an advected quantity through a sideset.
Preconditioner
- Moose App
- AddMFEMPreconditionerActionAdd a preconditioner to the MFEM problem.
- MFEMCGSolverMFEM native solver for the iterative solution of MFEM equation systems using the conjugate gradient method.
- MFEMGMRESSolverMFEM native solver for the iterative solution of MFEM equation systems using the generalized minimal residual method.
- MFEMHypreADSHypre auxiliary-space divergence solver and preconditioner for the iterative solution of MFEM equation systems.
- MFEMHypreAMSHypre auxiliary-space Maxwell solver and preconditioner for the iterative solution of MFEM equation systems.
- MFEMHypreBoomerAMGHypre BoomerAMG solver and preconditioner for the iterative solution of MFEM equation systems.
- MFEMHypreFGMRESHypre solver for the iterative solution of MFEM equation systems using the flexible generalized minimal residual method.
- MFEMHypreGMRESHypre solver for the iterative solution of MFEM equation systems using the generalized minimal residual method.
- MFEMHyprePCGHypre solver for the iterative solution of MFEM equation systems using the preconditioned conjugate gradient method.
- MFEMOperatorJacobiSmootherMFEM solver for performing Jacobi smoothing of the equation system.
- MFEMSuperLUMFEM solver for performing direct solves of sparse systems in parallel using the SuperLU_DIST library.
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.
- SCFSPPreconditioner designed to map onto PETSc's PCFieldSplit.
- SMPSingle matrix preconditioner (SMP) builds a preconditioner using user defined off-diagonal parts of the Jacobian.
- StaticCondensationStatic condensation preconditioner
- VCPVariable 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.
- MFEMProblemProblem type for building and solving finite element problem using the MFEM finite element library.
- 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
- External Petsc Solver App
- ExternalPETScProblemProblem extension point for wrapping external applications
- 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
- Sub Channel App
- NoSolveProblemDummy problem class that doesn't solve anything
- QuadSubChannel1PhaseProblemSolver class for subchannels in a square lattice assembly and bare fuel pins
- TriSubChannel1PhaseProblemSolver class for subchannels in a triangular lattice assembly and bare/wire-wrapped fuel pins
ProjectedStatefulMaterialStorage
- Moose App
- ProjectedStatefulMaterialStorageActionMark material properties for projected stateful storage.
RayBCs
- Ray Tracing App
- AddRayBCActionAdds a RayBC for use in ray tracing to the simulation.
- KillRayBCA RayBC that kills a Ray on a boundary.
- NullRayBCA RayBC that does nothing to a Ray on a boundary.
- ReflectRayBCA RayBC that reflects a Ray in a specular manner on a boundary.
- Heat 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.
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
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MFEMVariableClass for adding MFEM variables to the problem (mfem::ParGridFunctions).
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Chemical Reactions App
- AddCoupledEqSpeciesActionAdds coupled equilibrium Kernels and AuxKernels for primary species
- AddPrimarySpeciesActionAdds Variables for all primary species
- AddSecondarySpeciesActionAdds AuxVariables for all secondary species
- 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
ReactionNetwork/SolidKineticReactions
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MFEMVariableClass for adding MFEM variables to the problem (mfem::ParGridFunctions).
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Chemical Reactions App
- AddCoupledSolidKinSpeciesActionAdds solid kinetic Kernels and AuxKernels for primary species
- AddPrimarySpeciesActionAdds Variables for all primary species
- AddSecondarySpeciesActionAdds AuxVariables for all secondary species
- 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
Reporters
- Moose App
- AddReporterActionAdd a Reporter object to the simulation.
- AccumulateReporterReporter which accumulates the value of a inputted reporter value over time into a vector reporter value of the same type.
- ConstantReporterReporter with constant values to be accessed by other objects, can be modified using transfers.
- ElementVariableStatisticsElement reporter to get statistics for a coupled variable. This can be transfered to other apps.
- ExtraIDIntegralReporterThis ExtraIDIntegralReporter source code is to integrate variables based on parsed extra IDs based on reporter system.
- IterationInfoReport the time and iteration information for the simulation.
- LibtorchArtificialNeuralNetParametersOutputs the parameters of a LibtorchArtificialNeuralNetwork within a LibtorchNeuralNetControl.
- MeshInfoReport mesh information, such as the number of elements, nodes, and degrees of freedom.
- MeshMetaDataReporterReports the mesh meta data.
- NodalVariableStatisticsNodal reporter to get statistics for a coupled variable. This can be transfered to other apps.
- ParsedScalarReporterApplies parsed functions to scalar entries held in reporters.
- ParsedVectorRealReductionReporterUse a parsed function to iterate through a vector and reduce it to a scalar.
- ParsedVectorReporterApply parsed functions to vector entries held in reporters.
- ParsedVectorVectorRealReductionReporterUse a parsed function to iterate through a rows of a vector of vector and reduce it to a vector.
- PerfGraphReporterReports the full performance graph from the PerfGraph.
- RestartableDataReporterReports restartable data and restartable meta data.
- SolutionInvalidityReporterReports the Summary Table of Solution Invalid Counts.
- Optimization App
- OptimizationDataReporter to hold measurement and simulation data for optimization problems
- OptimizationInfoReports Optimization Output
- Stochastic Tools App
- ActiveLearningGPDecisionEvaluates a GP surrogate model, determines its prediction quality, launches full model if GP prediction is inadequate, and retrains GP.
- AdaptiveImportanceStatsReporter to compute statistics corresponding to the AdaptiveImportanceSampler.
- AdaptiveMonteCarloDecisionGeneric reporter which decides whether or not to accept a proposed sample in Adaptive Monte Carlo type of algorithms.
- AffineInvariantDifferentialDecisionPerform decision making for Affine Invariant differential MCMC.
- AffineInvariantStretchDecisionPerform decision making for Affine Invariant stretch MCMC.
- BiFidelityActiveLearningGPDecisionPerform active learning decision making in bi-fidelity modeling.
- ConditionalSampleReporterEvaluates parsed function to determine if sample needs to be evaluated, otherwise data is set to a default value.
- CrossValidationScoresTool for extracting cross-validation scores and storing them in a reporter for output.
- DRLControlNeuralNetParametersOutputs the parameters of a LibtorchArtificialNeuralNetwork within a LibtorchDRLControlTrainer.
- DRLRewardReporterReporter containing the reward values of a DRL controller trainer.
- DirectPerturbationReporterCompute local sensitivities using the direct perturbation method.
- EvaluateSurrogateTool for sampling surrogate models.
- IndependentMHDecisionPerform decision making for independent Metropolis-Hastings MCMC.
- MappingReporterA reporter which can map full solution fields to a latent space for given variables.
- MorrisReporterCompute global sensitivities using the Morris method.
- PMCMCDecisionGeneric reporter which decides whether or not to accept a proposed sample in parallel Markov chain Monte Carlo type of algorithms.
- ParallelSolutionStorageParallel container to store serialized solution fields from simulations on sub-applications.
- PolynomialChaosReporterTool for extracting data from PolynomialChaos surrogates and computing statistics.
- SingularTripletReporterTool for accessing and outputting the singular triplets of a singular value decomposition in PODMapping.
- SobolReporterCompute SOBOL statistics values of a given VectorPostprocessor or Reporter objects and vectors.
- SolutionContainerClass responsible for collecting distributed solution vectors into a container. We append a new distributed solution vector (containing all variables) at every execution.
- StatisticsReporterCompute statistical values of a given VectorPostprocessor objects and vectors.
- StochasticMatrixTool for extracting Sampler object data and storing data from stochastic simulations.
- StochasticReporterStorage container for stochastic simulation results coming from Reporters.
Samplers
- Moose App
- AddSamplerActionAdd a Sampler object to the simulation.
- Stochastic Tools App
- AdaptiveSamplerActionAdds extra objects pertaining to adaptive samplers.
- AISActiveLearningAdaptive Importance Sampler with Gaussian Process Active Learning.
- ActiveLearningMonteCarloSamplerMonte Carlo Sampler for active learning with surrogate model.
- AdaptiveImportanceAdaptive Importance Sampler.
- AffineInvariantDESPerform Affine Invariant Ensemble MCMC with differential sampler.
- AffineInvariantStretchSamplerPerform Affine Invariant Ensemble MCMC with stretch sampler.
- CSVSamplerSampler that reads samples from CSV file.
- Cartesian1DProvides complete Cartesian product for the supplied variables.
- CartesianProductProvides complete Cartesian product for the supplied variables.
- CartesianProductSamplerProvides complete Cartesian product for the supplied variables.
- DirectPerturbationSamplerSampler that creates samples for a direct perturbation-based sensitivity study.
- IndependentGaussianMHPerform M-H MCMC sampling with independent Gaussian propoposals.
- InputMatrixSampler that utilizes a sampling matrix defined at input.
- LatinHypercubeLatin Hypercube Sampler.
- MonteCarloMonte Carlo Sampler.
- MonteCarloSamplerMonte Carlo Sampler.
- MorrisSamplerMorris variance-based sensitivity analysis Sampler.
- NestedMonteCarloMonte Carlo sampler for nested loops of parameters.
- PMCMCBaseParallel Markov chain Monte Carlo base.
- ParallelSubsetSimulationParallel Subset Simulation sampler.
- QuadratureQuadrature sampler for Polynomial Chaos.
- QuadratureSamplerQuadrature sampler for Polynomial Chaos.
- SobolSobol variance-based sensitivity analysis Sampler.
- SobolSamplerSobol variance-based sensitivity analysis Sampler.
- VectorPostprocessorSamplerThe sampler uses vector postprocessors as inputs.
ScalarKernels
- Moose App
- AddScalarKernelActionAdd a AuxScalarKernel object to the simulation.
- ADScalarTimeDerivativeAdds the time derivative contribution to the residual for a scalar variable.
- AverageValueConstraintThis class is used to enforce integral of phi with a Lagrange multiplier approach.
- CoupledODETimeDerivativeResidual contribution of ODE from the time derivative of a coupled variable.
- NodalEqualValueConstraintConstrain two nodes to have identical values.
- NullScalarKernelScalar kernel that sets a zero residual, to avoid error from system missing this variable.
- ODETimeDerivativeReturns the time derivative contribution to the residual for a scalar variable.
- ParsedODEKernelParsed expression ODE kernel.
- Peridynamics App
- GeneralizedPlaneStrainPDClass for claculating residual and diagonal Jacobian forstate-based peridynamic generalized plane strain formulation
- Solid Mechanics App
- GeneralizedPlaneStrainGeneralized Plane Strain Scalar Kernel
- GlobalStrainScalar Kernel to solve for the global strain
- Thermal Hydraulics App
- ADShaftComponentTorqueScalarKernelTorque contributed by a component connected to a shaft
- ADShaftTimeDerivativeScalarKernelAdds a time derivative term to the shaft ODE
- ADVolumeJunctionAdvectionScalarKernelAdds advective fluxes for the junction variables for a volume junction
- ODECoefTimeDerivativeTime derivative term multiplied by a coefficient - used by ODEs.
- PostprocessorSourceScalarKernelAdds arbitrary post-processor value as source term
- ShaftComponentTorqueScalarKernelTorque contributed by a component connected to a shaft
- ShaftTimeDerivativeScalarKernelAdds a time derivative term to the shaft ODE
SolidProperties
- Solid Properties App
- AddSolidPropertiesActionAdd a UserObject object to the simulation.
- ThermalCompositeSiCPropertiesComposite silicon carbide thermal properties.
- ThermalFunctionSolidPropertiesFunction-based thermal properties.
- ThermalGraphitePropertiesGraphite thermal properties.
- ThermalMonolithicSiCPropertiesMonolithic silicon carbide thermal properties.
- ThermalSS316PropertiesStainless steel 316 thermal properties.
- ThermalUCPropertiesUranium Carbide (UC) thermal properties (SI units).
Solver
- Moose App
- AddMFEMSolverActionSet the Moose::MFEM solver and the solver options.
- MFEMCGSolverMFEM native solver for the iterative solution of MFEM equation systems using the conjugate gradient method.
- MFEMGMRESSolverMFEM native solver for the iterative solution of MFEM equation systems using the generalized minimal residual method.
- MFEMHypreADSHypre auxiliary-space divergence solver and preconditioner for the iterative solution of MFEM equation systems.
- MFEMHypreAMSHypre auxiliary-space Maxwell solver and preconditioner for the iterative solution of MFEM equation systems.
- MFEMHypreBoomerAMGHypre BoomerAMG solver and preconditioner for the iterative solution of MFEM equation systems.
- MFEMHypreFGMRESHypre solver for the iterative solution of MFEM equation systems using the flexible generalized minimal residual method.
- MFEMHypreGMRESHypre solver for the iterative solution of MFEM equation systems using the generalized minimal residual method.
- MFEMHyprePCGHypre solver for the iterative solution of MFEM equation systems using the preconditioned conjugate gradient method.
- MFEMOperatorJacobiSmootherMFEM solver for performing Jacobi smoothing of the equation system.
- MFEMSuperLUMFEM solver for performing direct solves of sparse systems in parallel using the SuperLU_DIST library.
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.
SubMeshes
- Moose App
- AddMFEMSubMeshActionAdd an MFEM SubMesh object to the simulation.
- MFEMBoundarySubMeshClass to construct an MFEMSubMesh formed from the subspace of the parent mesh restricted to the set of user-specified boundaries.
- MFEMCutTransitionSubMeshClass to construct an MFEMSubMesh formed from the set of elements that have least one vertex on the specified cut plane, that lie on one side of the plane, and that are restricted to the set of user-specified subdomains.
- MFEMDomainSubMeshClass to construct an MFEMSubMesh formed from the subspace of the parent mesh restricted to the set of user-specified subdomains.
Surrogates
- Stochastic Tools App
- AddSurrogateActionAdds SurrogateTrainer and SurrogateModel objects contained within the [Trainers]and[Surrogates]input blocks.
- GaussianProcessSurrogateComputes and evaluates Gaussian Process surrogate model.
- LibtorchANNSurrogateSurrogate that evaluates a feedforward artificial neural net.
- NearestPointSurrogateSurrogate that evaluates the value from the nearest point from data in NearestPointTrainer
- PODReducedBasisSurrogateEvaluates POD-RB surrogate model with reduced operators computed from PODReducedBasisTrainer.
- PolynomialChaosComputes and evaluates polynomial chaos surrogate model.
- PolynomialRegressionSurrogateEvaluates polynomial regression model with coefficients computed from PolynomialRegressionTrainer.
ThermalContact
- Heat 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
- Moose App
- AddTimesActionAdd a Times object to the simulation.
- CSVFileTimesImport times from one or more files.
- ControllableInputTimesTimes set directly from a user parameter in the input file
- ExodusFileTimesImport times from one or more Exodus files.
- FunctorTimesTimes created by evaluating a functor at the (0,0,0) point and the current time
- InputTimesTimes set directly from a user parameter in the input file
- ReporterTimesImport times from one or more reporters, for example other Times
- SimulationTimesTimes simulated
- TimeIntervalTimesTimes between a start time and end time with a fixed time interval.
Trainers
- Stochastic Tools App
- AddSurrogateActionAdds SurrogateTrainer and SurrogateModel objects contained within the [Trainers]and[Surrogates]input blocks.
- ActiveLearningGaussianProcessPermit re-training Gaussian Process surrogate model for active learning.
- GaussianProcessTrainerProvides data preperation and training for a single- or multi-output Gaussian Process surrogate model.
- LibtorchANNTrainerTrains a simple neural network using libtorch.
- LibtorchDRLControlTrainerTrains a neural network controller using the Proximal Policy Optimization (PPO) algorithm.
- NearestPointTrainerLoops over and saves sample values for NearestPointSurrogate.
- PODReducedBasisTrainerComputes the reduced subspace plus the reduced operators for POD-RB surrogate.
- PolynomialChaosTrainerComputes and evaluates polynomial chaos surrogate model.
- PolynomialRegressionTrainerComputes coefficients for polynomial regession model.
Transfers
- Moose App
- AddTransferActionAdd a Transfer object to the simulation.
- MFEMSubMeshTransferClass to transfer MFEM variable data to or from a restricted copy of the variable defined on an a subspace of an MFEMMesh, represented as an MFEMSubMesh.
- 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.
- MultiAppMFEMCopyTransferCopies variable values from one MFEM application to another
- 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
- 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
- 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.
- Sub Channel App
- PinSolutionTransferTransfers pin solution from computational mesh onto visualization mesh
- SCMPinSolutionTransferTransfers pin solution from computational mesh onto visualization mesh
- SCMSolutionTransferTransfers subchannel solution from computational mesh onto visualization mesh
- SolutionTransferTransfers subchannel solution from computational mesh onto visualization mesh
UserObjects
- Moose App
- AddUserObjectActionAdd a UserObject object to the simulation.
- ADProjectedStatefulMaterialNodalPatchRecoveryRankFourTensorPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ADProjectedStatefulMaterialNodalPatchRecoveryRankTwoTensorPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ADProjectedStatefulMaterialNodalPatchRecoveryRealPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ADProjectedStatefulMaterialNodalPatchRecoveryRealVectorValuePrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ActivateElementsByPathDetermine activated elements.
- ActivateElementsCoupledDetermine activated elements.
- CoupledVarThresholdElementSubdomainModifierModify the element subdomain ID if a coupled variable satisfies the criterion for the threshold (above, equal, or below)
- ElemSideNeighborLayersGeomTesterUser object to calculate ghosted elements on a single processor or the union across all processors.
- ElemSideNeighborLayersTesterUser object to calculate ghosted elements on a single processor or the union across all processors.
- ElementIntegralVariableUserObjectcomputes a volume integral of a variable.
- ElementPropertyReadFileUser Object to read property data from an external file and assign it to elements / nodes / subdomains etc.
- ElementQualityCheckerClass to check the quality of each element using different metrics from libmesh.
- FunctionElementIntegralUserObjectComputes a volume integral of a function.
- FunctionLayeredIntegralIntegrates a function in layers
- GeometrySphereSnap nodes to the surface of a sphere either during adaptivity or on execution
- GhostingUserObjectCreates ghosting maps that can be queried by external objects.
- InterfaceQpMaterialPropertyRealUOComputes the value, rate or increment of a Real Material property across an interface. The value, rate or increment is computed according to the provided interface_value_type parameter
- InterfaceQpValueUserObjectComputes the variable value, rate or increment across an interface. The value, rate or increment is computed according to the provided interface_value_type parameter
- JSONFileReaderLoads a JSON file and makes it content available to consumers
- LayeredAverageComputes averages of variables over layers
- LayeredAverageFunctorComputes layered side averages of a functor.
- LayeredExtremumMaterialPropertyCompute material property extrema over layers.
- LayeredIntegralCompute variable integrals over layers.
- LayeredIntegralFunctorComputes layered element integrals of a functor.
- LayeredSideAverageComputes side averages of a variable storing partial sums for the specified number of intervals in a direction (x,y,z).
- LayeredSideAverageFunctorComputes layered side averages of a functor.
- LayeredSideDiffusiveFluxAverageComputes the diffusive flux of a variable on layers alongside a boundary.
- LayeredSideFluxAverageComputes the diffusive flux of a variable on layers alongside a boundary.
- LayeredSideIntegralComputes surface integral of a variable storing partial sums for the specified number of intervals in a direction (x,y,z).
- LayeredSideIntegralFunctorComputes layered side integrals of a functor.
- MFEMGeneralUserObjectBase class for custom GeneralUserObjects to add to MFEM problems.
- MOOSEOldPostprocessorToNEML2Gather a MOOSE postprocessor value for insertion into the specified input variable or model parameter of a NEML2 model.
- MOOSEOldRankTwoTensorMaterialPropertyToNEML2Gather a MOOSE material property of type RankTwoTensorTempl<double> for insertion into the specified input or model parameter of a NEML2 model.
- MOOSEOldRealMaterialPropertyToNEML2Gather a MOOSE material property of type double for insertion into the specified input or model parameter of a NEML2 model.
- MOOSEOldRealVectorValueMaterialPropertyToNEML2Gather a MOOSE material property of type libMesh::VectorValue<double> for insertion into the specified input or model parameter of a NEML2 model.
- MOOSEOldSymmetricRankTwoTensorMaterialPropertyToNEML2Gather a MOOSE material property of type SymmetricRankTwoTensorTempl<double> for insertion into the specified input or model parameter of a NEML2 model.
- MOOSEOldVariableToNEML2Gather a MOOSE variable for insertion into the specified input or model parameter of a NEML2 model.
- MOOSEPostprocessorToNEML2Gather a MOOSE postprocessor value for insertion into the specified input variable or model parameter of a NEML2 model.
- MOOSERankTwoTensorMaterialPropertyToNEML2Gather a MOOSE material property of type RankTwoTensorTempl<double> for insertion into the specified input or model parameter of a NEML2 model.
- MOOSERealMaterialPropertyToNEML2Gather a MOOSE material property of type double for insertion into the specified input or model parameter of a NEML2 model.
- MOOSERealVectorValueMaterialPropertyToNEML2Gather a MOOSE material property of type libMesh::VectorValue<double> for insertion into the specified input or model parameter of a NEML2 model.
- MOOSESymmetricRankTwoTensorMaterialPropertyToNEML2Gather a MOOSE material property of type SymmetricRankTwoTensorTempl<double> for insertion into the specified input or model parameter of a NEML2 model.
- MOOSEVariableToNEML2Gather a MOOSE variable for insertion into the specified input or model parameter of a NEML2 model.
- MessageFromInputPrint out a message from the input file
- MoveNodesToSphereSnap nodes to the surface of a sphere either during adaptivity or on execution
- NEML2BatchIndexGeneratorGenerates the element to batch index map for MOOSEToNEML2 gatherers, NEML2ToMOOSE retrievers, and the NEML2 executor
- NEML2ModelExecutorExecute the specified NEML2 model
- NearestNodeNumberUOFinds and outputs the nearest node number to a point
- NearestPointAverageCompute element variable averages for nearest-point based subdomains
- NearestPointLayeredAverageComputes averages of a variable storing partial sums for the specified number of intervals in a direction (x,y,z). Given a list of points this object computes the layered average closest to each one of those points.
- NearestPointLayeredIntegralComputes integrals of a variable storing partial sums for the specified number of intervals in a direction (x,y,z). Given a list of points this object computes the layered integral closest to each one of those points.
- NearestPointLayeredSideAverageCompute layered side averages for nearest-point based subdomains
- NearestPointLayeredSideAverageFunctorComputes layered side averages of a functor nearest to a set of points.
- NearestPointLayeredSideDiffusiveFluxAverageCompute layered side diffusive flux averages for nearest-point based subdivisions
- NearestPointLayeredSideFluxAverageCompute layered side diffusive flux averages for nearest-point based subdivisions
- NearestPointLayeredSideIntegralCompute layered side integrals for nearest-point based sidesets
- NearestPointLayeredSideIntegralFunctorComputes layered side integrals of a functor nearest to a set of points.
- NearestRadiusLayeredAverageComputes averages of a variable storing partial sums for the specified number of intervals in a direction (x,y,z). Given a list of points this object computes the layered average closest to each one of those points, where the distance is computed in terms of radius (or distance to the origin in the plane perpendicular to 'direction').
- NodalNormalsCornerComputes nodal normals at boundary corners.
- NodalNormalsEvaluatorHelper object to compute nodal normal values via the NodalNormals input block.
- NodalNormalsPreprocessorAn object that prepares MOOSE for computing nodal normal vectors. This object is automatically created via the [NodalNormals] input block.
- NodalPatchRecoveryMaterialPropertyPrepare patches for use in nodal patch recovery based on a material property.
- NodalPatchRecoveryVariablePerforms patch recovery using a coupled variable.
- PointwiseRenormalizeVectorPointwise renormalize the solution of a set of variables comprising a vector
- PostprocessorSpatialUserObjectUser object (spatial) that holds a postprocessor value.
- ProjectedStatefulMaterialNodalPatchRecoveryRankFourTensorPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ProjectedStatefulMaterialNodalPatchRecoveryRankTwoTensorPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ProjectedStatefulMaterialNodalPatchRecoveryRealPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ProjectedStatefulMaterialNodalPatchRecoveryRealVectorValuePrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- PropertyReadFileUser Object to read property data from an external file and assign it to elements / nodes / subdomains etc.
- RadialAveragePerform a radial average of a material property
- SidesetAroundSubdomainUpdaterSets up a boundary between inner_subdomains and outer_subdomains
- SolutionUserObjectReads a variable from a mesh in one simulation to another
- TerminatorRequests termination of the current solve based on the evaluation of a parsed logical expression of the Postprocessor value(s).
- TimedSubdomainModifierModify element subdomain ID of entire subdomains for given points in time. This mesh modifier only runs on the undisplaced mesh, and it will modify both the undisplaced and the displaced mesh.
- TorchScriptUserObjectUser-facing object which loads a torch script module.
- VariableValueElementSubdomainModifierModify the element subdomain ID based on the provided variable value.
- VerifyElementUniqueIDVerifies that all element ids are unique.
- VerifyNodalUniqueIDVerifies that all node ids are unique.
- Peridynamics App
- GeneralizedPlaneStrainUserObjectNOSPDClass for calculating the scalar residual and diagonal Jacobian entry of generalized plane strain in the H1NOSPD formulation
- GeneralizedPlaneStrainUserObjectOSPDClass for calculating the scalar residual and diagonal Jacobian entry of generalized plane strain in OSPD formulation
- GhostElemPDClass for ghosting elements accross processors
- NodalDamageIndexPDClass for computing damage index for each material point in peridynamic fracture modeling and simulation
- NodalNumIntactBondsPDClass for computing number of intact bonds for each material point in peridynamic fracture modeling and simulation
- NodalRankTwoComponentPDClass for calculating components of nodal rank-two stress and strain tensors from material properties (stress and strain) for edge elements (i.e., bonds) connected at that node. NOTE: This UserObject only applies to the NOSPD model.
- NodalRankTwoScalarPDClass for calculating scalar quantities of nodal rank-two stress and strain tensors from material properties (stress and strain) for edge elements (i.e., bonds) connected at that node. NOTE: This UserObject only applies to the NOSPD model.
- SingularShapeTensorEliminatorUserObjectPDUserObject to eliminate the existance of singular shape tensor
- Functional Expansion Tools App
- FXBoundaryFluxUserObjectGenerates an Functional Expansion representation for a boundary flux condition using a 'FunctionSeries'-type Function
- FXBoundaryValueUserObjectGenerates an Functional Expansion representation for a boundary value condition using a 'FunctionSeries'-type Function
- FXVolumeUserObjectGenerates an Functional Expansion representation of a variable value over a volume using a 'FunctionSeries'-type Function
- Porous Flow App
- AdvectiveFluxCalculatorConstantVelocityCompute K_ij (a measure of advective flux from node i to node j) and R+ and R- (which quantify amount of antidiffusion to add) in the Kuzmin-Turek FEM-TVD multidimensional scheme. Constant advective velocity is assumed
- PorousFlowAdvectiveFluxCalculatorSaturatedComputes the advective flux of fluid of given phase, assuming fully-saturated conditions. Hence this UserObject is only relevant to single-phase situations. Explicitly, the UserObject computes (density / viscosity) * (- permeability * (grad(P) - density * gravity)), using the Kuzmin-Turek FEM-TVD multidimensional stabilization scheme
- PorousFlowAdvectiveFluxCalculatorSaturatedHeatComputes the advective flux of heat energy in the given phase, assuming fully-saturated conditions. Hence this UserObject is only relevant to single-phase situations. Explicitly, the UserObject computes (density * enthalpy / viscosity) * (- permeability * (grad(P) - density * gravity)), using the Kuzmin-Turek FEM-TVD multidimensional stabilization scheme
- PorousFlowAdvectiveFluxCalculatorSaturatedMultiComponentComputes the advective flux of fluid of given phase and fluid component. Explicitly, the UserObject computes (mass_fraction * density / viscosity) * (- permeability * (grad(P) - density * gravity)), using the Kuzmin-Turek FEM-TVD multidimensional stabilization scheme
- PorousFlowAdvectiveFluxCalculatorUnsaturatedComputes the advective flux of fluid of given phase, assuming unsaturated conditions. Hence this UserObject is only relevant to single-phase situations, or multi-phase situations where each fluid component appears in one phase only. Explicitly, the UserObject computes (density * relative_permeability / viscosity) * (- permeability * (grad(P) - density * gravity)), using the Kuzmin-Turek FEM-TVD multidimensional stabilization scheme
- PorousFlowAdvectiveFluxCalculatorUnsaturatedHeatComputes the advective flux of heat energy in a given phase, assuming unsaturated conditions. Hence this UserObject is only relevant to single-phase situations, or multi-phase situations where each fluid component appears in one phase only. Explicitly, the UserObject computes (density * enthalpy * relative_permeability / viscosity) * (- permeability * (grad(P) - density * gravity)), using the Kuzmin-Turek FEM-TVD multidimensional stabilization scheme
- PorousFlowAdvectiveFluxCalculatorUnsaturatedMultiComponentComputes the advective flux of fluid of given phase and component. Hence this UserObject is relevant to multi-phase, multi-component situations. Explicitly, the UserObject computes (mass_fraction * density * relative_permeability / viscosity) * (- permeability * (grad(P) - density * gravity)), using the Kuzmin-Turek FEM-TVD multidimensional stabilization scheme
- PorousFlowBrineCO2Fluid state class for brine and CO2
- PorousFlowCapillaryPressureBCBrooks-Corey capillary pressure
- PorousFlowCapillaryPressureBWBroadbridge and White capillary pressure for negligable Kn
- PorousFlowCapillaryPressureConstConstant capillary pressure
- PorousFlowCapillaryPressureRSCRogers-Stallybrass-Clements version of effective saturation for the water phase, valid for residual saturations = 0, and viscosityOil = 2 * viscosityWater. seff_water = 1 / sqrt(1 + exp((Pc - shift) / scale)), where scale = 0.25 * scale_ratio * oil_viscosity.
- PorousFlowCapillaryPressureVGvan Genuchten capillary pressure
- PorousFlowDictatorHolds information on the PorousFlow variable names
- PorousFlowSumQuantityRecords total mass flowing into a borehole
- PorousFlowWaterNCGFluid state class for water and non-condensable gas
- PorousFlowWaterVaporFluid state class for water and vapor
- XFEMApp
- CircleCutUserObjectCreates a UserObject for circular cuts on 3D meshes for XFEM
- ComboCutUserObjectCombine multiple geometric cut userobjects.
- CrackMeshCut3DUserObjectCreates a UserObject for a mesh cutter in 3D problems
- CutElementSubdomainModifierChange element subdomain based on CutSubdomainID
- EllipseCutUserObjectCreates a UserObject for elliptical cuts on 3D meshes for XFEM
- InterfaceMeshCut2DUserObjectA userobject to cut a 2D mesh using a 1D cutter mesh.
- InterfaceMeshCut3DUserObjectA userobject to cut a 3D mesh using a 2D cutter mesh.
- LevelSetCutUserObjectXFEM mesh cut by level set function
- LineSegmentCutSetUserObjectCreates a UserObject for a line segment cut on 2D meshes for XFEM
- LineSegmentCutUserObjectCreates a UserObject for a line segment cut on 2D meshes for XFEM
- MeshCut2DFractureUserObjectXFEM mesh cutter for 2D models that defines cuts with amesh and uses fracture integrals to determine growth
- MeshCut2DFunctionUserObjectCreates a UserObject for a mesh cutter in 2D problems where crack growth is specified by functions.
- MeshCut2DRankTwoTensorNucleationNucleate a crack in MeshCut2D UO based on a scalar extracted from a RankTwoTensor
- NodeValueAtXFEMInterfaceObtain field values and gradients on the interface.
- RectangleCutUserObjectCreates a UserObject for planar cuts on 3D meshes for XFEM
- XFEMPhaseTransitionMovingInterfaceVelocitycalculate the interface velocity for a simple phase transition problem.
- XFEMRankTwoTensorMarkerUserObjectMark elements to be cut by XFEM based on a scalar extracted from a RankTwoTensor
- Fluid Properties App
- FluidPropertiesInterrogatorUser object for querying a single-phase or two-phase fluid properties object
- Contact App
- BilinearMixedModeCohesiveZoneModelComputes the bilinear mixed mode cohesive zone model.
- LMWeightedGapUserObjectProvides the mortar normal Lagrange multiplier for constraint enforcement.
- LMWeightedVelocitiesUserObjectProvides the mortar contact Lagrange multipliers (normal and tangential) for constraint enforcement.
- NodalAreaCompute the tributary area for nodes on a surface
- NodalDensityCompute the tributary densities for nodes on a surface
- NodalWaveSpeedCompute the tributary wave speeds for nodes on a surface
- PenaltyFrictionUserObjectComputes the mortar frictional contact force via a penalty approach.
- PenaltySimpleCohesiveZoneModelComputes the mortar frictional contact force via a penalty approach.
- PenaltyWeightedGapUserObjectComputes the mortar normal contact force via a penalty approach.
- Optimization App
- AdjointSolutionUserObjectReads a variable from a mesh in one simulation to another specifically for loading forward solution in adjoint simulation during inverse optimization.
- DensityUpdateCompute updated densities based on sensitivities using an optimality criteria method to keep the volume constraint satisified.
- DensityUpdateTwoConstraintsCompute updated densities based on sensitivities using an optimality criteria method to keep the volume and cost constraints satisified.
- SensitivityFilterComputes the filtered sensitivity using a radial average user object.
- Stochastic Tools App
- InverseMappingEvaluates surrogate models and maps the results back to a full solution field for given variables.
- Heat Transfer App
- ConstantViewFactorSurfaceRadiationConstantViewFactorSurfaceRadiation computes radiative heat transfer between side sets and the view factors are provided in the input file
- FunctorGapFluxModelConductionGap flux model for varying gap conductance using a functor for temperature.
- FunctorGapFluxModelRadiationGap flux model for heat transfer across a gap due to radiation, based on the diffusion approximation. Uses a temperature functor.
- GapFluxModelConductionGap flux model for varying gap conductance using a coupled variable for temperature
- GapFluxModelPressureDependentConductionHeat flux model across a closed gap to calculate the conductance between two solid materials
- GapFluxModelRadiationGap flux model for heat conduction across a gap due to radiation, based on the diffusion approximation. Uses a coupled temperature variable.
- GapFluxModelRadiativeGap flux demonstration model for radiative heat conductance
- GapFluxModelSimpleGap flux model with a constant conductance
- RayTracingViewFactorComputes view factors for arbitrary geometries using raytracing.
- SelfShadowSideUserObjectCompute the illumination status for a self shadowing sideset
- UnobstructedPlanarViewFactorComputes the view factors for planar faces in unubstructed radiative heat transfer.
- ViewFactorObjectSurfaceRadiationViewFactorObjectSurfaceRadiation computes radiative heat transfer between side sets and the view factors are computed by a ViewFactor object
- ViewFactorRayStudyThis ray study is used to compute view factors in cavities with obstruction. It sends out rays from surfaces bounding the radiation cavity into a set of directions determined by an angular quadrature. The rays are tracked and view factors are computed by determining the surface where the ray dies.
- Geochemistry App
- GeochemicalModelDefinitionUser object that parses a geochemical database file, and only retains information relevant to the current geochemical model
- GeochemistryKineticRateUser object that defines a kinetic rate. Note that more than one rate can be prescribed to a single kinetic_species: the sum the individual rates defines the overall rate. GeochemistryKineticRate simply specifies the algebraic form for a kinetic rate: to actually use it in a calculation, you must use it in the GeochemicalModelDefinition. The rate is intrinsic_rate_constant * area_quantity * (optionally, mass of kinetic_species in grams) * kinetic_molalitykinetic_molal_index / (kinetic_molalitykinetic_molal_index + kinetic_half_saturationkinetic_molal_index)kinetic_monod_index * (product_over_promoting_species mpromoting_index / (mpromoting_index + promoting_half_saturationpromiting_index)promoting_monod_index) * |1 - (Q/K)^theta|^eta * exp(activation_energy / R * (1/T0 - 1/T)) * Direction(1 - (Q/K)). Please see the markdown documentation for examples
- GeochemistrySpatialReactorUserObject that controls the space-dependent and time-dependent geochemistry reaction processes
- GeochemistryTimeDependentReactorUserObject that controls the time-dependent geochemistry reaction processes. Spatial dependence is not possible using this class
- GeochemistryTimeIndependentReactorUserObject that controls the time-independent geochemistry reaction processes. Spatial dependence is not possible using this class
- NodalVoidVolumeUserObject to compute the nodal void volume. Take care if you block-restrict this UserObject, since the volumes of the nodes on the block's boundary will not include any contributions from outside the block.
- Rdg App
- AEFVFreeOutflowBoundaryFluxFree outflow BC based boundary flux user object for the advection equation using a cell-centered finite volume method.
- AEFVSlopeLimitingOneDOne-dimensional slope limiting to get the limited slope of cell average variable for the advection equation using a cell-centered finite volume method.
- AEFVUpwindInternalSideFluxUpwind numerical flux scheme for the advection equation using a cell-centered finite volume method.
- Chemical Reactions App
- ThermochimicaElementDataProvides access to Thermochimica-calculated data at elements.
- ThermochimicaNodalDataProvides access to Thermochimica-calculated data at nodes.
- Thermal Hydraulics App
- ADBoundaryFlux3EqnFreeOutflowComputes the outflow boundary flux directly for the 1-D, 1-phase, variable-area Euler equations
- ADBoundaryFlux3EqnGhostDensityVelocityComputes boundary flux from density and velocity for the 3-equation model using a ghost cell approach.
- ADBoundaryFlux3EqnGhostMassFlowRateTemperatureComputes a boundary flux from a specified mass flow rate and temperature for the 1-D, 1-phase, variable-area Euler equations using a ghost cell
- ADBoundaryFlux3EqnGhostPressureComputes boundary flux from a specified pressure for the 1-D, 1-phase, variable-area Euler equations
- ADBoundaryFlux3EqnGhostStagnationPressureTemperatureComputes boundary flux from a specified stagnation pressure and temperature for the 1-D, 1-phase, variable-area Euler equations
- ADBoundaryFlux3EqnGhostVelocityTemperatureComputes a boundary flux from a specified velocity and temperature for the 1-D, 1-phase, variable-area Euler equations using a ghost cell
- ADBoundaryFlux3EqnGhostWallWall boundary conditions for the 1-D, 1-phase, variable-area Euler equations
- ADGateValve1PhaseUserObjectGate valve user object for 1-phase flow
- ADHeatFluxFromHeatStructure3EqnUserObjectCache the heat flux between a single phase flow channel and a heat structure
- ADHeatTransferFromHeatStructure3D1PhaseUserObjectCaches heat flux information (fluid temperature and heat transfer coefficient) between flow channel and 3D heat structure.
- ADJunctionOneToOne1PhaseUserObjectComputes flux between two subdomains for 1-phase one-to-one junction
- ADJunctionParallelChannels1PhaseUserObjectComputes and caches flux and residual vectors for a 1-phase junction that connects flow channels that are parallel
- ADNumericalFlux3EqnCenteredComputes internal side flux for the 1-D, 1-phase, variable-area Euler equations using a centered average of the left and right side fluxes
- ADNumericalFlux3EqnHLLCComputes internal side flux for the 1-D, 1-phase, variable-area Euler equations using the HLLC approximate Riemann solver.
- ADPump1PhaseUserObjectComputes and caches flux and residual vectors for a 1-phase pump
- ADShaftConnectedCompressor1PhaseUserObjectComputes and caches flux and residual vectors for a 1-phase compressor. Also computes compressor torque and delta_p which is passed to the connected shaft
- ADShaftConnectedMotorUserObjectComputes the torque and moment of inertia of a shaft connected motor
- ADShaftConnectedPump1PhaseUserObjectComputes and caches flux and residual vectors for a 1-phase pump. Also computes pump torque and head which is passed to the connected shaft
- ADShaftConnectedTurbine1PhaseUserObjectComputes and caches flux and residual vectors for a 1-phase turbine. Also computes turbine torque and delta_p which is passed to the connected shaft
- ADSimpleTurbine1PhaseUserObjectComputes and caches flux and residual vectors for a 1-phase turbine
- ADVolumeJunction1PhaseUserObjectComputes and caches flux and residual vectors for a 1-phase volume junction
- BoundaryFluxGasMixGhostWallWall boundary flux for FlowModelGasMix.
- FunctionElementLoopIntegralUserObjectComputes the integral of a function using an element loop.
- HSCoupler2D2DRadiationUserObjectComputes heat fluxes for HSCoupler2D2D.
- HSCoupler2D3DUserObjectComputes heat fluxes for HSCoupler2D3D.
- LayeredAverageRZComputes layered averages of variable for RZ components in a XY coordinate system
- LayeredFlowAreaChangeThis layered user object computes the change in cross sectional area of a flow channel from the displacement variables. Note: the convention isthat reduction in flow area is negative. For this to be satisfied, normals mustpoint INTO the flow channel.
- NumericalFluxGasMixHLLCComputes internal side flux for the 1-D, 1-phase, variable-area Euler equations using the HLLC approximate Riemann solver.
- ShaftConnectedMotorUserObjectComputes the torque and moment of inertia of a shaft connected motor
- StoreVariableByElemIDSideUserObjectStores variable values at each quadrature point on a side by element ID.
- Ray Tracing App
- ConeRayStudyRay study that spawns Rays in the direction of a cone from a given set of starting points.
- RepeatableRayStudyA ray tracing study that generates rays from vector of user-input start points and end points/directions.
- Phase Field App
- ComputeExternalGrainForceAndTorqueUserobject for calculating force and torque acting on a grain
- ComputeGrainForceAndTorqueUserobject for calculating force and torque acting on a grain
- ConservedMaskedNormalNoiseGaussian normal distributed random number noise provider with an applied spatially dependent material property mask for the ConservedLangevinNoise kernel.
- ConservedMaskedUniformNoiseUniformly distributed random number noise provider with an applied spatially dependent material property mask for the ConservedLangevinNoise kernel.
- ConservedNormalNoiseGaussian normal distributed random number noise provider for the ConservedLangevinNoise kernel.
- ConservedUniformNoiseUniformly distributed random number noise provider for the ConservedLangevinNoise kernel.
- ConstantGrainForceAndTorqueUserobject for calculating force and torque acting on a grain
- DiscreteNucleationFromFileManages the list of currently active nucleation sites and adds new sites according to a predetermined list from a CSV file (use this with sync_times).
- DiscreteNucleationInserterManages the list of currently active nucleation sites and adds new sites according to a given probability function.
- DiscreteNucleationMapGenerates a spatial smoothed map of all nucleation sites with the data of the DiscreteNucleationInserter for use by the DiscreteNucleation material.
- EBSDReaderLoad and manage DREAM.3D EBSD data files for running simulations on reconstructed microstructures.
- EulerAngleUpdaterProvide updated euler angles after rigid body rotation of the grains.
- GrainForceAndTorqueSumUserobject for summing forces and torques acting on a grain
- MaskedGrainForceAndTorqueUserobject for masking/pinning grains and making forces and torques acting on that grain zero
- RandomEulerAngleProviderAssign random Euler angles for each grain.
- SolutionRasterizerProcess an XYZ file of atomic coordinates and filter atoms via threshold or map variable values.
- Level Set App
- LevelSetOlssonTerminatorTool for terminating the reinitialization of the level set equation based on the criteria defined by Olsson et. al. (2007).
- Solid Mechanics App
- AbaqusUExternalDBCoupling user object to use Abaqus UEXTERNALDB subroutines in MOOSE
- AbaqusUserElementCoupling UserObject to use Abaqus UEL plugins in MOOSE
- AnalysisStepUserObjectMaps the time steps and the load step simulation times. It can be used in either direction depending on the simulation setup. It generates steps to be used in StepPeriod to control the enabled/disabled state of objects with user-provided simulation steps.
- CavityPressureUserObjectUses the ideal gas law to compute internal pressure and an initial moles of gas quantity.
- CrackFrontDefinitionUsed to describe geometric characteristics of the crack front for fracture integral calculations
- CrystalPlasticitySlipRateGSSPhenomenological constitutive model slip rate class. Override the virtual functions in your class
- CrystalPlasticitySlipResistanceGSSPhenomenological constitutive models' slip resistance base class. Override the virtual functions in your class
- CrystalPlasticityStateVarRateComponentGSSPhenomenological constitutive model state variable evolution rate component base class. Override the virtual functions in your class
- CrystalPlasticityStateVarRateComponentVocePhenomenological Voce constitutive model state variable evolution rate component base class.
- CrystalPlasticityStateVariableCrystal plasticity state variable class. Override the virtual functions in your class
- EulerAngleFileReaderRead Euler angle data from a file and provide it to other objects.
- GeneralizedPlaneStrainUserObjectGeneralized plane strain UserObject to provide residual and diagonal Jacobian entries.
- GlobalStrainUserObjectGlobal Strain UserObject to provide Residual and diagonal Jacobian entry
- HEVPEqvPlasticStrainUser Object to integrate equivalent plastic strain
- HEVPEqvPlasticStrainRateUser Object computing equivalent plastic strain rate
- HEVPFlowRatePowerLawJ2User object to evaluate power law flow rate and flow direction based on J2
- HEVPLinearHardeningUser Object for linear hardening
- HEVPRambergOsgoodHardeningUser object for Ramberg-Osgood hardening power law hardening
- LinearViscoelasticityManagerManages the updating of the semi-implicit single-step first-order finite difference time-stepping scheme
- SolidMechanicsHardeningConstantNo hardening - the parameter is independent of the internal parameter(s)
- SolidMechanicsHardeningCubicHardening is Cubic
- SolidMechanicsHardeningCutExponentialHardening is Cut-exponential
- SolidMechanicsHardeningExponentialHardening is Exponential
- SolidMechanicsHardeningGaussianHardening is Gaussian
- SolidMechanicsHardeningPowerRuleHardening defined by power rule
- SolidMechanicsPlasticDruckerPragerNon-associative Drucker Prager plasticity with no smoothing of the cone tip.
- SolidMechanicsPlasticDruckerPragerHyperbolicNon-associative Drucker Prager plasticity with hyperbolic smoothing of the cone tip.
- SolidMechanicsPlasticIsotropicSDIsotropicSD plasticity for pressure sensitive materials and also models the strength differential effect
- SolidMechanicsPlasticJ2J2 plasticity, associative, with hardening
- SolidMechanicsPlasticMeanCapClass that limits the mean stress. Yield function = a*mean_stress - strength. mean_stress = (stress_xx + stress_yy + stress_zz)/3
- SolidMechanicsPlasticMeanCapTCAssociative mean-cap tensile and compressive plasticity with hardening/softening
- SolidMechanicsPlasticMohrCoulombNon-associative Mohr-Coulomb plasticity with hardening/softening
- SolidMechanicsPlasticMohrCoulombMultiNon-associative Mohr-Coulomb plasticity with hardening/softening
- SolidMechanicsPlasticOrthotropicOrthotropic plasticity for pressure sensitive materials and also models the strength differential effect
- SolidMechanicsPlasticSimpleTesterClass that can be used for testing multi-surface plasticity models. Yield function = a*stress_yy + b*stress_zz + c*stress_xx + d*(stress_xy + stress_yx)/2 + e*(stress_xz + stress_zx)/2 + f*(stress_yz + stress_zy)/2 - strength
- SolidMechanicsPlasticTensileAssociative tensile plasticity with hardening/softening, and tensile_strength = 1
- SolidMechanicsPlasticTensileMultiAssociative tensile plasticity with hardening/softening
- SolidMechanicsPlasticWeakPlaneShearNon-associative finite-strain weak-plane shear perfect plasticity. Here cohesion = 1, tan(phi) = 1 = tan(psi)
- SolidMechanicsPlasticWeakPlaneTensileAssociative weak-plane tensile plasticity with hardening/softening
- SolidMechanicsPlasticWeakPlaneTensileNAssociative weak-plane tensile plasticity with hardening/softening, with specified, fixed normal vector. (WeakPlaneTensile combined with specifying N in the Material might be preferable to you.)
- TensorMechanicsHardeningConstantNo hardening - the parameter is independent of the internal parameter(s)
- TensorMechanicsHardeningCubicHardening is Cubic
- TensorMechanicsHardeningCutExponentialHardening is Cut-exponential
- TensorMechanicsHardeningExponentialHardening is Exponential
- TensorMechanicsHardeningGaussianHardening is Gaussian
- TensorMechanicsHardeningPowerRuleHardening defined by power rule
- TensorMechanicsPlasticDruckerPragerNon-associative Drucker Prager plasticity with no smoothing of the cone tip.
- TensorMechanicsPlasticDruckerPragerHyperbolicNon-associative Drucker Prager plasticity with hyperbolic smoothing of the cone tip.
- TensorMechanicsPlasticIsotropicSDIsotropicSD plasticity for pressure sensitive materials and also models the strength differential effect
- TensorMechanicsPlasticJ2J2 plasticity, associative, with hardening
- TensorMechanicsPlasticMeanCapClass that limits the mean stress. Yield function = a*mean_stress - strength. mean_stress = (stress_xx + stress_yy + stress_zz)/3
- TensorMechanicsPlasticMeanCapTCAssociative mean-cap tensile and compressive plasticity with hardening/softening
- TensorMechanicsPlasticMohrCoulombNon-associative Mohr-Coulomb plasticity with hardening/softening
- TensorMechanicsPlasticMohrCoulombMultiNon-associative Mohr-Coulomb plasticity with hardening/softening
- TensorMechanicsPlasticOrthotropicOrthotropic plasticity for pressure sensitive materials and also models the strength differential effect
- TensorMechanicsPlasticSimpleTesterClass that can be used for testing multi-surface plasticity models. Yield function = a*stress_yy + b*stress_zz + c*stress_xx + d*(stress_xy + stress_yx)/2 + e*(stress_xz + stress_zx)/2 + f*(stress_yz + stress_zy)/2 - strength
- TensorMechanicsPlasticTensileAssociative tensile plasticity with hardening/softening, and tensile_strength = 1
- TensorMechanicsPlasticTensileMultiAssociative tensile plasticity with hardening/softening
- TensorMechanicsPlasticWeakPlaneShearNon-associative finite-strain weak-plane shear perfect plasticity. Here cohesion = 1, tan(phi) = 1 = tan(psi)
- TensorMechanicsPlasticWeakPlaneTensileAssociative weak-plane tensile plasticity with hardening/softening
- TensorMechanicsPlasticWeakPlaneTensileNAssociative weak-plane tensile plasticity with hardening/softening, with specified, fixed normal vector. (WeakPlaneTensile combined with specifying N in the Material might be preferable to you.)
- Navier Stokes App
- HLLCUserObjectComputes free-flow wave speeds on internal sides, useful in HLLC contexts
- INSADObjectTrackerUser object used to track the kernels added to an INS simulation and determine what properties to calculate in INSADMaterial
- INSFVRhieChowInterpolatorComputes the Rhie-Chow velocity based on gathered 'a' coefficient data.
- INSFVRhieChowInterpolatorSegregatedComputes H/A and 1/A together with face velocities for segregated momentum-pressure equations.
- NSFVPressurePinPins the pressure after a solve
- NSPressurePinPins the pressure after a solve
- PINSFVRhieChowInterpolatorPerforms interpolations and reconstructions of porosity and computes the Rhie-Chow face velocities.
- PINSFVRhieChowInterpolatorSegregatedComputes H/A and 1/A together with face velocities for segregated porous medium momentum-pressure equations.
- RhieChowMassFluxComputes H/A and 1/A together with face mass fluxes for segregated momentum-pressure equations using linear systems.
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
- Moose App
- AddVariableActionAdd a non-linear variable to the simulation.
- CopyNodalVarsActionCopies variable information from a file.
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MFEMVariableClass for adding MFEM variables to the problem (mfem::ParGridFunctions).
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- 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
Variables/CHPFCRFFSplitVariables
- Phase Field App
- CHPFCRFFSplitVariablesActionCreates the L auxiliary variables, as well as a MultiApp along with transfers to set the variables, for the Cahn-Hilliard equation for the RFF form of the phase field crystal model
Variables/HHPFCRFFSplitVariables
- Phase Field App
- HHPFCRFFSplitVariablesActionCreates the L nonlinear variables for the Cahn-Hilliard equation for the RFF form of the phase field crystal model, when using a split approach
Variables/PFCRFFVariables
- Phase Field App
- PFCRFFVariablesActionCreates the L nonlinear variables for the Cahn-Hilliard equation for the RFF form of the phase field crystal model
Variables/PolycrystalVariables
- Phase Field App
- PolycrystalVariablesActionSet up order parameter variables for a polycrystal simulation
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.
- ElementMaterialSamplerRecords all Real-valued material properties of a material object, or Real-valued material properties of the supplied property names on quadrature points on elements at the indicated execution points.
- ElementValueSamplerSamples values of variables on elements.
- 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 or averages 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 Real-valued material properties of a material object, or Real-valued material properties of the supplied property names on quadrature points 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
- AdjointStrainSymmetricStressGradInnerProductThis component is designed to compute the gradient of the objective function concerning specific properties. It achieves this by computing the inner product of the property derivative obtained a material property and the strain resulting from the forward simulation.
- ElementOptimizationDiffusionCoefFunctionInnerProductCompute the gradient for material inversion by taking the inner product of gradients of the forward and adjoint variables with material gradient
- ElementOptimizationReactionFunctionInnerProductCompute the gradient for reaction material inversion by taking the inner product of the forward and adjoint variables multiplied by the derivative of the optimization function with respect to the controllable parameters.
- 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.
- 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.
- CrackFrontNonlocalScalarMaterialComputes the average material at points provided by the crack_front_definition vectorpostprocessor.
- CrackFrontNonlocalStressComputes the average stress normal to the crack face.
- 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
- Navier Stokes App
- WaveSpeedVPPExtracts wave speeds from HLLC userobject for a given face
- 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)
- 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.
- 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.
- 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
XFEM
- XFEMApp
- XFEMActionAction to input general parameters and simulation options for use in XFEM.