Complete Syntax
ADBCs
- Moose App
- AddADBCActionThis action is used to add ADBoundaryCondition<RESIDUAL> and ADBoundaryCondition<JACOBIAN> objects
- ADFunctionDirichletBC<JACOBIAN>Imposes the essential boundary condition , where is calculated by a function.
- ADFunctionDirichletBC<RESIDUAL>Imposes the essential boundary condition , where is calculated by a function.
- ADLagrangeVecFunctionDirichletBC<JACOBIAN>Imposes the essential boundary condition , where components are calculated with functions.
- ADLagrangeVecFunctionDirichletBC<RESIDUAL>Imposes the essential boundary condition , where components are calculated with functions.
ADKernels
- Moose App
- AddADKernelActionThis action is used to add ADKernel<RESIDUAL> and ADKernel<JACOBIAN> objects
- ADDiffusion<JACOBIAN>Same as
Diffusion
in terms of physics/residual, but the Jacobian is computed using forward automatic differentiation - ADDiffusion<RESIDUAL>Same as
Diffusion
in terms of physics/residual, but the Jacobian is computed using forward automatic differentiation - ADTimeDerivative<JACOBIAN>The time derivative operator with the weak form of .
- ADTimeDerivative<RESIDUAL>The time derivative operator with the weak form of .
- ADVectorDiffusion<JACOBIAN>The Laplacian operator (), with the weak form of . The Jacobian is computed using automatic differentiation
- ADVectorDiffusion<RESIDUAL>The Laplacian operator (), with the weak form of . The Jacobian is computed using automatic differentiation
- Heat Conduction App
- ADHeatConduction<JACOBIAN>Same as
Diffusion
in terms of physics/residual, but the Jacobian is computed using forward automatic differentiation - ADHeatConduction<RESIDUAL>Same as
Diffusion
in terms of physics/residual, but the Jacobian is computed using forward automatic differentiation - ADHeatConductionTimeDerivative<JACOBIAN>AD Time derivative term of the heat equation for quasi-constant specific heat and the density .
- ADHeatConductionTimeDerivative<RESIDUAL>AD Time derivative term of the heat equation for quasi-constant specific heat and the density .
- ADMatHeatSource<JACOBIAN>
- ADMatHeatSource<RESIDUAL>
- Tensor Mechanics App
- ADStressDivergenceRSphericalTensors<JACOBIAN>Calculate stress divergence for a spherically symmetric 1D problem in polar coordinates.
- ADStressDivergenceRSphericalTensors<RESIDUAL>Calculate stress divergence for a spherically symmetric 1D problem in polar coordinates.
- ADStressDivergenceRZTensors<JACOBIAN>Calculate stress divergence for an axisymmetric problem in cylindrical coordinates.
- ADStressDivergenceRZTensors<RESIDUAL>Calculate stress divergence for an axisymmetric problem in cylindrical coordinates.
- ADStressDivergenceTensors<JACOBIAN>Stress divergence kernel with automatic differentiation for the Cartesian coordinate system
- ADStressDivergenceTensors<RESIDUAL>Stress divergence kernel with automatic differentiation for the Cartesian coordinate system
- Misc App
- ADMatDiffusion<JACOBIAN>Same as
Diffusion
in terms of physics/residual, but the Jacobian is computed using forward automatic differentiation - ADMatDiffusion<RESIDUAL>Same as
Diffusion
in terms of physics/residual, but the Jacobian is computed using forward automatic differentiation - ADThermoDiffusion<JACOBIAN>Calculates diffusion due to temperature gradient and Soret Coefficient
- ADThermoDiffusion<RESIDUAL>Calculates diffusion due to temperature gradient and Soret Coefficient
ADMaterials
- Moose App
- AddADMaterialActionThis action is used to add ADMaterial<RESIDUAL> and ADMaterial<JACOBIAN> objects
- Heat Conduction Test App
- ADThermalConductivityTest<JACOBIAN>
- ADThermalConductivityTest<RESIDUAL>
- Tensor Mechanics App
- ADComputeAxisymmetricRZFiniteStrain<JACOBIAN>Compute a strain increment for finite strains under axisymmetric assumptions.
- ADComputeAxisymmetricRZFiniteStrain<RESIDUAL>Compute a strain increment for finite strains under axisymmetric assumptions.
- ADComputeAxisymmetricRZIncrementalStrain<JACOBIAN>Compute a strain increment and rotation increment for finite strains under axisymmetric assumptions.
- ADComputeAxisymmetricRZIncrementalStrain<RESIDUAL>Compute a strain increment and rotation increment for finite strains under axisymmetric assumptions.
- ADComputeAxisymmetricRZSmallStrain<JACOBIAN>Compute a small strain in an Axisymmetric geometry
- ADComputeAxisymmetricRZSmallStrain<RESIDUAL>Compute a small strain in an Axisymmetric geometry
- ADComputeFiniteStrain<JACOBIAN>Compute a strain increment and rotation increment for finite strains.
- ADComputeFiniteStrain<RESIDUAL>Compute a strain increment and rotation increment for finite strains.
- ADComputeFiniteStrainElasticStress<JACOBIAN>Compute stress using elasticity for finite strains
- ADComputeFiniteStrainElasticStress<RESIDUAL>Compute stress using elasticity for finite strains
- ADComputeGreenLagrangeStrain<JACOBIAN>Compute a Green-Lagrange strain.
- ADComputeGreenLagrangeStrain<RESIDUAL>Compute a Green-Lagrange strain.
- ADComputeIncrementalSmallStrain<JACOBIAN>Compute a strain increment and rotation increment for small strains.
- ADComputeIncrementalSmallStrain<RESIDUAL>Compute a strain increment and rotation increment for small strains.
- ADComputeLinearElasticStress<JACOBIAN>Compute stress using elasticity for small strains
- ADComputeLinearElasticStress<RESIDUAL>Compute stress using elasticity for small strains
- ADComputeMultipleInelasticStress<JACOBIAN>Compute 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.
- ADComputeMultipleInelasticStress<RESIDUAL>Compute 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.
- ADComputeRSphericalFiniteStrain<JACOBIAN>Compute a strain increment and rotation increment for finite strains in 1D spherical symmetry problems.
- ADComputeRSphericalFiniteStrain<RESIDUAL>Compute a strain increment and rotation increment for finite strains in 1D spherical symmetry problems.
- ADComputeRSphericalIncrementalStrain<JACOBIAN>Compute a strain increment for incremental strains in 1D spherical symmetry problems.
- ADComputeRSphericalIncrementalStrain<RESIDUAL>Compute a strain increment for incremental strains in 1D spherical symmetry problems.
- ADComputeRSphericalSmallStrain<JACOBIAN>Compute a small strain 1D spherical symmetry case.
- ADComputeRSphericalSmallStrain<RESIDUAL>Compute a small strain 1D spherical symmetry case.
- ADComputeSmallStrain<JACOBIAN>Compute a small strain.
- ADComputeSmallStrain<RESIDUAL>Compute a small strain.
- ADPowerLawCreepStressUpdate<JACOBIAN>This 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.
- ADPowerLawCreepStressUpdate<RESIDUAL>This 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.
- Misc App
- ADDensity<JACOBIAN>Creates density AD material property
- ADDensity<RESIDUAL>Creates density AD material property
- Misc Test App
- ADSoretCoeffTest<JACOBIAN>
- ADSoretCoeffTest<RESIDUAL>
Adaptivity
- Moose App
- SetAdaptivityOptionsAction
- Indicators
- Markers
- Phase Field App
- Markers
Adaptivity/Indicators
Adaptivity/Markers
- Moose App
- AddElementalFieldAction
- AddMarkerAction
- 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.
- OrientedBoxMarkerMarks inside and outside a box that can have arbitrary orientation and center point.
- UniformMarkerUniformly mark all elements for refinement or coarsening.
- ValueRangeMarkerMark elements for adaptivity based on the supplied upper and lower bounds and the specified variable.
- ValueThresholdMarkerThe the refinement state based on a threshold value compared to the specified variable.
- Phase Field App
- DiscreteNucleationMarkerMark new nucleation sites for refinement
AuxKernels
- Moose App
- AddKernelAction
- BoundsAux
- ConstantAuxCreates a constant field in the domain.
- DebugResidualAux
- DiffusionFluxAuxCompute components of flux vector for diffusion problems .
- ElementH1ErrorFunctionAuxComputes the H1 or W^{1,p} error between an exact function and a coupled variable.
- 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.
- FunctionAuxAuxiliary Kernel that creates and updates a field variable by sampling a function through space and time.
- GapValueAux
- JouleHeatingHeatGeneratedAuxCompute heat generated from Joule heating .
- LineSegmentLevelSetAuxAuxiliary Kernel that calcuates level set value using line segments' description.
- MaterialRankFourTensorAuxAccess a component of a RankFourTensor for automatic material property output
- MaterialRankTwoTensorAuxAccess a component of a RankTwoTensor for automatic material property output
- MaterialRealAuxOutputs element volume-averaged material properties
- MaterialRealDenseMatrixAux
- MaterialRealTensorValueAux
- MaterialRealVectorValueAux
- MaterialStdVectorAuxExtracts a component of a material type std::vector<Real> to an aux variable. If the std::vector is not of sufficient size then zero is returned
- MaterialStdVectorRealGradientAuxExtracts a component of a material's std::vector<RealGradient> to an aux variable. If the std::vector is not of sufficient size then zero is returned
- NearestNodeDistanceAuxStores the distance between a block and boundary or between two boundaries.
- NearestNodeValueAuxRetrieves a field value from the closest node on the paired boundary and stores it on this boundary or block.
- NormalizationAux
- ParsedAuxParsed function AuxKernel.
- PenetrationAuxAuxiliary Kernel for computing several geometry related quantities between two contacting bodies.
- ProcessorIDAuxCreates a field showing the processors and partitioning.
- QuotientAuxDivides two coupled variables.
- SelfAux
- SolutionAuxCreates fields by using information from a SolutionUserObject.
- SpatialUserObjectAux
- TagMatrixAuxCouple the diag of a tag matrix, and return its nodal value
- TagVectorAuxCouple a tag vector, and return its nodal value
- VariableGradientComponentCreates a field with consisting of one component of a coupled variable.
- VariableTimeIntegrationAux
- VectorMagnitudeAuxCreates a field representing the magnitude of three coupled variables using an Euclidean norm.
- 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.
- Phase Field Test App
- VoronoiICAux
- Phase Field App
- BndsCalcAuxCalculate location of grain boundaries in a polycrystalline sample
- CrossTermGradientFreeEnergyFree energy contribution from the cross terms in ACMultiInetrface
- DiscreteNucleationAuxProject the DiscreteNucleationMap state onto an AuxVariable
- EBSDReaderAvgDataAux
- EBSDReaderPointDataAux
- EulerAngleProvider2RGBAuxOutput RGB representation of crystal orientation from user object to an AuxVariable. The entire domain must have the same crystal structure.
- EulerAngleVariables2RGBAux
- FeatureFloodCountAuxFeature detection by connectivity analysis
- GrainAdvectionAuxCalculates the advection velocity of grain due to rigid body translation and rotation
- 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
- OutputEulerAnglesOutput euler angles from user object to an AuxVariable.
- PFCEnergyDensity
- PFCRFFEnergyDensity
- TotalFreeEnergyTotal free energy (both the bulk and gradient parts), where the bulk free energy has been defined in a material
- MatVecRealGradAuxKernel
- MaterialVectorAuxKernel
- MaterialVectorGradAuxKernel
- Misc App
- CoupledDirectionalMeshHeightInterpolation
- Functional Expansion Tools App
- FunctionSeriesToAuxAuxKernel to convert a functional expansion (Functions object, type = FunctionSeries) to an AuxVariable
- Solid Mechanics App
- MaterialSymmElasticityTensorAux
- MaterialTensorAuxOutputs quantities related to second-order tensors used as material properties
- Fluid Properties App
- 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
- Contact App
- ContactPressureAux
- Richards App
- DarcyFluxComponentDarcy flux (in m3.s-1.m-2, or m.s-1) -(k_ij/mu (nabla_j P - w_j)), where k_ij is the permeability tensor, mu is the fluid viscosity, P is the fluid pressure, and w_j is the fluid weight. If velocity_scaling is used then -(k_ij/mu (nabla_j P - w_j))/velocity_scaling is returned
- RichardsDensityAuxauxillary variable which is fluid density
- RichardsDensityPrimeAuxauxillary variable which is d(density)/dp
- RichardsDensityPrimePrimeAuxauxillary variable which is d2(density)/dp2
- RichardsRelPermAuxauxillary variable which is the relative permeability
- RichardsRelPermPrimeAuxauxillary variable which is d(relative permeability)/dSeff
- RichardsRelPermPrimePrimeAuxauxillary variable which is d2(relative permeability)/dSeff2
- RichardsSatAuxauxillary variable which is saturation
- RichardsSatPrimeAuxauxillary variable which is saturation
- RichardsSeffAuxauxillary variable which is effective saturation
- RichardsSeffPrimeAuxauxillary variable which is effective saturation
- RichardsSeffPrimePrimeAuxauxillary variable which is 2nd derivative of effective saturation
- Tensor Mechanics App
- AccumulateAux
- CylindricalRankTwoAuxTakes RankTwoTensor material and outputs component in cylindrical coordinates
- DomainIntegralQFunction
- DomainIntegralTopologicalQFunction
- ElasticEnergyAuxCompute the local elastic energy
- GlobalDisplacementAuxAuxKernel to visualize the displacements generated by the global strain tensor
- NewmarkAccelAuxComputes the current acceleration using the Newmark method.
- NewmarkVelAuxCalculates the current velocity using Newmark method.
- RadialDisplacementCylinderAuxCompute the radial component of the displacement vector for cylindrical models.
- RadialDisplacementSphereAuxCompute the radial component of the displacement vector for spherical models.
- RankFourAuxAccess a component of a RankFourTensor
- RankTwoAuxAccess a component of a RankTwoTensor
- RankTwoScalarAuxCompute a scalar property of a RankTwoTensor
- TestNewmarkTIAssigns the velocity/acceleration calculated by time integrator to the velocity/acceleration auxvariable.
- XFEMApp
- XFEMCutPlaneAux
- XFEMMarkerAux
- XFEMVolFracAux
- Navier Stokes App
- EnthalpyAux
- INSCourantComputes h_min / |u|.
- INSDivergenceAuxComputes h_min / |u|.
- InternalEnergyAux
- NSEnthalpyAuxNodal auxiliary variable, for computing enthalpy at the nodes.
- NSInternalEnergyAuxAuxiliary kernel for computing the internal energy of the fluid.
- NSMachAuxAuxiliary kernel for computing the Mach number assuming an ideal gas.
- NSPressureAuxNodal auxiliary variable, for computing pressure at the nodes.
- NSSpecificVolumeAuxAuxiliary kernel for computing the specific volume (1/rho) of the fluid.
- NSTemperatureAuxTemperature is an auxiliary value computed from the total energy based on the FluidProperties.
- NSVelocityAuxVelocity auxiliary value.
- PressureAux
- SpecificInternalEnergyAux
- SpecificVolumeAux
- TemperatureAux
- Fluid Properties Test App
- TwoPhaseAverageDensityAuxComputes the average of the densities of the phases corresponding to a 2-phase fluid properties object.
- 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)
- Porous Flow App
- 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.
- 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.
AuxKernels/MatVecRealGradAuxKernel
- Phase Field App
- MatVecRealGradAuxKernelAction
AuxKernels/MaterialVectorAuxKernel
- Phase Field App
- MaterialVectorAuxKernelAction
AuxKernels/MaterialVectorGradAuxKernel
- Phase Field App
- MaterialVectorGradAuxKernelAction
AuxScalarKernels
- Moose App
- AddScalarKernelAction
- ConstantScalarAux
- FunctionScalarAux
- QuotientScalarAux
- ScalarTagMatrixAuxCouple a tag matrix, and return its nodal value
- ScalarTagVectorAuxCouple a tag vector, and return its value
- Tensor Mechanics App
- GeneralizedPlaneStrainReferenceResidualGeneralized Plane Strain Reference Residual Scalar Kernel
AuxVariables
- Moose App
- AddAuxVariableAction
- CopyNodalVarsAction
- InitialCondition
- Navier Stokes App
- InitialCondition
- Phase Field App
- InitialCondition
- MultiAuxVariables
- Porous Flow App
- InitialCondition
AuxVariables/MultiAuxVariables
- Phase Field App
- MultiAuxVariablesActionSet up auxvariables for components of MaterialProperty<std::vector<data_type> > for polycrystal sample.
BCs
- Moose App
- AddBCAction
- ConvectiveFluxBCDetermines boundary values via the initial and final values, flux, and exposure duration
- DGFunctionDiffusionDirichletBC
- DiffusionFluxBCComputes a boundary residual contribution consistent with the Diffusion Kernel. Does not impose a boundary condition; instead computes the boundary contribution corresponding to the current value of grad(u) and accumulates it in the residual vector.
- DirichletBCImposes the essential boundary condition , where is a constant, controllable value.
- EigenDirichletBCDirichlet BC for eigenvalue solvers
- FunctionDirichletBCImposes the essential boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- FunctionNeumannBCImposes the integrated boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- FunctionPenaltyDirichletBC
- FunctionPresetBCThe same as FunctionDirichletBC except the value is applied before the solve begins
- LagrangeVecDirichletBCImposes the essential boundary condition , where are constant, controllable values.
- LagrangeVecFunctionDirichletBCImposes the essential boundary condition , where components are calculated with functions.
- MatchedValueBCImplements a NodalBC which equates two different Variables' values on a specified boundary.
- NeumannBCImposes the integrated boundary condition , where is a constant, controllable value.
- OneDEqualValueConstraintBC
- PenaltyDirichletBCEnforces a Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet data.
- PostprocessorDirichletBC
- PostprocessorNeumannBC
- PresetBCSimilar to DirichletBC except the value is applied before the solve begins
- 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.
- VacuumBC
- VectorNeumannBCImposes the integrated boundary condition , where is a user-defined, constant vector.
- 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
- Rdg App
- AEFVBCA boundary condition kernel for the advection equation using a cell-centered finite volume method.
- 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.
- XFEMApp
- CrackTipEnrichmentCutOffBCSimilar to DirichletBC except the value is applied before the solve begins
- Heat Conduction App
- ConvectiveFluxFunctionDetermines boundary value by fluid heat transfer coefficient and far-field temperature
- CoupledConvectiveFlux
- CoupledConvectiveHeatFluxBCConvective heat transfer boundary condition with temperature and heat transfer coefficent given by auxiliary variables.
- GapHeatTransferTransfers heat across a gap between two surfaces dependant on the gap geometry specified.
- HeatConductionBC
- Richards App
- Q2PPiecewiseLinearSinkSink of fluid, controlled by (pressure, bare_fluxes) interpolation. This is for use in Q2P models
- RichardsExcavAllows the user to set variable values at the face of an excavation. You must have defined the excavation start time, start position, etc, through the excav_geom_function
- RichardsHalfGaussianSink
- RichardsPiecewiseLinearSink
- Tensor Mechanics App
- CoupledPressureBCApplies a pressure from a variable on a given boundary in a given direction
- DashpotBC
- DisplacementAboutAxisImplements a boundary condition that enforces rotationaldisplacement around an axis on a boundary
- InteractionIntegralBenchmarkBC
- PresetAccelerationPrescribe acceleration on a given boundary in a given direction
- PresetDisplacementPrescribe the displacement on a given boundary in a given direction.
- PresetVelocity
- PressureApplies a pressure on a given boundary in a given direction
- StickyBCImposes the boundary condition if exceeds the bounds provided
- CavityPressure
- CoupledPressure
- Pressure
- Navier Stokes App
- EnergyFreeBC
- 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'.
- MassFreeBC
- MomentumFreeBC
- MomentumFreeSlipBC
- 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.
- Chemical Reactions App
- ChemicalOutFlowBCChemical flux boundary condition
- Porous Flow App
- 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.
- 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.
BCs/CavityPressure
- Tensor Mechanics App
- CavityPressureAction
- CavityPressurePPActionThis Action creates a CavityPressurePostprocessor.
- CavityPressureUOAction
BCs/CoupledPressure
- Tensor Mechanics App
- CoupledPressureActionSet up Coupled Pressure boundary conditions
BCs/Periodic
- Moose App
- AddPeriodicBCAction
BCs/Pressure
- Tensor Mechanics App
- PressureActionSet up Pressure boundary conditions
Constraints
- Moose App
- AddConstraintAction
- CoupledTiedValueConstraint
- EqualGradientConstraint
- EqualValueBoundaryConstraint
- EqualValueConstraint
- EqualValueEmbeddedConstraintThis is a constraint enforcing overlapping portions of two blocks to have the same variable value
- LinearNodalConstraintConstrains slave node to move as a linear combination of master nodes.
- TiedValueConstraint
- Heat Conduction App
- GapConductanceConstraintComputes the residual and Jacobian contributions for the 'Lagrange Multiplier' implementation of the thermal contact problem. For more information, see the detailed description here: http://tinyurl.com/gmmhbe9
- XFEMApp
- XFEMEqualValueAtInterfaceenforce a same value on both sides of the interface.
- XFEMSingleVariableConstraint
- Contact App
- GluedContactConstraint
- MechanicalContactConstraint
- MultiDContactConstraint
- OneDContactConstraint
- SparsityBasedContactConstraint
Contact
Controls
- Moose App
- AddControlAction
- RealFunctionControlSets the value of a 'Real' input parameters to the value of a provided function.
- TimePeriodControl the enabled/disabled state of objects with time.
- Stochastic Tools App
- MultiAppCommandLineControlControl for modifying the command line arguments of MultiApps.
- SamplerReceiverControl for receiving data from a Sampler via SamplerTransfer.
DGKernels
- Moose App
- AddDGKernelAction
- DGConvectionDG upwinding for the convection
- DGDiffusion
- Rdg App
- AEFVKernelA dgkernel for the advection equation using a cell-centered finite volume method.
Dampers
- Moose App
- AddDamperAction
- BoundingValueElementDamper
- BoundingValueNodalDamper
- ConstantDamper
- MaxIncrement
- Tensor Mechanics App
- ElementJacobianDamperDamper that limits the change in element Jacobians
- Contact App
- ContactSlipDamper
Debug
- Moose App
- SetupDebugActionAdds various debugging type Outputters to the simulation system based on user parameters
- SetupResidualDebugAction
- MaterialDerivativeTest
Debug/MaterialDerivativeTest
- Moose App
- MaterialDerivativeTestAction
DeprecatedBlock
- Moose App
- DeprecatedBlockAction
DiracKernels
- Moose App
- AddDiracKernelAction
- ConstantPointSource
- FunctionDiracSource
- Heat Conduction App
- GapHeatPointSourceMaster
- Richards App
- Q2PBoreholeApproximates a borehole in the mesh with given bottomhole pressure, and radii using a number of point sinks whose positions are read from a file. This DiracKernel is for use by Q2P models
- RichardsBoreholeApproximates a borehole in the mesh with given bottomhole pressure, and radii using a number of point sinks whose positions are read from a file
- RichardsPolyLineSinkApproximates a polyline sink in the mesh by using a number of point sinks whose positions are read from a file
- XFEMApp
- XFEMPressure
- 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
- PorousFlowPolyLineSinkApproximates a polyline sink by using a number of point sinks with given weighting whose positions are read from a file
- PorousFlowSquarePulsePointSourcePoint source (or sink) that adds (removes) fluid at a constant mass flux rate for times between the specified start and end times.
- Contact App
- ContactMaster
- SlaveConstraint
Distributions
- Moose App
- AddDistributionAction
- Stochastic Tools App
- BoostLognormalDistributionBoost Lognormal distribution.
- BoostNormalDistributionBoost Normal distribution.
- BoostWeibullDistributionBoost Weibull distribution.
- JohnsonSBDistributionJohnson Special Bounded (SB) distribution.
- LogisticDistributionLogistic distribution.
- NormalDistributionNormal distribution
- TruncatedNormalDistributionTruncated normal distribution
- UniformDistributionContinuous uniform distribution.
- WeibullDistributionThree-parameter Weibull distribution.
DomainIntegral
- Tensor Mechanics App
- DomainIntegralAction
Executioner
- Moose App
- CreateExecutionerAction
- EigenvalueEigenvalue solves a standard/generalized eigenvaue problem
- InversePowerMethod
- NonlinearEigen
- Steady
- Transient
- Adaptivity
- Predictor
- Quadrature
- TimeIntegrator
- TimeStepper
Executioner/Adaptivity
- Moose App
- AdaptivityAction
Executioner/Predictor
Executioner/Quadrature
- Moose App
- SetupQuadratureAction
Executioner/TimeIntegrator
- Moose App
- SetupTimeIntegratorAction
- AStableDirk4
- ActuallyExplicitEulerImplementation of Explicit/Forward Euler without invoking any of the nonlinear solver
- BDF2
- CrankNicolson
- ExplicitEuler
- ExplicitMidpoint
- ExplicitTVDRK2
- Heun
- ImplicitEuler
- ImplicitMidpoint
- LStableDirk2
- LStableDirk3
- LStableDirk4
- NewmarkBetaComputes the first and second time derivative of variable using Newmark-Beta method.
- Ralston
Executioner/TimeStepper
- Moose App
- SetupTimeStepperAction
- AB2PredictorCorrector
- CSVTimeSequenceStepperSolves the Transient problem at a sequence of given time points read in a file.
- ConstantDTTimestepper that takes a constant time step size
- DT2
- ExodusTimeSequenceStepperSolves the Transient problem at a sequence of time points taken from a specified exodus file.
- FunctionDTTimestepper whose steps vary over time according to a user-defined fuction
- IterationAdaptiveDTAdjust the timestep based on the number of iterations
- LogConstantDTTimeStepper which imposes a time step constant in the logarithmic space
- PostprocessorDT
- SolutionTimeAdaptiveDT
- TimeSequenceStepperSolves the Transient problem at a sequence of given time points.
Functions
- Moose App
- AddFunctionAction
- Axisymmetric2D3DSolutionFunctionFunction for reading a 2D axisymmetric solution from file and mapping it to a 3D Cartesian model
- BicubicSplineFunction
- CompositeFunctionMultiplies an arbitrary set of functions together
- ConstantFunction
- ImageFunctionFunction with values sampled from a given image stack
- LinearCombinationFunctionReturns the linear combination of the functions
- ParsedFunction
- ParsedGradFunction
- ParsedVectorFunction
- PiecewiseBilinearInterpolates values from a csv file
- PiecewiseConstantDefines data using a set of x-y data pairs
- PiecewiseLinearLinearly interpolates between pairs of x-y data
- PiecewiseMulticonstantPiecewiseMulticonstant performs constant interpolation on 1D, 2D, 3D or 4D data. The data_file specifies the axes directions and the function values. If a point lies outside the data range, the appropriate end value is used.
- PiecewiseMultilinearPiecewiseMultilinear performs linear interpolation on 1D, 2D, 3D or 4D data. The data_file specifies the axes directions and the function values. If a point lies outside the data range, the appropriate end value is used.
- SolutionFunction
- SplineFunction
- TestSetupPostprocessorDataActionFunction
- VectorPostprocessorFunction
- Richards App
- Grad2ParsedFunction
- GradParsedFunction
- RichardsExcavGeomThis function defines excavation geometry. It can be used to enforce pressures at the boundary of excavations, and to record fluid fluxes into excavations.
- Functional Expansion Tools App
- FunctionSeriesThis function uses a convolution of functional series (functional expansion or FX) to create a 1D, 2D, or 3D function
- Navier Stokes App
- WedgeFunctionFunction which computes the exact solution for Jeffery-Hamel flow in a wedge.
- Level Set App
- LevelSetOlssonBubbleImplementation of 'bubble' ranging from 0 to 1.
- LevelSetOlssonVortexA function for creating vortex velocity fields for level set equation benchmark problems.
- 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.
GlobalParams
- Moose App
- GlobalParamsAction
ICs
- Moose App
- AddInitialConditionAction
- 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.
- FunctionScalarIC
- RandomICInitialize a variable with randomly generated numbers following either a uniform distribution or a user-defined distribution
- ScalarComponentIC
- ScalarConstantIC
- VectorConstantICSets constant component values for a vector field variable.
- Navier Stokes App
- NSInitialConditionNSInitialCondition sets intial constant values for all variables.
- 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)
- ClosePackICClose packed arrangement of smooth circles
- CrossICCross-shaped initial condition
- 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
- PFCFreezingIC
- PolycrystalColoringICRandom Voronoi tesselation polycrystal (used by PolycrystalVoronoiICAction)
- 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.
- ReconPhaseVarIC
- 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
- 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
- Porous Flow App
- PorousFlowFluidStateBrineCO2ICAn initial condition to calculate z from saturation for brine and CO2
- PorousFlowFluidStateICAn initial condition to calculate z from saturation
- PorousFlowFluidStateWaterNCGICAn initial condition to calculate z from saturation for water and non-condensable gas
ICs/PolycrystalICs
- Phase Field App
- BicrystalBoundingBoxIC
- BicrystalCircleGrainIC
- PolycrystalColoringIC
- PolycrystalRandomIC
- PolycrystalVoronoiVoidIC
- Tricrystal2CircleGrainsIC
ICs/PolycrystalICs/BicrystalBoundingBoxIC
- Phase Field App
- BicrystalBoundingBoxICActionBicrystal using a bounding box
ICs/PolycrystalICs/BicrystalCircleGrainIC
- Phase Field App
- BicrystalCircleGrainICActionBicrystal with a circular grain and an embedding outer grain
ICs/PolycrystalICs/PolycrystalColoringIC
- Phase Field App
- PolycrystalColoringICActionRandom Voronoi tesselation polycrystal action
ICs/PolycrystalICs/PolycrystalRandomIC
- Phase Field App
- PolycrystalRandomICAction
ICs/PolycrystalICs/PolycrystalVoronoiVoidIC
- Phase Field App
- PolycrystalVoronoiVoidICAction
ICs/PolycrystalICs/Tricrystal2CircleGrainsIC
- Phase Field App
- Tricrystal2CircleGrainsICAction
InterfaceKernels
- Moose App
- AddInterfaceKernelAction
- 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
- AddKernelAction
- AnisotropicDiffusionAnisotropic diffusion kernel with weak form given by .
- BodyForceDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- CoefTimeDerivativeThe time derivative operator with the weak form of .
- ConservativeAdvectionConservative form of which in its weak form is given by: .
- CoupledForceImplements a source term proportional to the value of a coupled variable. Weak form: .
- CoupledTimeDerivativeTime derivative Kernel that acts on a coupled variable. Weak form: .
- DiffusionThe Laplacian operator (), with the weak form of .
- MassEigenKernelAn eigenkernel with weak form where is the eigenvalue.
- MassLumpedTimeDerivativeLumped formulation of the time derivative . Its corresponding weak form is where denotes the time derivative of the solution coefficient associated with node .
- MatDiffusionDiffusion equation Kernel that takes an isotropic Diffusivity from a material property
- 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.
- NullKernelKernel that sets a zero residual.
- ReactionImplements a simple consuming reaction term with weak form .
- 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 .
- VectorDiffusionThe Laplacian operator (), with the weak form of .
- Phase Field Test App
- GaussContForcing
- 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-crystaline Allen-Cahn Kernel
- ACGrGrPolyGrain-Boundary model poly-crystaline interface Allen-Cahn Kernel
- 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.
- 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
- AllenCahnAllen-Cahn Kernel that uses a DerivativeMaterial Free Energy
- AllenCahnElasticEnergyOffDiagThis kernel calculates off-diagonal jacobian of elastic energy in AllenCahn with respect to displacements
- 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
- CoefCoupledTimeDerivativeScaled time derivative Kernel that acts on a coupled variable
- CoefReactionImplements the residual term (p*u, test)
- 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 $\frac{dh_\alpha}{d\eta_i} F_\alpha + \frac{dh_\beta}{d\eta_i} F_\beta + \dots)
- DiscreteNucleationForceTerm for inserting grain nuclei or phases in non-conserved order parameter fields
- GradientComponentSet the kernel variable to a specified component of the gradient of a coupled variable.
- HHPFCRFFReaction type kernel for the RFF phase fit crystal model
- KKSACBulkCKKS model kernel (part 2 of 2) for the Bulk Allen-Cahn. This includes all terms dependent on chemical potential.
- KKSACBulkFKKS model kernel (part 1 of 2) for the Bulk Allen-Cahn. This includes all terms NOT dependent on chemical potential.
- KKSCHBulkKKS model kernel for the Bulk Cahn-Hilliard term. This operates on the concentration 'c' as the non-linear variable
- KKSMultiACBulkCMulti-phase KKS model kernel (part 2 of 2) for the Bulk Allen-Cahn. This includes all terms dependent on chemical potential.
- KKSMultiACBulkFKKS model kernel (part 1 of 2) for the Bulk Allen-Cahn. This includes all terms NOT dependent on chemical potential.
- KKSMultiPhaseConcentrationKKS multi-phase model kernel to enforce . The non-linear variable of this kernel is , the final phase concentration in the list.
- KKSPhaseChemicalPotentialKKS model kernel to enforce the pointwise equality of phase chemical potentials dFa/dca = dFb/dcb. The non-linear variable of this kernel is ca.
- KKSPhaseConcentrationKKS model kernel to enforce the decomposition of concentration into phase concentration (1-h(eta))ca + h(eta)cb - c = 0. The non-linear variable of this kernel is cb.
- KKSSplitCHCResKKS model kernel for the split Bulk Cahn-Hilliard term. This operates on the chemical potential 'c' as the non-linear variable
- LangevinNoiseSource term for non-conserved Langevin noise
- LaplacianSplitSplit with a variable that holds the Laplacian of a phase field variable.
- MaskedBodyForceKernel that defines a body force modified by a material mask
- MatAnisoDiffusionDiffusion equation Kernel that takes an anisotropic Diffusivity from a material property
- MatGradSquareCoupledGradient square of a coupled variable.
- MatReactionKernel to add -L*v, where L=reaction rate, v=variable
- MultiGrainRigidBodyMotionAdds rigid mody motion to grains
- 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
- Misc App
- CoefDiffusionKernel for diffusion with diffusivity = coef + function
- ThermoDiffusionKernel for thermo-diffusion (Soret effect, thermophoresis, etc.)
- Navier Stokes Test App
- AdvectionThis class solves the scalar advection equation, with SUPG stabilization.
- 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
- HomogenizationKernel
- OutOfPlaneStress
- SolidMechImplicitEuler
- StressDivergence
- StressDivergenceRSpherical
- StressDivergenceRZ
- XFEMApp
- CrackTipEnrichmentStressDivergenceTensorsEnrich stress divergence kernel for small-strain simulations
- Heat Conduction App
- AnisoHeatConduction
- HeatCapacityConductionTimeDerivativeTime derivative term of the heat equation with the heat capacity as an argument.
- HeatConductionComputes residual/Jacobian contribution for term.
- HeatConductionTimeDerivativeTime derivative term of the heat equation for quasi-constant specific heat and the density .
- HeatSourceDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- HomogenizedHeatConduction
- JouleHeatingSourceDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- SpecificHeatConductionTimeDerivativeTime derivative term of the heat equation with the specific heat and the density as arguments.
- Richards App
- DarcyFluxDarcy flux. nabla_i (k_ij/mu (nabla_j P - w_j)), where k_ij is the permeability tensor, mu is the fluid viscosity, P is the fluid pressure, and w_j is the fluid weight
- PoroFullSatTimeDerivativeKernel = biot_coefficient*d(volumetric_strain)/dt + (1/biot_modulus)*d(porepressure)/dt. This is the time-derivative for poromechanics for a single-phase, fully-saturated fluid with constant bulk modulus
- Q2PNegativeNodalMassOld- fluid_mass
- Q2PNodalMassFluid mass lumped to the nodes divided by dt
- Q2PPorepressureFluxFlux according to Darcy-Richards flow. The Variable for this Kernel should be the porepressure.
- Q2PSaturationDiffusionDiffusion part of the Flux according to Darcy-Richards flow. The Variable of this Kernel must be the saturation.
- Q2PSaturationFluxFlux according to Darcy-Richards flow. The Variable of this Kernel must be the saturation
- RichardsFlux
- RichardsFullyUpwindFlux
- RichardsLumpedMassChange
- RichardsMassChangeThe time derivative operator with the weak form of .
- RichardsPPenaltyThis adds a term to the residual that attempts to enforce variable > lower_var. The term is a*(lower - variable) for variable<lower, and zero otherwise
- Tensor Mechanics App
- CosseratStressDivergenceTensorsStress divergence kernel for the Cartesian coordinate system
- DynamicStressDivergenceTensorsResidual due to stress related Rayleigh damping and HHT time integration terms
- GeneralizedPlaneStrainOffDiagGeneralized Plane Strain kernel to provide contribution of the out-of-plane strain to other kernels
- GravityApply gravity. Value is in units of acceleration.
- InertialForceCalculates the residual for the interial 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 interial force/moment and the contribution of mass dependent Rayleigh damping and HHT time integration scheme.
- InertialTorqueKernel for interial torque: density * displacement x acceleration
- MomentBalancing
- OutOfPlanePressureApply pressure in the out-of-plane direction in 2D plane stress or generalized plane strain models
- PhaseFieldFractureMechanicsOffDiagStress divergence kernel for phase-field fracture: Computes off diagonal damage dependent Jacobian components. To be used with StressDivergenceTensors or DynamicStressDivergenceTensors.
- PlasticHeatEnergyPlastic heat energy density = coeff * stress * plastic_strain_rate
- PoroMechanicsCouplingAdds , where the subscript is the component.
- StressDivergenceBeamQuasi-static and dynamic stress divergence kernel for Beam element
- StressDivergenceRSphericalTensorsCalculate stress divergence for a spherically symmetric 1D problem in polar coordinates.
- StressDivergenceRZTensorsCalculate stress divergence for an axisymmetric problem in cylindrical coordinates.
- StressDivergenceTensorsStress divergence kernel for the Cartesian coordinate system
- StressDivergenceTensorsTrussKernel for truss element
- WeakPlaneStressPlane stress kernel to provide out-of-plane strain contribution
- DynamicTensorMechanics
- PoroMechanics
- TensorMechanics
- 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
- PorousFlowEffectiveStressCouplingAdds , where the subscript is the component.
- 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
- 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
- PorousFlowHeatAdvectionFully-upwinded heat flux, advected by the fluid
- PorousFlowHeatConductionHeat conduction in the Porous Flow module
- PorousFlowHeatVolumetricExpansionEnergy-density*rate_of_solid_volumetric_expansion
- PorousFlowMassRadioactiveDecayRadioactive decay of a fluid component
- PorousFlowMassTimeDerivativeComponent mass derivative wrt time for component given by fluid_component
- PorousFlowMassVolumetricExpansionComponent_mass*rate_of_solid_volumetric_expansion
- PorousFlowPlasticHeatEnergyPlastic heat energy density source = (1 - porosity) * coeff * stress * plastic_strain_rate
- PorousFlowPreDisPrecipitation-dissolution of chemical species
- XFEMTest App
- TestMatTimeDerivativeThe time derivative operator with the weak form of .
- Navier Stokes App
- DistributedForce
- DistributedPower
- 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.
- 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.
- MassConvectiveFlux
- MomentumConvectiveFlux
- 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.
- PressureGradient
- TotalEnergyConvectiveFlux
- Fluid Properties Test App
- NaNInterfaceTestKernelKernel to test NaNInterface using NaNInterfaceTestFluidProperties
- 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
- DarcyFluxPressure
- 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
- Misc Test App
- Convection
Kernels/CHPFCRFFSplitKernel
- Phase Field App
- CHPFCRFFSplitKernelAction
Kernels/DynamicTensorMechanics
- Tensor Mechanics App
- DynamicTensorMechanicsActionSet 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 addes 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
- Tensor Mechanics App
- PoroMechanicsActionSet up stress divergence kernels with coordinate system aware logic
Kernels/RigidBodyMultiKernel
- Phase Field App
- RigidBodyMultiKernelActionAction for applying AllenCahn equations and SingleGrainRigidBodyMotion to grains
Kernels/TensorMechanics
- Tensor Mechanics App
- LegacyTensorMechanicsActionSet up stress divergence kernels with coordinate system aware logic
Materials
- Moose App
- AddMaterialAction
- DerivativeParsedMaterialParsed Function Material with automatic derivatives.
- DerivativeSumMaterialMeta-material to sum up multiple derivative materials
- GenericConstantMaterial
- GenericConstantRankTwoTensor
- GenericFunctionMaterial
- ParsedMaterialParsed Function Material.
- PiecewiseLinearInterpolationMaterialCompute a property using a piecewise linear interpolation to define its dependence on a variable
- Rdg App
- AEFVMaterialA material kernel for the advection equation using a cell-centered finite volume method.
- Phase Field App
- AsymmetricCrossTermBarrierFunctionMaterialFree energy contribution asymmetric across interfaces between arbitrary pairs of phases.
- BarrierFunctionMaterialHelper material to provide g(eta) and its derivative in a polynomial. SIMPLE: eta2*(1-eta)2 LOW: eta*(1-eta) HIGH: eta2*(1-eta2)^2
- CompositeMobilityTensorAssemble a mobility tensor from multiple tensor contributions weighted by material properties
- ComputePolycrystalElasticityTensorCompute an evolving elasticity tensor coupled to a grain growth phase field model.
- ConstantAnisotropicMobilityProvide a constant mobility tensor value
- CrossTermBarrierFunctionMaterialFree energy contribution symmetric across interfaces between arbitrary pairs of phases.
- DeformedGrainMaterial
- DerivativeMultiPhaseMaterialTwo phase material that combines n phase materials using a switching function with and n nonconserved 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.
- ExternalForceDensityMaterialProviding external applied force density to grains
- ForceDensityMaterialCalculating the force density acting on a grain
- GBAnisotropy
- GBDependentAnisotropicTensorCompute anisotropic rank two tensor based on GB phase variable
- GBDependentDiffusivityCompute diffusivity rank two tensor based on GB phase variable
- GBEvolutionComputes necessary material properties for the isotropic grian growth model
- GBWidthAnisotropy
- GrainAdvectionVelocityCalculation the advection velocity of grain due to rigid vody translation and rotation
- GrandPotentialInterfaceCalculate Grand Potential interface parameters for a specified interfacial free energy and width
- IdealGasFreeEnergyFree energy of an ideal gas.
- InterfaceOrientationMaterial
- InterfaceOrientationMultiphaseMaterialThis Material accounts for the the orientation dependence of interfacial energy for multi-phase multi-order parameter phase-field model.
- KKSXeVacSolidMaterialKKS Solid phase free energy for Xe,Vac in UO2. Fm(cmg,cmv)
- MathEBFreeEnergyMaterial that implements the math free energy using the expression builder and automatric differentiation
- MathFreeEnergyMaterial that implements the math free energy and its derivatives: F = 1/4(1 + c)^2*(1 - c)^2
- MixedSwitchingFunctionMaterialHelper material to provide h(eta) and its derivative in one of two polynomial forms. MIX234 and MIX246
- MultiBarrierFunctionMaterialDouble well phase transformation barrier free energy contribution.
- PFCRFFMaterial
- PFCTradMaterialPolynomial coefficients for a phase field crystal correlation function
- PFParamsPolyFreeEnergyPhase field parameters for polynomial free energy for single component systems
- PhaseNormalTensorCalculate normal tensor of a phase based on gradient
- 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: h_i = eta_i2/4 * [15 (1-eta_i) [1 + eta_i - (eta_k - eta_j)2] + eta_i * (9eta_i^2 - 5)]
- SwitchingFunctionMaterialHelper material to provide h(eta) and its derivative in one of two polynomial forms. SIMPLE: 3eta^2-2eta3 HIGH: eta3(6eta^2-15*eta+10)
- 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
- TimeStepMaterial
- VanDerWaalsFreeEnergyFree energy of a Van der Waals gas.
- VariableGradientMaterial
- Misc App
- DensityCreates density material property
- Richards App
- DarcyMaterialMaterial that holds the permeability tensor used in Darcy flow
- PoroFullSatMaterialThis Material is designed to calculate and store all the quantities needed for the fluid-flow part of poromechanics, assuming a fully-saturated, single-phase fluid with constant bulk modulus
- Q2PMaterial
- RichardsMaterial
- XFEMApp
- ComputeCrackTipEnrichmentSmallStrain
- 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.
- Heat Conduction App
- AnisoHeatConductionMaterial
- ElectricalConductivity
- GapConductance
- HeatConductionMaterialGeneral-purpose material model for heat conduction
- SemiconductorLinearConductivity
- Solid Mechanics App
- AbaqusCreepMaterial
- AbaqusUmatMaterial
- CLSHPlasticMaterial
- CLSHPlasticModel
- CombinedCreepPlasticityModels creep and instantaneous plasticity deformation
- ElasticA simple hypo-elastic model
- ElasticModel
- IsotropicPlasticityCalculates the stress and plastic strain in the general isotropic linear strain hardening plasticity model
- IsotropicPowerLawHardeningCalculates the stress and plastic strain in the general isotropic linear strain hardening plasticity model
- IsotropicTempDepHardeningCalculates the stress and plastic strain in the general isotropic linear strain hardening plasticity model
- LinearAnisotropicMaterial
- LinearGeneralAnisotropicMaterial
- LinearIsotropicMaterial
- LinearStrainHardening
- MacroElasticA simple hypo-elastic model
- PLC_LSH
- PowerLawCreep
- PowerLawCreepModel
- RateDepSmearCrackModel
- RateDepSmearIsoCrackModel
- SolidModel
- Tensor Mechanics App
- AbruptSofteningSoftening model with an abrupt stress release upon cracking. This class is intended to be used with ComputeSmearedCrackingStress.
- CappedDruckerPragerCosseratStressUpdateCapped Drucker-Prager plasticity stress calculator for the Cosserat situation where the host medium (ie, the limit where all Cosserat effects are zero) is isotropic. Note that the return-map flow rule uses an isotropic elasticity tensor built with the 'host' properties defined by the user.
- CappedDruckerPragerStressUpdateCapped Drucker-Prager plasticity stress calculator
- CappedMohrCoulombCosseratStressUpdateCapped Mohr-Coulomb plasticity stress calculator for the Cosserat situation where the host medium (ie, the limit where all Cosserat effects are zero) is isotropic. Note that the return-map flow rule uses an isotropic elasticity tensor built with the 'host' properties defined by the user.
- CappedMohrCoulombStressUpdateNonassociative, smoothed, Mohr-Coulomb plasticity capped with tensile (Rankine) and compressive caps, with hardening/softening
- CappedWeakInclinedPlaneStressUpdateCapped weak inclined plane plasticity stress calculator
- CappedWeakPlaneCosseratStressUpdateCapped weak-plane plasticity Cosserat stress calculator
- CappedWeakPlaneStressUpdateCapped weak-plane plasticity stress calculator
- CombinedScalarDamageScalar damage model which is computed as a function of multiple scalar damage models
- CompositeEigenstrainAssemble an Eigenstrain tensor from multiple tensor contributions weighted by material properties
- CompositeElasticityTensorAssemble an elasticity tensor from multiple tensor contributions weighted by material properties
- ComputeAxisymmetric1DFiniteStrainCompute a strain increment and rotation increment for finite strains in an axisymmetric 1D problem
- ComputeAxisymmetric1DIncrementalStrainCompute strain increment for small strains in an axisymmetric 1D problem
- ComputeAxisymmetric1DSmallStrainCompute a small strain in an Axisymmetric 1D problem
- ComputeAxisymmetricRZFiniteStrainCompute a strain increment for finite strains under axisymmetric assumptions.
- ComputeAxisymmetricRZIncrementalStrainCompute a strain increment and rotation increment for finite strains under axisymmetric assumptions.
- ComputeAxisymmetricRZSmallStrainCompute a small strain in an Axisymmetric geometry
- ComputeBeamResultantsCompute forces and moments using elasticity
- ComputeConcentrationDependentElasticityTensorCompute concentration dependent elasticity tensor.
- ComputeCosseratElasticityTensorCompute Cosserat elasticity and flexural bending rigidity tensors
- ComputeCosseratIncrementalSmallStrainCompute incremental small Cosserat strains
- ComputeCosseratLinearElasticStressCompute Cosserat stress and couple-stress elasticity for small strains
- ComputeCosseratSmallStrainCompute small Cosserat strains
- ComputeCrackedStressComputes energy and modifies the stress for phase field fracture
- ComputeDamageStressCompute stress for damaged elastic materials in conjunction with a damage model.
- ComputeDeformGradBasedStressComputes stress based on lagrangian strain
- 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
- ComputeFiniteBeamStrainCompute a rotation increment for finite rotations of the beam and computes the small/large strain increments in the current rotated configuration of the beam.
- ComputeFiniteStrainCompute a strain increment and rotation increment for finite strains.
- ComputeFiniteStrainElasticStressCompute stress using elasticity for finite strains
- ComputeGlobalStrainMaterial for storing the global strain values from the scalar variable
- ComputeIncrementalBeamStrainCompute a infinitesimal/large strain increment for the beam.
- ComputeIncrementalSmallStrainCompute a strain increment and rotation increment for small strains.
- ComputeInstantaneousThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the instantaneous thermal expansion as a function of temperature
- ComputeInterfaceStressStress in the plane of an interface defined by the gradient of an order parameter
- ComputeIsotropicElasticityTensorCompute a constant isotropic elasticity tensor.
- ComputeLayeredCosseratElasticityTensorComputes Cosserat elasticity and flexural bending rigidity tensors relevant for simulations with layered materials. The layering direction is assumed to be perpendicular to the 'z' direction.
- ComputeLinearElasticPFFractureStressComputes the stress and free energy derivatives for the phase field fracture model, with small strain
- ComputeLinearElasticStressCompute stress using elasticity for small strains
- ComputeLinearViscoelasticStressDivides total strain into elastic + creep + eigenstrains
- ComputeMeanThermalExpansionFunctionEigenstrainComputes eigenstrain due to thermal expansion using a function that describes the mean thermal expansion as a function of temperature
- ComputeMultiPlasticityStressMaterial for multi-surface finite-strain plasticity
- ComputeMultipleInelasticCosseratStressCompute state (stress and other quantities such as plastic strains and internal parameters) using an iterative process, as well as Cosserat versions of these quantities. Only elasticity is currently implemented for the Cosserat versions.Combinations of creep models and plastic models may be used
- ComputeMultipleInelasticStressCompute state (stress and internal parameters such as plastic strains and internal parameters) using an iterative process. Combinations of creep models and plastic models may be used.
- ComputePlaneFiniteStrainCompute strain increment and rotation increment for finite strain under 2D planar assumptions.
- ComputePlaneIncrementalStrainCompute strain increment for small strain under 2D planar assumptions.
- ComputePlaneSmallStrainCompute a small strain under generalized plane strain assumptions where the out of plane strain is generally nonzero.
- ComputePlasticHeatEnergyPlastic heat energy density = stress * plastic_strain_rate
- ComputeRSphericalFiniteStrainCompute a strain increment and rotation increment for finite strains in 1D spherical symmetry problems.
- ComputeRSphericalIncrementalStrainCompute a strain increment for incremental strains in 1D spherical symmetry problems.
- ComputeRSphericalSmallStrainCompute a small strain 1D spherical symmetry case.
- ComputeReducedOrderEigenstrainaccepts eigenstrains and computes a reduced order eigenstrain for consistency in the order of strain and eigenstrains.
- ComputeSmallStrainCompute a small strain.
- ComputeSmearedCrackingStressCompute stress using a fixed smeared cracking model
- ComputeStrainIncrementBasedStressCompute stress after subtracting inelastic strain increments
- ComputeSurfaceTensionKKSSurface tension of an interface defined by the gradient of an order parameter
- ComputeThermalExpansionEigenstrainComputes eigenstrain due to thermal expansion with a constant coefficient
- ComputeThermalExpansionEigenstrainBeamComputes eigenstrain due to thermal expansion with a constant coefficient
- ComputeVariableBaseEigenStrainComputes Eigenstrain based on material property tensor base
- ComputeVariableEigenstrainComputes an Eigenstrain and its derivatives that is a function of multiple variables, where the prefactor is defined in a derivative material
- ComputeVariableIsotropicElasticityTensorCompute an isotropic elasticity tensor for elastic constants that change as a function of material properties
- ComputeVolumetricDeformGradComputes volumetric deformation gradient and adjusts the total deformation gradient
- ComputeVolumetricEigenstrainComputes an eigenstrain that is defined by a set of scalar material properties that summed together define the volumetric change. This also computes the derivatives of that eigenstrain with respect to a supplied set of variable dependencies.
- EshelbyTensorComputes the Eshelby tensor as a function of strain energy density and the first Piola-Kirchoff stress
- ExponentialSofteningSoftening model with an exponential softening response upon cracking. This class is intended to be used with ComputeSmearedCrackingStress.
- FiniteStrainCPSlipRateResCrystal Plasticity base class: FCC system with power law flow rule implemented
- FiniteStrainCrystalPlasticityCrystal Plasticity base class: FCC system with power law flow rule implemented
- FiniteStrainHyperElasticViscoPlasticMaterial class for hyper-elastic visco-platic flow: Can handle multiple flow models defined by flowratemodel type user objects
- FiniteStrainPlasticMaterialAssociative J2 plasticity with isotropic hardening.
- FiniteStrainUObasedCPUserObject based Crystal Plasticity system.
- FluxBasedStrainIncrementCompute strain increment based on flux
- GBRelaxationStrainIncrementCompute strain increment based on lattice relaxation at GB
- GeneralizedKelvinVoigtModelGeneralized Kelvin-Voigt model composed of a serial assembly of unit Kelvin-Voigt modules
- GeneralizedMaxwellModelGeneralized Maxwell model composed of a parralel assembly of unit Maxwell modules
- HyperElasticPhaseFieldIsoDamageComputes damaged stress and energy in the intermediate configuration assuming isotropy
- HyperbolicViscoplasticityStressUpdateThis class uses the discrete material for a hyperbolic sine viscoplasticity model in which the effective plastic strain is solved for using a creep approach.
- InclusionProperties
- IsotropicPlasticityStressUpdateThis class uses the discrete material in a radial return isotropic plasticity model. This class is one of the basic radial return constitutive models, yet it can be used in conjunction with other creep and plasticity materials for more complex simulations.
- IsotropicPowerLawHardeningStressUpdateThis class uses the discrete material in a radial return isotropic plasticity power law hardening model, solving for the yield stress as the intersection of the power law relation curve and Hooke's law. This class can be used in conjunction with other creep and plasticity materials for more complex simulations.
- LinearElasticTruss
- LinearViscoelasticStressUpdateCalculates an admissible state (stress that lies on or within the yield surface, plastic strains, internal parameters, etc). This class is intended to be a parent class for classes with specific constitutive models.
- MultiPhaseStressMaterialCompute a global stress form multiple phase stresses
- 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.
- ScalarMaterialDamageScalar damage model for which the damage is prescribed by another material
- StrainEnergyDensityComputes the strain energy density using a combination of the elastic and inelastic components of the strain increment, which is a valid assumption for monotonic behavior.
- StressBasedChemicalPotentialChemical potential from stress
- SumTensorIncrementsCompute tensor property by summing tensor increments
- TemperatureDependentHardeningStressUpdateComputes the stress as a function of temperature and plastic strain from user-supplied hardening functions. This class can be used in conjunction with other creep and plasticity materials for more complex simulations
- TensileStressUpdateAssociative, smoothed, tensile (Rankine) plasticity with hardening/softening
- ThermalFractureIntegralCalculates summation of the derivative of the eigenstrains with respect to temparture.
- TwoPhaseStressMaterialCompute a global stress in a two phase model
- VolumeDeformGradCorrectedStressTransforms stress with volumetric term from previous configuration to this configuration
- Fluid Properties App
- FluidPropertiesMaterialComputes fluid properties using (u, v) formulation
- FluidPropertiesMaterialPTFluid properties using the (pressure, temperature) formulation
- Navier Stokes App
- AirAir.
- Fluid Properties Test App
- MultiComponentFluidPropertiesMaterialPTFluid properties of a multicomponent fluid using the (pressure, temperature) formulation
- 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
- 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
- PorousFlow1PhaseFullySaturatedThis Material is used for the fully saturated single-phase situation where porepressure is the primary variable
- 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 isothermal situation, and derivatives of these with respect to the PorousFlowVariables. A gaussian capillary function is assumed
- PorousFlow1PhasePThis Material is used for the fully saturated single-phase situation where porepressure is the primary variable
- PorousFlow2PhasePPThis Material calculates the 2 porepressures and the 2 saturations in a 2-phase isothermal situation, and derivatives of these with respect to the PorousFlowVariables
- PorousFlow2PhasePSThis Material calculates the 2 porepressures and the 2 saturations in a 2-phase isothermal 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
- PorousFlowFluidStateBrineCO2Fluid state class for brine and CO2
- PorousFlowFluidStateWaterNCGFluid state class for water and non-condensable gas
- 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
- 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, k = k_ijk * A * phin / (1 - phi)m, where k_ijk is a tensor providing the anisotropy, phi is porosity, n and m are positive scalar constants and A is given in one of the following forms: A = k0 * (1 - phi0)^m / phi0^n (where k0 and phi0 are a reference permeability and porosity) or A = f * d^2 (where f is a scalar constant and d is grain diameter.
- 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
- 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 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.
Mesh
- Moose App
- CreateDisplacedProblemAction
- SetupMeshAction
- SetupMeshCompleteAction
- 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 tmin!0 and tmax!2Pi, a sector of an annulus or disc is created. In this case boundary sidesets are also created a tmin and tmax, and given these names
- ConcentricCircleMeshThis ConcentricCircleMesh source code is to generate concentric circle meshes.
- DistributedGeneratedMeshCreate a line, square, or cube mesh with uniformly spaced or biased elements.
- 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.
- MeshGeneratorMesh
- 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.
- MortarInterfaces
- Partitioner
- External Petsc Solver App
- PETScDMDAMeshCreate a line, square, or cube mesh with uniformly spaced memsh using PETSc DMDA.
- Phase Field App
- EBSDMeshMesh generated from a specified DREAM.3D EBSD data file.
- MortarPeriodicMeshSet up an orthogonal mesh with additional dim-1 dimensional side domains for use with the Mortar method.
Mesh/MortarInterfaces
- Moose App
- AddMortarInterfaceAction
Mesh/Partitioner
- Moose App
- PartitionerAction
- GridPartitionerCreate a uniform grid that overlays the mesh to be partitioned. Assign all elements within each cell of the grid to the same processor.
- LibmeshPartitioner
- PetscExternalPartitionerPartition mesh using external packages via PETSc MatPartitioning interface
MeshGenerators
- Moose App
- AddMeshGeneratorAction
- AllSideSetsByNormalsGenerator
- 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 tmin!0 and tmax!2Pi, a sector of an annulus or disc is created. In this case boundary sidesets are also created a tmin and tmax, and given these names
- BlockDeletionGeneratorMesh modifier which removes elements with the specified subdomain ID
- BoundingBoxNodeSetGeneratorAssigns all of the nodes either inside or outside of a bounding box to a new nodeset.
- BreakBoundaryOnSubdomainGeneratorBreak boundaries based on the subdomains to which their sides are attached. Naming convention for the new boundaries will be the old boundary name plus "_to_" plus the subdomain name
- BreakMeshByBlockGeneratorBreak boundaries based on the subdomains to which their sides are attached. Naming convention for the new boundaries will be the old boundary name plus "_to_" plus the subdomain name. At the momentthis only works on REPLICATED mesh
- CartesianMeshGeneratorThis CartesianMeshGenerator creates a non-uniform Cartesian mesh.
- ConcentricCircleMeshGeneratorThis ConcentricCircleMesh source code is to generate concentric circle meshes.
- ElementGenerator
- ElementSubdomainIDGenerator
- ExtraNodesetGenerator
- FileMeshGenerator
- 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 value as each element's subdomain ID
- LowerDBlockFromSidesetGeneratorAdds lower dimensional elements on the specified sidesets.
- MeshExtruderGeneratorTakes a 1D or 2D mesh and extrudes the entire structure along the specified axis increasing the dimensionality of the mesh.
- MeshSideSetGeneratorAdd lower dimensional elements along the faces contained in a side set to set up mixed dimensional problems
- OrientedSubdomainBoundingBoxGenerator
- ParsedGenerateSidesetA MeshModifier that adds element's sides to a sideset if the centroid satisfies the combinatorial_geometry expression, (and optionally) if one of the side's elements is in included_subdomain_ids and if it features the correct normal.
- ParsedSubdomainMeshGeneratorMeshModifier that uses a parsed expression (combinatorial_geometry) to determine if an element (aka its centroid) is inside the combinatorial geometry and assigns a new block id.
- PatternedMeshGeneratorCreates a 2D mesh from a specified set of unique 'tiles' meshes and a two-dimensional pattern.
- RenameBlockGeneratorRenameBlock re-numbers or re-names an old_block_id or old_block_name with a new_block_id or new_block_name. If using RenameBlock to merge blocks (by giving them the same name, for instance) it is advisable to specify all your blocks in old_blocks to avoid inconsistencies
- RenameBoundaryGeneratorRenameBoundaryGenerator re-numbers or re-names an old_boundary_id or old_boundary_name with a new_boundary_id or new_boundary_name. If using RenameBoundaryGenerator to merge boundaries (by giving them the same name, for instance) it is advisable to specify all your boundaries in old_boundaries to avoid inconsistencies
- RinglebMeshGeneratorCreates a mesh for the Ringleb problem.
- SideSetsAroundSubdomainGeneratorAdds element faces that are on the exterior of the given block to the sidesets specified
- SideSetsBetweenSubdomainsGenerator
- SideSetsFromBoundingBoxGeneratorFind sidesets with given boundary ids in bounding box and add new boundary id. This can be done by finding all required boundary and adding the new boundary id to those sidesets. Alternatively, a number of boundary ids can be provided and all nodes within the bounding box that have all the required boundary ids will have a newboundary id added.
- SideSetsFromNormalsGeneratorAdds a new named sideset to the mesh for all faces matching the specified normal.
- SideSetsFromPointsGeneratorAdds a new sideset starting at the specified point containing all connected element faces with the same normal.
- SmoothMeshGeneratorUtilizes a simple Laplacian based smoother to attempt to improve mesh quality. Will not move boundary nodes or nodes along block/subdomain boundaries
- SpiralAnnularMeshGeneratorCreates an annual mesh based on TRI3 elements (it can also be TRI6 elements) on several rings.
- StackGeneratorUse the supplied meshes and stitch them on top of each other
- StitchedMeshGenerator
- SubdomainBoundingBoxGeneratorChanges the subdomain ID of elements either (XOR) inside or outside the specified box to the specified ID.
- SubdomainIDGenerator
- TiledMeshGeneratorUse the supplied mesh and create a tiled grid by repeating this mesh in the x,y, and z directions.
- TransformGeneratorApplies a linear transform to the entire mesh.
MeshModifiers
- Moose App
- AddMeshModifierAction
- AddAllSideSetsByNormals
- AddExtraNodeset
- AddSideSetsFromBoundingBoxFind sidesets with given boundary ids in bounding box and add new boundary id. This can be done by finding all required boundary and adding the new boundary id to those sidesets. Alternatively, a number of boundary ids can be provided and all nodes within the bounding box that have all the required boundary ids will have a newboundary id added.
- AssignElementSubdomainID
- AssignSubdomainID
- BlockDeleterMesh modifier which removes elements with the specified subdomain ID
- BoundingBoxNodeSetAssigns all of the nodes either inside or outside of a bounding box to a new nodeset.
- BreakBoundaryOnSubdomainBreak 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
- BreakMeshByBlockBreak boundaries based on the subdomains to which their sides are attached. Naming convention for the new boundaries will be the old boundary name plus "_to_" plus the subdomain name. At the momentthis only works on REPLICATED mesh
- ImageSubdomainSamples an image at the coordinates of each element centroid using the resulting value as each element's subdomain ID
- LowerDBlockFromSidesetAdds lower dimensional elements on the specified sidesets.
- MeshExtruderTakes a 1D or 2D mesh and extrudes the entire structure along the specified axis increasing the dimensionality of the mesh.
- MeshSideSetAdd lower dimensional elements along the faces contained in a side set to set up mixed dimensional problems
- OrientedSubdomainBoundingBox
- ParsedAddSidesetA MeshModifier that adds element's sides to a sideset if the centroid satisfies the combinatorial_geometry expression, (and optionally) if one of the side's elements is in included_subdomain_ids and if it features the correct normal.
- ParsedSubdomainMeshModifierMeshModifier that uses a parsed expression (combinatorial_geometry) to determine if an element (aka its centroid) is inside the combinatorial geometry and assigns a new block id.
- RenameBlockRenameBlock re-numbers or re-names an old_block_id or old_block_name with a new_block_id or new_block_name. If using RenameBlock to merge blocks (by giving them the same name, for instance) it is advisable to specify all your blocks in old_blocks to avoid inconsistencies
- SideSetsAroundSubdomainAdds element faces that are on the exterior of the given block to the sidesets specified
- SideSetsBetweenSubdomains
- SideSetsFromNormalsAdds a new named sideset to the mesh for all faces matching the specified normal.
- SideSetsFromPointsAdds a new sideset starting at the specified point containing all connected element faces with the same normal.
- SmoothMeshUtilizes a simple Laplacian based smoother to attempt to improve mesh quality. Will not move boundary nodes or nodes along block/subdomain boundaries
- SubdomainBoundingBoxChanges the subdomain ID of elements either (XOR) inside or outside the specified box to the specified ID.
- TransformApplies a linear transform to the entire mesh.
Modules
- Tensor Mechanics App
- TensorMechanics
- Phase Field App
- PhaseField
- Navier Stokes App
- NavierStokes
- Fluid Properties Test App
- FluidProperties
- Fluid Properties App
- FluidProperties
Modules/FluidProperties
- Fluid Properties Test App
- NaNInterfaceTestFluidPropertiesFluid properties for testing NaNInterface
- Fluid Properties App
- AddFluidPropertiesAction
- BrineFluidPropertiesFluid properties for brine
- CO2FluidPropertiesFluid properties for carbon dioxide (CO2) using the Span & Wagner EOS
- GeneralVaporMixtureFluidPropertiesClass for fluid properties of an arbitrary vapor mixture
- HydrogenFluidPropertiesFluid properties for Hydrogen (H2)
- IdealGasFluidPropertiesFluid properties for an ideal gas
- IdealGasFluidPropertiesPTFluid properties for an ideal gas
- IdealRealGasMixtureFluidPropertiesClass for fluid properties of an arbitrary vapor mixture
- MethaneFluidPropertiesFluid properties for methane (CH4)
- NaClFluidPropertiesFluid properties for NaCl
- NitrogenFluidPropertiesFluid properties for Nitrogen (N2)
- SimpleFluidPropertiesFluid properties for a simple fluid with a constant bulk density
- SodiumPropertiesFluid properties for sodium
- StiffenedGasFluidPropertiesFluid properties for a stiffened gas
- TabulatedFluidPropertiesFluid properties using bicubic interpolation on tabulated values provided
- TwoPhaseFluidPropertiesIndependent2-phase fluid properties for 2 independent single-phase fluid properties
- Water97FluidPropertiesFluid properties for water and steam (H2O) using IAPWS-IF97
Modules/NavierStokes
Modules/NavierStokes/BCs
- Navier Stokes App
- AddNavierStokesBCsActionThis class allows us to have a section of the input file like the following which adds BC objects for each requested boundary condition.
- NSNoPenetrationBCThis class facilitates adding solid wall 'no penetration' BCs for the Euler equations.
- NSStaticPressureOutletBCThis class facilitates adding specified static pressure outlet BCs for the Euler equations.
- NSWeakStagnationInletBCThis class facilitates adding weak stagnation inlet BCs via an Action by setting up the required parameters.
Modules/NavierStokes/ICs
- Navier Stokes App
- AddNavierStokesICsActionThis class allows us to have a section of the input file like the following which automatically adds initial conditions for all the required nonlinear and auxiliary variables.
Modules/NavierStokes/Kernels
- Navier Stokes App
- AddNavierStokesKernelsActionThis 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/NavierStokes/Variables
- Navier Stokes App
- AddNavierStokesVariablesActionThis class allows us to have a section of the input file like the following which automatically adds all the required nonlinear variables with the appropriate scaling.
Modules/PhaseField
- Phase Field App
- Conserved
- DisplacementGradients
- EulerAngles2RGB
- GrainGrowth
- GrandPotential
- MortarPeriodicity
- Nonconserved
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/GrandPotential
- Phase Field App
- GrandPotentialKernelActionAutomatically generate most or all of the kernels for the grand potential model
Modules/PhaseField/MortarPeriodicity
- Phase Field App
- MortarPeriodicActionAdd mortar interfaces, Lagrange multiplier variables, and constraints to implement mortar based periodicity of values or gradients on a MortarPeriodicMesh
Modules/PhaseField/Nonconserved
- Phase Field App
- NonconservedActionSet up the variable and the kernels needed for a nonconserved phase field variable
Modules/TensorMechanics
- Tensor Mechanics App
- GeneralizedPlaneStrain
- GlobalStrain
- LineElementMaster
- Master
Modules/TensorMechanics/GeneralizedPlaneStrain
- Tensor Mechanics App
- GeneralizedPlaneStrainActionSet up the GeneralizedPlaneStrain environment
Modules/TensorMechanics/GlobalStrain
- Tensor Mechanics App
- GlobalStrainActionSet up the GlobalStrainAction environment
Modules/TensorMechanics/LineElementMaster
- Tensor Mechanics App
- CommonLineElementActionSets up variables, stress divergence kernels and materials required for a static analysis with beam or truss elements. Also sets up aux variables, aux kernels, and consistent or nodal inertia kernels for dynamic analysis with beam elements.
- LineElementActionSets up variables, stress divergence kernels and materials required for a static analysis with beam or truss elements. Also sets up aux variables, aux kernels, and consistent or nodal inertia kernels for dynamic analysis with beam elements.
Modules/TensorMechanics/Master
- Tensor Mechanics App
- CommonTensorMechanicsAction
- TensorMechanicsActionSet up stress divergence kernels with coordinate system aware logic
MultiApps
- Moose App
- AddMultiAppAction
- CentroidMultiApp
- FullSolveMultiApp
- TransientMultiApp
- Level Set App
- LevelSetReinitializationMultiAppMultiApp capable of performing repeated complete solves for level set reinitialization.
- Stochastic Tools App
- SamplerMultiAppCreates a sub-application for each row of each Sampler matrix.
NodalKernels
- Moose App
- AddNodalKernelAction
- ConstantRate
- TimeDerivativeNodalKernel
- UserForcingFunctionNodalKernel
- Tensor Mechanics App
- NodalGravityComputes the gravitational force for a given nodal mass.
- NodalRotationalInertiaCalculates the inertial torques and inertia proportional damping corresponding to the nodal rotational inertia.
- NodalTranslationalInertiaComputes the interial forces and mass proportional damping terms corresponding to nodal mass.
NodalNormals
- Moose App
- AddNodalNormalsAction
Outputs
- Moose App
- CommonOutputAction
- AddOutputAction
- CSV
- Checkpoint
- Console
- ControlOutput
- DOFMap
- ExodusObject for output data in the Exodus II format
- GMVObject for outputting data in the GMV format
- Gnuplot
- MaterialPropertyDebugOutput
- NemesisObject for output data in the Nemesis format
- PerfGraphOutputControls output of the PerfGraph: the performance log for MOOSE
- SolutionHistory
- TecplotObject for outputting data in the Tecplot format
- TopResidualDebugOutput
- VTK
- VariableResidualNormsDebugOutput
- XDAObject for outputting data in the XDA/XDR format
- XDRObject for outputting data in the XDA/XDR format
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 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. Full-upwinding of fluid flow is not available in this Action, so the results may differ slightly from the Unsaturated Action. However KT stabilization may be employed for both the fluid and any heat flow. 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
Postprocessors
- Moose App
- AddPostprocessorAction
- SetupPostprocessorDataAction
- AreaPostprocessorComputes the "area" or dimension - 1 "volume" of a given boundary or boundaries in your mesh.
- AverageElementSize
- AverageNodalVariableValue
- AxisymmetricCenterlineAverageValueComputes the average value of a variable on a sideset located along the centerline of an axisymmetric model.
- ChangeOverTimePostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- ChangeOverTimestepPostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- CumulativeValuePostprocessor
- DifferencePostprocessor
- ElementAverageSecondTimeDerivativeComputes the element averaged second derivative of variable
- ElementAverageTimeDerivative
- ElementAverageValue
- ElementExtremeValue
- ElementH1Error
- ElementH1SemiError
- ElementIntegralMaterialProperty
- ElementIntegralVariablePostprocessor
- ElementL2Difference
- ElementL2Error
- ElementL2Norm
- ElementVectorL2Error
- ElementW1pError
- ElementalVariableValueOutputs an elemental variable value at a particular location
- EmptyPostprocessor
- ExecutionerAttributeReporter
- 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.
- FunctionSideIntegral
- FunctionValuePostprocessor
- LinearCombinationPostprocessor
- MemoryUsageMemory usage statistics for the running simulation.
- NodalExtremeValue
- NodalL2Error
- NodalL2Norm
- NodalMaxValue
- NodalProxyMaxValue
- NodalSum
- NodalVariableValueOutputs values of a nodal variable at a particular location
- NumDOFsReturn the number of Degrees of freedom from either the NL, Aux or both systems.
- NumElemsReturn the number of active or total elements in the simulation.
- NumLinearIterations
- NumNodesReturns the total number of nodes in a simulation (works with DistributedMesh)
- NumNonlinearIterationsOutputs the number of nonlinear iterations
- NumPicardIterations
- NumResidualEvaluations
- NumVarsReturn the number of variables from either the NL, Aux, or both systems.
- PercentChangePostprocessor
- PerfGraphDataRetrieves timing information from the PerfGraph.
- PerformanceDataProvides programmatic access to Performance Log Data
- PointValue
- PostprocessorComparisonCompares two post-processors and produces a boolean value
- Receiver
- RelativeDifferencePostprocessorComputes the absolute value of the relative difference between 2 post-processor values.
- RelativeSolutionDifferenceNorm
- Residual
- ScalarL2Error
- ScalarVariable
- ScalePostprocessor
- SideAverageValueComputes the average value of a variable on a sideset. Note that this cannot be used on the centerline of an axisymmetric model.
- SideFluxAverageComputes the integral of the flux over the specified boundary
- SideFluxIntegralComputes the integral of the flux over the specified boundary
- SideIntegralVariablePostprocessor
- TimeExtremeValueA postprocessor for reporting the extreme value of another postprocessor over time.
- TimestepSizeReports the timestep size
- TotalVariableValue
- VariableInnerProduct
- VariableResidual
- VectorPostprocessorComparisonCompares two vector post-processors of equal size and produces a boolean value
- VolumePostprocessor
- Stochastic Tools Test App
- TestDistributionDirectPostprocessor
- TestDistributionPostprocessor
- 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.
- 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".
- FeatureVolumeFraction
- 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.
- PFCElementEnergyIntegral
- 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 tesselation polycrystal (used by PolycrystalVoronoiAction)
- Misc App
- InternalVolumeComputes the volume of an enclosed area by performing an integral over a user-supplied boundary.
- 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.
- Richards App
- Q2PPiecewiseLinearSinkFluxRecords the fluid flow into a sink (positive values indicate fluid is flowing from porespace into the sink).
- RichardsExcavFlowRecords total flow INTO an excavation (if quantity is positive then flow has occured from rock into excavation void)
- RichardsHalfGaussianSinkFlux
- RichardsMassReturns the mass in a region.
- RichardsPiecewiseLinearSinkFluxRecords the fluid flow into a sink (positive values indicate fluid is flowing from porespace into the sink).
- RichardsPlotQuantity
- Heat Conduction App
- HomogenizedThermalConductivity
- ThermalConductivityComputes the average value of a variable on a sideset. Note that this cannot be used on the centerline of an axisymmetric model.
- Solid Mechanics App
- HomogenizedElasticConstants
- InteractionIntegralSM
- MaterialTensorIntegralSM
- Tensor Mechanics App
- CavityPressurePostprocessorInterfaces with the CavityPressureUserObject to store the initial number of moles of a gas contained within an internal volume.
- CrackFrontData
- InteractionIntegralComputes the interaction integral for fracture
- JIntegralCalculates the J-integral at a specified point along the crack front
- Mass
- 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.
- MixedModeEquivalentKComputes the mixed-mode stress intensity factor given the , , and stress intensity factors
- TorqueReactionTorqueReaction calculates the torque in 2D and 3Dabout a user-specified axis of rotation centeredat a user-specied origin.
- XFEMTest App
- TestCrackCounterTest postprocessor for extracting the crack_tip_origin_direction_map from XFEM.
- Navier Stokes App
- INSExplicitTimestepSelectorPostprocessor that computes the minimum value of h_min/|u|, where |u| is coupled in as an aux variable.
- NSEntropyErrorComputes entropy error.
- VolumetricFlowRateComputes the volumetric flow rate through a boundary.
- Chemical Reactions App
- TotalMineralVolumeFractionTotal volume fraction of coupled mineral species
- Porous Flow App
- 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
Preconditioning
- Moose App
- SetupPreconditionerAction
- AddFieldSplitAction
- Split
- FDP
- FSP
- PBP
- SMP
- Contact App
- ContactSplit
Problem
- Moose App
- CreateProblemAction
- DynamicObjectRegistrationAction
- DisplacedProblem
- DumpObjectsProblemSingle purpose problem object that does not run the given input but allows deconstructing actions into their series of underlying Moose objects and variables.
- EigenProblem
- FEProblem
- 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.
- External Petsc Solver App
- ExternalPETScProblemProblem extension point for wrapping external applications
- Richards App
- RichardsMultiphaseProblem
- Contact App
- AugmentedLagrangianContactProblemProblem that checks for convergence relative to a user-supplied reference quantity rather than the initial residual
- ReferenceResidualProblemProblem that checks for convergence relative to a user-supplied reference quantity rather than the initial residual
ReactionNetwork
- Chemical Reactions App
- AqueousEquilibriumReactions
- SolidKineticReactions
ReactionNetwork/AqueousEquilibriumReactions
- Chemical Reactions App
- AddCoupledEqSpeciesActionAdds coupled equilibrium Kernels and AuxKernels for primary species
- AddPrimarySpeciesActionAdds Variables for all primary species
- AddSecondarySpeciesActionAdds AuxVariables for all secondary species
ReactionNetwork/SolidKineticReactions
- Chemical Reactions App
- AddCoupledSolidKinSpeciesActionAdds solid kinetic Kernels and AuxKernels for primary species
- AddPrimarySpeciesActionAdds Variables for all primary species
- AddSecondarySpeciesActionAdds AuxVariables for all secondary species
Samplers
- Moose App
- AddSamplerAction
- Stochastic Tools App
- MonteCarloSamplerMonte Carlo Sampler.
- SobolSamplerSobol variance-based sensitivity analysis Sampler.
ScalarKernels
- Moose App
- AddScalarKernelAction
- CoupledODETimeDerivative
- NodalEqualValueConstraint
- ODETimeDerivative
- ParsedODEKernelParsed ODE function kernel.
- Tensor Mechanics App
- GeneralizedPlaneStrainGeneralized Plane Strain Scalar Kernel
- GlobalStrainScalar Kernel to solve for the global strain
ThermalContact
Transfers
- Moose App
- AddTransferAction
- MultiAppCopyTransferCopies variables (nonlinear and auxiliary) between multiapps that have identical meshes.
- MultiAppInterpolationTransferTransfers the value to the target domain from the nearest node in the source domain.
- MultiAppMeshFunctionTransfer
- MultiAppNearestNodeTransfer
- MultiAppPostprocessorInterpolationTransfer
- MultiAppPostprocessorToAuxScalarTransfer
- MultiAppPostprocessorTransfer
- MultiAppProjectionTransfer
- MultiAppScalarToAuxScalarTransfer
- MultiAppUserObjectTransfer
- MultiAppVariableValueSamplePostprocessorTransfer
- MultiAppVariableValueSampleTransfer
- 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.
- Stochastic Tools App
- SamplerPostprocessorTransferTransfers data to and from Postprocessors on the sub-application.
- SamplerTransferCopies Sampler data to a SamplerReceiver object.
- Functional Expansion Tools App
- MultiAppFXTransferTransfers coefficient arrays between objects that are derived from MutableCoefficientsInterface; currently includes the following types: FunctionSeries, FXBoundaryUserObject, and FXVolumeUserObject
UserObjects
- Moose App
- AddUserObjectAction
- AreaPostprocessorComputes the "area" or dimension - 1 "volume" of a given boundary or boundaries in your mesh.
- AverageElementSize
- AverageNodalVariableValue
- AxisymmetricCenterlineAverageValueComputes the average value of a variable on a sideset located along the centerline of an axisymmetric model.
- ChangeOverTimePostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- ChangeOverTimestepPostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- CumulativeValuePostprocessor
- DifferencePostprocessor
- ElementAverageSecondTimeDerivativeComputes the element averaged second derivative of variable
- ElementAverageTimeDerivative
- ElementAverageValue
- ElementExtremeValue
- ElementH1Error
- ElementH1SemiError
- ElementIntegralMaterialProperty
- ElementIntegralVariablePostprocessor
- ElementIntegralVariableUserObject
- ElementL2Difference
- ElementL2Error
- ElementL2Norm
- ElementQualityCheckerClass to check the quality of each element using different metrics from libmesh.
- ElementVectorL2Error
- ElementW1pError
- ElementalVariableValueOutputs an elemental variable value at a particular location
- EmptyPostprocessor
- ExecutionerAttributeReporter
- 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.
- FunctionSideIntegral
- FunctionValuePostprocessor
- GeometrySphereSnap nodes to the surface of a sphere on adaptivity
- LayeredAverage
- LayeredIntegral
- LayeredSideAverage
- LayeredSideFluxAverage
- LayeredSideIntegral
- LinearCombinationPostprocessor
- MemoryUsageMemory usage statistics for the running simulation.
- NearestPointLayeredAverage
- NodalExtremeValue
- NodalL2Error
- NodalL2Norm
- NodalMaxValue
- NodalNormalsCorner
- NodalNormalsEvaluator
- NodalNormalsPreprocessor
- NodalProxyMaxValue
- NodalSum
- NodalVariableValueOutputs values of a nodal variable at a particular location
- NumDOFsReturn the number of Degrees of freedom from either the NL, Aux or both systems.
- NumElemsReturn the number of active or total elements in the simulation.
- NumLinearIterations
- NumNodesReturns the total number of nodes in a simulation (works with DistributedMesh)
- NumNonlinearIterationsOutputs the number of nonlinear iterations
- NumPicardIterations
- NumResidualEvaluations
- NumVarsReturn the number of variables from either the NL, Aux, or both systems.
- PercentChangePostprocessor
- PerfGraphDataRetrieves timing information from the PerfGraph.
- PerformanceDataProvides programmatic access to Performance Log Data
- PointValue
- PostprocessorComparisonCompares two post-processors and produces a boolean value
- Receiver
- RelativeDifferencePostprocessorComputes the absolute value of the relative difference between 2 post-processor values.
- RelativeSolutionDifferenceNorm
- Residual
- ScalarL2Error
- ScalarVariable
- ScalePostprocessor
- SideAverageValueComputes the average value of a variable on a sideset. Note that this cannot be used on the centerline of an axisymmetric model.
- SideFluxAverageComputes the integral of the flux over the specified boundary
- SideFluxIntegralComputes the integral of the flux over the specified boundary
- SideIntegralVariablePostprocessor
- SolutionUserObjectReads a variable from a mesh in one simulation to another
- Terminator
- TimeExtremeValueA postprocessor for reporting the extreme value of another postprocessor over time.
- TimestepSizeReports the timestep size
- TotalVariableValue
- VariableInnerProduct
- VariableResidual
- VectorPostprocessorComparisonCompares two vector post-processors of equal size and produces a boolean value
- VerifyElementUniqueID
- VerifyNodalUniqueID
- VolumePostprocessor
- Stochastic Tools Test App
- TestDistributionDirectPostprocessor
- TestDistributionPostprocessor
- TestSampler
- 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.
- Phase Field App
- AverageGrainVolumeCalculate average grain area in a polycrystal
- 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
- DiscreteNucleationDataOutput diagnostic data on a DiscreteNucleationInserter
- 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.
- DiscreteNucleationTimeStepReturn a time step limit for nucleation event to be used by IterationAdaptiveDT
- 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.
- FauxGrainTrackerFake grain tracker object for cases where the number of grains is equal to the number of order parameters.
- 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".
- FeatureVolumeFraction
- GrainBoundaryAreaCalculate total grain boundary length in 2D and area in 3D
- GrainForceAndTorqueSumUserobject for summing forces and torques acting on a grain
- GrainTrackerGrain Tracker object for running reduced order parameter simulations without grain coalescence.
- GrainTrackerElasticityGrain Tracker object for running reduced order parameter simulations without grain coalescence.
- MaskedGrainForceAndTorqueUserobject for masking/pinning grains and making forces and torques acting on that grain zero
- PFCElementEnergyIntegral
- 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 tesselation polycrystal (used by PolycrystalVoronoiAction)
- RandomEulerAngleProviderAssign random euler angles for each grain.
- SolutionRasterizerProcess an XYZ file of atomic coordinates and filter atoms via threshold or map variable values.
- Misc App
- InternalVolumeComputes the volume of an enclosed area by performing an integral over a user-supplied boundary.
- RigidBodyModes3D
- 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
- Level Set App
- LevelSetCFLConditionCompute the minimum timestep from the Courant-Friedrichs-Lewy (CFL) condition for the level-set equation.
- LevelSetOlssonTerminatorTool for terminating the reinitialization of the level set equation based on the criteria defined by Olsson et. al. (2007).
- LevelSetVolumeCompute the area or volume of the region inside or outside of a level set contour.
- Richards App
- Q2PPiecewiseLinearSinkFluxRecords the fluid flow into a sink (positive values indicate fluid is flowing from porespace into the sink).
- Q2PRelPermPowerGasPower form of relative permeability that might be useful for gases as a function of water saturation in Q2P models. Define s = seff/(1 - simm). Then relperm = 1 - (n+1)sn + ns(n+1) if seff<1-simm, otherwise relperm=1. Here seff is the water saturation
- RichardsDensityConstBulkFluid density assuming constant bulk modulus. dens0 * Exp(pressure/bulk)
- RichardsDensityConstBulkCutFluid density assuming constant bulk modulus. dens0 * Exp(pressure/bulk)
- RichardsDensityIdealFluid density of ideal gas. Density = slope*(p - p0)
- RichardsDensityMethane20degCMethane density (kg/m^3) at 20degC. Pressure is assumed to be measured in Pascals. NOTE: this expression is only valid to about P=20MPa. Use van der Waals (RichardsDensityVDW) for higher pressures.
- RichardsDensityVDWDensity of van der Waals gas.
- RichardsExcavFlowRecords total flow INTO an excavation (if quantity is positive then flow has occured from rock into excavation void)
- RichardsHalfGaussianSinkFlux
- RichardsMassReturns the mass in a region.
- RichardsPiecewiseLinearSinkFluxRecords the fluid flow into a sink (positive values indicate fluid is flowing from porespace into the sink).
- RichardsPlotQuantity
- RichardsRelPermBWBroadbridge-White form of relative permeability. Define s = (seff - Sn)/(Ss - Sn). Then relperm = Kn + s^2(c-1)(Kn-Ks)/(c-s) if 0<s<1, otherwise relperm = Kn if s<0, otherwise relperm = Ks if s>1.
- RichardsRelPermMonomialMonomial form of relative permeability. Define s = (seff - simm)/(1 - simm). Then relperm = s^n if s<simm, otherwise relperm=1
- RichardsRelPermPowerPower form of relative permeability. Define s = (seff - simm)/(1 - simm). Then relperm = (n+1)sn - ns(n+1) if s<simm, otherwise relperm=1
- RichardsRelPermPowerGasPower form of relative permeability that might be useful for gases. Define s = (seff - simm)/(1 - simm). Then relperm = 1 - (n+1)(1-s)^n + n(1-s)^(n+1) if s<simm, otherwise relperm=1
- RichardsRelPermVGVG form of relative permeability. Define s = (seff - simm)/(1 - simm). Then relperm = s(1/2) * (1 - (1 - s(1/m))^m)^2, if s>0, and relperm=0 otherwise
- RichardsRelPermVG1VG1 form of relative permeability. Define s = (seff - simm)/(1 - simm). Then relperm = s(1/2) * (1 - (1 - s(1/m))^m)^2, if s>0, and relperm=0 otherwise
- RichardsSUPGnoneUser object for no SUPG
- RichardsSUPGstandardStandard SUPG relationships for Richards flow based on Appendix A of TJR Hughes, M Mallet and A Mizukami
A new finite element formulation for computational fluid dynamics:: II. Behond SUPG'' Computer Methods in Applied Mechanics and Engineering 54 (1986) 341–355
- RichardsSatUser object yielding saturation for a phase as a function of effective saturation of that phase
- RichardsSeff1BWsmallBroadbridge-white form of effective saturation for negligable Kn. Then porepressure = -las*( (1-th)/th - (1/c)Ln((C-th)/((C-1)th))), for th = (Seff - Sn)/(Ss - Sn). A Lambert-W function must be evaluated to express Seff in terms of porepressure, which can be expensive
- RichardsSeff1RSCRogers-Stallybrass-Clements version of effective saturation for the water phase, valid for residual saturations = 0, and viscosityOil = 2viscosityWater. seff_water = 1/Sqrt(1 + Exp((Pc - shift)/scale)), where scale = 0.25scale_ratio*oil_viscosity. Note that this effective saturation is mostly useful for 2-phase, not single-phase.
- RichardsSeff1VGvan-Genuchten effective saturation as a function of pressure suitable for use in single-phase simulations.. seff = (1 + (-al*p)^(1/(1-m)))^(-m)
- RichardsSeff1VGcutcut van-Genuchten effective saturation as a function of capillary pressure. Single-phase seff = (1 + (-al*p)^(1/(1-m)))^(-m) for p>p_cut, otherwise user a a linear relationship that is chosen so the value and derivative match van-Genuchten at p=p_cut.
- RichardsSeff2gasRSCRogers-Stallybrass-Clements version of effective saturation for the oil (gas) phase, valid for residual saturations = 0, and viscosityOil = 2viscosityWater. seff_gas = 1 - 1/Sqrt(1 + Exp((Pc - shift)/scale)), where scale = 0.25scale_ratio*oil_viscosity
- RichardsSeff2gasVGvan-Genuchten effective saturation as a function of (Pwater, Pgas) suitable for use for the gas phase in two-phase simulations. With Pc=Pgas-Pwater, seff = 1 - (1 + (al*pc)^(1/(1-m)))^(-m)
- RichardsSeff2gasVGshiftedShifted van-Genuchten effective saturation as a function of (Pwater, Pgas) suitable for use for the gas phase in two-phase simulations. seff = (1 + (-al*(P0-p1-shift))^(1/(1-m)))^(-m), then scaled so it runs between 0 and 1.
- RichardsSeff2waterRSCRogers-Stallybrass-Clements version of effective saturation for the water phase, valid for residual saturations = 0, and viscosityOil = 2viscosityWater. seff_water = 1/Sqrt(1 + Exp(Pc - shift)/scale)), where scale = 0.25scale_ratio*oil_viscosity
- RichardsSeff2waterVGvan-Genuchten effective saturation as a function of (Pwater, Pgas) suitable for use for the water phase in two-phase simulations. With Pc=Pgas-Pwater, seff = (1 + (al*pc)^(1/(1-m)))^(-m)
- RichardsSeff2waterVGshiftedShifted van-Genuchten effective saturation as a function of (Pwater, Pgas) suitable for use for the water phase in two-phase simulations. seff = (1 + (-al*(P0-p1-shift))^(1/(1-m)))^(-m), then scaled so it runs between 0 and 1.
- RichardsSumQuantity
- RichardsVarNamesHolds information on the porepressure variable names
- XFEMApp
- CircleCutUserObjectCreates a UserObject for circular cuts on 3D meshes for XFEM
- EllipseCutUserObjectCreates a UserObject for elliptical cuts on 3D meshes for XFEM
- LevelSetCutUserObjectXFEM mesh cut by level set function
- LineSegmentCutSetUserObjectCreates a UserObject for a line segment cut on 2D meshes for XFEM
- LineSegmentCutUserObjectCreates a UserObject for a line segment cut on 2D meshes for XFEM
- MeshCut3DUserObjectCreates a UserObject for a mesh cutter in 3D problems
- MovingLineSegmentCutSetUserObjectCreates a UserObject for a moving line segment cut on 2D meshes for XFEM
- PointValueAtXFEMInterfaceObtain field values and gradients on the interface.
- RectangleCutUserObjectCreates a UserObject for planar cuts on 3D meshes for XFEM
- XFEMMaterialTensorMarkerUserObject
- 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
- Contact App
- NodalArea
- Heat Conduction App
- HomogenizedThermalConductivity
- ThermalConductivityComputes the average value of a variable on a sideset. Note that this cannot be used on the centerline of an axisymmetric model.
- Solid Mechanics App
- HomogenizedElasticConstants
- InteractionIntegralSM
- MaterialTensorIntegralSM
- Tensor Mechanics App
- CavityPressurePostprocessorInterfaces with the CavityPressureUserObject to store the initial number of moles of a gas contained within an internal volume.
- CavityPressureUserObjectUses the ideal gas law to compute internal pressure and an initial moles of gas quantity.
- CrackFrontData
- CrackFrontDefinition
- CrystalPlasticitySlipRateGSSPhenomenological constitutive model slip rate class. Override the virtual functions in your class
- CrystalPlasticitySlipResistanceGSSPhenomenological constitutive models' slip resistance base class. Override the virtual functions in your class
- CrystalPlasticityStateVarRateComponentGSSPhenomenological constitutive model state variable evolution rate component base class. Override the virtual functions in your class
- CrystalPlasticityStateVarRateComponentVocePhenomenological Voce constitutive model state variable evolution rate component base class.
- CrystalPlasticityStateVariableCrystal plasticity state variable class. Override the virtual functions in your class
- ElementPropertyReadFileUser Object to read property data from an external file and assign to elements: Works only for Rectangular geometry (2D-3D)
- 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
- InteractionIntegralComputes the interaction integral for fracture
- JIntegralCalculates the J-integral at a specified point along the crack front
- LinearViscoelasticityManagerManages the updating of the semi-implicit single-step first-order finite difference time-stepping scheme
- Mass
- 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.
- MixedModeEquivalentKComputes the mixed-mode stress intensity factor given the , , and stress intensity factors
- TensorMechanicsHardeningConstantNo hardening - the parameter is independent of the internal parameter(s)
- TensorMechanicsHardeningCubicHardening is Cubic
- TensorMechanicsHardeningCutExponentialHardening is Cut-exponential
- TensorMechanicsHardeningExponentialHardening is Exponential
- TensorMechanicsHardeningGaussianHardening is Gaussian
- TensorMechanicsHardeningPowerRuleHardening defined by power rule
- TensorMechanicsPlasticDruckerPragerNon-associative Drucker Prager plasticity with no smoothing of the cone tip.
- TensorMechanicsPlasticDruckerPragerHyperbolicNon-associative Drucker Prager plasticity with hyperbolic smoothing of the cone tip.
- TensorMechanicsPlasticIsotropicSDIsotropicSD plasticity for pressure sensitive materials and also models the strength differential effect
- TensorMechanicsPlasticJ2J2 plasticity, associative, with hardening
- TensorMechanicsPlasticMeanCapClass that limits the mean stress. Yield function = a*mean_stress - strength. mean_stress = (stress_xx + stress_yy + stress_zz)/3
- TensorMechanicsPlasticMeanCapTCAssociative mean-cap tensile and compressive plasticity with hardening/softening
- TensorMechanicsPlasticMohrCoulombNon-associative Mohr-Coulomb plasticity with hardening/softening
- TensorMechanicsPlasticMohrCoulombMultiNon-associative Mohr-Coulomb plasticity with hardening/softening
- TensorMechanicsPlasticOrthotropicOrthotropic plasticity for pressure sensitive materials and also models the strength differential effect
- TensorMechanicsPlasticSimpleTesterClass that can be used for testing multi-surface plasticity models. Yield function = a*stress_yy + b*stress_zz + c*stress_xx + d*(stress_xy + stress_yx)/2 + e*(stress_xz + stress_zx)/2 + f*(stress_yz + stress_zy)/2 - strength
- TensorMechanicsPlasticTensileAssociative tensile plasticity with hardening/softening, and tensile_strength = 1
- TensorMechanicsPlasticTensileMultiAssociative tensile plasticity with hardening/softening
- TensorMechanicsPlasticWeakPlaneShearNon-associative finite-strain weak-plane shear perfect plasticity. Here cohesion = 1, tan(phi) = 1 = tan(psi)
- TensorMechanicsPlasticWeakPlaneTensileAssociative weak-plane tensile plasticity with hardening/softening
- TensorMechanicsPlasticWeakPlaneTensileNAssociative weak-plane tensile plasticity with hardening/softening, with specified, fixed normal vector. (WeakPlaneTensile combined with specifying N in the Material might be preferable to you.)
- TorqueReactionTorqueReaction calculates the torque in 2D and 3Dabout a user-specified axis of rotation centeredat a user-specied origin.
- XFEMTest App
- TestCrackCounterTest postprocessor for extracting the crack_tip_origin_direction_map from XFEM.
- Navier Stokes App
- INSExplicitTimestepSelectorPostprocessor that computes the minimum value of h_min/|u|, where |u| is coupled in as an aux variable.
- NSEntropyErrorComputes entropy error.
- VolumetricFlowRateComputes the volumetric flow rate through a boundary.
- Tensor Mechanics Test App
- TestSubblockIndexProvider
- Chemical Reactions App
- TotalMineralVolumeFractionTotal volume fraction of coupled mineral species
- 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
- PorousFlowFluidMassCalculates the mass of a fluid component in a region
- PorousFlowFluidStateFlashCompositional flash calculations for use in fluid state classes
- 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
- PorousFlowSumQuantityRecords total mass flowing into a borehole
- PorousFlowWaterNCGFluid state class for water and non-condensable gas
Variables
- Moose App
- AddVariableAction
- CopyNodalVarsAction
- InitialCondition
- Navier Stokes App
- InitialCondition
- Phase Field App
- InitialCondition
- CHPFCRFFSplitVariables
- HHPFCRFFSplitVariables
- PFCRFFVariables
- PolycrystalVariables
- Porous Flow App
- InitialCondition
Variables/CHPFCRFFSplitVariables
- Phase Field App
- CHPFCRFFSplitVariablesAction
Variables/HHPFCRFFSplitVariables
- Phase Field App
- HHPFCRFFSplitVariablesAction
Variables/PFCRFFVariables
- Phase Field App
- PFCRFFVariablesAction
Variables/PolycrystalVariables
- Phase Field App
- PolycrystalVariablesActionSet up order parameter variables for a polycrystal simulation
VectorPostprocessors
- Moose App
- AddVectorPostprocessorAction
- CSVReaderConverts columns of a CSV file into vectors of a VectorPostprocessor.
- ConstantVectorPostprocessor
- Eigenvalues
- ElementValueSamplerSamples values of elemental variable(s).
- ElementVariablesDifferenceMax
- ElementsAlongLineOutputs the IDs of every element intersected by a user-defined line
- ElementsAlongPlaneOutputs the IDs of every element intersected by a user-defined plane
- HistogramVectorPostprocessorCompute a histogram for each column of a VectorPostprocessor
- IntersectionPointsAlongLine
- 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
- LineFunctionSampler
- LineMaterialRealSampler
- LineValueSampler
- MaterialVectorPostprocessor
- NodalValueSamplerSamples values of nodal variable(s).
- PointValueSampler
- SideValueSampler
- SphericalAverage
- StatisticsVectorPostprocessorCompute statistical values of a given VectorPostprocessor. The statistics are computed for each column.
- 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
- VolumeHistogram
- WorkBalanceComputes several metrics for workload balance per processor
- Solid Mechanics App
- LineMaterialSymmTensorSampler
- Tensor Mechanics App
- CrackDataSamplerOutputs the values of a set of domain integral postprocessors as a vector, along with their positions along the crack front.
- LineMaterialRankTwoSamplerAccess a component of a RankTwoTensor
- LineMaterialRankTwoScalarSamplerCompute a scalar property of a RankTwoTensor
- Stochastic Tools App
- SamplerDataTool for extracting Sampler object data and storing in VectorPostprocessor vectors.
- StochasticResultsStorage container for stochastic simulation results coming from a Postprocessor.
- 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
- XFEMAction