https://mooseframework.inl.gov
Classes | Namespaces | Functions | Variables
MooseError.h File Reference

Go to the source code of this file.

Classes

class  MooseRuntimeError
 Exception to be thrown whenever we have _throw_on_error set and a mooseError() is emitted. More...
 

Namespaces

 MetaPhysicL
 We need to instantiate the following CompareTypes to tell the compiler that ADReal is a subtype of ChainedADReal.
 
 hit
 
 moose
 
 moose::internal
 

Functions

template<size_t n, typename... T>
void print_tuple (std::ostream &os, const std::tuple< T... > &tup)
 
template<typename... T>
std::ostream & operator<< (std::ostream &os, const std::tuple< T... > &tup)
 
template<typename... Args>
void mooseError (Args &&... args)
 Emit an error message with the given stringified, concatenated args and terminate the application. More...
 
std::string moose::internal::incompatVarMsg (MooseVariableFieldBase &var1, MooseVariableFieldBase &var2)
 Builds and returns a string of the form: More...
 
std::string moose::internal::mooseMsgFmt (const std::string &msg, const std::string &title, const std::string &color)
 Format a message for output with a title. More...
 
std::string moose::internal::mooseMsgFmt (const std::string &msg, const std::string &color)
 Format a message for output without a title. More...
 
void moose::internal::mooseErrorRaw (std::string msg, const std::string &prefix="", const hit::Node *node=nullptr)
 Main callback for emitting a moose error. More...
 
std::string moose::internal::formatMooseDocumentedError (const std::string &repo_name, const unsigned int issue_num, const std::string &msg)
 Formats a documented error. More...
 
void moose::translateMetaPhysicLError (const MetaPhysicL::LogicError &)
 emit a relatively clear error message when we catch a MetaPhysicL logic error More...
 
template<typename... Args>
void mooseDocumentedError (const std::string &repo_name, const unsigned int issue_num, Args &&... args)
 Emit a documented error message with the given stringified, concatenated args and terminate the application. More...
 
template<typename... Args>
void mooseWarning (Args &&... args)
 Emit a warning message with the given stringified, concatenated args. More...
 
template<typename... Args>
void mooseUnused (Args &&... args)
 Warning message used to notify the users of unused parts of their input files Really used internally by the parser and shouldn't really be called elsewhere. More...
 
template<typename... Args>
void mooseDeprecated (Args &&... args)
 Emit a deprecated code/feature message with the given stringified, concatenated args. More...
 
template<typename... Args>
void mooseDeprecationExpired (Args &&... args)
 Emit a deprecated code/feature message with the given stringified, concatenated args. More...
 
template<typename... Args>
void mooseInfo (Args &&... args)
 Emit an informational message with the given stringified, concatenated args. More...
 
template<typename... Args>
void mooseInfoRepeated (Args &&... args)
 Emit an informational message with the given stringified, concatenated args. More...
 
void moose::internal::mooseStreamAll (std::ostringstream &ss)
 All of the following are not meant to be called directly - they are called by the normal macros (mooseError(), etc.) down below. More...
 
template<typename T , typename... Args>
void moose::internal::mooseStreamAll (std::ostringstream &ss, T &&val, Args &&... args)
 
template<typename S , typename... Args>
void moose::internal::mooseWarningStream (S &oss, Args &&... args)
 
template<typename S , typename... Args>
void moose::internal::mooseUnusedStream (S &oss, Args &&... args)
 
template<typename S , typename... Args>
void moose::internal::mooseInfoStreamRepeated (S &oss, Args &&... args)
 
template<typename S , typename... Args>
void moose::internal::mooseInfoStream (S &oss, Args &&... args)
 
template<typename S , typename... Args>
void moose::internal::mooseDeprecatedStream (S &oss, const bool expired, const bool print_title, Args &&... args)
 

Variables

libMesh::Threads::spin_mutex moose::internal::moose_stream_lock
 

Function Documentation

◆ mooseDeprecated()

template<typename... Args>
void mooseDeprecated ( Args &&...  args)

Emit a deprecated code/feature message with the given stringified, concatenated args.

Definition at line 374 of file MooseError.h.

Referenced by Registry::addDeprecatedAppDataFilePath(), InputParameters::addDeprecatedCoupledVar(), Coupleable::adZeroGradient(), Coupleable::adZeroSecond(), Coupleable::adZeroValue(), MultiMooseEnum::clear(), NonlinearSystemBase::computeResidual(), AppFactory::createAppShared(), Factory::createUnique(), Factory::deprecatedMessage(), MooseVariableFE< Real >::dofValue(), MultiMooseEnum::erase(), MultiMooseEnum::getEnum(), Coupleable::getFEVar(), Registry::getRegisteredName(), Syntax::isActionRequired(), MooseEnum::operator!=(), MultiMooseEnum::operator+=(), MooseEnum::operator==(), InputParameters::paramSetByUser(), ActionWarehouse::problem(), DerivativeMaterialPropertyNameInterface::propertyName(), DerivativeMaterialPropertyNameInterface::propertyNameFirst(), DerivativeMaterialPropertyNameInterface::propertyNameSecond(), DerivativeMaterialPropertyNameInterface::propertyNameThird(), MultiMooseEnum::push_back(), RankTwoTensorTempl< Real >::RankTwoTensorTempl(), Moose::registerActions(), NonlinearSystemBase::residualVector(), PointReduction::sqr(), TimedPrint::TimedPrint(), Syntax::verifyMooseObjectTask(), Moose::Builder::walkRaw(), and Coupleable::writableCoupledValue().

375 {
376  moose::internal::mooseDeprecatedStream(Moose::out, false, true, std::forward<Args>(args)...);
377 }
void mooseDeprecatedStream(S &oss, const bool expired, const bool print_title, Args &&... args)
Definition: MooseError.h:265

◆ mooseDeprecationExpired()

template<typename... Args>
void mooseDeprecationExpired ( Args &&...  args)

Emit a deprecated code/feature message with the given stringified, concatenated args.

Definition at line 382 of file MooseError.h.

Referenced by Factory::deprecatedMessage().

383 {
384  moose::internal::mooseDeprecatedStream(Moose::out, true, true, std::forward<Args>(args)...);
385 }
void mooseDeprecatedStream(S &oss, const bool expired, const bool print_title, Args &&... args)
Definition: MooseError.h:265

◆ mooseDocumentedError()

template<typename... Args>
void mooseDocumentedError ( const std::string &  repo_name,
const unsigned int  issue_num,
Args &&...  args 
)

Emit a documented error message with the given stringified, concatenated args and terminate the application.

Inside static functions, you will need to explicitly scope your mooseError call - i.e. do "::mooseError(arg1, ...);".

Here, a documented error message is one with an associated issue. See formatMooseDocumentedError for more information.

Parameters
repo_nameThe repository name where the issue resides
issue_numThe number of the issue
argsThe error message to stringify

Definition at line 344 of file MooseError.h.

345 {
346  std::ostringstream oss;
347  moose::internal::mooseStreamAll(oss, std::forward<Args>(args)...);
349  moose::internal::formatMooseDocumentedError(repo_name, issue_num, oss.str()));
350 }
void mooseStreamAll(std::ostringstream &ss)
All of the following are not meant to be called directly - they are called by the normal macros (moos...
Definition: MooseError.C:123
void mooseErrorRaw(std::string msg, const std::string &prefix="", const hit::Node *node=nullptr)
Main callback for emitting a moose error.
Definition: MooseError.C:53
std::string formatMooseDocumentedError(const std::string &repo_name, const unsigned int issue_num, const std::string &msg)
Formats a documented error.
Definition: MooseError.C:128

◆ mooseError()

template<typename... Args>
void mooseError ( Args &&...  args)

Emit an error message with the given stringified, concatenated args and terminate the application.

Inside static functions, you will need to explicitly scope your mooseError call - i.e. do "::mooseError(arg1, ...);".

Definition at line 323 of file MooseError.h.

Referenced by Coupleable::adCoupledCurl(), Coupleable::adCoupledDofValues(), Coupleable::adCoupledDot(), Coupleable::adCoupledDotDot(), Coupleable::adCoupledGradient(), Coupleable::adCoupledGradientDot(), Coupleable::adCoupledLowerValue(), NeighborCoupleable::adCoupledNeighborGradient(), NeighborCoupleable::adCoupledNeighborValue(), NeighborCoupleable::adCoupledNeighborValueDot(), Coupleable::adCoupledNodalValue(), ScalarCoupleable::adCoupledScalarValue(), Coupleable::adCoupledSecond(), Coupleable::adCoupledValue(), Coupleable::adCoupledVectorDot(), Coupleable::adCoupledVectorGradient(), NeighborCoupleable::adCoupledVectorNeighborValue(), adCoupledVectorSecond(), Coupleable::adCoupledVectorValue(), Moose::Capabilities::add(), Moose::ParameterRegistry::add(), VariableWarehouse::add(), Moose::WebServerControlTypeRegistry::add(), MooseLinearVariableFV< Real >::add(), ActionWarehouse::addActionBlock(), NonlinearSystemBase::addBoundaryCondition(), Moose::MFEM::CoefficientMap< mfem::MatrixCoefficient, mfem::PWMatrixCoefficient >::addCoefficient(), InputParameterWarehouse::addControllableParameterAlias(), InputParameterWarehouse::addControllableParameterConnection(), NonlinearSystemBase::addDamper(), FormattedTable::addData(), Registry::addDataFilePath(), Syntax::addDependency(), InputParameters::addDeprecatedParam(), MooseEnumBase::addDocumentation(), MooseEnumBase::addEnumerationItem(), MooseEnumBase::addEnumerationName(), FunctionParserUtils< false >::addFParserConstants(), NonlinearSystemBase::addImplicitGeometricCouplingEntries(), InputParameterWarehouse::addInputParameters(), AuxiliarySystem::addKernel(), Moose::LibtorchArtificialNeuralNet::addLayer(), SystemBase::addMatrix(), InitialConditionWarehouse::addObject(), FVInitialConditionWarehouse::addObject(), ConstraintWarehouse::addObject(), ExecuteMooseObjectWarehouse< Transfer >::addObject(), OutputWarehouse::addOutputFilename(), InputParameters::addParam(), Moose::PetscSupport::addPetscFlagsToPetscOptions(), Moose::MFEM::CoefficientMap< mfem::MatrixCoefficient, mfem::PWMatrixCoefficient >::addPiecewiseBlocks(), InputParameters::addPrivateParam(), MaterialPropertyStorage::addProperty(), Registry::addRepository(), SystemBase::addVariable(), MooseVariableData< OutputType >::adGradPhi(), MooseVariableData< OutputType >::adGradPhiFace(), MooseVariableDataFV< OutputType >::adGradSlnDot(), ADMaterialProperty< Real >::ADMaterialProperty(), Moose::adOffset(), AllLocalDofIndicesThread::AllLocalDofIndicesThread(), ExecFlagEnum::appendCurrent(), MeshGeneratorSystem::appendMeshGenerator(), Syntax::appendTaskName(), Registry::appNameFromAppPath(), NEML2Utils::assertNEML2Enabled(), NEML2Utils::assertOldVariable(), NEML2Utils::assertVariable(), MooseEnum::assign(), MultiMooseEnum::assignValues(), SystemBase::associateMatrixToTag(), SystemBase::associateVectorToTag(), TheWarehouse::attribID(), LinearSystem::augmentSparsity(), MFEMBoundaryRestrictable::boundariesToAttributes(), boundaryIntegrityCheckError(), MooseMeshXYCuttingUtils::boundaryTriElemImprover(), ReporterContext< std::vector< T > >::broadcast(), RegistryEntry< T >::build(), Moose::FV::Limiter< T >::build(), RegistryEntry< T >::buildAction(), MooseMeshUtils::buildBoundaryMesh(), CommandLine::buildHitParams(), AutomaticMortarGeneration::buildMortarSegmentMesh(), AutomaticMortarGeneration::buildMortarSegmentMesh3d(), AutomaticMortarGeneration::buildNodeToElemMaps(), ParsedFunctorMaterialTempl< is_ad >::buildParsedFunction(), MooseObjectParameterName::check(), MooseObjectName::check(), ReporterData::check(), MaterialPropertyInterface::checkBlockAndBoundaryCompatibility(), DM_Moose::checkChildSize(), ControllableParameter::checkExecuteOnType(), MaterialPropertyInterface::checkExecutionStage(), Moose::FunctorBase< libMesh::VectorValue >::checkFace(), MooseUtils::checkFileReadable(), MooseUtils::checkFileWriteable(), FunctorInterface::checkFunctorSupportsSideIntegration(), Coupleable::checkFuncType(), Moose::MFEM::ScaleIntegrator::CheckIntegrator(), NonlinearEigenSystem::checkIntegrity(), NonlinearSystemBase::checkKernelCoverage(), MeshBaseDiagnosticsUtils::checkNonConformalMesh(), OutputWarehouse::checkOutputs(), ColumnMajorMatrixTempl< Real >::checkShapeEquality(), checkSize(), ColumnMajorMatrixTempl< Real >::checkSquareness(), ActionWarehouse::checkUnsatisfiedActions(), ScalarCoupleable::checkVar(), Coupleable::checkVar(), BlockRestrictable::checkVariable(), Coupleable::checkWritableVar(), MathUtils::circumcenter2D(), MathUtils::circumcenter3D(), ReporterGeneralContext< T >::clear(), AppFactory::clearAppParams(), MooseUtils::clearSymlink(), FunctionPeriodicBoundary::clone(), Factory::clone(), SystemBase::closeTaggedVector(), PenetrationThread::competeInteractions(), CompositeTensorBase< T, U >::CompositeTensorBase(), ComputeJacobianThread::compute(), AuxKernelTempl< Real >::compute(), MooseVariableData< OutputType >::computeAD(), SplineInterpolationBase::computeCoeffs(), ADInterfaceKernelTempl< T >::computeElemNeighJacobian(), InterfaceKernelTempl< T >::computeElemNeighJacobian(), Assembly::computeFaceMap(), MooseVariableFV< Real >::computeFaceValues(), AutomaticMortarGeneration::computeInactiveLMNodes(), AutomaticMortarGeneration::computeIncorrectEdgeDroppingInactiveLMNodes(), MooseVariableData< OutputType >::computeIncrementAtNode(), ADIntegratedBCTempl< T >::computeJacobian(), ADKernelTempl< T >::computeJacobian(), Moose::LibtorchArtificialNeuralNetTrainer< SamplerType >::computeLocalBatchSize(), SideAdvectiveFluxIntegralTempl< is_ad >::computeQpIntegral(), EqualValueEmbeddedConstraintTempl< is_ad >::computeQpJacobian(), PenaltyEqualValueConstraintTempl< is_ad >::computeQpJacobian(), ConservativeAdvectionTempl< is_ad >::computeQpJacobian(), EqualValueEmbeddedConstraintTempl< is_ad >::computeQpOffDiagJacobian(), ADKernelGradTempl< T >::computeQpResidual(), ADKernelValueTempl< T >::computeQpResidual(), ADKernelStabilizedTempl< T >::computeQpResidual(), InterfaceQpMaterialPropertyBaseUserObject< Real >::computeRealValue(), NonlinearSystemBase::computeScaling(), ControllableItem::connect(), NonlinearSystemBase::constraintJacobians(), MooseUnits::convert(), MooseUtils::convert(), MooseMeshElementConversionUtils::convert3DMeshToAllTet4(), MooseMeshUtils::convertBlockToMesh(), MemoryUtils::convertBytes(), MooseUtils::convertLatestCheckpoint(), MooseMeshUtils::coordTransformFactor(), Factory::copyConstruct(), Assembly::copyFaceShapes(), Assembly::copyNeighborShapes(), Assembly::copyShapes(), NEML2Utils::copyTensorToMOOSEData(), SystemBase::copyVars(), LazyCoupleable::coupled(), NeighborCoupleable::coupledArrayNeighborGradient(), NeighborCoupleable::coupledArrayNeighborGradientOld(), NeighborCoupleable::coupledArrayNeighborGradientOlder(), AuxKernelTempl< Real >::coupledDot(), AuxKernelTempl< Real >::coupledDotDu(), Coupleable::coupledMatrixTagValue(), Coupleable::coupledMatrixTagValues(), Coupleable::coupledName(), NeighborCoupleable::coupledNeighborDofValues(), NeighborCoupleable::coupledNeighborDofValuesOld(), NeighborCoupleable::coupledNeighborDofValuesOlder(), NeighborCoupleable::coupledNeighborGradient(), NeighborCoupleable::coupledNeighborGradientOld(), NeighborCoupleable::coupledNeighborGradientOlder(), NeighborCoupleable::coupledNeighborSecond(), NeighborCoupleable::coupledNeighborValueOlder(), Coupleable::coupledNodalDot(), Coupleable::coupledNodalValue(), Coupleable::coupledNodalValueOld(), Coupleable::coupledNodalValueOlder(), ScalarCoupleable::coupledScalarComponents(), ScalarCoupleable::coupledScalarValueOlder(), Coupleable::coupledValueLower(), NeighborCoupleable::coupledVectorNeighborGradient(), NeighborCoupleable::coupledVectorNeighborGradientOld(), NeighborCoupleable::coupledVectorNeighborGradientOlder(), Coupleable::coupledVectorTagArrayGradient(), Coupleable::coupledVectorTagArrayGradients(), Coupleable::coupledVectorTagArrayValues(), Coupleable::coupledVectorTagDofValues(), Coupleable::coupledVectorTagGradient(), Coupleable::coupledVectorTagGradients(), ScalarCoupleable::coupledVectorTagScalarValue(), Coupleable::coupledVectorTagValues(), ActionFactory::create(), AppFactory::create(), MeshGeneratorSystem::createAddedMeshGenerators(), AppFactory::createdAppCount(), MeshGeneratorSystem::createMeshGeneratorOrder(), Moose::createMooseApp(), MortarData::createMortarInterface(), MooseMeshUtils::createSubdomainFromSidesets(), MooseUtils::createSymlink(), Factory::createUnique(), MooseLinearVariableFV< Real >::curlPhi(), MooseVariableDataFV< OutputType >::curlSln(), MooseVariableData< OutputType >::curlSln(), DependencyResolverInterface::cyclicDependencyError(), CyclicDependencyException< T, Compare >::CyclicDependencyException(), RankTwoTensorTempl< Real >::d2sin3Lode(), RestartableDataMap::data(), dataLoad(), dataStore(), ChainControlDataSystem::declareChainControlData(), ReporterVectorContext< T >::declareClone(), Moose::MFEM::CoefficientManager::declareMatrixProperty(), Moose::MFEM::CoefficientManager::declareScalarProperty(), ReporterVectorContext< T >::declareVectorClone(), Moose::MFEM::CoefficientManager::declareVectorProperty(), FunctorInterface::deduceFunctorName(), Syntax::deleteTaskDependencies(), MooseEnumBase::deprecate(), Syntax::deprecatedActionSyntaxMessage(), RestartableDataReader::deserializeValue(), Registry::determineDataFilePath(), ComputeResidualAndJacobianThread::determineObjectWarehouses(), SystemBase::disassociateMatrixFromTag(), SystemBase::disassociateVectorFromTag(), MooseLinearVariableFV< Real >::divPhi(), MooseVariableData< OutputType >::divSln(), DMMooseFunction(), DMMooseGetEmbedding_Private(), DMMooseJacobian(), DMSetUp_Moose_Pre(), MooseVariableDataFV< OutputType >::dofValuesDot(), MooseVariableData< OutputType >::dofValuesDot(), MooseVariableDataFV< OutputType >::dofValuesDotDot(), MooseVariableData< OutputType >::dofValuesDotDot(), MooseVariableDataFV< OutputType >::dofValuesDotDotOld(), MooseVariableData< OutputType >::dofValuesDotDotOld(), MooseVariableDataFV< OutputType >::dofValuesDotOld(), MooseVariableData< OutputType >::dofValuesDotOld(), SymmetricRankTwoTensorTempl< Real >::dsin3Lode(), RankTwoTensorTempl< Real >::dsin3Lode(), Moose::Capabilities::dump(), ColumnMajorMatrixTempl< Real >::eigen(), ColumnMajorMatrixTempl< Real >::eigenNonsym(), NonlinearSystemBase::enforceNodalConstraintsJacobian(), BicubicInterpolation::errorCheck(), FileRangeBuilder::errorCheck(), SplineInterpolation::errorCheck(), BicubicSplineInterpolation::errorCheck(), Moose::Builder::errorCheck(), ADFParser::Eval(), GeneralFieldTransfer::RecordRequests< Output >::eval_mixed_derivatives(), GeneralFieldTransfer::CachedData< Output >::eval_mixed_derivatives(), GeneralFieldTransfer::RecordRequests< Output >::eval_old_dofs(), GeneralFieldTransfer::CachedData< Output >::eval_old_dofs(), FunctionParserUtils< false >::evaluate(), PiecewiseByBlockLambdaFunctor< T >::evaluate(), evaluate(), MooseLinearVariableFV< Real >::evaluate(), MooseVariableFE< Real >::evaluate(), Moose::NullFunctor< T >::evaluate(), Moose::FunctorBase< libMesh::VectorValue >::evaluateDot(), MooseVariableFV< Real >::evaluateDot(), GriddedData::evaluateFcn(), Moose::FunctorBase< libMesh::VectorValue >::evaluateGradDot(), Moose::FunctorBase< libMesh::VectorValue >::evaluateGradient(), MooseVariableFE< Real >::faceEvaluate(), FactorizedRankTwoTensorTempl< T >::FactorizedRankTwoTensorTempl(), Moose::fe_lagrange_1D_shape(), Moose::fe_lagrange_1D_shape_deriv(), Moose::fe_lagrange_2D_shape(), Moose::fe_lagrange_2D_shape_deriv(), MooseVariableData< OutputType >::fetchADNodalValues(), FieldSplitPreconditionerTempl< MoosePreconditioner >::FieldSplitPreconditionerTempl(), MooseVariableField< Real >::fieldType(), FileRangeBuilder::FileRangeBuilder(), ColumnMajorMatrixTempl< Real >::fill(), RankFourTensorTempl< T >::fillAntisymmetricFromInputVector(), RankFourTensorTempl< T >::fillAntisymmetricIsotropicFromInputVector(), FillBetweenPointVectorsTools::fillBetweenPointVectorsGenerator(), SymmetricRankTwoTensorTempl< Real >::fillFromInputVector(), RankThreeTensorTempl< T >::fillFromInputVector(), SymmetricRankFourTensorTempl< T >::fillFromInputVector(), RankFourTensorTempl< T >::fillFromInputVector(), RankTwoTensorTempl< Real >::fillFromInputVector(), SymmetricRankTwoTensorTempl< Real >::fillFromScalarVariable(), RankTwoTensorTempl< Real >::fillFromScalarVariable(), RankThreeTensorTempl< T >::fillGeneralFromInputVector(), RankFourTensorTempl< T >::fillGeneralFromInputVector(), RankFourTensorTempl< T >::fillGeneralIsotropicFromInputVector(), SymmetricRankFourTensorTempl< T >::fillGeneralOrthotropicFromInputVector(), RankFourTensorTempl< T >::fillGeneralOrthotropicFromInputVector(), NearestPointBase< LayeredSideDiffusiveFluxAverage, SideIntegralVariableUserObject >::fillPoints(), SymmetricRankFourTensorTempl< T >::fillPrincipalFromInputVector(), RankFourTensorTempl< T >::fillPrincipalFromInputVector(), SymmetricRankFourTensorTempl< T >::fillSymmetricIsotropicEandNuFromInputVector(), RankFourTensorTempl< T >::fillSymmetricIsotropicEandNuFromInputVector(), SamplerBase::finalize(), VectorPostprocessorContext< T >::finalize(), ReporterContext< std::vector< T > >::finalize(), CommandLine::findCommandLineParam(), NearestNodeLocator::findNodes(), DiracKernelInfo::findPoint(), MultiIndex< Real >::flatIndex(), FormattedTable::FormattedTable(), FunctionPeriodicBoundary::FunctionPeriodicBoundary(), FunctionParserUtils< false >::functionsOptimize(), LeastSquaresFitBase::generate(), GeometricSearchData::GeometricSearchData(), FileInputStream::get(), ControllableItem::get(), Moose::WebServerControlTypeRegistry::get(), FunctionPeriodicBoundary::get_corresponding_pos(), ActionWarehouse::getAction(), ActionWarehouse::getActionByTask(), MooseObjectWarehouseBase< Indicator >::getActiveObject(), AppFactory::getAppParams(), AppFactory::getAppParamsID(), BlockRestrictable::getBlockCoordSystem(), MaterialPropertyInterface::getBlockMaterialProperty(), MooseVariableFV< Real >::getBoundaryFaceValue(), MooseMeshUtils::getBoundaryIDs(), ChainControlDataBase::getChainControl(), ChainControlDataSystem::getChainControlData(), MooseServer::getCheckApp(), Moose::MFEM::CoefficientMap< mfem::MatrixCoefficient, mfem::PWMatrixCoefficient >::getCoefficientPtr(), Parser::getCommandLineRoot(), NonlinearEigenSystem::getConvergedEigenpair(), NonlinearEigenSystem::getConvergedEigenvalue(), NonlinearEigenSystem::getCurrentNonlinearIterationNumber(), MooseUtils::DelimitedFileReaderTempl< T >::getData(), MooseUtils::DelimitedFileReaderTempl< T >::getDataAsPoints(), Registry::getDataFilePath(), Coupleable::getDefaultValue(), DistributionInterface::getDistribution(), DistributionInterface::getDistributionByName(), MooseServer::getDocumentText(), MooseVariableDataFV< OutputType >::getElementalValue(), MooseVariableData< OutputType >::getElementalValue(), ElementIDInterface::getElementIDIndex(), ElementIDInterface::getElementIDIndexByName(), ElementPairLocator::getElemPairInfo(), ElementPairLocator::getElemPairs(), NonlinearEigenSystem::getEPS(), Moose::getExec(), NonlinearSystemBase::getFieldSplitPreconditioner(), MeshCoarseningUtils::getFineElementsFromInteriorNode(), VariableWarehouse::getFVVariable(), AuxKernelTempl< Real >::getGenericMaterialProperty(), RestartableDataReader::getHeader(), MortarData::getHigherDimSubdomainIDs(), MaterialPropertyRegistry::getID(), MooseMeshUtils::getIDFromName(), BatchMaterial< Tuple, Output, Input >::getIndex(), PenetrationThread::getInfoForFacesWithCommonNodes(), InputParameterWarehouse::getInputParameters(), FormattedTable::getLastData(), Parser::getLastInputFileName(), MooseUtils::getLatestCheckpointFilePrefix(), LayeredBase::getLayerValue(), AuxKernelTempl< Real >::getMaterialProperty(), AuxKernelTempl< Real >::getMaterialPropertyOld(), AuxKernelTempl< Real >::getMaterialPropertyOlder(), SystemBase::getMatrix(), MeshGeneratorSystem::getMeshGenerator(), MortarData::getMortarInterface(), MortarSegmentHelper::getMortarSegments(), MaterialPropertyRegistry::getName(), MooseVariableData< OutputType >::getNodalValue(), MooseObjectWarehouseBase< Indicator >::getObject(), MeshCoarseningUtils::getOppositeNodeIndex(), OutputWarehouse::getOutput(), Moose::DataFileUtils::getPath(), Moose::PetscSupport::getPetscKSPNormType(), Moose::PetscSupport::getPetscPCSide(), ActionWarehouse::getPhysics(), MaterialPropertyInterface::getPossiblyConstantGenericMaterialPropertyByName(), InterfaceValueTools::getQuantity(), ReporterData::getReporterContextBase(), ReporterData::getReporterStateBase(), ReporterData::getReporterStateHelper(), ReporterData::getReporterValue(), Registry::getRepositoryURL(), Parser::getRoot(), MooseServer::getRoot(), RankTwoTensorTempl< Real >::getRUDecompositionRotation(), SamplerInterface::getSamplerByName(), MeshGeneratorSystem::getSavedMesh(), Moose::MFEM::CoefficientManager::getScalarCoefficientPtr(), ScalarCoupleable::getScalarVar(), SystemBase::getScalarVariable(), PenetrationThread::getSideCornerNodes(), PenetrationThread::getSmoothingEdgeNodesAndWeights(), PenetrationThread::getSmoothingFacesAndWeights(), NonlinearSystem::getSNES(), NonlinearEigenSystem::getSNES(), Syntax::getSortedTask(), MooseMeshUtils::getSubdomainID(), MooseMeshUtils::getSubdomainIDs(), SystemBase::getTimeIntegrator(), ActionFactory::getValidParams(), AppFactory::getValidParams(), Coupleable::getVarHelper(), SystemBase::getVariable(), SystemBase::getVector(), Moose::MFEM::CoefficientManager::getVectorCoefficientPtr(), Coupleable::getVectorVar(), Moose::globalDofIndexToDerivative(), MooseVariableInterface< Real >::gradient(), MooseVariableInterface< Real >::gradientOld(), MooseVariableInterface< Real >::gradientOlder(), MooseVariableDataFV< OutputType >::gradSlnDot(), MooseVariableData< OutputType >::gradSlnDot(), MooseVariableDataFV< OutputType >::gradSlnDotDot(), MooseVariableData< OutputType >::gradSlnDotDot(), Moose::FV::greenGaussGradient(), Moose::FunctorBase< libMesh::VectorValue >::hasBlocks(), MooseUtils::hostname(), GeneralRegistry< std::string, PerfGraphSectionInfo >::id(), Moose::MFEM::TimeDomainEquationSystemProblemOperator::ImplicitSolve(), LazyCoupleable::init(), Moose::MFEM::EquationSystem::Init(), FunctionPeriodicBoundary::init(), MooseParsedFunctionWrapper::initialize(), BlockRestrictable::initializeBlockRestrictable(), BoundaryRestrictable::initializeBoundaryRestrictable(), ChainControlParsedFunctionWrapper::initializeFunctionInputs(), LinearSystem::initialSetup(), Moose::Builder::initSyntaxFormatter(), InputParameters::addDeprecatedParam< std::vector< MooseEnum > >(), InputParameters::addParam< std::vector< MooseEnum > >(), InputParameters::addParam< std::vector< MultiMooseEnum > >(), InputParameters::addRequiredParam< std::vector< MultiMooseEnum > >(), MooseUtils::StaticallyAllocatedSet< T, N >::insert(), MOOSEToNEML2::insertInto(), MooseLinearVariableFV< Real >::insertLower(), MooseUtils::installedInputsDir(), LayeredBase::integralValue(), Moose::FV::interpCoeffs(), Moose::FV::interpolate(), ColumnMajorMatrixTempl< Real >::inverse(), RankFourTensorTempl< T >::invSymm(), MooseVariableField< Real >::isArray(), RestartableDataReader::isAvailable(), Coupleable::isCoupled(), ScalarCoupleable::isCoupledScalar(), Moose::FunctorBase< libMesh::VectorValue >::isExtrapolatedBoundaryFace(), ActionWarehouse::isTaskComplete(), MortarSegmentInfo::isValid(), GeneralRegistry< std::string, PerfGraphSectionInfo >::itemNonLocking(), ADFParser::JITCompile(), LayeredBase::LayeredBase(), LayeredIntegralBase< ElementIntegralVariableUserObject >::LayeredIntegralBase(), Moose::LibtorchArtificialNeuralNet::LibtorchArtificialNeuralNet(), Moose::FV::limiterType(), MooseMeshXYCuttingUtils::lineRemoverCutElemTri(), MooseMeshXYCuttingUtils::lineRemoverMoveNode(), RestartableEquationSystems::load(), Moose::TorchScriptModule::loadNeuralNetwork(), LockFile::LockFile(), MooseVariableFV< Real >::lowerDError(), MooseUtils::makedirs(), FaceArgProducerInterface::makeFace(), FormattedTable::makeGnuplot(), MultiAppCoordTransform::mapBack(), MaterialProperty< Real >::MaterialProperty(), MaterialPropertyBase< T, false >::MaterialPropertyBase(), MooseVariableDataBase< OutputType >::matrixTagValue(), MeshBaseImageSampler::MeshBaseImageSampler(), MeshMetaDataInterface::meshPropertyPrefix(), MooseAppCoordTransform::MooseAppCoordTransform(), moose::internal::mooseDeprecatedStream(), MooseEnumBase::MooseEnumBase(), MeshMetaDataInterface::mooseErrorInternal(), MooseVariableInterface< Real >::mooseLinearVariableFV(), Moose::SlepcSupport::mooseMatMult_Eigen(), Moose::SlepcSupport::mooseMatMult_NonEigen(), MooseParsedFunctionBase::MooseParsedFunctionBase(), MathUtils::mooseSetToZero(), Moose::SlepcSupport::mooseSlepcEPSGetSNES(), MooseVariableInterface< Real >::mooseVariable(), MooseVariableInterface< Real >::mooseVariableFV(), MooseVariableInterface< Real >::MooseVariableInterface(), moose::internal::mooseWarningStream(), NonlinearSystemBase::mortarConstraints(), MultiIndex< Real >::MultiIndex(), SystemBase::needSolutionState(), NeighborMooseVariableInterface< Real >::neighborGradient(), NeighborMooseVariableInterface< Real >::neighborGradientOld(), NeighborMooseVariableInterface< Real >::neighborGradientOlder(), MooseMeshElementConversionUtils::neighborNodeIndicesHEX8(), KDTree::neighborSearch(), NeighborMooseVariableInterface< Real >::neighborSecond(), NeighborMooseVariableInterface< Real >::neighborSecondOld(), NeighborMooseVariableInterface< Real >::neighborSecondOlder(), NeighborMooseVariableInterface< Real >::neighborSecondPhi(), NeighborMooseVariableInterface< Real >::neighborSecondTest(), NeighborMooseVariableInterface< Real >::neighborValue(), NeighborMooseVariableInterface< Real >::neighborValueOld(), NeighborMooseVariableInterface< Real >::neighborValueOlder(), MooseVariableDataBase< OutputType >::nodalMatrixTagValue(), ProjectedStatefulMaterialNodalPatchRecoveryTempl< T, is_ad >::nodalPatchRecovery(), MooseVariableDataBase< OutputType >::nodalValue(), MooseVariableDataBase< OutputType >::nodalValueArray(), MooseVariableData< OutputType >::nodalValueDot(), MooseVariableData< OutputType >::nodalValueDotDot(), MooseVariableData< OutputType >::nodalValueDotDotOld(), MooseVariableData< OutputType >::nodalValueDotOld(), MooseVariableDataBase< OutputType >::nodalVectorTagValue(), MooseMeshElementConversionUtils::nodeRotationHEX8(), MooseMeshElementConversionUtils::nodeRotationPRISM6(), MooseMeshElementConversionUtils::nodeRotationPYRAMID5(), NonlinearEigenSystem::NonlinearEigenSystem(), NonlinearEigenSystem::nonlinearSolver(), SystemBase::nonTimeVectorTag(), Registry::objData(), Moose::FV::onBoundary(), FlagElementsThread::onElement(), ProjectMaterialProperties::onInternalSide(), FormattedTable::open(), MooseUnits::operator Real(), NearestNodeThread::operator()(), PenetrationThread::operator()(), ColumnMajorMatrixTempl< Real >::operator()(), ColumnMajorMatrixTempl< Real >::operator*(), ColumnMajorMatrixTempl< Real >::operator+=(), MaterialPropertyBase< T, false >::operator=(), ColumnMajorMatrixTempl< Real >::operator=(), MaterialProperty< Real >::operator=(), ADMaterialProperty< Real >::operator=(), RankTwoTensorTempl< Real >::operator=(), ExecuteMooseObjectWarehouse< Transfer >::operator[](), OutputMapWrapper< ExecFlagEnum >::operator[](), OrientedBoxInterface::OrientedBoxInterface(), MortarNodalGeometryOutput::output(), FVRelationshipManagerInterface::parameterError(), MooseUnits::parse(), CommandLine::parse(), GriddedData::parse(), FunctionMaterialPropertyDescriptor< is_ad >::parseDependentSymbols(), FunctionMaterialPropertyDescriptor< is_ad >::parseDerivative(), FunctionParserUtils< false >::parsedFunctionSetup(), MooseUnits::parseError(), Parser::parseError(), Parser::Parser(), Factory::parseTime(), Moose::SlepcSupport::PCApply_MoosePC(), Moose::SlepcSupport::PCSetUp_MoosePC(), PenetrationLocator::PenetrationLocator(), MathUtils::plainLog(), MathUtils::poly1Log(), MathUtils::poly2Log(), MathUtils::poly3Log(), MathUtils::poly4Log(), PolynomialFit::PolynomialFit(), CommandLine::populateCommandLineParams(), SymmetricRankTwoTensorTempl< Real >::positiveProjectionEigenDecomposition(), RankTwoTensorTempl< Real >::positiveProjectionEigenDecomposition(), NonlinearEigenSystem::postAddResidualObject(), MortarNodalAuxKernelTempl< ComputeValueType >::precalculateValue(), MaterialPropertyValueTempl< is_ad >::precomputeQpJacobian(), MooseUtils::DelimitedFileReaderTempl< T >::preprocessLine(), NonlinearSystemBase::preSMOResidual(), MooseUtils::DelimitedFileReaderTempl< T >::processLine(), processLiteralVectors(), Moose::Mortar::projectQPoints3d(), PerfGraph::push(), rankConfig(), RankFourTensorTempl< T >::RankFourTensorTempl(), RankMap::ranks(), RankThreeTensorTempl< T >::RankThreeTensorTempl(), RankTwoTensorTempl< Real >::RankTwoTensorTempl(), MooseUtils::DelimitedFileReaderTempl< T >::readColumnData(), RestartableDataReader::readHeader(), DerivativeParsedMaterialHelperTempl< is_ad >::recurseDerivative(), FunctorChangeFunctorMaterialTempl< is_ad >::referenceState(), Factory::reg(), moose::internal::PerfGraphRegistry::registerSection(), Syntax::registerTaskName(), EqualValueEmbeddedConstraintTempl< is_ad >::reinitConstraint(), StringInputStream::release(), CommandLine::removeArgument(), ExecFlagEnum::removeAvailableFlags(), MooseUtils::removedirs(), SystemBase::removeMatrix(), SystemBase::removeVector(), ReporterName::ReporterName(), Factory::reportUnregisteredError(), Coupleable::requestStates(), RestartableDataReader::requireRestoring(), ReporterContextBase::requiresConsumerModes(), NonlinearSystem::residualAndJacobianTogether(), NonlinearEigenSystem::residualAndJacobianTogether(), SystemBase::residualCopy(), SystemBase::residualGhosted(), NonlinearSystemBase::residualVector(), SystemBase::residualVectorTag(), MultiIndex< Real >::resize(), ReporterGeneralContext< T >::resize(), MooseVariableDataBase< OutputType >::resizeVectorTagData(), OptionalMaterialPropertyProxy< M, T, is_ad >::resolve(), RestartableDataReader::restore(), RestartableEquationSystems::restore(), RestartableDataReader::restoreData(), SystemBase::restoreSolutions(), Moose::restrictPointToFace(), PenetrationThread::restrictPointToFace(), PenetrationThread::restrictPointToSpecifiedEdgeOfFace(), SymmetricRankTwoTensorTempl< Real >::row(), LinearInterpolation::sample(), BidimensionalInterpolation::sample2ndDerivative(), BicubicInterpolation::sample2ndDerivative(), BicubicSplineInterpolation::sample2ndDerivative(), BidimensionalInterpolation::sampleDerivative(), BicubicInterpolation::sampleDerivative(), BicubicSplineInterpolation::sampleDerivative(), BilinearInterpolation::sampleDerivativeInternal(), BidimensionalInterpolation::sampleValueAndDerivatives(), ScalarCoupleable::ScalarCoupleable(), MooseVariableInterface< Real >::second(), MooseVariableInterface< Real >::secondOld(), MooseVariableInterface< Real >::secondOlder(), MooseVariableInterface< Real >::secondPhi(), MooseLinearVariableFV< Real >::secondPhi(), MooseVariableInterface< Real >::secondPhiFace(), MooseLinearVariableFV< Real >::secondPhiFace(), MooseLinearVariableFV< Real >::secondPhiFaceNeighbor(), MooseLinearVariableFV< Real >::secondPhiNeighbor(), MooseVariableDataFV< OutputType >::secondSln(), MooseVariableData< OutputType >::secondSln(), MooseVariableInterface< Real >::secondTest(), MooseVariableInterface< Real >::secondTestFace(), PerfGraph::sectionData(), Moose::FV::selectInterpolationMethod(), Moose::ParameterRegistry::set(), ControllableItem::set(), Adaptivity::setAdaptivityOn(), CommandLine::setCommandLineParam(), MooseAppCoordTransform::setCoordinateSystem(), MultiAppCoordTransform::setDestinationCoordTransform(), Moose::SlepcSupport::setEigenProblemOptions(), Moose::SlepcSupport::setEigenProblemSolverParams(), Moose::SlepcSupport::setEigenSolverOptions(), Adaptivity::setErrorEstimator(), ActionWarehouse::setFinalTask(), PiecewiseByBlockLambdaFunctor< T >::setFunctor(), MooseEnumItem::setID(), Moose::PetscSupport::setLineSearchFromParams(), MOOSEToNEML2::setMode(), SolverSystem::setMooseKSPNormType(), Assembly::setMortarQRule(), Moose::SlepcSupport::setNewtonPetscOptions(), MooseVariableFV< Real >::setNodalValue(), Moose::SlepcSupport::setNonlinearPowerOptions(), PenetrationLocator::setNormalSmoothingMethod(), Adaptivity::setParam(), SolverSystem::setPCSide(), NonlinearSystemBase::setPreconditioner(), MooseAppCoordTransform::setRotation(), Moose::PetscSupport::setSinglePetscOption(), NonlinearSystem::setupColoringFiniteDifferencedPreconditioner(), MooseAppCoordTransform::setUpDirection(), NonlinearSystem::setupFiniteDifferencedPreconditioner(), NonlinearEigenSystem::setupFiniteDifferencedPreconditioner(), MeshBaseImageSampler::setupImageSampler(), ImageSampler::setupImageSampler(), NonlinearSystemBase::setupScalingData(), Moose::SlepcSupport::setWhichEigenPairsOptions(), SymmetricRankTwoTensorTempl< Real >::sin3Lode(), RankTwoTensorTempl< Real >::sin3Lode(), MultiIndex< Real >::slice(), SystemBase::solutionState(), SystemBase::solutionStateParallelType(), Moose::MFEM::EquationSystemProblemOperator::Solve(), SplineInterpolationBase::spline(), MooseUtils::splitFileName(), GriddedData::splitToRealVec(), MooseVariableDataBase< OutputType >::stateToTagHelper(), NonlinearSystem::stopSolve(), NonlinearEigenSystem::stopSolve(), RestartableDataValue::store(), Moose::PetscSupport::stringify(), Moose::stringify(), Moose::stringToEnum< CoordinateSystemType >(), Moose::stringToEnum< EigenProblemType >(), Moose::stringToEnum< EigenSolveType >(), Moose::stringToEnum< LineSearchType >(), Moose::stringToEnum< MffdType >(), Moose::stringToEnum< RelationshipManagerType >(), Moose::stringToEnum< SolveType >(), Moose::stringToEnum< TimeIntegratorType >(), Moose::stringToEnum< WhichEigenPairs >(), PiecewiseByBlockLambdaFunctor< T >::subdomainErrorMessage(), RankFourTensorTempl< T >::surfaceFillFromInputVector(), RankTwoTensorTempl< Real >::surfaceFillFromInputVector(), SymmetricRankTwoTensorTempl< Real >::syev(), RankTwoTensorTempl< Real >::syev(), SymmetricRankTwoTensorTempl< Real >::symmetricEigenvaluesEigenvectors(), RankTwoTensorTempl< Real >::symmetricEigenvaluesEigenvectors(), SymmetricRankFourTensorTempl< T >::SymmetricRankFourTensorTempl(), SymmetricRankTwoTensorTempl< Real >::SymmetricRankTwoTensorTempl(), SystemBase::systemMatrixTag(), TableValue< T >::TableValue(), TaggingInterface::TaggingInterface(), LibtorchUtils::tensorToVector(), MooseMeshElementConversionUtils::tetNodesForHex(), LinearTimeIntegratorInterface::timeDerivativeMatrixContribution(), LinearTimeIntegratorInterface::timeDerivativeRHSContribution(), SystemBase::timeVectorTag(), Moose::LibtorchArtificialNeuralNetTrainer< SamplerType >::train(), ReporterContext< std::vector< T > >::transferFromVector(), ReporterContext< std::vector< T > >::transferToVector(), MooseAppCoordTransform::transformMesh(), moose::translateMetaPhysicLError(), MortarSegmentHelper::triangulatePoly(), TrilinearInterpolation::TrilinearInterpolation(), MooseVariableDataFV< OutputType >::uDot(), MooseVariableData< OutputType >::uDot(), MooseVariableDataFV< OutputType >::uDotDot(), MooseVariableData< OutputType >::uDotDot(), MooseVariableDataFV< OutputType >::uDotDotOld(), MooseVariableData< OutputType >::uDotDotOld(), MooseVariableDataFV< OutputType >::uDotOld(), MooseVariableData< OutputType >::uDotOld(), geom_utils::unitVector(), AuxKernelTempl< Real >::uOld(), AuxKernelTempl< Real >::uOlder(), MortarData::update(), NearestNodeLocator::updatePatch(), TaggingInterface::useMatrixTag(), TaggingInterface::useVectorTag(), ScalarCoupleable::validateExecutionerType(), Coupleable::validateExecutionerType(), ADInterfaceKernelTempl< T >::validParams(), ADKernelTempl< T >::validParams(), DiracKernelTempl< T >::validParams(), InterfaceKernelTempl< T >::validParams(), FunctionMaterialPropertyDescriptor< is_ad >::value(), ReporterState< std::vector< T > >::value(), ValueCache< T >::ValueCache(), ReporterGeneralContext< T >::vectorSum(), ReporterVectorContext< T >::vectorSum(), MooseVariableDataBase< OutputType >::vectorTagDofValue(), Coupleable::vectorTagDofValueHelper(), MooseVariableDataBase< OutputType >::vectorTagGradient(), MooseVariableDataBase< OutputType >::vectorTagValue(), Coupleable::vectorTagValueHelper(), MooseParsedFunctionBase::verifyFunction(), MeshBaseImageSampler::vtkThreshold(), ImageSampler::vtkThreshold(), Coupleable::writableCoupledValue(), Coupleable::writableVariable(), RestartableDataWriter::write(), SystemBase::zeroTaggedVector(), SystemBase::zeroVariables(), InputStream::~InputStream(), and ThreadedFaceLoop< RangeType >::~ThreadedFaceLoop().

324 {
325  std::ostringstream oss;
326  moose::internal::mooseStreamAll(oss, std::forward<Args>(args)...);
328 }
void mooseStreamAll(std::ostringstream &ss)
All of the following are not meant to be called directly - they are called by the normal macros (moos...
Definition: MooseError.C:123
void mooseErrorRaw(std::string msg, const std::string &prefix="", const hit::Node *node=nullptr)
Main callback for emitting a moose error.
Definition: MooseError.C:53

◆ mooseInfo()

template<typename... Args>
void mooseInfo ( Args &&...  args)

Emit an informational message with the given stringified, concatenated args.

Definition at line 390 of file MooseError.h.

Referenced by Parser::parse(), DerivativeParsedMaterialHelperTempl< is_ad >::recurseDerivative(), and ReporterData::restoreState().

391 {
392  moose::internal::mooseInfoStream(Moose::out, std::forward<Args>(args)...);
393 }
void mooseInfoStream(S &oss, Args &&... args)
Definition: MooseError.h:258

◆ mooseInfoRepeated()

template<typename... Args>
void mooseInfoRepeated ( Args &&...  args)

◆ mooseUnused()

template<typename... Args>
void mooseUnused ( Args &&...  args)

Warning message used to notify the users of unused parts of their input files Really used internally by the parser and shouldn't really be called elsewhere.

Definition at line 366 of file MooseError.h.

Referenced by Moose::Builder::errorCheck().

367 {
368  moose::internal::mooseUnusedStream(Moose::out, std::forward<Args>(args)...);
369 }
void mooseUnusedStream(S &oss, Args &&... args)
Definition: MooseError.h:229

◆ mooseWarning()

template<typename... Args>
void mooseWarning ( Args &&...  args)

Emit a warning message with the given stringified, concatenated args.

Inside static functions, you will need to explicitly scope your mooseWarning call - i.e. do "::mooseWarning(arg1, ...);".

Definition at line 357 of file MooseError.h.

Referenced by AutomaticMortarGeneration::buildMortarSegmentMesh(), AutomaticMortarGeneration::buildMortarSegmentMesh3d(), MooseEnumBase::checkDeprecated(), SolverSystem::checkInvalidSolution(), NonlinearSystem::converged(), PenetrationLocator::detectPenetration(), FunctionParserUtils< false >::evaluate(), FileRangeBuilder::FileRangeBuilder(), Moose::findContactPoint(), FunctionParserUtils< false >::FunctionParserUtils(), ControllableParameter::get(), MooseMeshUtils::getBoundaryIDs(), Coupleable::getDefaultVectorValue(), MemoryUtils::getMemoryStats(), Moose::FV::greenGaussGradient(), Moose::FV::harmonicInterpolation(), DerivativeFunctionMaterialBaseTempl< is_ad >::initialSetup(), LayeredBase::LayeredBase(), LockFile::LockFile(), MemoryUsageReporter::MemoryUsageReporter(), MooseMeshXYCuttingUtils::quadToTriOnLine(), MooseMeshXYCuttingUtils::quasiTriElementsFixer(), MooseUtils::serialBegin(), MooseUtils::serialEnd(), Moose::SlepcSupport::setEigenProblemSolverParams(), ShapeUserObject< SideUserObject >::ShapeUserObject(), InputParameters::transferParam(), DerivativeMaterialInterface< MortarScalarBase >::validateCoupling(), DerivativeMaterialInterface< MortarScalarBase >::validateDerivativeMaterialPropertyBase(), LockFile::~LockFile(), and ValueCache< T >::~ValueCache().

358 {
359  moose::internal::mooseWarningStream(Moose::out, std::forward<Args>(args)...);
360 }
void mooseWarningStream(S &oss, Args &&... args)
Definition: MooseError.h:210

◆ operator<<()

template<typename... T>
std::ostream& operator<< ( std::ostream &  os,
const std::tuple< T... > &  tup 
)

Definition at line 52 of file MooseError.h.

53 {
54  os << "[";
55  print_tuple<0>(os, tup);
56  return os << "]";
57 }
std::basic_ostream< charT, traits > * os
Definition: InfixIterator.h:33

◆ print_tuple()

template<size_t n, typename... T>
void print_tuple ( std::ostream &  os,
const std::tuple< T... > &  tup 
)

Definition at line 40 of file MooseError.h.

41 {
42  if constexpr (n < sizeof...(T))
43  {
44  if (n != 0)
45  os << ", ";
46  os << std::get<n>(tup);
47  print_tuple<n + 1>(os, tup);
48  }
49 }
std::basic_ostream< charT, traits > * os
Definition: InfixIterator.h:33