Complete Code Syntax
Listed below are all of the possible input parameter options for a Zapdos input file. Click the blue link to see more detailed information about the usage of each object.
For a filtered list of Zapdos-only syntax, please click here.
ActionComponents
- Moose App
- CombineComponentsMeshesCombines meshes generated by disjoined components.
- CreateMeshSetupActionsForComponentsAdds the SetupMesh-Actions to the simulation, if they are not created by the Mesh block.
- AddActionComponentActionAction responsible for creating component actions. A component action is a component derived from an Action base class
- CylinderComponentCylindrical component.
- MeshGeneratorComponentComponent with a mesh coming from a mesh generator.
Adaptivity
- Moose App
- SetAdaptivityOptionsActionAction for defining adaptivity parameters.
- Indicators
- Markers
Adaptivity/Indicators
- Moose App
- AddElementalFieldActionAdds elemental auxiliary variable for adaptivity system.
- AddIndicatorActionAdd an Indicator object to a simulation.
- AnalyticalIndicatorCompute the square of the error as the difference between an unknown variable and an analytical solution.
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- GradientJumpIndicatorCompute the jump of the solution gradient across element boundaries.
- LaplacianJumpIndicatorCompute the jump of the solution laplacian across element bondaries.
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- ValueJumpIndicatorCompute the jump of the solution across element bondaries.
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Zapdos App
- AnalyticalDiffIndicatorReturns the difference between the function of the analytic solution vs the computed solution
Adaptivity/Markers
- Moose App
- AddElementalFieldActionAdds elemental auxiliary variable for adaptivity system.
- AddMarkerActionAdd a Marker object to a simulation.
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- BoundaryMarkerMarks all elements with sides on a given boundary for refinement/coarsening
- BoundaryPreservedMarkerMarks elements for refinement or coarsening based on the provided marker value, while preserving the given boundary.
- BoxMarkerMarks the region inside and outside of a 'box' domain for refinement or coarsening.
- ComboMarkerA marker that converts many markers into a single marker by considering the maximum value of the listed markers (i.e., refinement takes precedent).
- ErrorFractionMarkerMarks elements for refinement or coarsening based on the fraction of the min/max error from the supplied indicator.
- ErrorToleranceMarkerCoarsen or refine elements based on an absolute tolerance allowed from the supplied indicator.
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- OrientedBoxMarkerMarks inside and outside a box that can have arbitrary orientation and center point.
- ReporterPointMarkerMarks the region inside or empty if it contains a reporter defined point for refinement or coarsening.
- UniformMarkerUniformly mark all elements for refinement or coarsening.
- ValueRangeMarkerMark elements for adaptivity based on the supplied upper and lower bounds and the specified variable.
- ValueThresholdMarkerThe refinement state based on a threshold value compared to the specified variable.
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
Application
- Moose App
- CreateApplicationBlockActionAdds application and application related parameters.
AuxKernels
- Moose App
- AddKernelActionAdd a Kernel object to the simulation.
- ADDivergenceAuxComputes the divergence of a vector of functors.
- ADFunctorElementalAuxEvaluates a functor (variable, function or functor material property) on the current element, quadrature point, or node.
- ADFunctorElementalGradientAuxEvaluates the gradient of a functor (variable, function or functor material property) on the current element or quadrature point.
- ADFunctorMaterialRealAuxOutputs element volume-averaged material properties
- ADFunctorMaterialRealVectorValueAuxCapture a component of a vector material property in an auxiliary variable.
- ADFunctorVectorElementalAuxEvaluates a vector functor (material property usually) on the current element.For finite volume, this evaluates the vector functor at the centroid.
- ADMaterialRankFourTensorAuxAccess a component of a RankFourTensor for automatic material property output
- ADMaterialRankTwoTensorAuxAccess a component of a RankTwoTensor for automatic material property output
- ADMaterialRateRealAuxOutputs element material properties rate of change
- ADMaterialRealAuxOutputs element volume-averaged material properties
- ADMaterialRealTensorValueAuxObject for extracting a component of a rank two tensor material property to populate an auxiliary variable.
- ADMaterialRealVectorValueAuxCapture a component of a vector material property in an auxiliary variable.
- ADMaterialStdVectorAuxExtracts a component of a material type std::vector<Real> to an aux variable. If the std::vector is not of sufficient size then zero is returned
- ADMaterialSymmetricRankFourTensorAuxAccess a component of a RankTwoTensor for automatic material property output
- ADMaterialSymmetricRankTwoTensorAuxCapture a component of a vector material property in an auxiliary variable.
- ADProjectedStatefulMaterialRankFourTensorAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
- ADProjectedStatefulMaterialRankTwoTensorAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
- ADProjectedStatefulMaterialRealAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
- ADProjectedStatefulMaterialRealVectorValueAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
- ADVectorMaterialRealVectorValueAuxConverts a vector-quantity material property into a vector auxiliary variable
- AdvectiveFluxAuxCompute components of flux vector for advection problems .
- ArrayParsedAuxSets field array variable values to the evaluation of a parsed expression.
- ArrayVarReductionAuxTakes an array variable and performs a reduction operation on it (max, min, sum, average) and stores as a standard variable.
- ArrayVariableComponentCopy a component of an array variable.
- BuildArrayVariableAuxCombines multiple standard variables into an array variable.
- ConstantAuxCreates a constant field in the domain.
- ContainsPointAuxComputes a binary field where the field is 1 in the elements that contain the point and 0 everywhere else
- CopyValueAuxReturns the specified variable as an auxiliary variable with a simple copy of the variable values.
- DebugResidualAuxPopulate an auxiliary variable with the residual contribution of a variable.
- DiffusionFluxAuxCompute components of flux vector for diffusion problems .
- DivergenceAuxComputes the divergence of a vector of functors.
- ElemExtraIDAuxPuts element extra IDs into an aux variable.
- ElementH1ErrorFunctionAuxComputes the H1 or W^{1,p} error between an exact function and a coupled variable.
- ElementIntegerAuxCreates a field showing the element integer.
- ElementL2ErrorFunctionAuxA class for computing the element-wise L^2 (Euclidean) error between a function and a coupled variable.
- ElementLengthAuxCompute the element size using Elem::hmin() or Elem::hmax() from libMesh.
- ElementLpNormAuxCompute an elemental field variable (single value per element) equal to the Lp-norm of a coupled Variable.
- ElementQualityAuxGenerates a field containing the quality metric for each element. Useful for visualizing mesh quality.
- ElementUOAuxAux Kernel to display generic spatial (elemental) information from a UserObject that satisfies the underlying ElementUOProvider interface.
- ExtraElementIDAuxPuts element extra IDs into an aux variable.
- ForcingFunctionAuxAuxiliary Kernel that adds a forcing function to the value of an AuxVariable from the previous time step.
- FunctionArrayAuxAuxiliary Kernel that creates and updates an array field variable by sampling functions through space and time.
- FunctionAuxAuxiliary Kernel that creates and updates a field variable by sampling a function through space and time.
- FunctorAuxEvaluates a functor (variable, function or functor material property) on the current element, quadrature point, or node.
- FunctorCoordinatesFunctionAuxAuxiliary Kernel that creates and updates a field variable by sampling a function with functors (variables, functions, others) as the coordinates.
- FunctorElementalAuxEvaluates a functor (variable, function or functor material property) on the current element, quadrature point, or node.
- FunctorElementalGradientAuxEvaluates the gradient of a functor (variable, function or functor material property) on the current element or quadrature point.
- FunctorMaterialRealAuxOutputs element volume-averaged material properties
- FunctorMaterialRealVectorValueAuxCapture a component of a vector material property in an auxiliary variable.
- FunctorVectorElementalAuxEvaluates a vector functor (material property usually) on the current element.For finite volume, this evaluates the vector functor at the centroid.
- GapValueAuxReturn the nearest value of a variable on a boundary from across a gap.
- GhostingAuxColors the elements ghosted to the chosen PID.
- GhostingFromUOAuxColors the elements ghosted to the chosen PID.
- HardwareIDAuxCreates a field showing the assignment of partitions to physical nodes in the cluster.
- InterfaceValueUserObjectAuxGet stored value from the specified InterfaceQpUserObjectBase.
- MaterialRankFourTensorAuxAccess a component of a RankFourTensor for automatic material property output
- MaterialRankTwoTensorAuxAccess a component of a RankTwoTensor for automatic material property output
- MaterialRateRealAuxOutputs element material properties rate of change
- MaterialRealAuxOutputs element volume-averaged material properties
- MaterialRealDenseMatrixAuxPopulate an auxiliary variable with an entry from a dense matrix material property.
- MaterialRealTensorValueAuxObject for extracting a component of a rank two tensor material property to populate an auxiliary variable.
- MaterialRealVectorValueAuxCapture a component of a vector material property in an auxiliary variable.
- MaterialStdVectorAuxExtracts a component of a material type std::vector<Real> to an aux variable. If the std::vector is not of sufficient size then zero is returned
- MaterialStdVectorRealGradientAuxExtracts a component of a material's std::vector<RealGradient> to an aux variable. If the std::vector is not of sufficient size then zero is returned
- MaterialSymmetricRankFourTensorAuxAccess a component of a RankTwoTensor for automatic material property output
- MaterialSymmetricRankTwoTensorAuxCapture a component of a vector material property in an auxiliary variable.
- MeshDivisionAuxReturns the value of the mesh division index for each element / node
- NearestNodeDistanceAuxStores the distance between a block and boundary or between two boundaries.
- NearestNodeValueAuxRetrieves a field value from the closest node on the paired boundary and stores it on this boundary or block.
- NodalPatchRecoveryAuxThis Auxkernel solves a least squares problem at each node to fit a value from quantities defined on quadrature points.
- NormalizationAuxNormalizes a variable based on a Postprocessor value.
- ParsedAuxSets a field variable value to the evaluation of a parsed expression.
- ParsedVectorAuxSets a field vector variable value to the evaluation of a parsed expression.
- PenetrationAuxAuxiliary Kernel for computing several geometry related quantities between two contacting bodies.
- ProcessorIDAuxCreates a field showing the processors and partitioning.
- ProjectedMaterialPropertyNodalPatchRecoveryAuxThis Auxkernel solves a least squares problem at each node to fit a value from quantities defined on quadrature points.
- ProjectedStatefulMaterialRankFourTensorAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
- ProjectedStatefulMaterialRankTwoTensorAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
- ProjectedStatefulMaterialRealAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
- ProjectedStatefulMaterialRealVectorValueAuxPicks a component of an indexable material property to get projected on an elemental Auxvariable. For use by ProjectedStatefulMaterialStorageAction.
- ProjectionAuxReturns the specified variable as an auxiliary variable with a projection of the source variable. If they are the same type, this amounts to a simple copy.
- QuotientAuxDivides two coupled variables.
- SecondTimeDerivativeAuxReturns the second order time derivative of the specified variable as an auxiliary variable.
- SelfAuxReturns the specified variable as an auxiliary variable with a projection of the source variable. If they are the same type, this amounts to a simple copy.
- SolutionAuxCreates fields by using information from a SolutionUserObject.
- SpatialUserObjectAuxPopulates an auxiliary variable with a spatial value returned from a UserObject spatialValue method.
- TagMatrixAuxCouple the diagonal of a tag matrix, and return its nodal value
- TagVectorArrayVariableAuxCouple a tagged vector, and return its evaluations at degree of freedom indices corresponding to the coupled array variable.
- TagVectorArrayVariableValueAuxCouple a tagged vector, and return its array value.
- TagVectorAuxCouple a tag vector, and return its nodal value
- TimeDerivativeAuxReturns the time derivative of the specified variable/functor as an auxiliary variable.
- VariableGradientComponentCreates a field consisting of one component of the gradient of a coupled variable.
- VariableTimeIntegrationAuxIntegrates a field variable in time.
- VectorFunctionAuxAuxiliary Kernel that creates and updates a vector field variable by sampling a Function object, via the vectorValue method, through space and time.
- VectorMagnitudeAuxCreates a field representing the magnitude of three coupled variables using an Euclidean norm.
- VectorMaterialRealVectorValueAuxConverts a vector-quantity material property into a vector auxiliary variable
- VectorPostprocessorVisualizationAuxRead values from a VectorPostprocessor that is producing vectors that are 'number of processors' * in length. Puts the value for each processor into an elemental auxiliary field.
- VectorVariableComponentAuxCreates a field consisting of one component of a coupled vector variable.
- VectorVariableMagnitudeAuxCreates a field consisting of the magnitude of a coupled vector variable.
- VolumeAuxAuxiliary Kernel that samples volumes.
- WeightedGapAuxReturns the specified variable as an auxiliary variable with the same value.
- Zapdos App
- ADCurrentReturns the electric current associated with the flux of the specified species
- ADDiffusiveFluxReturns the diffusive flux of the specified species
- ADEFieldAdvAuxReturns the electric field driven advective flux of the specified species
- ADPowerDepAmount of power deposited into a user specified specie by Joule Heating
- ADProcRateReaction rate for electron impact collisions in units of #/ms. User can pass choice of elastic, excitation, or ionization Townsend coefficients
- ADProcRateForRateCoeffReaction rate for two body collisions in units of #/ms. User can pass choice of elastic, excitation, or ionization reaction rate coefficients
- ADProcRateForRateCoeffThreeBodyReaction rate for three body collisions in units of #/ms. User can pass choice of elastic, excitation, or ionization reaction rate coefficients
- ADTotalFluxReturns the total flux of the specified species
- AbsValueAuxReturns the absolute value of the specified variable
- CurrentReturns the electric current associated with the flux of the specified species
- DensityMolesReturns physical densities in units of #/m
- DensityNormalizationSimilar to NormalizationAux except meant to normalize variables expressed in log form
- DiffusiveFluxReturns the diffusive flux of the specified species
- DriftDiffusionFluxAuxReturns the drift-diffusion flux of the specified species
- EFieldAdvAuxReturns the electric field driven advective flux of the specified species
- EfieldReturns the defined component of the electric field (0 = x, 1 = y, 2 = z)
- ElectronTemperatureReturns the electron temperature
- LinearCombinationAuxKernelLinearly combine coupled variables with user provided weights and a bias
- PositionProduces an elemental auxiliary variable useful for plotting against other elemental auxiliary variables. Mesh points automatically output by Zapdos only work for plotting nodal variables. Since almost all auxiliary variables are elemental, this AuxKernel is very important
- PowerDepAmount of power deposited into a user specified specie by Joule Heating
- ProcRateReaction rate for electron impact collisions in units of #/ms. User can pass choice of elastic, excitation, or ionization Townsend coefficients
- ProcRateForRateCoeffReaction rate for two body collisions in units of #/ms. User can pass choice of elastic, excitation, or ionization reaction rate coefficients
- ProcRateForRateCoeffThreeBodyReaction rate for three body collisions in units of #/ms. User can pass choice of elastic, excitation, or ionization reaction rate coefficients
- SigmaCalculates the surface charge due to a simplified version of the ion flux to a boundary.
- TM0CylindricalErAuxCalculates the radial E-field for an axisymmetric TM wave.
- TM0CylindricalEzAuxCalculates the axial E-field for an axisymmetric TM wave.
- TotalFluxReturns the total flux of the specified species
- Crane App
- ADReactionRateEEDFTownsendLog
- DataRead
- DensityLogConvert
- ReactionRateEEDFTownsendLog
- ReactionRateFirstOrderReaction rate for one body collisions. User can pass choice of elastic, excitation, or ionization reaction rate coefficients. Automatically added if track_rates set to true in the Reactions action.
- ReactionRateFirstOrderLogReaction rate for one body collisions. User can pass choice of elastic, excitation, or ionization reaction rate coefficients. Automatically added if track_rates set to true in the Reactions action.
- ReactionRateSecondOrderReaction rate for two body collisions. User can pass choice of elastic, excitation, or ionization reaction rate coefficients. Automatically added if track_rates set to true in the Reactions action.
- ReactionRateSecondOrderLogReaction rate for two body collisions. User can pass choice of elastic, excitation, or ionization reaction rate coefficients. Automatically added if track_rates set to true in the Reactions action.
- ReactionRateThirdOrderReaction rate for three body collisions. User can pass choice of elastic, excitation, or ionization reaction rate coefficients. Automatically added if track_rates set to true in the Reactions action.
- ReactionRateThirdOrderLogReaction rate for three body collisions. User can pass choice of elastic, excitation, or ionization reaction rate coefficients. Automatically added if track_rates set to true in the Reactions action.
- Squirrel App
- Density
- FunctionDerivativeAux
AuxScalarKernels
- Moose App
- AddScalarKernelActionAdd a AuxScalarKernel object to the simulation.
- ConstantScalarAuxSets an auxiliary field variable to a controllable constant value.
- FunctionScalarAuxSets a value of a scalar variable based on a function.
- QuotientScalarAuxCompute the ratio of two scalar variables.
- ScalarTagMatrixAuxCouple a tag matrix, and return its nodal value
- ScalarTagVectorAuxCouple a tag vector, and return its value
- SolutionScalarAuxSets scalar variable by using information from a SolutionUserObject.
- Crane App
- AuxInitialConditionScalar
- BolsigValueScalar
- DensityLogConvertScalar
- EEDFRateCoefficientScalar
- ElectronMobility
- MoleFraction
- ParsedAuxScalarParsed function AuxScalarKernel.
- ParsedScalarRateCoefficientParsed function AuxKernel.
- ReactionRateOneBodyScalar
- ReactionRateThreeBodyScalar
- ReactionRateTwoBodyScalar
- ReducedField
- ReducedFieldScalar
- ScalarLinearInterpolation
- ScalarSplineInterpolation
- SuperelasticRateCoefficientScalar
- VariableSum
- VariableSumLog
AuxVariables
- Moose App
- AddAuxVariableActionAdd auxiliary variable to the simulation.
- CopyNodalVarsActionCopies variable information from a file.
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
BCs
- Moose App
- AddBCActionAdd a BoundaryCondition object to the simulation.
- ADConservativeAdvectionBCBoundary condition for advection when it is integrated by parts. Supports Dirichlet (inlet-like) and implicit (outlet-like) conditions.
- ADCoupledVarNeumannBCImposes the integrated boundary condition , where is a variable.
- ADDirichletBCImposes the essential boundary condition , where is a constant, controllable value.
- ADFunctionDirichletBCImposes the essential boundary condition , where is calculated by a function.
- ADFunctionNeumannBCImposes the integrated boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- ADFunctionPenaltyDirichletBCEnforces a (possibly) time and space-dependent MOOSE Function Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet data.
- ADMatNeumannBCImposes the integrated boundary condition , where is a constant, is a material property, and is a coefficient defined by the kernel for .
- ADMatchedValueBCImplements a NodalBC which equates two different Variables' values on a specified boundary.
- ADNeumannBCImposes the integrated boundary condition , where is a constant, controllable value.
- ADPenaltyDirichletBCEnforces a Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet data.
- ADRobinBCImposes the Robin integrated boundary condition .
- ADVectorFunctionDirichletBCImposes the essential boundary condition , where components are calculated with functions.
- ADVectorFunctionNeumannBCImposes the integrated boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- ADVectorMatchedValueBCImplements a ADVectorNodalBC which equates two different Variables' values on a specified boundary.
- ADVectorRobinBCImposes the Robin integrated boundary condition .
- ArrayDirichletBCImposes the essential boundary condition , where are constant, controllable values.
- ArrayHFEMDirichletBCImposes the Dirichlet BC with HFEM.
- ArrayNeumannBCImposes the integrated boundary condition , where is a constant, controllable value.
- ArrayPenaltyDirichletBCEnforces a Dirichlet boundary condition in a weak sense with , where is the constant scalar penalty; is the test functions and is the differences between the current solution and the Dirichlet data.
- ArrayVacuumBCImposes the Robin boundary condition .
- ConvectiveFluxBCDetermines boundary values via the initial and final values, flux, and exposure duration
- CoupledVarNeumannBCImposes the integrated boundary condition , where is a variable.
- DGFunctionDiffusionDirichletBCDiffusion Dirichlet boundary condition for discontinuous Galerkin method.
- DiffusionFluxBCComputes a boundary residual contribution consistent with the Diffusion Kernel. Does not impose a boundary condition; instead computes the boundary contribution corresponding to the current value of grad(u) and accumulates it in the residual vector.
- DirectionalNeumannBCImposes the integrated boundary condition , where is a user-defined, constant vector.
- DirichletBCImposes the essential boundary condition , where is a constant, controllable value.
- EigenArrayDirichletBCArray Dirichlet BC for eigenvalue solvers
- EigenDirichletBCDirichlet BC for eigenvalue solvers
- FunctionDirichletBCImposes the essential boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- FunctionGradientNeumannBCImposes the integrated boundary condition arising from integration by parts of a diffusion/heat conduction operator, and where the exact solution can be specified.
- FunctionNeumannBCImposes the integrated boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- FunctionPenaltyDirichletBCEnforces a (possibly) time and space-dependent MOOSE Function Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet data.
- FunctorDirichletBCImposes the Dirichlet boundary condition , where is a functor and can have complex dependencies.
- FunctorNeumannBCImposes the integrated boundary condition , where is a functor.
- HFEMDirichletBCImposes the Dirichlet BC with HFEM.
- LagrangeVecDirichletBCImposes the essential boundary condition , where are constant, controllable values.
- LagrangeVecFunctionDirichletBCImposes the essential boundary condition , where components are calculated with functions.
- MatNeumannBCImposes the integrated boundary condition , where is a constant, is a material property, and is a coefficient defined by the kernel for .
- MatchedValueBCImplements a NodalBC which equates two different Variables' values on a specified boundary.
- NeumannBCImposes the integrated boundary condition , where is a constant, controllable value.
- OneDEqualValueConstraintBCComputes the integral of lambda times dg term from the mortar method (for two 1D domains only).
- PenaltyDirichletBCEnforces a Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet data.
- PostprocessorDirichletBCDirichlet boundary condition with value prescribed by a Postprocessor value.
- PostprocessorNeumannBCNeumann boundary condition with value prescribed by a Postprocessor value.
- SinDirichletBCImposes a time-varying essential boundary condition , where varies from an given initial value at time to a given final value over a specified duration.
- SinNeumannBCImposes a time-varying flux boundary condition , where varies from an given initial value at time to a given final value over a specified duration.
- VacuumBCVacuum boundary condition for diffusion.
- VectorCurlPenaltyDirichletBCEnforces a Dirichlet boundary condition for the curl of vector nonlinear variables in a weak sense by applying a penalty to the difference in the current solution and the Dirichlet data.
- VectorDirichletBCImposes the essential boundary condition , where are constant, controllable values.
- VectorDivPenaltyDirichletBCEnforces, in a weak sense, a Dirichlet boundary condition on the divergence of a nonlinear vector variable by applying a penalty to the difference between the current solution and the Dirichlet data.
- VectorFunctionDirichletBCImposes the essential boundary condition , where components are calculated with functions.
- VectorNeumannBCImposes the integrated boundary condition , where is a user-defined, constant vector.
- VectorPenaltyDirichletBCEnforces a Dirichlet boundary condition for vector nonlinear variables in a weak sense by applying a penalty to the difference in the current solution and the Dirichlet data.
- WeakGradientBCComputes a boundary residual contribution consistent with the Diffusion Kernel. Does not impose a boundary condition; instead computes the boundary contribution corresponding to the current value of grad(u) and accumulates it in the residual vector.
- Periodic
- Zapdos App
- CircuitDirichletPotentialDirichlet circuit boundary condition for potential (The current is given through a UserObject)
- DCIonBCElectric field driven outflow boundary condition (Based on Hagelaar et al. (2000))
- DriftDiffusionDoNothingBCBoundary condition where the flux at the boundary is equal to the bulk dift-diffusion equation
- EconomouDielectricBCDielectric boundary condition (Based on Lymberopoulos and Economou (1994))
- ElectronAdvectionDoNothingBCBoundary condition where the electron advection flux at the boundary is equal to the bulk electron advection equation
- ElectronDiffusionDoNothingBCBoundary condition where the electron diffusion flux at the boundary is equal to the bulk electron diffusion equation
- ElectronTemperatureDirichletBCElectron temperature boundary condition
- FieldEmissionBCThe electron flux boundary condition due to field emission (Based on Forbes (2006) and Forbes (2008))
- HagelaarElectronAdvectionBCKinetic advective electron boundary condition (Based on Hagelaar et al. (2000))
- HagelaarElectronBCKinetic electron boundary condition (Based on Hagelaar et al. (2000))
- HagelaarEnergyAdvectionBCKinetic advective electron energy boundary condition (Based on Hagelaar et al. (2000))
- HagelaarEnergyBCKinetic electron mean energy boundary condition (Based on Hagelaar et al. (2000))
- HagelaarIonAdvectionBCKinetic advective ion boundary condition (Based on Hagelaar et al. (2000))
- HagelaarIonDiffusionBCKinetic electron boundary condition (Based on Hagelaar et al. (2000))
- LogDensityDirichletBCDensity Dirichlet boundary condition (Densities must be in log form and in moles/m)
- LymberopoulosElectronBCSimpified kinetic electron boundary condition (Based on Lymberopoulos and Economou (1993))
- LymberopoulosIonBCSimpified kinetic ion boundary condition (Based on Lymberopoulos and Economou (1993))
- MatchedValueLogBCHenry’s Law like thermodynamic boundary condition for specifying a species concentration ratio at the gas-liquid interface
- NeumannCircuitVoltageMoles_KVA Neumann boundary condition based on Kirchhoff's law of voltage
- PenaltyCircuitPotentialCircuit boundary condition for potential multiplied by a penalty term
- PotentialDriftOutflowBCThe drift flux boundary condition
- SakiyamaElectronDiffusionBCKinetic electron boundary condition (Based on Sakiyama and Graves (2006))
- SakiyamaEnergyDiffusionBCKinetic advective electron energy boundary condition (Based on Sakiyama and Graves (2007))
- SakiyamaEnergySecondaryElectronBCKinetic secondary electron for mean electron energy boundary condition (Based on Sakiyama and Graves (2007))
- SakiyamaIonAdvectionBCKinetic advective ion boundary condition (Based on Sakiyama and Graves (2006))
- SakiyamaSecondaryElectronBCKinetic secondary electron boundary condition (Based on Sakiyama and Graves (2006))
- SchottkyEmissionBCThe electron flux boundary condition due to field ehanced thermionic emission (Schottky emission) (Based on Go (2012))
- SecondaryElectronBCKinetic secondary electron boundary condition
- SecondaryElectronEnergyBCKinetic secondary electron for mean electron energy boundary condition
- TM0AntennaVertBCA simple vertical antenna BC of the azimuthal component of the magnetizing field.
- TM0PECVertBCA perfect electric conductor BC of the azimuthal component of the magnetizing field.
- Squirrel App
- ChannelGradientBC
- DGDiffusionPostprocessorDirichletBC
- DiffusiveFluxBC
- ExampleShapeSideIntegratedBC
- FlexiblePostprocessorDirichletBC
- InflowBC
- MatINSTemperatureNoBCBC
- OutflowBCDG upwinding for the convection
- PostprocessorInflowBC
- PostprocessorPenaltyDirichletBCEnforces a Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet postprocessor value.
- PostprocessorTemperatureInflowBC
- PostprocessorVelocityFunctionInflowBC
- RobinBC
- TemperatureInflowBC
- TemperatureOutflowBCDG upwinding for the convection
- VelocityFunctionOutflowBC
- VelocityFunctionTemperatureOutflowBC
BCs/Periodic
- Moose App
- AddPeriodicBCActionAction that adds periodic boundary conditions
Bounds
- Moose App
- AddBoundsVectorsActionAction to add vectors to nonlinear system when using the Bounds syntax.
- AddBoundActionAdd a Kernel object to the simulation.
- ConstantBoundsProvides constant bound of a variable for the PETSc's variational inequalities solver
- ConstantBoundsAuxProvides constant bound of a variable for the PETSc's variational inequalities solver
- VariableOldValueBoundsUses the old variable values as the bounds for the new solve.
- VariableOldValueBoundsAuxUses the old variable values as the bounds for the new solve.
ChemicalReactions
ChemicalReactions/Network
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Crane App
- AddReactionsThis Action automatically adds the necessary kernels and materials for a reaction network.
- ChemicalReactionsBaseThis Action automatically adds the necessary kernels and materials for a reaction network.
ChemicalReactions/ScalarNetwork
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Crane App
- AddScalarReactionsThis Action automatically adds the necessary kernels and materials for a reaction network.
- ChemicalReactionsBaseThis Action automatically adds the necessary kernels and materials for a reaction network.
ChemicalReactions/ZapdosNetwork
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Crane App
- AddZapdosReactionsThis Action automatically adds the necessary kernels and materials for a reaction network.
ChemicalReactionsSolo
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Crane App
- ChemicalReactionsThis Action automatically adds the necessary kernels and materials for a reaction network.
ChemicalSpecies
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Crane App
- AddSpeciesAdds Variables for all primary species
Constraints
- Moose App
- AddConstraintActionAdd a Constraint object to the simulation.
- ADPenaltyEqualValueConstraintPenaltyEqualValueConstraint enforces solution continuity between secondary and primary sides of a mortar interface using a penalty approach (no Lagrange multipliers needed)
- ADPenaltyPeriodicSegmentalConstraintADPenaltyPeriodicSegmentalConstraint enforces macro-micro periodic conditions between secondary and primary sides of a mortar interface using a penalty approach (no Lagrange multipliers needed). Must be used alongside PenaltyEqualValueConstraint.
- ADPeriodicSegmentalConstraintADPeriodicSegmentalConstraint enforces macro-micro periodic conditions between secondary and primary sides of a mortar interface using Lagrange multipliers.Must be used alongside EqualValueConstraint.
- CoupledTiedValueConstraintRequires the value of two variables to be the consistent on both sides of an interface.
- EqualGradientConstraintEqualGradientConstraint enforces continuity of a gradient component between secondary and primary sides of a mortar interface using lagrange multipliers
- EqualValueBoundaryConstraintConstraint for enforcing that variables on each side of a boundary are equivalent.
- EqualValueConstraintEqualValueConstraint enforces solution continuity between secondary and primary sides of a mortar interface using lagrange multipliers
- EqualValueEmbeddedConstraintThis is a constraint enforcing overlapping portions of two blocks to have the same variable value
- LinearNodalConstraintConstrains secondary node to move as a linear combination of primary nodes.
- OldEqualValueConstraintOldEqualValueConstraint enforces solution continuity between secondary and primary sides of a mortar interface using lagrange multipliers
- PenaltyEqualValueConstraintPenaltyEqualValueConstraint enforces solution continuity between secondary and primary sides of a mortar interface using a penalty approach (no Lagrange multipliers needed)
- PenaltyPeriodicSegmentalConstraintPenaltyPeriodicSegmentalConstraint enforces macro-micro periodic conditions between secondary and primary sides of a mortar interface using a penalty approach (no Lagrange multipliers needed). Must be used alongside PenaltyEqualValueConstraint.
- PeriodicSegmentalConstraintPeriodicSegmentalConstraint enforces macro-micro periodic conditions between secondary and primary sides of a mortar interface using Lagrange multipliers.Must be used alongside EqualValueConstraint.
- TiedValueConstraintConstraint that forces the value of a variable to be the same on both sides of an interface.
- Zapdos App
- ArbitrarilyTiedValueConstraint
Controls
- Moose App
- AddControlActionAdd a Control object to the simulation.
- BoolFunctionControlSets the value of a 'bool' input parameters to the value of a provided function.
- ConditionalFunctionEnableControlControl for enabling/disabling objects when a function value is true
- PIDTransientControlSets the value of a 'Real' input parameter (or postprocessor) based on a Proportional Integral Derivative control of a postprocessor to match a target a target value.
- RealFunctionControlSets the value of a 'Real' input parameters to the value of a provided function.
- TimePeriodControl the enabled/disabled state of objects with time.
- TimesEnableControlControl for enabling/disabling objects when a certain time is reached.
- WebServerControlStarts a webserver for sending/receiving JSON messages to get data and control a running MOOSE calculation
Correctors
- Moose App
- AddCorrectorActionAdd a Corrector object to the simulation.
- PointwiseRenormalizeVectorPointwise renormalize the solution of a set of variables comprising a vector
DGKernels
- Moose App
- AddDGKernelActionAdd a DGKernel object to the simulation.
- ADDGAdvectionAdds internal face advection flux contributions for discontinuous Galerkin discretizations
- ADDGDiffusionDG kernel for diffusion operator
- ArrayDGDiffusionImplements interior penalty method for array diffusion equations.
- ArrayHFEMDiffusionImposes the constraints on internal sides with HFEM.
- DGConvectionDG upwinding for the convection
- DGDiffusionComputes residual contribution for the diffusion operator using discontinous Galerkin method.
- HFEMDiffusionImposes the constraints on internal sides with HFEM.
- HFEMTestJumpImposes constraints for HFEM with side-discontinuous variables.
- HFEMTrialJumpImposes constraints for HFEM with side-discontinuous variables.
- Zapdos App
- DGCoeffDiffusionThe discontinuous Galerkin form of the generic diffusion term(Densities must be in log form)
- DGEFieldAdvectionThe discontinuous Galerkin form of the generic electric field driven advection term(Densities must be in log form)
- Squirrel App
- DGCoupledAdvectionDG upwinding for convection on Navier-Stokes velocity variables
- DGFunctionConvection
- DGFunctionTemperatureAdvectionDG upwinding for func temp convection
- DGTemperatureAdvectionDG upwinding for the convection
Dampers
- Moose App
- AddDamperActionAdd a Damper object to the simulation.
- BoundingValueElementDamperThis class implements a damper that limits the value of a variable to be within user-specified bounds.
- BoundingValueNodalDamperLimits the value of a variable to be within user-specified bounds.
- ConstantDamperModifies the non-linear step by applying a constant damping factor.
- MaxIncrementLimits a variable's update by some max fraction
Debug
- Moose App
- SetupDebugActionAdds various debugging type output to the simulation system.
- SetupResidualDebugActionAdds the necessary objects for computing the residuals for individual variables.
- MaterialDerivativeTest
Debug/MaterialDerivativeTest
- Moose App
- MaterialDerivativeTestActionAction for setting up the necessary objects for debugging material property derivatives.
DeprecatedBlock
- Moose App
- DeprecatedBlockActionTool for marking input syntax as deprecated.
DiracKernels
- Moose App
- AddDiracKernelActionAdd a DiracKernel object to the simulation.
- ConstantPointSourceResidual contribution of a constant point source term.
- FunctionDiracSourceResidual contribution from a point source defined by a function.
- ReporterPointSourceApply a point load defined by Reporter.
- VectorConstantPointSourceResidual contribution of a constant point source term.
Distributions
- Moose App
- AddDistributionActionAdd a Distribution object to the simulation.
DriftDiffusionAction
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Zapdos App
- AddDriftDiffusionActionAdd a non-linear variable to the simulation.
Executioner
- Moose App
- CreateExecutionerActionAdd an Executioner object to the simulation.
- EigenvalueEigenvalue solves a standard/generalized linear or nonlinear eigenvalue problem
- InversePowerMethodInverse power method for eigenvalue problems.
- NonlinearEigenExecutioner for eigenvalue problems.
- SteadyExecutioner for steady-state simulations.
- TransientExecutioner for time varying simulations.
- Adaptivity
- Predictor
- Quadrature
- TimeIntegrator
- TimeIntegrators
- TimeStepper
- TimeSteppers
Executioner/Adaptivity
- Moose App
- AdaptivityActionAdd libMesh based adaptation schemes via the Executioner/Adaptivity input syntax.
Executioner/Predictor
- Moose App
- SetupPredictorActionAdd a Predictor object to the simulation.
- AdamsPredictorImplements an explicit Adams predictor based on two old solution vectors.
- SimplePredictorAlgorithm that will predict the next solution based on previous solutions.
Executioner/Quadrature
- Moose App
- SetupQuadratureActionSets the quadrature type for the simulation.
Executioner/TimeIntegrator
- Moose App
- SetupTimeIntegratorActionAdd a TimeIntegrator object to the simulation.
- AStableDirk4Fourth-order diagonally implicit Runge Kutta method (Dirk) with three stages plus an update.
- ActuallyExplicitEulerImplementation of Explicit/Forward Euler without invoking any of the nonlinear solver
- BDF2Second order backward differentiation formula time integration scheme.
- CentralDifferenceImplementation of explicit, Central Difference integration without invoking any of the nonlinear solver
- CrankNicolsonCrank-Nicolson time integrator.
- ExplicitEulerTime integration using the explicit Euler method.
- ExplicitMidpointTime integration using the explicit midpoint method.
- ExplicitSSPRungeKuttaExplicit strong stability preserving Runge-Kutta methods
- ExplicitTVDRK2Explicit TVD (total-variation-diminishing) second-order Runge-Kutta time integration method.
- HeunHeun's (aka improved Euler) time integration method.
- ImplicitEulerTime integration using the implicit Euler method.
- ImplicitMidpointSecond-order Runge-Kutta (implicit midpoint) time integration.
- LStableDirk2Second order diagonally implicit Runge Kutta method (Dirk) with two stages.
- LStableDirk3Third order diagonally implicit Runge Kutta method (Dirk) with three stages.
- LStableDirk4Fourth-order diagonally implicit Runge Kutta method (Dirk) with five stages.
- NewmarkBetaComputes the first and second time derivative of variable using Newmark-Beta method.
- RalstonRalston's time integration method.
Executioner/TimeIntegrators
- Moose App
- SetupTimeIntegratorActionAdd a TimeIntegrator object to the simulation.
- AStableDirk4Fourth-order diagonally implicit Runge Kutta method (Dirk) with three stages plus an update.
- ActuallyExplicitEulerImplementation of Explicit/Forward Euler without invoking any of the nonlinear solver
- BDF2Second order backward differentiation formula time integration scheme.
- CentralDifferenceImplementation of explicit, Central Difference integration without invoking any of the nonlinear solver
- CrankNicolsonCrank-Nicolson time integrator.
- ExplicitEulerTime integration using the explicit Euler method.
- ExplicitMidpointTime integration using the explicit midpoint method.
- ExplicitSSPRungeKuttaExplicit strong stability preserving Runge-Kutta methods
- ExplicitTVDRK2Explicit TVD (total-variation-diminishing) second-order Runge-Kutta time integration method.
- HeunHeun's (aka improved Euler) time integration method.
- ImplicitEulerTime integration using the implicit Euler method.
- ImplicitMidpointSecond-order Runge-Kutta (implicit midpoint) time integration.
- LStableDirk2Second order diagonally implicit Runge Kutta method (Dirk) with two stages.
- LStableDirk3Third order diagonally implicit Runge Kutta method (Dirk) with three stages.
- LStableDirk4Fourth-order diagonally implicit Runge Kutta method (Dirk) with five stages.
- NewmarkBetaComputes the first and second time derivative of variable using Newmark-Beta method.
- RalstonRalston's time integration method.
Executioner/TimeStepper
- Moose App
- AddTimeStepperActionAdd a TimeStepper object to the simulation.
- AB2PredictorCorrectorImplements second order Adams-Bashforth method for timestep calculation.
- CSVTimeSequenceStepperSolves the Transient problem at a sequence of given time points read in a file.
- CompositionDTThe time stepper takes all the other time steppers as input and returns the minimum time step size.
- ConstantDTTimestepper that takes a constant time step size
- ExodusTimeSequenceStepperSolves the Transient problem at a sequence of time points taken from a specified exodus file.
- FixedPointIterationAdaptiveDTComputes time step size based on a target number of fixed point iterations
- FunctionDTTimestepper whose steps vary over time according to a user-defined function
- IterationAdaptiveDTAdjust the timestep based on the number of iterations
- LogConstantDTTimeStepper which imposes a time step constant in the logarithmic space
- PostprocessorDTComputes timestep based on a Postprocessor value.
- SolutionTimeAdaptiveDTCompute simulation timestep based on actual solution time.
- TimeSequenceFromTimesSolves the Transient problem at a sequence of time points taken from a specified Times object.
- TimeSequenceStepperSolves the Transient problem at a sequence of given time points.
Executioner/TimeSteppers
- Moose App
- ComposeTimeStepperActionAdd the composition time stepper if multiple time steppers have been created.
- AddTimeStepperActionAdd a TimeStepper object to the simulation.
- AB2PredictorCorrectorImplements second order Adams-Bashforth method for timestep calculation.
- CSVTimeSequenceStepperSolves the Transient problem at a sequence of given time points read in a file.
- CompositionDTThe time stepper takes all the other time steppers as input and returns the minimum time step size.
- ConstantDTTimestepper that takes a constant time step size
- ExodusTimeSequenceStepperSolves the Transient problem at a sequence of time points taken from a specified exodus file.
- FixedPointIterationAdaptiveDTComputes time step size based on a target number of fixed point iterations
- FunctionDTTimestepper whose steps vary over time according to a user-defined function
- IterationAdaptiveDTAdjust the timestep based on the number of iterations
- LogConstantDTTimeStepper which imposes a time step constant in the logarithmic space
- PostprocessorDTComputes timestep based on a Postprocessor value.
- SolutionTimeAdaptiveDTCompute simulation timestep based on actual solution time.
- TimeSequenceFromTimesSolves the Transient problem at a sequence of time points taken from a specified Times object.
- TimeSequenceStepperSolves the Transient problem at a sequence of given time points.
Executors
- Moose App
- ReadExecutorParamsActionAdd an Executor object to the simulation.
- NullExecutorDummy executor that does nothing. Useful for testing among other things.
FVBCs
- Moose App
- CheckFVBCActionCheck that boundary conditions are defined correctly for finite volume problems.
- AddFVBCActionAdd a FVBoundaryCondition object to the simulation.
- FVADFunctorDirichletBCUses the value of a functor to set a Dirichlet boundary value.
- FVBoundaryIntegralValueConstraintThis class is used to enforce integral of phi = boundary area * phi_0 with a Lagrange multiplier approach.
- FVConstantScalarOutflowBCConstant velocity scalar advection boundary conditions for finite volume method.
- FVDirichletBCDefines a Dirichlet boundary condition for finite volume method.
- FVFunctionDirichletBCImposes the essential boundary condition , where is a (possibly) time and space-dependent MOOSE Function.
- FVFunctionNeumannBCNeumann boundary condition for finite volume method.
- FVFunctorDirichletBCUses the value of a functor to set a Dirichlet boundary value.
- FVFunctorNeumannBCNeumann boundary condition for the finite volume method.
- FVNeumannBCNeumann boundary condition for finite volume method.
- FVOrthogonalBoundaryDiffusionImposes an orthogonal diffusion boundary term with specified boundary function.
- FVPostprocessorDirichletBCDefines a Dirichlet boundary condition for finite volume method.
FVICs
- Moose App
- AddFVInitialConditionActionAdd an FVInitialCondition object to the simulation.
- FVConstantICSets a constant field value.
- FVFunctionICAn initial condition that uses a normal function of x, y, z to produce values (and optionally gradients) for a field variable.
FVInterfaceKernels
- Moose App
- AddFVInterfaceKernelActionAdd a FVInterfaceKernel object to the simulation.
- FVDiffusionInterfaceComputes the residual for diffusion operator across an interface for the finite volume method.
- FVOneVarDiffusionInterfaceComputes residual for diffusion operator across an interface for finite volume method.
- FVTwoVarContinuityConstraintForces two variables to be equal on an interface for the finite volume method.
FVKernels
- Moose App
- AddFVKernelActionAdd a FVKernel object to the simulation.
- FVAdvectionResidual contribution from advection operator for finite volume method.
- FVAnisotropicDiffusionComputes residual for anisotropic diffusion operator for finite volume method.
- FVBodyForceDemonstrates the multiple ways that scalar values can be introduced into finite volume kernels, e.g. (controllable) constants, functions, and postprocessors.
- FVBoundedValueConstraintThis class is used to enforce a min or max value for a finite volume variable
- FVCoupledForceImplements a source term proportional to the value of a coupled variable.
- FVDiffusionComputes residual for diffusion operator for finite volume method.
- FVDivergenceComputes the residual coming from the divergence of a vector fieldthat can be represented as a functor.
- FVFunctorTimeKernelResidual contribution from time derivative of an AD functor (default is the variable this kernel is acting upon if the 'functor' parameter is not supplied) for the finite volume method.
- FVIntegralValueConstraintThis class is used to enforce integral of phi = volume * phi_0 with a Lagrange multiplier approach.
- FVMassMatrixComputes a 'mass matrix', which will just be a diagonal matrix for the finite volume method, meant for use in preconditioning schemes which require one
- FVMatAdvectionComputes the residual of advective term using finite volume method.
- FVOrthogonalDiffusionImposes an orthogonal diffusion term.
- FVPointValueConstraintThis class is used to enforce integral of phi = volume * phi_0 with a Lagrange multiplier approach.
- FVReactionSimple consuming reaction term
- FVScalarLagrangeMultiplierThis class is used to enforce integral of phi = volume * phi_0 with a Lagrange multiplier approach.
- FVTimeKernelResidual contribution from time derivative of a variable for the finite volume method.
Functions
- Moose App
- AddFunctionActionAdd a Function object to the simulation.
- ADParsedFunctionFunction created by parsing a string
- ADPiecewiseLinearLinearly interpolates between pairs of x-y data
- Axisymmetric2D3DSolutionFunctionFunction for reading a 2D axisymmetric solution from file and mapping it to a 3D Cartesian model
- BicubicSplineFunctionDefine a bicubic spline function from interpolated data defined by input parameters.
- CoarsenedPiecewiseLinearPerform a point reduction of the tabulated data upon initialization, then evaluate using a linear interpolation.
- CompositeFunctionMultiplies an arbitrary set of functions together
- ConstantFunctionA function that returns a constant value as defined by an input parameter.
- ImageFunctionFunction with values sampled from an image or image stack.
- LinearCombinationFunctionReturns the linear combination of the functions
- ParsedFunctionFunction created by parsing a string
- ParsedGradFunctionDefines a function and its gradient using input file parameters.
- ParsedVectorFunctionReturns a vector function based on string descriptions for each component.
- PeriodicFunctionProvides a periodic function by repeating a user-supplied base function in time and/or any of the three Cartesian coordinate directions
- PiecewiseBilinearInterpolates values from a csv file
- PiecewiseConstantDefines data using a set of x-y data pairs
- PiecewiseConstantFromCSVUses data read from CSV to assign values
- PiecewiseLinearLinearly interpolates between pairs of x-y data
- PiecewiseLinearFromVectorPostprocessorProvides piecewise linear interpolation of from two columns of a VectorPostprocessor
- PiecewiseMulticonstantPiecewiseMulticonstant performs constant interpolation on 1D, 2D, 3D or 4D data. The data_file specifies the axes directions and the function values. If a point lies outside the data range, the appropriate end value is used.
- PiecewiseMultilinearPiecewiseMultilinear performs linear interpolation on 1D, 2D, 3D or 4D data. The data_file specifies the axes directions and the function values. If a point lies outside the data range, the appropriate end value is used.
- SolutionFunctionFunction for reading a solution from file.
- SplineFunctionDefine a spline function from interpolated data defined by input parameters.
- VectorPostprocessorFunctionProvides piecewise linear interpolation of from two columns of a VectorPostprocessor
FunctorMaterials
- Moose App
- AddFunctorMaterialActionAdd a Functor Material object to the simulation.
- ADGenericConstantFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- ADGenericConstantVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- ADGenericFunctionFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- ADGenericFunctorGradientMaterialFunctorMaterial object for declaring properties that are populated by evaluation of gradients of Functors (a constant, variable, function or functor material property) objects.
- ADGenericFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- ADGenericFunctorTimeDerivativeMaterialFunctorMaterial object for declaring properties that are populated by evaluation of time derivatives of Functors objects. (such as variables, constants, postprocessors). The time derivative is only returned if the 'dot' functor routine is implemented.
- ADGenericVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- ADParsedFunctorMaterialComputes a functor material from a parsed expression of other functors.
- ADPiecewiseByBlockFunctorMaterialComputes a property value on a per-subdomain basis
- ADPiecewiseByBlockVectorFunctorMaterialComputes a property value on a per-subdomain basis
- ADVectorMagnitudeFunctorMaterialThis class takes up to three scalar-valued functors corresponding to vector components or a single vector functor and computes the Euclidean norm.
- FVADPropValPerSubdomainMaterialComputes a property value on a per-subdomain basis
- FVPropValPerSubdomainMaterialComputes a property value on a per-subdomain basis
- FunctorADConverterConverts regular functors to AD functors and AD functors to regular functors
- FunctorSmootherCreates smoother functor(s) using various averaging techniques
- GenericConstantFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- GenericConstantVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- GenericFunctionFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- GenericFunctorGradientMaterialFunctorMaterial object for declaring properties that are populated by evaluation of gradients of Functors (a constant, variable, function or functor material property) objects.
- GenericFunctorMaterialFunctorMaterial object for declaring properties that are populated by evaluation of a Functor (a constant, variable, function or functor material property) objects.
- GenericFunctorTimeDerivativeMaterialFunctorMaterial object for declaring properties that are populated by evaluation of time derivatives of Functors objects. (such as variables, constants, postprocessors). The time derivative is only returned if the 'dot' functor routine is implemented.
- GenericVectorFunctorMaterialFunctorMaterial object for declaring vector properties that are populated by evaluation of functor (constants, functions, variables, matprops) object.
- ParsedFunctorMaterialComputes a functor material from a parsed expression of other functors.
- PiecewiseByBlockFunctorMaterialComputes a property value on a per-subdomain basis
- PiecewiseByBlockVectorFunctorMaterialComputes a property value on a per-subdomain basis
- VectorFunctorADConverterConverts regular functors to AD functors and AD functors to regular functors
- VectorMagnitudeFunctorMaterialThis class takes up to three scalar-valued functors corresponding to vector components or a single vector functor and computes the Euclidean norm.
GlobalParams
- Moose App
- GlobalParamsActionAction used to aid in the application of parameters defined in the GlobalParams input block.
GlobalReactions
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Crane App
- AddScalarReactionsThis Action automatically adds the necessary kernels and materials for a reaction network.
HDGBCs
- Moose App
- AddHDGBCActionAdd a hybridized integrated boundary condition object to the simulation.
- DiffusionHDGDirichletBCWeakly imposes Dirichlet boundary conditions for a hybridized discretization of a diffusion equation
- DiffusionHDGPrescribedGradientBCImplements a flux boundary condition for use with a hybridized discretization of the diffusion equation
HDGKernels
- Moose App
- AddHDGKernelActionAdd a hybridized kernel object to the simulation.
- DiffusionHDGKernelImplements the diffusion equation for a hybridized discretization
ICs
- Moose App
- AddInitialConditionActionAdd an InitialCondition object to the simulation.
- ArrayConstantICSets constant component values for an array field variable.
- ArrayFunctionICAn initial condition that uses a normal function of x, y, z to produce values (and optionally gradients) for a field variable.
- BoundingBoxICBoundingBoxIC allows setting the initial condition of a value inside and outside of a specified box. The box is aligned with the x, y, z axes
- ConstantICSets a constant field value.
- FunctionICAn initial condition that uses a normal function of x, y, z to produce values (and optionally gradients) for a field variable.
- FunctionScalarICInitializes a scalar variable using a function.
- IntegralPreservingFunctionICFunction initial condition that preserves an integral
- RandomICInitialize a variable with randomly generated numbers following either a uniform distribution or a user-defined distribution
- ScalarComponentICInitial condition to set different values on each component of scalar variable.
- ScalarConstantICInitalize a scalar variable with a constant value prescribed by an input parameter.
- ScalarSolutionICSets the initial condition from a scalar variable stored in an Exodus file, retrieved by a SolutionUserObject
- ScalarSolutionInitialConditionSets the initial condition from a scalar variable stored in an Exodus file, retrieved by a SolutionUserObject
- SolutionICSets the initial condition from a field variable stored in an Exodus file, retrieved by a SolutionUserObject
- SolutionInitialConditionSets the initial condition from a field variable stored in an Exodus file, retrieved by a SolutionUserObject
- VectorConstantICSets constant component values for a vector field variable.
- VectorFunctionICSets component values for a vector field variable based on a vector function.
InterfaceKernels
- Moose App
- AddInterfaceKernelActionAdd an InterfaceKernel object to the simulation.
- ADMatInterfaceReactionImplements a reaction to establish ReactionRate=k_f*u-k_b*v at interface.
- ADPenaltyInterfaceDiffusionA penalty-based interface condition that forcesthe continuity of variables and the flux equivalence across an interface.
- ADVectorPenaltyInterfaceDiffusionA penalty-based interface condition that forcesthe continuity of variables and the flux equivalence across an interface.
- InterfaceDiffusionThe kernel is utilized to establish flux equivalence on an interface for variables.
- InterfaceReactionImplements a reaction to establish ReactionRate=k_f*u-k_b*v at interface.
- PenaltyInterfaceDiffusionA penalty-based interface condition that forcesthe continuity of variables and the flux equivalence across an interface.
- VectorPenaltyInterfaceDiffusionA penalty-based interface condition that forcesthe continuity of variables and the flux equivalence across an interface.
- Zapdos App
- HphiRadialInterface
- InterfaceAdvectionUsed to include the electric field driven advective flux of speciesinto or out of a neighboring subdomain. Currently this interface kernelis specific to electrons because the transport coefficients are assumedto be a function of the mean electron energy. A generic interfacekernel with constant transport coefficients will have a much simpler Jacobian
- InterfaceLogDiffusionElectronsUsed to include the diffusive flux of species into or out of a neighboringsubdomain. Currently specific to electrons.
- PotentialSurfaceCharge
- Squirrel App
- InterTemperatureAdvectionDG upwinding for the convection
Kernels
- Moose App
- AddKernelActionAdd a Kernel object to the simulation.
- ADBodyForceDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- ADCoefReactionImplements the residual term (p*u, test)
- ADConservativeAdvectionConservative form of which in its weak form is given by: .
- ADCoupledForceImplements a source term proportional to the value of a coupled variable. Weak form: .
- ADCoupledTimeDerivativeTime derivative Kernel that acts on a coupled variable. Weak form: .
- ADDiffusionSame as
Diffusion
in terms of physics/residual, but the Jacobian is computed using forward automatic differentiation - ADMatBodyForceKernel that defines a body force modified by a material property
- ADMatCoupledForceKernel representing the contribution of the PDE term , where is a material property coefficient, is a coupled scalar field variable, and Jacobian derivatives are calculated using automatic differentiation.
- ADMatDiffusionDiffusion equation kernel that takes an isotropic diffusivity from a material property
- ADMatReactionKernel representing the contribution of the PDE term , where is a reaction rate material property, is a scalar variable (nonlinear or coupled), and whose Jacobian contribution is calculated using automatic differentiation.
- ADMaterialPropertyValueResidual term (u - prop) to set variable u equal to a given material property prop
- ADReactionImplements a simple consuming reaction term with weak form .
- ADScalarLMKernelThis class is used to enforce integral of phi = V_0 with a Lagrange multiplier approach.
- ADTimeDerivativeThe time derivative operator with the weak form of .
- ADVectorDiffusionThe Laplacian operator (), with the weak form of . The Jacobian is computed using automatic differentiation
- ADVectorTimeDerivativeThe time derivative operator with the weak form of .
- AnisotropicDiffusionAnisotropic diffusion kernel with weak form given by .
- ArrayBodyForceApplies body forces specified with functions to an array variable.
- ArrayCoupledTimeDerivativeTime derivative Array Kernel that acts on a coupled variable. Weak form: . The coupled variable and the variable must have the same dimensionality
- ArrayDiffusionThe array Laplacian operator (), with the weak form of .
- ArrayReactionThe array reaction operator with the weak form of .
- ArrayTimeDerivativeArray time derivative operator with the weak form of .
- BodyForceDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- CoefReactionImplements the residual term (p*u, test)
- CoefTimeDerivativeThe time derivative operator with the weak form of .
- ConservativeAdvectionConservative form of which in its weak form is given by: .
- CoupledForceImplements a source term proportional to the value of a coupled variable. Weak form: .
- CoupledTimeDerivativeTime derivative Kernel that acts on a coupled variable. Weak form: .
- DiffusionThe Laplacian operator (), with the weak form of .
- DivFieldThe divergence operator optionally scaled by a constant scalar coefficient. Weak form: .
- FunctionDiffusionDiffusion with a function coefficient.
- GradFieldThe gradient operator optionally scaled by a constant scalar coefficient. Weak form: .
- MassEigenKernelAn eigenkernel with weak form where is the eigenvalue.
- MassLumpedTimeDerivativeLumped formulation of the time derivative . Its corresponding weak form is where denotes the time derivative of the solution coefficient associated with node .
- MassMatrixComputes a finite element mass matrix
- MatBodyForceKernel that defines a body force modified by a material property
- MatCoupledForceImplements a forcing term RHS of the form PDE = RHS, where RHS = Sum_j c_j * m_j * v_j. c_j, m_j, and v_j are provided as real coefficients, material properties, and coupled variables, respectively.
- MatDiffusionDiffusion equation Kernel that takes an isotropic Diffusivity from a material property
- MatReactionKernel to add -L*v, where L=reaction rate, v=variable
- MaterialDerivativeRankFourTestKernelClass used for testing derivatives of a rank four tensor material property.
- MaterialDerivativeRankTwoTestKernelClass used for testing derivatives of a rank two tensor material property.
- MaterialDerivativeTestKernelClass used for testing derivatives of a scalar material property.
- MaterialPropertyValueResidual term (u - prop) to set variable u equal to a given material property prop
- NullKernelKernel that sets a zero residual.
- ReactionImplements a simple consuming reaction term with weak form .
- ScalarLMKernelThis class is used to enforce integral of phi = V_0 with a Lagrange multiplier approach.
- ScalarLagrangeMultiplierThis class is used to enforce integral of phi = V_0 with a Lagrange multiplier approach.
- TimeDerivativeThe time derivative operator with the weak form of .
- UserForcingFunctionDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- VectorBodyForceDemonstrates the multiple ways that scalar values can be introduced into kernels, e.g. (controllable) constants, functions, and postprocessors. Implements the weak form .
- VectorCoupledTimeDerivativeTime derivative Kernel that acts on a coupled vector variable. Weak form: .
- VectorDiffusionThe Laplacian operator (), with the weak form of .
- VectorFunctionReactionKernel representing the contribution of the PDE term , where is a function coefficient and is a vector variable.
- VectorTimeDerivativeThe time derivative operator with the weak form of .
- Zapdos App
- AccelerationByAveragingAn acceleration scheme based on averaging a density over a periodic cycle
- AxisymmetricCurlZThe Z-component of an axisymmetric curl.
- ChargeSourceMoles_KVUsed for adding charged sources to Poisson’s equation. This kernel assumes that densities are measured in units of mol/m as opposed to #/m
- CoeffDiffusionGeneric diffusion term (densities must be in logarithmic form), where the Jacobian is computed using forward automatic differentiation.
- CoeffDiffusionForShootMethodThe derivative of the generic diffusion term used to calculate the sensitivity value for the shoothing method.(Densities must be in logarithmic form)
- CoeffDiffusionLinGeneric linear diffusion term (Values are NOT in logarithmic form), where the Jacobian is computed using forward automatic differentiation.
- DriftDiffusionGeneric drift-diffusion equation that contains both an electric field driven advection term and a diffusion term (Densities must be in logarithmic form)
- EEDFReactionLogForShootMethodThe derivative of an EEDF reaction term used to calculate the sensitivity variable for the shoothing method.(Densities must be in logarithmic form)
- EFieldAdvectionGeneric electric field driven advection term. (Densities must be in logarithmic form.)
- EFieldArtDiffGeneric artificial electric field driven advection term (Densities must be in logarithmic form)
- EFieldMagnitudeSourceElectric field magnitude term based on the electrostatic approximation
- ElectronEnergyLossFromElasticElectron energy loss term for elastic collisions using Townsend coefficient (Densities must be in logarithmic form)
- ElectronEnergyLossFromExcitationElectron energy loss term for inelastic excitation collisions using Townsend coefficient, the energy lost in Volts in a single excitation collision (Densities must be in logarithmic form)
- ElectronEnergyLossFromIonizationElectron energy loss term for inelastic ionization collisions using Townsend coefficients, the energy lost in Volts in a single ionization collision (Densities must be in logarithmic form)
- ElectronEnergyTermElasticRateElectron energy loss term for elastic collisions using reaction rate coefficients (Densities must be in logarithmic form)
- ElectronEnergyTermRateElectron energy loss term for inelastic collisions using reaction rate coefficients. Threshold energy is the energy lost in Volts in a single collision (Densities must be in logarithmic form)
- ElectronTimeDerivativeGeneric accumulation term for variables in logarithmic form.
- ElectronsFromIonizationRate of production of electrons from ionization using Townsend coefficients (Electron density must be in logarithmic form)
- ExcitationReactionRate of production of metastables from excitation using Townsend coefficients (Densities must be in logarithmic form)
- IonsFromIonizationRate of production of ions from ionization using Townsend coefficients (Ion density must be in logarithmic form)
- JouleHeatingJoule heating term for electrons (densities must be in logarithmic form), where the Jacobian is computed using forward automatic differentiation.
- LogStabilizationMolesKernel stabilizes solution variable u in places where u → 0; b is the offset valuespecified by the user. A typical value for b is 20.
- ProductAABBRxnGeneric second order reaction source term in which two molecules of v are produced from two molecules of u (Densities must be in logarithmic form)
- ProductFirstOrderRxnGeneric first order reaction source term for u (v is the reactant and densities must be in logarithmic form)
- ReactantAARxnGeneric second order reaction sink term for u in which twomolecules of u are consumed(Densities must be in logarithmic form)
- ReactantFirstOrderRxnGeneric first order reaction sink term for u (u is the reactant)(Densities must be in logarithmic form)
- ReactionSecondOrderLogForShootMethodThe derivative of a second order reaction term used to calculate the sensitivity variable for the shoothing method. (Densities must be in logarithmic form)
- ReactionThirdOrderLogForShootMethodThe derivative of a third order reaction term used to calculate the sensitivity variable for the shoothing method. (Densities must be in logarithmic form)
- ScaledReactionThe multiple of a given variable (Used for calculating the effective ion potential for a given collision frequency)
- ShootMethodLogAn acceleration scheme based on the shooting method
- TM0CylindricalThe axisymmetric wave equation for the azimuthal component of the magnetizing field.
- TM0CylindricalErThe axisymmetric wave equation for the radial component of the electric field.
- TM0CylindricalEzThe axisymmetric wave equation for the axial component of the electric field.
- UserSourceUser defined source term
- Crane App
- ADEEDFElasticLog
- ADEEDFElasticTownsendLog
- ADEEDFEnergyLog
- ADEEDFEnergyTownsendLogAdds the change in enthalpy from a chemical reaction to the electron and/or gas temperature equations.
- ADEEDFReactionLog
- ADEEDFReactionTownsendLog
- ADReactionSecondOrderLog
- ADReactionThirdOrderLog
- EEDFElasticLog
- EEDFElasticTownsendLog
- EEDFEnergyLog
- EEDFEnergyTownsendLog
- EEDFReactionLog
- EEDFReactionTownsendLog
- LogStabilization
- ReactionFirstOrder
- ReactionFirstOrderEnergy
- ReactionFirstOrderEnergyLog
- ReactionFirstOrderLog
- ReactionSecondOrder
- ReactionSecondOrderEnergy
- ReactionSecondOrderEnergyLog
- ReactionSecondOrderLog
- ReactionThirdOrder
- ReactionThirdOrderEnergy
- ReactionThirdOrderEnergyLog
- ReactionThirdOrderLog
- TimeDerivativeLogThe time derivative operator with the weak form of .
- Squirrel App
- ConservativeTemperatureAdvectionConservative form of which in its weak form is given by: .
- CtrlConservativeAdvection
- CtrlConservativeTemperatureAdvection
- MatINSTemperatureTimeDerivativeThe time derivative operator with the weak form of .
- NonConservativeAdvection
- PotentialAdvection
- VelocityFunctionConservativeAdvection
- VelocityFunctionTemperatureAdvection
LinearFVBCs
- Moose App
- AddLinearFVBCActionAdd a LinearFVBoundaryCondition object to the simulation.
- LinearFVAdvectionDiffusionExtrapolatedBCAdds a boundary condition which calculates the face values and face gradients assuming one or two term expansions from the cell centroid. This kernel is only compatible with advection-diffusion problems.
- LinearFVAdvectionDiffusionFunctorDirichletBCAdds a dirichlet BC which can be used for the assembly of linear finite volume system and whose face values are determined using a functor. This kernel is only designed to work with advection-diffusion problems.
- LinearFVAdvectionDiffusionOutflowBCAdds a boundary condition which represents a surface with outflowing material with a constant velocity. This kernel is only compatible with advection-diffusion problems.
LinearFVKernels
- Moose App
- AddLinearFVKernelActionAdd a LinearFVKernel object to the simulation.
- LinearFVAdvectionRepresents the matrix and right hand side contributions of an advection term in a partial differential equation.
- LinearFVAnisotropicDiffusionRepresents the matrix and right hand side contributions of a diffusion term in a partial differential equation.
- LinearFVDiffusionRepresents the matrix and right hand side contributions of a diffusion term in a partial differential equation.
- LinearFVReactionRepresents the matrix and right hand side contributions of a reaction term () in a partial differential equation.
- LinearFVSourceRepresents the matrix and right hand side contributions of a solution-independent source term in a partial differential equation.
Materials
- Moose App
- AddMaterialActionAdd a Material object to the simulation.
- ADCoupledValueFunctionMaterialCompute a function value from coupled variables
- ADDerivativeParsedMaterialParsed Function Material with automatic derivatives.
- ADDerivativeSumMaterialMeta-material to sum up multiple derivative materials
- ADGenericConstantMaterialDeclares material properties based on names and values prescribed by input parameters.
- ADGenericConstantRankTwoTensorObject for declaring a constant rank two tensor as a material property.
- ADGenericConstantSymmetricRankTwoTensorObject for declaring a constant symmetric rank two tensor as a material property.
- ADGenericConstantVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
- ADGenericFunctionMaterialMaterial object for declaring properties that are populated by evaluation of Function object.
- ADGenericFunctionRankTwoTensorMaterial object for defining rank two tensor properties using functions.
- ADGenericFunctionVectorMaterialMaterial object for declaring vector properties that are populated by evaluation of Function objects.
- ADParsedMaterialParsed expression Material.
- ADPiecewiseConstantByBlockMaterialComputes a property value on a per-subdomain basis
- ADPiecewiseLinearInterpolationMaterialCompute a property using a piecewise linear interpolation to define its dependence on a variable
- ADVectorFromComponentVariablesMaterialComputes a vector material property from coupled variables
- CoupledValueFunctionMaterialCompute a function value from coupled variables
- DerivativeParsedMaterialParsed Function Material with automatic derivatives.
- DerivativeSumMaterialMeta-material to sum up multiple derivative materials
- GenericConstant2DArrayA material evaluating one material property in type of RealEigenMatrix
- GenericConstantArrayA material evaluating one material property in type of RealEigenVector
- GenericConstantMaterialDeclares material properties based on names and values prescribed by input parameters.
- GenericConstantRankTwoTensorObject for declaring a constant rank two tensor as a material property.
- GenericConstantSymmetricRankTwoTensorObject for declaring a constant symmetric rank two tensor as a material property.
- GenericConstantVectorMaterialDeclares material properties based on names and vector values prescribed by input parameters.
- GenericFunctionMaterialMaterial object for declaring properties that are populated by evaluation of Function object.
- GenericFunctionRankTwoTensorMaterial object for defining rank two tensor properties using functions.
- GenericFunctionVectorMaterialMaterial object for declaring vector properties that are populated by evaluation of Function objects.
- InterpolatedStatefulMaterialRankFourTensorAccess old state from projected data.
- InterpolatedStatefulMaterialRankTwoTensorAccess old state from projected data.
- InterpolatedStatefulMaterialRealAccess old state from projected data.
- InterpolatedStatefulMaterialRealVectorValueAccess old state from projected data.
- MaterialADConverterConverts regular material properties to AD properties and vice versa
- MaterialConverterConverts regular material properties to AD properties and vice versa
- MaterialFunctorConverterConverts functor to non-AD and AD regular material properties
- ParsedMaterialParsed expression Material.
- PiecewiseConstantByBlockMaterialComputes a property value on a per-subdomain basis
- PiecewiseLinearInterpolationMaterialCompute a property using a piecewise linear interpolation to define its dependence on a variable
- RankFourTensorMaterialADConverterConverts regular material properties to AD properties and vice versa
- RankFourTensorMaterialConverterConverts regular material properties to AD properties and vice versa
- RankTwoTensorMaterialADConverterConverts regular material properties to AD properties and vice versa
- RankTwoTensorMaterialConverterConverts regular material properties to AD properties and vice versa
- VectorFromComponentVariablesMaterialComputes a vector material property from coupled variables
- VectorMaterialFunctorConverterConverts functor to non-AD and AD regular material properties
- Zapdos App
- ADGasElectronMomentsMaterial properties of electrons(Defines reaction properties with rate coefficients)
- ADHeavySpecies
- ADSurfaceChargeAdds a surface charge material property based on the rate of change of the total charged flux to a boundary. (NOTE: this material is meant to be boundary-restricted.)
- GasMaterial properties of electron and ions for argon gas(Defines reaction properties with Townsend coefficients)
- GasBaseMaterial properties of electrons(Defines reaction properties with Townsend coefficients)
- GasElectronMomentsMaterial properties of electrons(Defines reaction properties with rate coefficients)
- HeavySpecies
- WaterMaterial properties of water species
- Crane App
- ADEEDFRateConstantTownsendAdds townsend coefficient for a reaction as a material property. Note that this material is only intended to be used with the plasma transport software, Zapdos. For any other MOOSE application (or when using Crane by itself) it is recommended to use rate coefficient formulation rather than the townsend coefficients, which may be done with the (AD)EEDFRateConstant material.
- ADGenericRateConstant
- ADZapdosEEDFRateConstant
- DiffusionRateTemp
- EEDFRateConstant
- EEDFRateConstantTownsend
- ElectricField
- GenericRateConstant
- HeatCapacityRatio
- InterpolatedCoefficientLinearAdds townsend coefficient for a reaction as a material property. Note that this material is only intended to be used with the plasma transport software, Zapdos. For any other MOOSE application (or when using Crane by itself) it is recommended to use rate coefficient formulation rather than the townsend coefficients, which may be done with the (AD)EEDFRateConstant material.
- InterpolatedCoefficientSplineAdds townsend coefficient for a reaction as a material property. Note that this material is only intended to be used with the plasma transport software, Zapdos. For any other MOOSE application (or when using Crane by itself) it is recommended to use rate coefficient formulation rather than the townsend coefficients, which may be done with the (AD)EEDFRateConstant material.
- SpeciesSum
- SuperelasticReactionRate
- ZapdosEEDFRateConstant
Mesh
- Moose App
- CreateDisplacedProblemActionCreate a Problem object that utilizes displacements.
- DisplayGhostingActionAction to setup AuxVariables and AuxKernels to display ghosting when running in parallel
- ElementIDOutputActionAction for copying extra element IDs into auxiliary variables for output.
- SetupMeshActionAdd or create Mesh object to the simulation.
- SetupMeshCompleteActionPerform operations on the mesh in preparation for a simulation.
- AddMeshGeneratorActionAdd a MeshGenerator object to the simulation.
- AddMetaDataGeneratorThis mesh generator assigns extraneous mesh metadata to the input mesh
- AdvancedExtruderGeneratorExtrudes a 1D mesh into 2D, or a 2D mesh into 3D, can have a variable height for each elevation, variable number of layers within each elevation, variable growth factors of axial element sizes within each elevation and remap subdomain_ids, boundary_ids and element extra integers within each elevation as well as interface boundaries between neighboring elevation layers.
- AllSideSetsByNormalsGeneratorAdds sidesets to the entire mesh based on unique normals.
- AnnularMeshGeneratorFor rmin>0: creates an annular mesh of QUAD4 elements. For rmin=0: creates a disc mesh of QUAD4 and TRI3 elements. Boundary sidesets are created at rmax and rmin, and given these names. If dmin!0 and dmax!360, a sector of an annulus or disc is created. In this case boundary sidesets are also created at dmin and dmax, and given these names
- BlockDeletionGeneratorMesh generator which removes elements from the specified subdomains
- BlockToMeshConverterGeneratorConverts one or more blocks (subdomains) from a mesh into a stand-alone mesh with a single block in it.
- BoundaryDeletionGeneratorMesh generator which removes side sets
- BoundingBoxNodeSetGeneratorAssigns all of the nodes either inside or outside of a bounding box to a new nodeset.
- BreakBoundaryOnSubdomainGeneratorBreak boundaries based on the subdomains to which their sides are attached. Naming convention for the new boundaries will be the old boundary name plus "_to_" plus the subdomain name
- BreakMeshByBlockGeneratorBreak the mesh at interfaces between blocks. New nodes will be generated so elements on each side of the break are no longer connected. At the moment, this only works on a REPLICATED mesh
- BreakMeshByElementGeneratorBreak all element-element interfaces in the specified subdomains.
- CartesianMeshGeneratorThis CartesianMeshGenerator creates a non-uniform Cartesian mesh.
- CircularBoundaryCorrectionGeneratorThis CircularBoundaryCorrectionGenerator object is designed to correct full or partial circular boundaries in a 2D mesh to preserve areas.
- CoarsenBlockGeneratorMesh generator which coarsens one or more blocks in an existing mesh. The coarsening algorithm works best for regular meshes.
- CombinerGeneratorCombine multiple meshes (or copies of one mesh) together into one (disjoint) mesh. Can optionally translate those meshes before combining them.
- ConcentricCircleMeshGeneratorThis ConcentricCircleMeshGenerator source code is to generate concentric circle meshes.
- CutMeshByPlaneGeneratorThis CutMeshByPlaneGenerator object is designed to trim the input mesh by removing all the elements on one side of a given plane with special processing on the elements crossed by the cutting line to ensure a smooth cross-section. The output mesh only consists of TET4 elements.
- DistributedRectilinearMeshGeneratorCreate a line, square, or cube mesh with uniformly spaced or biased elements.
- ElementGeneratorGenerates individual elements given a list of nodal positions.
- ElementOrderConversionGeneratorMesh generator which converts orders of elements
- ElementSubdomainIDGeneratorAllows the user to assign each element the subdomain ID of their choice
- ElementsToSimplicesConverterSplits all non-simplex elements in a mesh into simplices.
- ElementsToTetrahedronsConverterThis ElementsToTetrahedronsConverter object is designed to convert all the elements in a 3D mesh consisting only linear elements into TET4 elements.
- ExamplePatchMeshGeneratorCreates 2D or 3D patch meshes.
- ExplodeMeshGeneratorBreak all element-element interfaces in the specified subdomains.
- ExtraNodesetGeneratorCreates a new node set and a new boundary made with the nodes the user provides.
- FancyExtruderGeneratorExtrudes a 1D mesh into 2D, or a 2D mesh into 3D, can have a variable height for each elevation, variable number of layers within each elevation, variable growth factors of axial element sizes within each elevation and remap subdomain_ids, boundary_ids and element extra integers within each elevation as well as interface boundaries between neighboring elevation layers.
- FileMeshGeneratorRead a mesh from a file.
- FillBetweenCurvesGeneratorThis FillBetweenCurvesGenerator object is designed to generate a transition layer to connect two boundaries of two input meshes.
- FillBetweenPointVectorsGeneratorThis FillBetweenPointVectorsGenerator object is designed to generate a transition layer with two sides containing different numbers of nodes.
- FillBetweenSidesetsGeneratorThis FillBetweenSidesetsGenerator object is designed to generate a transition layer to connect two boundaries of two input meshes.
- FlipSidesetGeneratorA Mesh Generator which flips a given sideset
- GeneratedMeshGeneratorCreate a line, square, or cube mesh with uniformly spaced or biased elements.
- ImageMeshGeneratorGenerated mesh with the aspect ratio of a given image stack.
- ImageSubdomainGeneratorSamples an image at the coordinates of each element centroid, using the resulting pixel color value as each element's subdomain ID
- LowerDBlockFromSidesetGeneratorAdds lower dimensional elements on the specified sidesets.
- MeshCollectionGeneratorCollects multiple meshes into a single (unconnected) mesh.
- MeshDiagnosticsGeneratorRuns a series of diagnostics on the mesh to detect potential issues such as unsupported features
- MeshExtruderGeneratorTakes a 1D or 2D mesh and extrudes the entire structure along the specified axis increasing the dimensionality of the mesh.
- MeshRepairGeneratorMesh generator to perform various improvement / fixing operations on an input mesh
- MoveNodeGeneratorModifies the position of one or more nodes
- NodeSetsFromSideSetsGeneratorMesh generator which constructs node sets from side sets
- OrientedSubdomainBoundingBoxGeneratorDefines a subdomain inside or outside of a bounding box with arbitrary orientation.
- OverlayMeshGeneratorCreates a Cartesian mesh overlaying the input mesh region.
- ParsedCurveGeneratorThis ParsedCurveGenerator object is designed to generate a mesh of a curve that consists of EDGE2 elements.
- ParsedElementDeletionGeneratorRemoves elements such that the parsed expression is evaluated as strictly positive. The parameters of the parsed expression can be the X,Y,Z coordinates of the element vertex average (must be 'x','y','z' in the expression), the element volume (must be 'volume' in the expression) and the element id ('id' in the expression).
- ParsedExtraElementIDGeneratorUses a parsed expression to set an extra element id for elements (via their centroids).
- ParsedGenerateNodesetA MeshGenerator that adds nodes to a nodeset if the node satisfies the
expression
expression. - ParsedGenerateSidesetA MeshGenerator that adds element sides to a sideset if the centroid of the side satisfies the
combinatorial_geometry
expression. - ParsedNodeTransformGeneratorApplies a transform to a the x,y,z coordinates of a Mesh
- ParsedSubdomainMeshGeneratorUses a parsed expression (
combinatorial_geometry
) to determine if an element (via its centroid) is inside the region defined by the expression and assigns a new block ID. - PatchMeshGeneratorCreates 2D or 3D patch meshes.
- PatternedMeshGeneratorCreates a 2D mesh from a specified set of unique 'tiles' meshes and a two-dimensional pattern.
- PlaneDeletionGeneratorRemoves elements lying 'above' the plane (in the direction of the normal).
- PlaneIDMeshGeneratorAdds an extra element integer that identifies planes in a mesh.
- PolyLineMeshGeneratorGenerates meshes from edges connecting a list of points.
- RefineBlockGeneratorMesh generator which refines one or more blocks in an existing mesh
- RefineSidesetGeneratorMesh generator which refines one or more sidesets
- RenameBlockGeneratorChanges the block IDs and/or block names for a given set of blocks defined by either block ID or block name. The changes are independent of ordering. The merging of blocks is supported.
- RenameBoundaryGeneratorChanges the boundary IDs and/or boundary names for a given set of boundaries defined by either boundary ID or boundary name. The changes are independent of ordering. The merging of boundaries is supported.
- RinglebMeshGeneratorCreates a mesh for the Ringleb problem.
- SideSetExtruderGeneratorTakes a 1D or 2D mesh and extrudes a selected sideset along the specified axis.
- SideSetsAroundSubdomainGeneratorAdds element faces that are on the exterior of the given block to the sidesets specified
- SideSetsBetweenSubdomainsGeneratorMeshGenerator that creates a sideset composed of the nodes located between two or more subdomains.
- SideSetsFromBoundingBoxGeneratorDefines new sidesets using currently-defined sideset IDs inside or outside of a bounding box.
- SideSetsFromNodeSetsGeneratorMesh generator which constructs side sets from node sets
- SideSetsFromNormalsGeneratorAdds a new named sideset to the mesh for all faces matching the specified normal.
- SideSetsFromPointsGeneratorAdds a new sideset starting at the specified point containing all connected element faces with the same normal.
- SmoothMeshGeneratorUtilizes a simple Laplacian based smoother to attempt to improve mesh quality. Will not move boundary nodes or nodes along block/subdomain boundaries
- SphereMeshGeneratorGenerate a 3-D sphere mesh centered on the origin
- SpiralAnnularMeshGeneratorCreates an annular mesh based on TRI3 or TRI6 elements on several rings.
- StackGeneratorUse the supplied meshes and stitch them on top of each other
- StitchBoundaryMeshGeneratorAllows a pair of boundaries to be stitched together.
- StitchedMeshGeneratorAllows multiple mesh files to be stitched together to form a single mesh.
- SubdomainBoundingBoxGeneratorChanges the subdomain ID of elements either (XOR) inside or outside the specified box to the specified ID.
- SubdomainIDGeneratorSets all the elements of the input mesh to a unique subdomain ID.
- SubdomainPerElementGeneratorAllows the user to assign each element the subdomain ID of their choice
- SymmetryTransformGeneratorApplies a symmetry transformation to the entire mesh.
- TiledMeshGeneratorUse the supplied mesh and create a tiled grid by repeating this mesh in the x, y, and z directions.
- TransfiniteMeshGeneratorCreates a QUAD4 mesh given a set of corner vertices and edge types. The edge type can be either LINE, CIRCARC, DISCRETE or PARSED, with LINE as the default option. For the non-default options the user needs to specify additional parameters via the edge_parameter option as follows: for CIRCARC the deviation of the midpoint from an arccircle, for DISCRETE a set of points, or a paramterization via the PARSED option. Opposite edges may have different distributions s long as the number of points is identical. Along opposite edges a different point distribution can be prescribed via the options bias_x or bias_y for opposing edges.
- TransformGeneratorApplies a linear transform to the entire mesh.
- UniqueExtraIDMeshGeneratorAdd a new extra element integer ID by finding unique combinations of the existing extra element integer ID values
- XYDelaunayGeneratorTriangulates meshes within boundaries defined by input meshes.
- XYMeshLineCutterThis XYMeshLineCutter object is designed to trim the input mesh by removing all the elements on one side of a given straight line with special processing on the elements crossed by the cutting line to ensure a smooth cross-section.
- XYZDelaunayGeneratorCreates tetrahedral 3D meshes within boundaries defined by input meshes.
- AnnularMeshFor rmin>0: creates an annular mesh of QUAD4 elements. For rmin=0: creates a disc mesh of QUAD4 and TRI3 elements. Boundary sidesets are created at rmax and rmin, and given these names. If dmin!0 and dmax!360, a sector of an annulus or disc is created. In this case boundary sidesets are also created a dmin and dmax, and given these names
- ConcentricCircleMeshThis ConcentricCircleMesh source code is to generate concentric circle meshes.
- FileMeshRead a mesh from a file.
- GeneratedMeshCreate a line, square, or cube mesh with uniformly spaced or biased elements.
- ImageMeshGenerated mesh with the aspect ratio of a given image stack.
- MeshGeneratorMeshMesh generated using mesh generators
- PatternedMeshCreates a 2D mesh from a specified set of unique 'tiles' meshes and a two-dimensional pattern.
- RinglebMeshCreates a mesh for the Ringleb problem.
- SpiralAnnularMeshCreates an annual mesh based on TRI3 elements (it can also be TRI6 elements) on several rings.
- StitchedMeshReads in all of the given meshes and stitches them all together into one mesh.
- TiledMeshUse the supplied mesh and create a tiled grid by repeating this mesh in the x,y, and z directions.
- Partitioner
Mesh/Partitioner
- Moose App
- PartitionerActionAdd a Partitioner object to the simulation.
- BlockWeightedPartitionerPartition mesh by weighting blocks
- GridPartitionerCreate a uniform grid that overlays the mesh to be partitioned. Assign all elements within each cell of the grid to the same processor.
- HierarchicalGridPartitionerPartitions a mesh into sub-partitions for each computational node then into partitions within that node. All partitions are made using a regular grid.
- LibmeshPartitionerMesh partitioning using capabilities defined in libMesh.
- PetscExternalPartitionerPartition mesh using external packages via PETSc MatPartitioning interface
- RandomPartitionerAssigns element processor ids randomly with a given seed.
- SingleRankPartitionerAssigns element processor ids to a single MPI rank.
MeshDivisions
- Moose App
- AddMeshDivisionActionAdd a MeshDivision object to the simulation.
- CartesianGridDivisionDivide the mesh along a Cartesian grid. Numbering increases from bottom to top and from left to right and from back to front. The inner ordering is X, then Y, then Z
- CylindricalGridDivisionDivide the mesh along a cylindrical grid. The innermost numbering of divisions is the radial bins, then comes the azimuthal bins, then the axial bins
- ExtraElementIntegerDivisionDivide the mesh by increasing extra element IDs. The division will be contiguously numbered even if the extra element ids are not
- FunctorBinnedValuesDivisionDivide the mesh along based on uniformly binned values of a functor.
- NearestPositionsDivisionDivide the mesh using a nearest-point / voronoi algorithm, with the points coming from a Positions object
- NestedDivisionDivide the mesh using nested divisions objects
- SphericalGridDivisionDivide the mesh along a spherical grid.
- SubdomainsDivisionDivide the mesh by increasing subdomain ids. The division will be contiguously numbered even if the subdomain ids are not
MeshModifiers
- Moose App
- AddMeshModifiersActionAdd a MeshModifier object to the simulation.
- ActivateElementsByPathDetermine activated elements.
- ActivateElementsCoupledDetermine activated elements.
- CoupledVarThresholdElementSubdomainModifierModify the element subdomain ID if a coupled variable satisfies the criterion for the threshold (above, equal, or below)
- SidesetAroundSubdomainUpdaterSets up a boundary between inner_subdomains and outer_subdomains
- TimedSubdomainModifierModify element subdomain ID of entire subdomains for given points in time. This mesh modifier only runs on the undisplaced mesh, and it will modify both the undisplaced and the displaced mesh.
- VariableValueElementSubdomainModifierModify the element subdomain ID based on the provided variable value.
MultiApps
- Moose App
- AddMultiAppActionAdd a MultiApp object to the simulation.
- CentroidMultiAppAutomatically generates Sub-App positions from centroids of elements in the parent app mesh.
- FullSolveMultiAppPerforms a complete simulation during each execution.
- QuadraturePointMultiAppAutomatically generates sub-App positions from the elemental quadrature points, with the default quadrature, in the parent mesh.
- TransientMultiAppMultiApp for performing coupled simulations with the parent and sub-application both progressing in time.
NodalKernels
- Moose App
- AddNodalKernelActionAdd a NodalKernel object to the simulation.
- ConstantRateComputes residual or the rate in a simple ODE of du/dt = rate.
- CoupledForceNodalKernelAdds a force proportional to the value of the coupled variable
- LowerBoundNodalKernelUsed to prevent a coupled variable from going below a lower bound
- PenaltyDirichletNodalKernelEnforces a Dirichlet boundary condition in a weak sense by penalizing differences between the current solution and the Dirichlet value on nodesets.
- ReactionNodalKernelImplements a simple consuming reaction term at nodes
- TimeDerivativeNodalKernelForms the contribution to the residual and jacobian of the time derivative term from an ODE being solved at all nodes.
- UpperBoundNodalKernelUsed to prevent a coupled variable from going above a upper bound
- UserForcingFunctionNodalKernelResidual contribution to an ODE from a source function acting at nodes.
NodalNormals
- Moose App
- AddNodalNormalsActionCreates Auxiliary variables and objects for computing the outward facing normal from a node.
Outputs
- Moose App
- AutoCheckpointActionAction to create shortcut syntax-specified checkpoints and automatic checkpoints.
- CommonOutputActionAdds short-cut syntax and common parameters to the Outputs block.
- AddOutputActionAction responsible for creating Output objects.
- BlockRestrictionDebugOutputDebug output object for displaying information regarding block-restriction of objects.
- CSVOutput for postprocessors, vector postprocessors, and scalar variables using comma seperated values (CSV).
- CheckpointOutput for MOOSE recovery checkpoint files.
- ConsoleObject for screen output.
- ControlOutputOutput for displaying objects and parameters associated with the Control system.
- DOFMapOutput degree-of-freedom (DOF) map.
- ExodusObject for output data in the Exodus format
- GMVObject for outputting data in the GMV format
- GnuplotOutput for postprocessors and scalar variables in GNU plot format.
- JSONOutput for Reporter values using JSON format.
- MaterialPropertyDebugOutputDebug output object for displaying material property information.
- NemesisObject for output data in the Nemesis (parallel ExodusII) format.
- PerfGraphOutputControls output of the PerfGraph: the performance log for MOOSE
- ProgressOutput a simulation time progress bar on the console.
- ReporterDebugOutputDebug output object for displaying Reporter information.
- SolutionHistoryOutputs the non-linear and linear iteration solve history.
- TecplotObject for outputting data in the Tecplot format
- TopResidualDebugOutputDebug output object for displaying the top contributing residuals.
- VTKOutput data using the Visualization Toolkit (VTK).
- VariableResidualNormsDebugOutputReports the residual norm for each variable.
- XDAObject for outputting data in the XDA/XDR format.
- XDRObject for outputting data in the XDA/XDR format.
- XMLOutputOutput for VectorPostprocessor using XML format.
PeriodicControllers
- Moose App
- BoolFunctionControlSets the value of a 'bool' input parameters to the value of a provided function.
- ConditionalFunctionEnableControlControl for enabling/disabling objects when a function value is true
- PIDTransientControlSets the value of a 'Real' input parameter (or postprocessor) based on a Proportional Integral Derivative control of a postprocessor to match a target a target value.
- RealFunctionControlSets the value of a 'Real' input parameters to the value of a provided function.
- TimePeriodControl the enabled/disabled state of objects with time.
- TimesEnableControlControl for enabling/disabling objects when a certain time is reached.
- WebServerControlStarts a webserver for sending/receiving JSON messages to get data and control a running MOOSE calculation
- Zapdos App
- AddPeriodicControllersThis Action automatically adds multiply 'TimePeriod' controllers forthe purpose of enabling and disabling multiple objects during multiple cycles.(Ideally for periodic accelerations)
PeriodicRelativeNodalDifference
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Zapdos App
- AddPeriodicRelativeNodalDifferenceThis Action automatically adds the necessary objects to calculate the relative periodic difference. Relative Difference will be outputted as an Postprocessor named: 'var'_periodic_difference
Physics
Physics/Diffusion
Physics/Diffusion/ContinuousGalerkin
- Moose App
- DiffusionCGDiscretizes a diffusion equation with the continuous Galerkin finite element method
Physics/Diffusion/FiniteVolume
- Moose App
- DiffusionFVAdd diffusion physics discretized with cell-centered finite volume
Positions
- Moose App
- AddPositionsActionAdd a Positions object to the simulation.
- DistributedPositionsDistribute positions, using translations, over one or more positions
- ElementCentroidPositionsPositions of element centroids.
- ElementGroupCentroidPositionsGets the Positions of the centroid of groups of elements. Groups may be defined using subdomains or element extra ids.
- FilePositionsImport positions from one or more files.
- FunctorPositionsImport positions from one or more reporters, for example other Positions
- InputPositionsPositions set directly from a user parameter in the input file
- MultiAppPositionsObtain positions from MultiApps. This may only be used to set the positions of those same multiapps if an 'initial_positions' parameter is used.
- QuadraturePointsPositionsPositions of element quadrature points.
- ReporterPositionsImport positions from one or more reporters, for example other Positions
- TransformedPositionsTransform, with a linear transformation, positions from another Positions object
Postprocessors
- Moose App
- AddPostprocessorActionAdd a Postprocessor object to the simulation.
- ADElementAverageMaterialPropertyComputes the average of a material property over a volume.
- ADElementExtremeFunctorValueFinds either the min or max elemental value of a functor over the domain.
- ADElementExtremeMaterialPropertyDetermines the minimum or maximum of a material property over a volume.
- ADElementIntegralFunctorPostprocessorComputes a volume integral of the specified functor
- ADElementIntegralMaterialPropertyCompute the integral of the material property over the domain
- ADElementL2FunctorErrorComputes L2 error between an 'approximate' functor and an 'exact' functor
- ADInterfaceDiffusiveFluxAverageComputes the diffusive flux on the interface.
- ADInterfaceDiffusiveFluxIntegralComputes the diffusive flux on the interface.
- ADSideAdvectiveFluxIntegralComputes the volumetric advected quantity through a sideset.
- ADSideAverageMaterialPropertyComputes the average of a material property over a side set.
- ADSideDiffusiveFluxAverageComputes the integral of the diffusive flux over the specified boundary
- ADSideDiffusiveFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- ADSideFluxAverageComputes the integral of the diffusive flux over the specified boundary
- ADSideFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- ADSideIntegralFunctorPostprocessorComputes a surface integral of the specified functor, using the single-sided face argument, which usually means that the functor will be evaluated from a single side of the surface, not interpolated between both sides.
- ADSideIntegralMaterialPropertyCompute the integral of a scalar material property component over the domain.
- ADSideVectorDiffusivityFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- AreaPostprocessorComputes the "area" or dimension - 1 "volume" of a given boundary or boundaries in your mesh.
- AverageElementSizeComputes the average element size.
- AverageNodalVariableValueComputes the average value of a field by sampling all nodal solutions on the domain or within a subdomain
- AverageVariableChangeComputes the volume-weighted L1 or L2 norm of the change of a variable over a time step or between nonlinear iterations.
- AxisymmetricCenterlineAverageValueComputes the average value of a variable on a sideset located along the centerline of an axisymmetric model.
- ChangeOverFixedPointPostprocessorComputes the change or relative change in a post-processor value over a single or multiple fixed point iterations
- ChangeOverTimePostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- ChangeOverTimestepPostprocessorComputes the change or relative change in a post-processor value over a timestep or the entire transient
- ConstantPostprocessorPostprocessor that holds a constant value
- CumulativeValuePostprocessorCreates a cumulative sum of a Postprocessor value with time.
- DifferencePostprocessorComputes the difference between two postprocessors
- ElementArrayL2NormEvaluates L2-norm of a component of an array variable
- ElementAverageMaterialPropertyComputes the average of a material property over a volume.
- ElementAverageSecondTimeDerivativeComputes the element averaged second derivative of variable
- ElementAverageTimeDerivativeComputes a volume integral of the time derivative of a given variable
- ElementAverageValueComputes the volumetric average of a variable
- ElementExtremeFunctorValueFinds either the min or max elemental value of a functor over the domain.
- ElementExtremeMaterialPropertyDetermines the minimum or maximum of a material property over a volume.
- ElementExtremeValueFinds either the min or max elemental value of a variable over the domain.
- ElementH1ErrorComputes the H1 error between a variable and a function
- ElementH1SemiErrorReturns the gradient difference norm part of the H1 error
- ElementHCurlErrorReturns the H(curl)-norm of the difference between a pair of computed and analytical vector-valued solutions.
- ElementHCurlSemiErrorReturns the H(curl)-seminorm of the difference between a pair of computed and analytical vector-valued solutions.
- ElementHDivErrorReturns the H(div)-norm of the difference between a pair of computed and analytical vector-valued solutions.
- ElementHDivSemiErrorReturns the H(div)-seminorm of the difference between a pair of computed and analytical vector-valued solutions.
- ElementIntegralArrayVariablePostprocessorIntegral of one component of an array variable.
- ElementIntegralFunctorPostprocessorComputes a volume integral of the specified functor
- ElementIntegralMaterialPropertyCompute the integral of the material property over the domain
- ElementIntegralVariablePostprocessorComputes a volume integral of the specified variable
- ElementL1ErrorComputes L1 error between an elemental field variable and an analytical function.
- ElementL2DifferenceComputes the element-wise L2 difference between the current variable and a coupled variable.
- ElementL2ErrorComputes L2 error between a field variable and an analytical function
- ElementL2FunctorErrorComputes L2 error between an 'approximate' functor and an 'exact' functor
- ElementL2NormComputes a volume integral of the specified variable
- ElementSidesL2NormComputes the L2 norm of a variable over element sides.
- ElementVectorL2ErrorReturns the L2-norm of the difference between a pair of computed and analytical vector-valued solutions.
- ElementW1pErrorComputes the W1p norm of the difference between a variable and an analytic solution, as a function
- ElementalVariableValueOutputs an elemental variable value at a particular location
- EmptyPostprocessorA postprocessor object that returns a value of zero.
- FindValueOnLineFind a specific target value along a sampling line. The variable values along the line should change monotonically. The target value is searched using a bisection algorithm.
- FunctionElementAverageComputes the average of a function over a volume.
- FunctionElementIntegralIntegrates a function over elements
- FunctionSideAverageComputes the average of a function over a boundary.
- FunctionSideIntegralComputes the integral of a function over a boundary.
- FunctionValuePostprocessorComputes the value of a supplied function at a single point (scalable)
- GreaterThanLessThanPostprocessorCount number of DOFs of a non-linear variable that are greater than or less than a given threshold
- InterfaceAverageVariableValuePostprocessorComputes the average value of a variable on an interface. Note that this cannot be used on the centerline of an axisymmetric model.
- InterfaceDiffusiveFluxAverageComputes the diffusive flux on the interface.
- InterfaceDiffusiveFluxIntegralComputes the diffusive flux on the interface.
- InterfaceIntegralVariableValuePostprocessorAdd access to variables and their gradient on an interface.
- InternalSideIntegralVariablePostprocessorComputes an integral on internal sides of the specified variable
- IsMatrixSymmetricReport whether the system matrix is symmetric or not.
- LinearCombinationPostprocessorComputes a linear combination between an arbitrary number of post-processors
- MemoryUsageMemory usage statistics for the running simulation.
- NearestNodeNumberOutputs the nearest node number to a point
- NodalExtremeValueFinds either the min or max elemental value of a variable over the domain.
- NodalL2ErrorThe L2-norm of the difference between a variable and a function computed at nodes.
- NodalL2NormComputes the nodal L2-norm of the coupled variable, which is defined by summing the square of its value at every node and taking the square root.
- NodalMaxValueComputes the maximum (over all the nodal values) of a variable.
- NodalMaxValueIdFinds the node id with the maximum nodal value across all postprocessors.
- NodalProxyMaxValueFinds the node id with the maximum nodal value across all postprocessors.
- NodalSumComputes the sum of all of the nodal values of the specified variable. Note: This object sets the default "unique_node_execute" flag to true to avoid double counting nodes between shared blocks.
- NodalVariableValueOutputs values of a nodal variable at a particular location
- NumDOFsReturn the number of Degrees of freedom from either the NL, Aux or both systems.
- NumElementsReturn the number of active or total elements in the simulation.
- NumElemsReturn the number of active or total elements in the simulation.
- NumFailedTimeStepsCollects the number of failed time steps from the time stepper.
- NumFixedPointIterationsReturns the number of fixed point iterations taken by the executioner.
- NumLinearIterationsCompute the number of linear iterations.
- NumMeshDivisionsReturn the number of divisions/regions from a MeshDivision object.
- NumNodesReturns the total number of nodes in a simulation (works with DistributedMesh)
- NumNonlinearIterationsOutputs the number of nonlinear iterations
- NumPicardIterationsReturns the number of fixed point iterations taken by the executioner.
- NumPositionsReturn the number of Positions from a Positions object.
- NumRelationshipManagersReturn the number of relationship managers active.
- NumResidualEvaluationsReturns the total number of residual evaluations performed.
- NumVarsReturn the number of variables from either the NL, Aux, or both systems.
- ParsedPostprocessorComputes a parsed expression with post-processors
- PercentChangePostprocessorComputes the percent change of a postprocessor value compared to the value at the previous timestep.
- PerfGraphDataRetrieves performance information about a section from the PerfGraph.
- PointValueCompute the value of a variable at a specified location
- PostprocessorComparisonCompares two post-processors and produces a boolean value
- PseudoTimestepComputes pseudo-time steps for obtaining steady-state solutions through a pseudo transient process.
- ReceiverReports the value stored in this processor, which is usually filled in by another object. The Receiver does not compute its own value.
- RelativeDifferencePostprocessorComputes the absolute value of the relative difference between 2 post-processor values.
- RelativeSolutionDifferenceNormComputes the relative norm of the solution difference of two consecutive time steps.
- ResidualReport the non-linear residual.
- ScalarL2ErrorCompute L2 error of a scalar variable using analytic function.
- ScalarVariableReturns the value of a scalar variable as a postprocessor value.
- ScalePostprocessorScales a post-processor by a value
- SideAdvectiveFluxIntegralComputes the volumetric advected quantity through a sideset.
- SideAverageFunctorPostprocessorComputes the average of a functor over a side set.
- SideAverageMaterialPropertyComputes the average of a material property over a side set.
- SideAverageValueComputes the average value of a variable on a sideset. Note that this cannot be used on the centerline of an axisymmetric model.
- SideDiffusiveFluxAverageComputes the integral of the diffusive flux over the specified boundary
- SideDiffusiveFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- SideExtremeValueFinds either the min or max variable value of a variable over a boundary.
- SideFVFluxBCIntegralComputes the side integral of different finite volume flux boundary conditions.
- SideFluxAverageComputes the integral of the diffusive flux over the specified boundary
- SideFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- SideIntegralFunctorPostprocessorComputes a surface integral of the specified functor, using the single-sided face argument, which usually means that the functor will be evaluated from a single side of the surface, not interpolated between both sides.
- SideIntegralMaterialPropertyCompute the integral of a scalar material property component over the domain.
- SideIntegralVariablePostprocessorComputes a surface integral of the specified variable
- SideVectorDiffusivityFluxIntegralComputes the integral of the diffusive flux over the specified boundary
- TagVectorSumComputes the sum of components of the requested tagged vector
- TimeExtremeValueA postprocessor for reporting the extreme value of another postprocessor over time.
- TimeIntegratedPostprocessorIntegrate a Postprocessor value over time using trapezoidal rule.
- TimePostprocessorReports the current time
- TimestepSizeReports the timestep size
- TotalVariableValueIntegrate a Postprocessor value over time using trapezoidal rule.
- VariableInnerProductComputes a volume integral of the specified variable
- VariableResidualComputes the L2 norm of the residual of a single variable in the solution vector.
- VectorPostprocessorComparisonCompares two vector post-processors of equal size and produces a boolean value
- VectorPostprocessorComponentReturns the value of the specified component of a VectorPostprocessor
- VectorPostprocessorReductionValueTakes a VectorPostprocessor and performs a reduction operation on it (max, min, sum, average) and stores as postprocessor.
- VolumePostprocessorComputes the volume of a specified block
- Zapdos App
- AverageNodalDensitySimilar to AverageNodalVariableValue except meant to average variables expressed in log form
- AverageNodalDifferenceReturns the average nodal differences between two variables
- BlockAverageValueReturns the average value of a defined variable for a given domain
- MultiPeriodAveragerCalculate the average value of a post processor over multiple periods
- MultipliedTimeIntegratedPostprocessorIntegrate a Postprocessor value over time using trapezoidal rule.
- PeriodicAmplitudeRegulatorPostprocessor that will modify its value by the ratio of anotherpostprocessor to the provided reference value
- PeriodicComparisonCounterCompares two Postprocessors or values and keeps countof how many cycles in a row that comparision is true.
- PeriodicTimeIntegratedPostprocessorIntegrate a Postprocessor value over a period in time using trapezoidal rule.
- PlasmaFrequencyInverseReturns the inverse of the peak electron frequency
- RelativeElementL2DifferenceComputes the element-wise relative L2 difference between the current variable and a coupled variable: i.e. ||u-v||/||u||
- SideCurrentComputes a surface integral of the specified variable
- SideTotFluxIntegralReturns the flux of a defined species at a boundary
- Crane App
- ElectricFieldCalculator
Preconditioning
- Moose App
- SetupPreconditionerActionAdd a Preconditioner object to the simulation.
- AddFieldSplitActionAdd a Split object to the simulation.
- SplitField split based preconditioner for nonlinear solver.
- FDPFinite difference preconditioner (FDP) builds a numerical Jacobian for preconditioning, only use for testing and verification.
- FSPPreconditioner designed to map onto PETSc's PCFieldSplit.
- PBPPhysics-based preconditioner (PBP) allows individual physics to have their own preconditioner.
- SMPSingle matrix preconditioner (SMP) builds a preconditioner using user defined off-diagonal parts of the Jacobian.
- VCPVarialble condensation preconditioner (VCP) condenses out specified variable(s) from the Jacobian matrix and produces a system of equations with less unkowns to be solved by the underlying preconditioners.
Problem
- Moose App
- CreateProblemActionAdd a Problem object to the simulation.
- DynamicObjectRegistrationActionRegister MooseObjects from other applications dynamically.
- DisplacedProblemA Problem object for providing access to the displaced finite element mesh and associated variables.
- DumpObjectsProblemSingle purpose problem object that does not run the given input but allows deconstructing actions into their series of underlying Moose objects and variables.
- EigenProblemProblem object for solving an eigenvalue problem.
- FEProblemA normal (default) Problem object that contains a single NonlinearSystem and a single AuxiliarySystem object.
- ReferenceResidualProblemProblem that checks for convergence relative to a user-supplied reference quantity rather than the initial residual
ProjectedStatefulMaterialStorage
- Moose App
- ProjectedStatefulMaterialStorageActionMark material properties for projected stateful storage.
Reactions
- Moose App
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
- Crane App
- AddZapdosReactionsThis Action automatically adds the necessary kernels and materials for a reaction network.
Reporters
- Moose App
- AddReporterActionAdd a Reporter object to the simulation.
- AccumulateReporterReporter which accumulates the value of a inputted reporter value over time into a vector reporter value of the same type.
- ConstantReporterReporter with constant values to be accessed by other objects, can be modified using transfers.
- ElementVariableStatisticsElement reporter to get statistics for a coupled variable. This can be transfered to other apps.
- ExtraIDIntegralReporterThis ExtraIDIntegralReporter source code is to integrate variables based on parsed extra IDs based on reporter system.
- IterationInfoReport the time and iteration information for the simulation.
- MeshInfoReport mesh information, such as the number of elements, nodes, and degrees of freedom.
- MeshMetaDataReporterReports the mesh meta data.
- NodalVariableStatisticsNodal reporter to get statistics for a coupled variable. This can be transfered to other apps.
- PerfGraphReporterReports the full performance graph from the PerfGraph.
- RestartableDataReporterReports restartable data and restartable meta data.
- SolutionInvalidityReporterReports the Summary Table of Solution Invalid Counts.
Samplers
- Moose App
- AddSamplerActionAdd a Sampler object to the simulation.
ScalarKernels
- Moose App
- AddScalarKernelActionAdd a AuxScalarKernel object to the simulation.
- ADScalarTimeDerivativeAdds the time derivative contribution to the residual for a scalar variable.
- AverageValueConstraintThis class is used to enforce integral of phi with a Lagrange multiplier approach.
- CoupledODETimeDerivativeResidual contribution of ODE from the time derivative of a coupled variable.
- NodalEqualValueConstraintConstrain two nodes to have identical values.
- NullScalarKernelScalar kernel that sets a zero residual, to avoid error from system missing this variable.
- ODETimeDerivativeReturns the time derivative contribution to the residual for a scalar variable.
- ParsedODEKernelParsed expression ODE kernel.
- Crane App
- EnergyTermScalar
- LogStabilizationScalar
- ODETimeDerivativeLog
- ODETimeDerivativeTemperature
- ParsedScalarReactionParsed expression ODE kernel.
- Product1BodyScalar
- Product1BodyScalarLog
- Product2BodyScalar
- Product2BodyScalarLog
- Product3BodyScalar
- Product3BodyScalarLog
- Reactant1BodyScalar
- Reactant1BodyScalarLog
- Reactant2BodyScalar
- Reactant2BodyScalarLog
- Reactant3BodyScalar
- Reactant3BodyScalarLog
- ScalarDiffusion
Times
- Moose App
- AddTimesActionAdd a Times object to the simulation.
- CSVFileTimesImport times from one or more files.
- ExodusFileTimesImport times from one or more Exodus files.
- FunctorTimesTimes created by evaluating a functor at the (0,0,0) point and the current time
- InputTimesTimes set directly from a user parameter in the input file
- ReporterTimesImport times from one or more reporters, for example other Times
- SimulationTimesTimes simulated
- TimeIntervalTimesTimes between a start time and end time with a fixed time interval.
Transfers
- Moose App
- AddTransferActionAdd a Transfer object to the simulation.
- MultiAppCloneReporterTransferDeclare and transfer reporter data from sub-application(s) to main application.
- MultiAppCopyTransferCopies variables (nonlinear and auxiliary) between multiapps that have identical meshes.
- MultiAppGeneralFieldNearestLocationTransferTransfers field data at the MultiApp position by finding the value at the nearest neighbor(s) in the origin application.
- MultiAppGeneralFieldNearestNodeTransferTransfers field data at the MultiApp position by finding the value at the nearest neighbor(s) in the origin application.
- MultiAppGeneralFieldShapeEvaluationTransferTransfers field data at the MultiApp position using the finite element shape functions from the origin application.
- MultiAppGeneralFieldUserObjectTransferTransfers user object spatial evaluations from an origin app onto a variable in the target application.
- MultiAppGeometricInterpolationTransferTransfers the value to the target domain from a combination/interpolation of the values on the nearest nodes in the source domain, using coefficients based on the distance to each node.
- MultiAppInterpolationTransferTransfers the value to the target domain from a combination/interpolation of the values on the nearest nodes in the source domain, using coefficients based on the distance to each node.
- MultiAppMeshFunctionTransferTransfers field data at the MultiApp position using solution the finite element function from the main/parent application, via a 'libMesh::MeshFunction' object.
- MultiAppNearestNodeTransferTransfer the value to the target domain from the nearest node in the source domain.
- MultiAppPostprocessorInterpolationTransferTransfer postprocessor data from sub-application into field data on the parent application.
- MultiAppPostprocessorToAuxScalarTransferTransfers from a postprocessor to a scalar auxiliary variable.
- MultiAppPostprocessorTransferTransfers postprocessor data between the master application and sub-application(s).
- MultiAppProjectionTransferPerform a projection between a master and sub-application mesh of a field variable.
- MultiAppReporterTransferTransfers reporter data between two applications.
- MultiAppScalarToAuxScalarTransferTransfers data from a scalar variable to an auxiliary scalar variable from different applications.
- MultiAppShapeEvaluationTransferTransfers field data at the MultiApp position using solution the finite element function from the main/parent application, via a 'libMesh::MeshFunction' object.
- MultiAppUserObjectTransferSamples a variable's value in the Parent app domain at the point where the MultiApp is and copies that value into a post-processor in the MultiApp
- MultiAppVariableValueSamplePostprocessorTransferSamples the value of a variable within the main application at each sub-application position and transfers the value to a postprocessor on the sub-application(s) when performing the to-multiapp transfer. Reconstructs the value of a CONSTANT MONOMIAL variable associating the value of each element to the value of the postprocessor in the closest sub-application whem performing the from-multiapp transfer.
- MultiAppVariableValueSampleTransferTransfers the value of a variable within the master application at each sub-application position and transfers the value to a field variable on the sub-application(s).
- MultiAppVectorPostprocessorTransferThis transfer distributes the N values of a VectorPostprocessor to Postprocessors located in N sub-apps or collects Postprocessor values from N sub-apps into a VectorPostprocessor
UserObjects
- Moose App
- AddUserObjectActionAdd a UserObject object to the simulation.
- ADProjectedStatefulMaterialNodalPatchRecoveryRankFourTensorPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ADProjectedStatefulMaterialNodalPatchRecoveryRankTwoTensorPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ADProjectedStatefulMaterialNodalPatchRecoveryRealPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ADProjectedStatefulMaterialNodalPatchRecoveryRealVectorValuePrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ActivateElementsByPathDetermine activated elements.
- ActivateElementsCoupledDetermine activated elements.
- BatchPropertyDerivativeRankTwoTensorRealThis user object gathers a material property used as a parameter in a NEML2 material model, and receives the corresponding derivatives of the model output with respect to the material property. This object is useful in the
optimization
module for material inversion problems. - CoupledVarThresholdElementSubdomainModifierModify the element subdomain ID if a coupled variable satisfies the criterion for the threshold (above, equal, or below)
- ElemSideNeighborLayersGeomTesterUser object to calculate ghosted elements on a single processor or the union across all processors.
- ElemSideNeighborLayersTesterUser object to calculate ghosted elements on a single processor or the union across all processors.
- ElementIntegralVariableUserObjectcomputes a volume integral of a variable.
- ElementPropertyReadFileUser Object to read property data from an external file and assign it to elements / nodes / subdomains etc.
- ElementQualityCheckerClass to check the quality of each element using different metrics from libmesh.
- FunctionElementIntegralUserObjectComputes a volume integral of a function.
- FunctionLayeredIntegralIntegrates a function in layers
- GeometrySphereSnap nodes to the surface of a sphere on adaptivity
- GhostingUserObjectCreates ghosting maps that can be queried by external objects.
- InterfaceQpMaterialPropertyRealUOComputes the value, rate or increment of a Real Material property across an interface. The value, rate or increment is computed according to the provided interface_value_type parameter
- InterfaceQpValueUserObjectComputes the variable value, rate or increment across an interface. The value, rate or increment is computed according to the provided interface_value_type parameter
- JSONFileReaderLoads a JSON file and makes it content available to consumers
- LayeredAverageComputes averages of variables over layers
- LayeredExtremumMaterialPropertyCompute material property extrema over layers.
- LayeredIntegralCompute variable integrals over layers.
- LayeredSideAverageComputes side averages of a variable storing partial sums for the specified number of intervals in a direction (x,y,z).
- LayeredSideAverageFunctorComputes layered side averages of a functor.
- LayeredSideDiffusiveFluxAverageComputes the diffusive flux of a variable on layers alongside a boundary.
- LayeredSideFluxAverageComputes the diffusive flux of a variable on layers alongside a boundary.
- LayeredSideIntegralComputes surface integral of a variable storing partial sums for the specified number of intervals in a direction (x,y,z).
- LayeredSideIntegralFunctorComputes layered side integrals of a functor.
- MessageFromInputPrint out a message from the input file
- NearestNodeNumberUOFinds and outputs the nearest node number to a point
- NearestPointAverageCompute element variable averages for nearest-point based subdomains
- NearestPointLayeredAverageComputes averages of a variable storing partial sums for the specified number of intervals in a direction (x,y,z). Given a list of points this object computes the layered average closest to each one of those points.
- NearestPointLayeredIntegralComputes integrals of a variable storing partial sums for the specified number of intervals in a direction (x,y,z). Given a list of points this object computes the layered integral closest to each one of those points.
- NearestPointLayeredSideAverageCompute layered side averages for nearest-point based subdomains
- NearestPointLayeredSideAverageFunctorComputes layered side averages of a functor nearest to a set of points.
- NearestPointLayeredSideDiffusiveFluxAverageCompute layered side diffusive flux averages for nearest-point based subdivisions
- NearestPointLayeredSideFluxAverageCompute layered side diffusive flux averages for nearest-point based subdivisions
- NearestPointLayeredSideIntegralCompute layered side integrals for nearest-point based sidesets
- NearestPointLayeredSideIntegralFunctorComputes layered side integrals of a functor nearest to a set of points.
- NearestRadiusLayeredAverageComputes averages of a variable storing partial sums for the specified number of intervals in a direction (x,y,z). Given a list of points this object computes the layered average closest to each one of those points, where the distance is computed in terms of radius (or distance to the origin in the plane perpendicular to 'direction').
- NodalNormalsCornerComputes nodal normals at boundary corners.
- NodalNormalsEvaluatorHelper object to compute nodal normal values via the NodalNormals input block.
- NodalNormalsPreprocessorAn object that prepares MOOSE for computing nodal normal vectors. This object is automatically created via the [NodalNormals] input block.
- NodalPatchRecoveryMaterialPropertyPrepare patches for use in nodal patch recovery based on a material property.
- PointwiseRenormalizeVectorPointwise renormalize the solution of a set of variables comprising a vector
- PostprocessorSpatialUserObjectUser object (spatial) that holds a postprocessor value.
- ProjectedStatefulMaterialNodalPatchRecoveryRankFourTensorPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ProjectedStatefulMaterialNodalPatchRecoveryRankTwoTensorPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ProjectedStatefulMaterialNodalPatchRecoveryRealPrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- ProjectedStatefulMaterialNodalPatchRecoveryRealVectorValuePrepare patches for use in nodal patch recovery based on a material property for material property states projected onto nodal variables.
- PropertyReadFileUser Object to read property data from an external file and assign it to elements / nodes / subdomains etc.
- RadialAveragePerform a radial average of a material property
- SidesetAroundSubdomainUpdaterSets up a boundary between inner_subdomains and outer_subdomains
- SolutionUserObjectReads a variable from a mesh in one simulation to another
- TerminatorRequests termination of the current solve based on the evaluation of a parsed logical expression of the Postprocessor value(s).
- TimedSubdomainModifierModify element subdomain ID of entire subdomains for given points in time. This mesh modifier only runs on the undisplaced mesh, and it will modify both the undisplaced and the displaced mesh.
- VariableValueElementSubdomainModifierModify the element subdomain ID based on the provided variable value.
- VerifyElementUniqueIDVerifies that all element ids are unique.
- VerifyNodalUniqueIDVerifies that all node ids are unique.
- Zapdos App
- CurrentDensityShapeSideUserObjectCalculates the total current at a boundary
- ProvideMobilityDefines ballast resistance and the area of an electrode(Used with Circuit BCs)
- Crane App
- BoltzmannSolverScalar
- ObjTest
- PolynomialCoefficients
- RateCoefficientProvider
- ValueProvider
- Squirrel App
- DenomShapeSideUserObject
- NumShapeSideUserObject
Variables
- Moose App
- AddVariableActionAdd a non-linear variable to the simulation.
- CopyNodalVarsActionCopies variable information from a file.
- ArrayMooseVariableUsed for grouping standard field variables with the same finite element family and order
- MooseLinearVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableRepresents standard field variables, e.g. Lagrange, Hermite, or non-constant Monomials
- MooseVariableBaseBase class for Moose variables. This should never be the terminal object type
- MooseVariableConstMonomialSpecialization for constant monomials that avoids unnecessary loops
- MooseVariableFVRealBase class for Moose variables. This should never be the terminal object type
- MooseVariableScalarMoose wrapper class around scalar variables
- VectorMooseVariableRepresents vector field variables, e.g. Vector Lagrange, Nedelec or Raviart-Thomas
VectorPostprocessors
- Moose App
- AddVectorPostprocessorActionAdd a VectorPostprocessor object to the simulation.
- CSVReaderConverts columns of a CSV file into vectors of a VectorPostprocessor.
- CSVReaderVectorPostprocessorConverts columns of a CSV file into vectors of a VectorPostprocessor.
- ConstantVectorPostprocessorPopulate constant VectorPostprocessorValue directly from input file.
- CylindricalAverageCompute a cylindrical average of a variableas a function of radius throughout the simulation domain.
- EigenvaluesReturns the Eigen values from the nonlinear Eigen system.
- ElementMaterialSamplerRecords all Real-valued material properties of a material object on quadrature points on elements at the indicated execution points.
- ElementValueSamplerSamples values of elemental variable(s).
- ElementVariablesDifferenceMaxComputes the largest difference between two variable fields.
- ElementsAlongLineOutputs the IDs of every element intersected by a user-defined line
- ElementsAlongPlaneOutputs the IDs of every element intersected by a user-defined plane
- ExtraIDIntegralVectorPostprocessorIntegrates or averages variables based on extra element IDs
- HistogramVectorPostprocessorCompute a histogram for each column of a VectorPostprocessor
- IntersectionPointsAlongLineGet the intersection points for all of the elements that are intersected by a line.
- LeastSquaresFitPerforms a polynomial least squares fit on the data contained in another VectorPostprocessor
- LeastSquaresFitHistoryPerforms a polynomial least squares fit on the data contained in another VectorPostprocessor and stores the full time history of the coefficients
- LineFunctionSamplerSample one or more functions along a line.
- LineMaterialRealSamplerSamples real-valued material properties for all quadrature points in all elements that are intersected by a specified line
- LineValueSamplerSamples variable(s) along a specified line
- MaterialVectorPostprocessorRecords all Real-valued material properties of a material object on quadrature points on elements at the indicated execution points.
- MeshDivisionFunctorReductionVectorPostprocessorPerform reductions on functors based on a per-mesh-division basis
- NearestPointIntegralVariablePostprocessorCompute element variable integrals for nearest-point based subdomains
- NodalValueSamplerSamples values of nodal variable(s).
- PointValueSamplerSample a variable at specific points.
- PositionsFunctorValueSamplerSample one or more functors at points specified by a Positions object.
- SideValueSamplerSample variable(s) along a sideset, internal or external.
- SidesetInfoVectorPostprocessorThis VectorPostprocessor collects meta data for provided sidesets.
- SpatialUserObjectVectorPostprocessorOutputs the values of a spatial user object in the order of the specified spatial points
- SphericalAverageCompute a spherical average of a variable as a function of radius throughout the simulation domain.
- VariableValueVolumeHistogramCompute a histogram of volume fractions binned according to variable values.
- VectorMemoryUsageGet memory stats for all ranks in the simulation
- VectorOfPostprocessorsOutputs the values of an arbitrary user-specified set of postprocessors as a vector in the order specified by the user
- VolumeHistogramCompute a histogram of volume fractions binned according to variable values.
- WorkBalanceComputes several metrics for workload balance per processor
- Squirrel App
- ChannelGradientTakes the difference between two line value samplers; useful for calculating macroscopically averaged gradients
References
- Richard G Forbes.
Simple good approximations for the special elliptic functions in standard fowler-nordheim tunneling theory for a schottky-nordheim barrier.
Applied physics letters, 2006.
doi:10.1063/1.2354582.[BibTeX]
- Richard G Forbes.
Physics of generalized fowler-nordheim-type equations.
Journal of Vacuum Science & Technology B: Microelectronics and Nanometer Structures Processing, Measurement, and Phenomena, 26(2):788–793, 2008.
doi:10.1116/1.2827505.[BibTeX]
- David B Go.
Theoretical analysis of ion-enhanced thermionic emission for low-temperature, non-equilibrium gas discharges.
Journal of Physics D: Applied Physics, 46(3):035202, 2012.
doi:10.1088/0022-3727/46/3/035202.[BibTeX]
- GJM Hagelaar, FJ De Hoog, and GMW Kroesen.
Boundary conditions in fluid models of gas discharges.
Physical Review E, 62(1):1452, 2000.
doi:10.1103/PhysRevE.62.1452.[BibTeX]
- Dimitris P Lymberopoulos and Demetre J Economou.
Modeling and simulation of glow discharge plasma reactors.
Journal of Vacuum Science & Technology A: Vacuum, Surfaces, and Films, 12(4):1229–1236, 1994.
doi:10.1116/1.579300.[BibTeX]
- Dimitris P. Lymberopoulos and Demetre J. Economou.
Fluid simulations of glow discharges: effect of metastable atoms in argon.
Journal of Applied Physics, 73(8):3668–3679, 04 1993.
doi:10.1063/1.352926.[BibTeX]
- Y Sakiyama and David B Graves.
Corona-glow transition in the atmospheric pressure rf-excited plasma needle.
Journal of Physics D: Applied Physics, 39(16):3644, 2006.
doi:10.1088/0022-3727/39/16/018.[BibTeX]
- Yukinori Sakiyama and David B Graves.
Nonthermal atmospheric rf plasma in one-dimensional spherical coordinates: asymmetric sheath structure and the discharge mechanism.
Journal of applied physics, 2007.
doi:https://doi.org/10.1063/1.2715745.[BibTeX]