Reference documentation for deal.II version GIT relicensing-136-gb80d0be4af 2024-03-18 08:20:02+00:00
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Loading...
Searching...
No Matches
Namespaces | Classes | Macros | Functions
Exceptions and assertions

Namespaces

namespace  StandardExceptions
 
namespace  deal_II_exceptions
 
namespace  deal_II_exceptions::internals
 

Classes

class  ExceptionBase
 
class  StandardExceptions::ExcMPI
 
class  LACExceptions::ExcPETScError
 

Macros

#define DeclException0(Exception0)
 
#define DeclExceptionMsg(Exception, defaulttext)
 
#define DeclException1(Exception1, type1, outsequence)
 
#define DeclException2(Exception2, type1, type2, outsequence)
 
#define DeclException3(Exception3, type1, type2, type3, outsequence)
 
#define DeclException4(Exception4, type1, type2, type3, type4, outsequence)
 
#define DeclException5( Exception5, type1, type2, type3, type4, type5, outsequence)
 
#define Assert(cond, exc)
 
#define AssertNothrow(cond, exc)
 
#define AssertThrow(cond, exc)
 
#define AssertDimension(dim1, dim2)
 
#define AssertVectorVectorDimension(VEC, DIM1, DIM2)
 
#define AssertIndexRange(index, range)
 
#define AssertIsFinite(number)
 
#define AssertThrowMPI(error_code)    AssertThrow(error_code == MPI_SUCCESS, ::ExcMPI(error_code))
 
#define AssertCuda(error_code)
 
#define AssertNothrowCuda(error_code)
 
#define AssertCudaKernel()
 
#define AssertCusparse(error_code)
 
#define AssertNothrowCusparse(error_code)
 
#define AssertCusolver(error_code)
 

Functions

static ::ExceptionBaseAnyData::ExcNameNotFound (std::string arg1)
 An entry with this name does not exist in the AnyData object.
 
static ::ExceptionBaseAnyData::ExcTypeMismatch (std::string arg1, std::string arg2)
 The requested type and the stored type are different.
 
static ::ExceptionBaseAnyData::ExcNameMismatch (int arg1, std::string arg2)
 
static ::ExceptionBaseGeneralDataStorage::ExcNameNotFound (std::string arg1)
 
static ::ExceptionBaseGeneralDataStorage::ExcNameHasBeenFound (std::string arg1)
 
static ::ExceptionBaseGeneralDataStorage::ExcTypeMismatch (std::string arg1, const char *arg2, const char *arg3)
 
static ::ExceptionBaseAlignedVector< T >::ExcAlignedVectorChangeAfterReplication ()
 
static ::ExceptionBaseConvergenceTable::ExcRateColumnAlreadyExists (std::string arg1)
 
static ::ExceptionBaseDataOutBase::Patch< dim, spacedim >::ExcInvalidCombinationOfDimensions (int arg1, int arg2)
 
static ::ExceptionBaseDataOutBase::Patch< 0, spacedim >::ExcInvalidCombinationOfDimensions (int arg1, int arg2)
 
static ::ExceptionBaseDataOutBase::GnuplotFlags::ExcNotEnoughSpaceDimensionLabels ()
 
static ::ExceptionBaseDataOutBase::ExcInvalidDatasetSize (int arg1, int arg2)
 
static ::ExceptionBaseDataOutBase::ExcNoPatches ()
 
static ::ExceptionBaseDataOutBase::ExcTecplotAPIError ()
 
static ::ExceptionBaseDataOutBase::ExcErrorOpeningTecplotFile (char *arg1)
 
static ::ExceptionBaseDataOutReader< dim, spacedim >::ExcIncompatibleDatasetNames ()
 
static ::ExceptionBaseDataOutReader< dim, spacedim >::ExcIncompatiblePatchLists ()
 
static ::ExceptionBaseDataOutReader< dim, spacedim >::ExcIncompatibleDimensions (int arg1, int arg2, int arg3, int arg4)
 
static ::ExceptionBaseDerivativeForm< order, dim, spacedim, Number >::ExcInvalidTensorIndex (int arg1)
 
static ::ExceptionBaseStandardExceptions::ExcDivideByZero ()
 
static ::ExceptionBaseStandardExceptions::ExcNumberNotFinite (std::complex< double > arg1)
 
static ::ExceptionBaseStandardExceptions::ExcOutOfMemory (std::size_t arg1)
 
static ::ExceptionBaseStandardExceptions::ExcMemoryLeak (int arg1)
 
static ::ExceptionBaseStandardExceptions::ExcIO ()
 
static ::ExceptionBaseStandardExceptions::ExcFileNotOpen (std::string arg1)
 
static ::ExceptionBaseStandardExceptions::ExcNotImplemented ()
 
static ::ExceptionBaseStandardExceptions::ExcInternalError ()
 
static ::ExceptionBaseStandardExceptions::ExcPureFunctionCalled ()
 
static ::ExceptionBaseStandardExceptions::ExcFunctionNotProvided (std::string arg1)
 
static ::ExceptionBaseStandardExceptions::ExcFunctionNonzeroReturn (std::string arg1, int arg2)
 
static ::ExceptionBaseStandardExceptions::ExcNotInitialized ()
 
static ::ExceptionBaseStandardExceptions::ExcInvalidState ()
 
static ::ExceptionBaseStandardExceptions::ExcImpossibleInDim (int arg1)
 
static ::ExceptionBaseStandardExceptions::ExcImpossibleInDimSpacedim (int arg1, int arg2)
 
static ::ExceptionBaseStandardExceptions::ExcZero ()
 
static ::ExceptionBaseStandardExceptions::ExcEmptyObject ()
 
static ::ExceptionBaseStandardExceptions::ExcDimensionMismatch (std::size_t arg1, std::size_t arg2)
 
static ::ExceptionBaseStandardExceptions::ExcDimensionMismatch2 (std::size_t arg1, std::size_t arg2, std::size_t arg3)
 
static ::ExceptionBaseStandardExceptions::ExcIndexRange (std::size_t arg1, std::size_t arg2, std::size_t arg3)
 
template<typename T >
static ::ExceptionBaseStandardExceptions::ExcIndexRangeType (T arg1, T arg2, T arg3)
 
static ::ExceptionBaseStandardExceptions::ExcLowerRange (int arg1, int arg2)
 
template<typename T >
static ::ExceptionBaseStandardExceptions::ExcLowerRangeType (T arg1, T arg2)
 
static ::ExceptionBaseStandardExceptions::ExcNotMultiple (int arg1, int arg2)
 
static ::ExceptionBaseStandardExceptions::ExcInvalidIterator ()
 
static ::ExceptionBaseStandardExceptions::ExcIteratorPastEnd ()
 
static ::ExceptionBaseStandardExceptions::ExcMessage (std::string arg1)
 
static ::ExceptionBaseStandardExceptions::ExcGhostsPresent ()
 
static ::ExceptionBaseStandardExceptions::ExcGridHasInvalidCell (int arg1)
 
static ::ExceptionBaseStandardExceptions::ExcScalarAssignmentOnlyForZeroValue ()
 
static ::ExceptionBaseStandardExceptions::ExcNeedsLAPACK ()
 
static ::ExceptionBaseStandardExceptions::ExcNeedsHDF5 ()
 
static ::ExceptionBaseStandardExceptions::ExcNeedsMPI ()
 
static ::ExceptionBaseStandardExceptions::ExcNeedsFunctionparser ()
 
static ::ExceptionBaseStandardExceptions::ExcNeedsAssimp ()
 
static ::ExceptionBaseStandardExceptions::ExcCudaError (const char *arg1)
 
static ::ExceptionBaseStandardExceptions::ExcCusparseError (std::string arg1)
 
static ::ExceptionBaseStandardExceptions::ExcNeedsExodusII ()
 
static ::ExceptionBaseStandardExceptions::ExcNeedsCGAL ()
 
static ::ExceptionBaseStandardExceptions::RecoverableUserCallbackError ()
 
static ::ExceptionBaseFunctions::ExcCSplineEmpty (int arg1)
 
static ::ExceptionBaseFunctions::ExcCSplineSizeMismatch (int arg1, int arg2)
 
static ::ExceptionBaseFunctions::ExcCSplineOrder (int arg1, double arg2, double arg3)
 
static ::ExceptionBaseFunctions::ExcCSplineRange (double arg1, double arg2, double arg3)
 
static ::ExceptionBaseFunctionParser< dim >::ExcParseError (int arg1, std::string arg2)
 
static ::ExceptionBaseFunctionParser< dim >::ExcInvalidExpressionSize (int arg1, int arg2)
 
static ::ExceptionBaseRefinementCase< dim >::ExcInvalidRefinementCase (int arg1)
 
static ::ExceptionBaseinternal::SubfaceCase< dim >::ExcInvalidSubfaceCase (int arg1)
 
static ::ExceptionBaseGeometryInfo< dim >::ExcInvalidCoordinate (double arg1)
 
static ::ExceptionBaseGeometryInfo< dim >::ExcInvalidSubface (int arg1, int arg2, int arg3)
 
static ::ExceptionBaseIndexSet::ExcIndexNotPresent (size_type arg1)
 
static ::ExceptionBaseinternal::FunctionParser::ExcParseError (int arg1, std::string arg2)
 
static ::ExceptionBaseParameterHandler::ExcEntryAlreadyExists (std::string arg1)
 
static ::ExceptionBaseParameterHandler::ExcValueDoesNotMatchPattern (std::string arg1, std::string arg2)
 
static ::ExceptionBaseParameterHandler::ExcAlreadyAtTopLevel ()
 
static ::ExceptionBaseParameterHandler::ExcEntryUndeclared (std::string arg1)
 
static ::ExceptionBaseParameterHandler::ExcUnbalancedSubsections (std::string arg1, std::string arg2)
 
static ::ExceptionBaseParameterHandler::ExcNoSubsection (int arg1, std::string arg2, std::string arg3)
 
static ::ExceptionBaseParameterHandler::ExcCannotParseLine (int arg1, std::string arg2, std::string arg3)
 
static ::ExceptionBaseParameterHandler::ExcInvalidEntryForPattern (int arg1, std::string arg2, std::string arg3, std::string arg4, std::string arg5)
 
static ::ExceptionBaseParameterHandler::ExcInvalidXMLParameterFile ()
 
static ::ExceptionBaseParameterHandler::ExcCannotOpenIncludeStatementFile (int arg1, std::string arg2, std::string arg3)
 
static ::ExceptionBaseUtilities::MPI::Partitioner::ExcIndexNotPresent (types::global_dof_index arg1, unsigned int arg2)
 
static ::ExceptionBaseUtilities::MPI::Partitioner::ExcGhostIndexArrayHasWrongSize (unsigned int arg1, unsigned int arg2, unsigned int arg3)
 
static ::ExceptionBasePathSearch::ExcNoClass (std::string arg1)
 
static ::ExceptionBasePathSearch::ExcFileNotFound (std::string arg1, std::string arg2)
 
static ::ExceptionBasePatterns::List::ExcInvalidRange (int arg1, int arg2)
 
static ::ExceptionBasePatterns::Map::ExcInvalidRange (int arg1, int arg2)
 
static ::ExceptionBasePatterns::MultipleSelection::ExcCommasNotAllowed (int arg1)
 
static ::ExceptionBasePatterns::Tools::ExcNoMatch (std::string arg1, std::string arg2)
 
static ::ExceptionBaseQIterated< dim >::ExcInvalidQuadratureFormula ()
 
static ::ExceptionBaseCellDataStorage< CellIteratorType, DataType >::ExcCellDataTypeMismatch ()
 
static ::ExceptionBaseCellDataStorage< CellIteratorType, DataType >::ExcTriangulationMismatch ()
 
static ::ExceptionBaseQuadratureSelector< dim >::ExcInvalidQGaussOrder (int arg1)
 
static ::ExceptionBaseQuadratureSelector< dim >::ExcInvalidOrder (std::string arg1, unsigned int arg2)
 
static ::ExceptionBaseQuadratureSelector< dim >::ExcInvalidQuadrature (std::string arg1)
 
static ::ExceptionBaseSubscriptor::ExcInUse (int arg1, std::string arg2, std::string arg3)
 
static ::ExceptionBaseSubscriptor::ExcNoSubscriber (std::string arg1, std::string arg2)
 
static ::ExceptionBaseinternal::TableBaseAccessors::Accessor< N, T, C, P >::ExcIndexRange (size_type arg1, size_type arg2, size_type arg3)
 
static ::ExceptionBaseTableHandler::ExcColumnNotExistent (std::string arg1)
 
static ::ExceptionBaseTableHandler::ExcSuperColumnNotExistent (std::string arg1)
 
static ::ExceptionBaseTableHandler::ExcColumnOrSuperColumnNotExistent (std::string arg1)
 
static ::ExceptionBaseTableHandler::ExcWrongNumberOfDataEntries (std::string arg1, int arg2, std::string arg3, int arg4)
 
static ::ExceptionBaseTableHandler::ExcUndefinedTexFormat (std::string arg1)
 
static ::ExceptionBaseTensorFunctionParser< rank, dim, Number >::ExcParseError (int arg1, std::string arg2)
 
static ::ExceptionBaseTensorFunctionParser< rank, dim, Number >::ExcInvalidExpressionSize (int arg1, int arg2)
 
static ::ExceptionBaseThreads::Task< RT >::ExcNoTask ()
 
static ::ExceptionBaseDifferentiation::AD::ExcRequiresADNumberSpecialization ()
 
static ::ExceptionBaseDifferentiation::AD::ExcRequiresADOLC ()
 
static ::ExceptionBaseDifferentiation::AD::ExcSupportedDerivativeLevels (std::size_t arg1, std::size_t arg2)
 
static ::ExceptionBaseExcADOLCAdvancedBranching ()
 
static ::ExceptionBaseDifferentiation::SD::ExcSymEngineParserError (std::string arg1)
 
static ::ExceptionBaseDifferentiation::SD::ExcSymEngineLLVMNotAvailable ()
 
static ::ExceptionBaseDifferentiation::SD::ExcSymEngineLLVMReturnTypeNotSupported ()
 
static ::ExceptionBaseDoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcInvalidObject ()
 
static ::ExceptionBaseDoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcVectorNotEmpty ()
 
static ::ExceptionBaseDoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcVectorDoesNotMatch ()
 
static ::ExceptionBaseDoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcMatrixDoesNotMatch ()
 
static ::ExceptionBaseDoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcNotActive ()
 
static ::ExceptionBaseDoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcCantCompareIterators ()
 
static ::ExceptionBaseDoFAccessor< 0, 1, spacedim, level_dof_access >::ExcInvalidObject ()
 
static ::ExceptionBaseDoFAccessor< 0, 1, spacedim, level_dof_access >::ExcVectorNotEmpty ()
 
static ::ExceptionBaseDoFAccessor< 0, 1, spacedim, level_dof_access >::ExcVectorDoesNotMatch ()
 
static ::ExceptionBaseDoFAccessor< 0, 1, spacedim, level_dof_access >::ExcMatrixDoesNotMatch ()
 
static ::ExceptionBaseDoFAccessor< 0, 1, spacedim, level_dof_access >::ExcNotActive ()
 
static ::ExceptionBaseDoFAccessor< 0, 1, spacedim, level_dof_access >::ExcCantCompareIterators ()
 
static ::ExceptionBaseDoFHandler< dim, spacedim >::ExcNoFESelected ()
 
static ::ExceptionBaseDoFHandler< dim, spacedim >::ExcInvalidBoundaryIndicator ()
 
static ::ExceptionBaseDoFHandler< dim, spacedim >::ExcInvalidLevel (int arg1)
 
static ::ExceptionBaseDoFHandler< dim, spacedim >::ExcNewNumbersNotConsecutive (types::global_dof_index arg1)
 
static ::ExceptionBaseDoFHandler< dim, spacedim >::ExcInvalidFEIndex (int arg1, int arg2)
 
static ::ExceptionBaseDoFHandler< dim, spacedim >::ExcOnlyAvailableWithHP ()
 
static ::ExceptionBaseDoFHandler< dim, spacedim >::ExcNotImplementedWithHP ()
 
static ::ExceptionBaseinternal::hp::DoFHandlerImplementation::ExcNoDominatedFiniteElementOnChildren ()
 
static ::ExceptionBaseDoFRenumbering::ExcDoFHandlerNotInitialized ()
 
static ::ExceptionBaseDoFRenumbering::ExcInvalidComponentOrder ()
 
static ::ExceptionBaseDoFRenumbering::ExcNotDGFEM ()
 
static ::ExceptionBaseComponentMask::ExcNoComponentSelected ()
 
static ::ExceptionBaseFiniteElement< dim, spacedim >::ExcShapeFunctionNotPrimitive (int arg1)
 
static ::ExceptionBaseFiniteElement< dim, spacedim >::ExcFENotPrimitive ()
 
static ::ExceptionBaseFiniteElement< dim, spacedim >::ExcUnitShapeValuesDoNotExist ()
 
static ::ExceptionBaseFiniteElement< dim, spacedim >::ExcFEHasNoSupportPoints ()
 
static ::ExceptionBaseFiniteElement< dim, spacedim >::ExcEmbeddingVoid ()
 
static ::ExceptionBaseFiniteElement< dim, spacedim >::ExcProjectionVoid ()
 
static ::ExceptionBaseFiniteElement< dim, spacedim >::ExcWrongInterfaceMatrixSize (int arg1, int arg2)
 
static ::ExceptionBaseFiniteElement< dim, spacedim >::ExcInterpolationNotImplemented ()
 
static ::ExceptionBaseFE_Q_Base< dim, spacedim >::ExcFEQCannotHaveDegree0 ()
 
static ::ExceptionBaseFETools::ExcInvalidFEName (std::string arg1)
 
static ::ExceptionBaseFETools::ExcInvalidFEDimension (char arg1, int arg2)
 
static ::ExceptionBaseFETools::ExcInvalidFE ()
 
static ::ExceptionBaseFETools::ExcFENotPrimitive ()
 
static ::ExceptionBaseFETools::ExcTriangulationMismatch ()
 
static ::ExceptionBaseFETools::ExcHangingNodesNotAllowed ()
 
static ::ExceptionBaseFETools::ExcGridNotRefinedAtLeastOnce ()
 
static ::ExceptionBaseFETools::ExcMatrixDimensionMismatch (int arg1, int arg2, int arg3, int arg4)
 
static ::ExceptionBaseFETools::ExcLeastSquaresError (double arg1)
 
static ::ExceptionBaseFETools::ExcNotGreaterThan (int arg1, int arg2)
 
static ::ExceptionBaseFESubfaceValues< dim, spacedim >::ExcReinitCalledWithBoundaryFace ()
 
static ::ExceptionBaseFESubfaceValues< dim, spacedim >::ExcFaceHasNoSubfaces ()
 
static ::ExceptionBaseFEValuesBase< dim, spacedim >::ExcAccessToUninitializedField (std::string arg1)
 
static ::ExceptionBaseFEValuesBase< dim, spacedim >::ExcNotReinited ()
 
static ::ExceptionBaseFEValuesBase< dim, spacedim >::ExcFEDontMatch ()
 
static ::ExceptionBaseFEValuesBase< dim, spacedim >::ExcShapeFunctionNotPrimitive (int arg1)
 
static ::ExceptionBaseFEValuesBase< dim, spacedim >::ExcFENotPrimitive ()
 
static ::ExceptionBaseFEValuesBase< dim, spacedim >::CellIteratorWrapper::ExcNeedsDoFHandler ()
 
static ::ExceptionBaseMappingFEField< dim, spacedim, VectorType >::ExcInactiveCell ()
 
static ::ExceptionBaseMappingQ1Eulerian< dim, VectorType, spacedim >::ExcInactiveCell ()
 
static ::ExceptionBaseMappingQEulerian< dim, VectorType, spacedim >::ExcInactiveCell ()
 
static ::ExceptionBaseFilteredIterator< BaseIterator >::ExcInvalidElement (BaseIterator arg1)
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcUnknownSectionType (int arg1)
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcUnknownElementType (int arg1)
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcUnknownIdentifier (std::string arg1)
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcNoTriangulationSelected ()
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcInvalidVertexIndex (int arg1, int arg2)
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcInvalidVertexIndexGmsh (int arg1, int arg2, int arg3)
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcInvalidDBMeshFormat ()
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcInvalidDBMESHInput (std::string arg1)
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcDBMESHWrongDimension (int arg1)
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcInvalidGMSHInput (std::string arg1)
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcGmshUnsupportedGeometry (int arg1)
 
static ::ExceptionBaseGridIn< dim, spacedim >::ExcGmshNoCellInformation (unsigned int arg1, unsigned int arg2)
 
static ::ExceptionBaseGridOut::ExcInvalidState ()
 
static ::ExceptionBaseGridRefinement::ExcNegativeCriteria ()
 
static ::ExceptionBaseGridRefinement::ExcInvalidParameterValue ()
 
static ::ExceptionBaseInterGridMap< MeshType >::ExcInvalidKey (cell_iterator arg1)
 
static ::ExceptionBaseInterGridMap< MeshType >::ExcIncompatibleGrids ()
 
static ::ExceptionBaseFlatManifold< dim, spacedim >::ExcPeriodicBox (int arg1, Point< spacedim > arg2, double arg3)
 
static ::ExceptionBasePersistentTriangulation< dim, spacedim >::ExcTriaNotEmpty ()
 
static ::ExceptionBasePersistentTriangulation< dim, spacedim >::ExcFlagsNotCleared ()
 
static ::ExceptionBaseinternal::ExcNonMatchingReferenceCellTypes (ReferenceCell arg1, ReferenceCell arg2)
 
static ::ExceptionBaseTriaAccessorExceptions::ExcCellNotUsed ()
 
static ::ExceptionBaseTriaAccessorExceptions::ExcCellNotActive ()
 
static ::ExceptionBaseTriaAccessorExceptions::ExcCellHasNoChildren ()
 
static ::ExceptionBaseTriaAccessorExceptions::ExcCellHasNoParent ()
 
static ::ExceptionBaseTriaAccessorExceptions::ExcCantSetChildren (int arg1)
 
template<typename AccessorType >
static ::ExceptionBaseTriaAccessorExceptions::ExcDereferenceInvalidObject (AccessorType arg1)
 
static ::ExceptionBaseTriaAccessorExceptions::ExcCantCompareIterators ()
 
static ::ExceptionBaseTriaAccessorExceptions::ExcNeighborIsCoarser ()
 
static ::ExceptionBaseTriaAccessorExceptions::ExcNeighborIsNotCoarser ()
 
static ::ExceptionBaseTriaAccessorExceptions::ExcFacesHaveNoLevel ()
 
static ::ExceptionBaseTriaAccessorExceptions::ExcNoPeriodicNeighbor ()
 
static ::ExceptionBaseTriaAccessorExceptions::ExcSetOnlyEvenChildren (int arg1)
 
static ::ExceptionBaseCellAccessor< dim, spacedim >::ExcRefineCellNotActive ()
 
static ::ExceptionBaseCellAccessor< dim, spacedim >::ExcCellFlaggedForRefinement ()
 
static ::ExceptionBaseCellAccessor< dim, spacedim >::ExcCellFlaggedForCoarsening ()
 
static ::ExceptionBaseTriaIterator< Accessor >::ExcAssignmentOfUnusedObject ()
 
static ::ExceptionBaseTriaActiveIterator< Accessor >::ExcAssignmentOfInactiveObject ()
 
static ::ExceptionBaseinternal::TriangulationImplementation::TriaObjects::ExcPointerIndexClash ()
 
static ::ExceptionBasehp::QCollection< dim >::ExcNoQuadrature ()
 
static ::ExceptionBaseAffineConstraints< number >::ExcMatrixIsClosed ()
 
static ::ExceptionBaseAffineConstraints< number >::ExcMatrixNotClosed ()
 
static ::ExceptionBaseAffineConstraints< number >::ExcLineInexistant (size_type arg1)
 
static ::ExceptionBaseAffineConstraints< number >::ExcEntryAlreadyExists (size_type arg1, size_type arg2, number arg3, number arg4)
 
static ::ExceptionBaseAffineConstraints< number >::ExcDoFConstrainedToConstrainedDoF (int arg1, int arg2)
 
static ::ExceptionBaseAffineConstraints< number >::ExcDoFIsConstrainedFromBothObjects (size_type arg1)
 
static ::ExceptionBaseAffineConstraints< number >::ExcDoFIsConstrainedToConstrainedDoF (size_type arg1)
 
static ::ExceptionBaseAffineConstraints< number >::ExcRowNotStoredHere (size_type arg1)
 
static ::ExceptionBaseAffineConstraints< number >::ExcColumnNotStoredHere (size_type arg1, size_type arg2)
 
static ::ExceptionBaseAffineConstraints< number >::ExcIncorrectConstraint (int arg1, int arg2)
 
static ::ExceptionBaseArpackSolver::ArpackExcInvalidNumberofEigenvalues (int arg1, int arg2)
 
static ::ExceptionBaseArpackSolver::ArpackExcInvalidEigenvectorSize (int arg1, int arg2)
 
static ::ExceptionBaseArpackSolver::ArpackExcInvalidEigenvectorSizeNonsymmetric (int arg1, int arg2)
 
static ::ExceptionBaseArpackSolver::ArpackExcInvalidEigenvalueSize (int arg1, int arg2)
 
static ::ExceptionBaseArpackSolver::ArpackExcInvalidNumberofArnoldiVectors (int arg1, int arg2)
 
static ::ExceptionBaseArpackSolver::ArpackExcSmallNumberofArnoldiVectors (int arg1, int arg2)
 
static ::ExceptionBaseArpackSolver::ArpackExcArpackIdo (int arg1)
 
static ::ExceptionBaseArpackSolver::ArpackExcArpackMode (int arg1)
 
static ::ExceptionBaseArpackSolver::ArpackExcArpackInfodsaupd (int arg1)
 
static ::ExceptionBaseArpackSolver::ArpackExcArpackInfodnaupd (int arg1)
 
static ::ExceptionBaseArpackSolver::ArpackExcArpackInfodseupd (int arg1)
 
static ::ExceptionBaseArpackSolver::ArpackExcArpackInfodneupd (int arg1)
 
static ::ExceptionBaseArpackSolver::ArpackExcArpackInfoMaxIt (int arg1)
 
static ::ExceptionBaseArpackSolver::ArpackExcArpackNoShifts ()
 
static ::ExceptionBaseBlockMatrixBase< MatrixType >::ExcIncompatibleRowNumbers (int arg1, int arg2, int arg3, int arg4)
 
static ::ExceptionBaseBlockMatrixBase< MatrixType >::ExcIncompatibleColNumbers (int arg1, int arg2, int arg3, int arg4)
 
static ::ExceptionBaseBlockSparseMatrix< number >::ExcBlockDimensionMismatch ()
 
static ::ExceptionBaseBlockSparsityPatternBase< SparsityPatternType >::ExcNeedsCollectSizes ()
 
static ::ExceptionBaseBlockSparsityPatternBase< SparsityPatternType >::ExcIncompatibleRowNumbers (int arg1, int arg2, int arg3, int arg4)
 
static ::ExceptionBaseBlockSparsityPatternBase< SparsityPatternType >::ExcIncompatibleColNumbers (int arg1, int arg2, int arg3, int arg4)
 
static ::ExceptionBaseBlockVector< Number >::ExcIteratorRangeDoesNotMatchVectorSize ()
 
static ::ExceptionBaseinternal::BlockVectorIterators::Iterator< BlockVectorType, Constness >::ExcPointerToDifferentVectors ()
 
static ::ExceptionBaseChunkSparseMatrix< number >::ExcInvalidIndex (int arg1, int arg2)
 
static ::ExceptionBaseChunkSparseMatrix< number >::ExcDifferentChunkSparsityPatterns ()
 
static ::ExceptionBaseChunkSparseMatrix< number >::ExcIteratorRange (int arg1, int arg2)
 
static ::ExceptionBaseChunkSparseMatrix< number >::ExcSourceEqualsDestination ()
 
static ::ExceptionBaseChunkSparsityPattern::ExcInvalidNumber (size_type arg1)
 
static ::ExceptionBaseChunkSparsityPattern::ExcInvalidIndex (size_type arg1, size_type arg2)
 
static ::ExceptionBaseChunkSparsityPattern::ExcNotEnoughSpace (size_type arg1, size_type arg2)
 
static ::ExceptionBaseChunkSparsityPattern::ExcNotCompressed ()
 
static ::ExceptionBaseChunkSparsityPattern::ExcMatrixIsCompressed ()
 
static ::ExceptionBaseChunkSparsityPattern::ExcEmptyObject ()
 
static ::ExceptionBaseChunkSparsityPattern::ExcIteratorRange (size_type arg1, size_type arg2)
 
static ::ExceptionBaseChunkSparsityPattern::ExcMETISNotInstalled ()
 
static ::ExceptionBaseChunkSparsityPattern::ExcInvalidNumberOfPartitions (size_type arg1)
 
static ::ExceptionBaseChunkSparsityPattern::ExcInvalidArraySize (size_type arg1, size_type arg2)
 
static ::ExceptionBaseLinearAlgebra::CUDAWrappers::Vector< Number >::ExcVectorTypeNotCompatible ()
 
static ::ExceptionBaseDynamicSparsityPatternIterators::Accessor::DummyAccessor ()
 
static ::ExceptionBaseLACExceptions::ExcNotQuadratic ()
 
static ::ExceptionBaseLACExceptions::ExcSingular ()
 
static ::ExceptionBaseLACExceptions::ExcDifferentBlockIndices ()
 
static ::ExceptionBaseLACExceptions::ExcNeedsSparsityPattern ()
 
static ::ExceptionBaseLACExceptions::ExcTrilinosError (int arg1)
 
static ::ExceptionBaseFullMatrix< number >::ExcEmptyMatrix ()
 
static ::ExceptionBaseFullMatrix< number >::ExcNotRegular (number arg1)
 
static ::ExceptionBaseFullMatrix< number >::ExcInvalidDestination (size_type arg1, size_type arg2, size_type arg3)
 
static ::ExceptionBaseFullMatrix< number >::ExcSourceEqualsDestination ()
 
static ::ExceptionBaseFullMatrix< number >::ExcMatrixNotPositiveDefinite ()
 
static ::ExceptionBaseLinearAlgebra::distributed::BlockVector< Number >::ExcVectorTypeNotCompatible ()
 
static ::ExceptionBaseLinearAlgebra::distributed::BlockVector< Number >::ExcIteratorRangeDoesNotMatchVectorSize ()
 
static ::ExceptionBaseLinearAlgebra::distributed::Vector< Number, MemorySpace >::ExcVectorTypeNotCompatible ()
 
static ::ExceptionBaseLinearAlgebra::distributed::Vector< Number, MemorySpace >::ExcNonMatchingElements (Number arg1, Number arg2, unsigned int arg3)
 
static ::ExceptionBaseLinearAlgebra::distributed::Vector< Number, MemorySpace >::ExcAccessToNonLocalElement (size_type arg1, size_type arg2, size_type arg3, size_type arg4)
 
static ::ExceptionBaseLAPACKSupport::ExcErrorCode (std::string arg1, types::blas_int arg2)
 
static ::ExceptionBaseLAPACKSupport::ExcState (State arg1)
 
static ::ExceptionBaseLAPACKSupport::ExcProperty (Property arg1)
 
static ::ExceptionBaseLAPACKSupport::ExcMissing (std::string arg1)
 
static ::ExceptionBaseMatrixBlock< MatrixType >::ExcBlockIndexMismatch (size_type arg1, size_type arg2)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcConvergedEigenvectors (int arg1, int arg2)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcInvalidNumberofEigenvalues (int arg1, int arg2)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcInvalidEigenvectorSize (int arg1, int arg2)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcInvalidEigenvectorSizeNonsymmetric (int arg1, int arg2)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcInvalidEigenvalueSize (int arg1, int arg2)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcInvalidNumberofArnoldiVectors (int arg1, int arg2)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcSmallNumberofArnoldiVectors (int arg1, int arg2)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcIdo (int arg1)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcMode (int arg1)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcInfoPdnaupd (int arg1)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcInfoPdneupd (int arg1)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcInfoMaxIt (int arg1)
 
static ::ExceptionBasePArpackSolver< VectorType >::PArpackExcNoShifts (int arg1)
 
static ::ExceptionBasePETScWrappers::MPI::BlockVector::ExcIteratorRangeDoesNotMatchVectorSize ()
 
static ::ExceptionBasePETScWrappers::MPI::BlockVector::ExcNonMatchingBlockVectors ()
 
static ::ExceptionBasePETScWrappers::MatrixIterators::const_iterator::Accessor::ExcBeyondEndOfMatrix ()
 
static ::ExceptionBasePETScWrappers::MatrixIterators::const_iterator::Accessor::ExcAccessToNonlocalRow (int arg1, int arg2, int arg3)
 
static ::ExceptionBasePETScWrappers::MatrixIterators::const_iterator::ExcInvalidIndexWithinRow (int arg1, int arg2)
 
static ::ExceptionBasePETScWrappers::MatrixBase::ExcSourceEqualsDestination ()
 
static ::ExceptionBasePETScWrappers::MatrixBase::ExcWrongMode (int arg1, int arg2)
 
static ::ExceptionBasePETScWrappers::MPI::SparseMatrix::ExcLocalRowsTooLarge (int arg1, int arg2)
 
static ::ExceptionBasePreconditionBlock< MatrixType, inverse_type >::ExcWrongBlockSize (int arg1, int arg2)
 
static ::ExceptionBasePreconditionBlock< MatrixType, inverse_type >::ExcInverseMatricesAlreadyExist ()
 
static ::ExceptionBasePreconditionBlockBase< number >::ExcDiagonalsNotStored ()
 
static ::ExceptionBasePreconditionBlockBase< number >::ExcInverseNotAvailable ()
 
static ::ExceptionBasePreconditionSelector< MatrixType, VectorType >::ExcNoMatrixGivenToUse ()
 
static ::ExceptionBaseSLEPcWrappers::SolverBase::ExcSLEPcWrappersUsageError ()
 
static ::ExceptionBaseSLEPcWrappers::SolverBase::ExcSLEPcError (int arg1)
 
static ::ExceptionBaseSLEPcWrappers::SolverBase::ExcSLEPcEigenvectorConvergenceMismatchError (int arg1, int arg2)
 
static ::ExceptionBaseSolverControl::ExcHistoryDataRequired ()
 
static ::ExceptionBaseSolverGMRES< VectorType >::ExcTooFewTmpVectors (int arg1)
 
static ::ExceptionBaseSolverMinRes< VectorType >::ExcPreconditionerNotDefinite ()
 
static ::ExceptionBaseSolverSelector< VectorType >::ExcSolverDoesNotExist (std::string arg1)
 
static ::ExceptionBaseSparseLUDecomposition< number >::ExcInvalidStrengthening (double arg1)
 
static ::ExceptionBaseSparseDirectUMFPACK::ExcUMFPACKError (std::string arg1, int arg2)
 
static ::ExceptionBaseSparseILU< number >::ExcInvalidStrengthening (double arg1)
 
static ::ExceptionBaseSparseILU< number >::ExcZeroPivot (size_type arg1)
 
static ::ExceptionBaseSparseMatrix< number >::ExcInvalidIndex (int arg1, int arg2)
 
static ::ExceptionBaseSparseMatrix< number >::ExcDifferentSparsityPatterns ()
 
static ::ExceptionBaseSparseMatrix< number >::ExcIteratorRange (int arg1, int arg2)
 
static ::ExceptionBaseSparseMatrix< number >::ExcSourceEqualsDestination ()
 
static ::ExceptionBaseSparseMatrixEZ< number >::ExcNoDiagonal ()
 
static ::ExceptionBaseSparseMatrixEZ< number >::ExcInvalidEntry (int arg1, int arg2)
 
static ::ExceptionBaseSparseMatrixEZ< number >::ExcEntryAllocationFailure (int arg1, int arg2)
 
static ::ExceptionBaseSparseMIC< number >::ExcStrengthenDiagonalTooSmall ()
 
static ::ExceptionBaseSparseMIC< number >::ExcInvalidStrengthening (double arg1)
 
static ::ExceptionBaseSparseMIC< number >::ExcDecompositionNotStable (int arg1, double arg2)
 
static ::ExceptionBaseSparsityPatternIterators::Accessor::DummyAccessor ()
 
static ::ExceptionBaseSparsityPattern::ExcIteratorRange (int arg1, int arg2)
 
static ::ExceptionBaseSparsityPattern::ExcInvalidNumberOfPartitions (int arg1)
 
static ::ExceptionBaseSparsityPattern::ExcNotEnoughSpace (int arg1, int arg2)
 
static ::ExceptionBaseSparsityPattern::ExcMatrixIsCompressed ()
 
static ::ExceptionBaseSparsityPattern::ExcNotCompressed ()
 
static ::ExceptionBaseSparsityTools::ExcMETISNotInstalled ()
 
static ::ExceptionBaseSparsityTools::ExcInvalidNumberOfPartitions (int arg1)
 
static ::ExceptionBaseSparsityTools::ExcMETISError (int arg1)
 
static ::ExceptionBaseSparsityTools::ExcInvalidArraySize (int arg1, int arg2)
 
static ::ExceptionBaseSparsityTools::ExcZOLTANNotInstalled ()
 
static ::ExceptionBaseTrilinosWrappers::BlockSparseMatrix::ExcIncompatibleRowNumbers (int arg1, int arg2, int arg3, int arg4)
 
static ::ExceptionBaseTrilinosWrappers::BlockSparseMatrix::ExcIncompatibleColNumbers (int arg1, int arg2, int arg3, int arg4)
 
static ::ExceptionBaseLinearAlgebra::EpetraWrappers::Vector::ExcDifferentParallelPartitioning ()
 
static ::ExceptionBaseLinearAlgebra::EpetraWrappers::Vector::ExcVectorTypeNotCompatible ()
 
static ::ExceptionBaseLinearAlgebra::EpetraWrappers::Vector::ExcTrilinosError (int arg1)
 
static ::ExceptionBaseTrilinosWrappers::MPI::BlockVector::ExcIteratorRangeDoesNotMatchVectorSize ()
 
static ::ExceptionBaseTrilinosWrappers::MPI::BlockVector::ExcNonMatchingBlockVectors ()
 
static ::ExceptionBaseTrilinosWrappers::PreconditionBase::ExcNonMatchingMaps (std::string arg1)
 
static ::ExceptionBaseTrilinosWrappers::SolverBase::ExcTrilinosError (int arg1)
 
static ::ExceptionBaseTrilinosWrappers::SolverDirect::ExcTrilinosError (int arg1)
 
static ::ExceptionBaseTrilinosWrappers::SparseMatrixIterators::ExcBeyondEndOfMatrix ()
 
static ::ExceptionBaseTrilinosWrappers::SparseMatrixIterators::ExcAccessToNonlocalRow (std::size_t arg1, std::size_t arg2, std::size_t arg3)
 
static ::ExceptionBaseTrilinosWrappers::SparseMatrixIterators::Iterator< Constness >::ExcInvalidIndexWithinRow (size_type arg1, size_type arg2)
 
static ::ExceptionBaseTrilinosWrappers::SparseMatrix::ExcAccessToNonlocalRow (std::size_t arg1)
 
static ::ExceptionBaseTrilinosWrappers::SparseMatrix::ExcTrilinosError (int arg1)
 
static ::ExceptionBaseTrilinosWrappers::SparseMatrix::ExcInvalidIndex (size_type arg1, size_type arg2)
 
static ::ExceptionBaseTrilinosWrappers::SparseMatrix::ExcSourceEqualsDestination ()
 
static ::ExceptionBaseTrilinosWrappers::SparseMatrix::ExcMatrixNotCompressed ()
 
static ::ExceptionBaseTrilinosWrappers::SparseMatrix::ExcAccessToNonLocalElement (size_type arg1, size_type arg2, size_type arg3, size_type arg4)
 
static ::ExceptionBaseTrilinosWrappers::SparseMatrix::ExcAccessToNonPresentElement (size_type arg1, size_type arg2)
 
static ::ExceptionBaseTrilinosWrappers::SparsityPatternIterators::Accessor::ExcBeyondEndOfSparsityPattern ()
 
static ::ExceptionBaseTrilinosWrappers::SparsityPatternIterators::Accessor::ExcAccessToNonlocalRow (size_type arg1, size_type arg2, size_type arg3)
 
static ::ExceptionBaseTrilinosWrappers::SparsityPatternIterators::Iterator::ExcInvalidIndexWithinRow (size_type arg1, size_type arg2)
 
static ::ExceptionBaseTrilinosWrappers::SparsityPattern::ExcTrilinosError (int arg1)
 
static ::ExceptionBaseTrilinosWrappers::SparsityPattern::ExcInvalidIndex (size_type arg1, size_type arg2)
 
static ::ExceptionBaseTrilinosWrappers::SparsityPattern::ExcAccessToNonLocalElement (size_type arg1, size_type arg2, size_type arg3, size_type arg4)
 
static ::ExceptionBaseTrilinosWrappers::SparsityPattern::ExcAccessToNonPresentElement (size_type arg1, size_type arg2)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::ExcTrilinosAmesos2SolverUnsupported (std::string arg1)
 The chosen Solver is not supported or configured with Amesos2.
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SolverDirectBase< Number, MemorySpace >::ExcTrilinosError (int arg1)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcAccessToNonlocalRow (std::size_t arg1)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcMatrixNotCompressed ()
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcSourceEqualsDestination ()
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcColMapMissmatch ()
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcDomainMapMissmatch ()
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcInvalidIndex (size_type arg1, size_type arg2)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcAccessToNonLocalElement (size_type arg1, size_type arg2, size_type arg3, size_type arg4)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparseMatrixIterators::ExcBeyondEndOfMatrix ()
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparseMatrixIterators::Iterator< Number, MemorySpace, Constness >::ExcInvalidIndexWithinRow (size_type arg1, size_type arg2)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparsityPatternIterators::Accessor< MemorySpace >::ExcBeyondEndOfSparsityPattern ()
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparsityPatternIterators::Accessor< MemorySpace >::ExcAccessToNonlocalRow (size_type arg1, size_type arg2, size_type arg3)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparsityPatternIterators::Iterator< MemorySpace >::ExcInvalidIndexWithinRow (size_type arg1, size_type arg2)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparsityPattern< MemorySpace >::ExcTrilinosError (int arg1)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparsityPattern< MemorySpace >::ExcInvalidIndex (size_type arg1, size_type arg2)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparsityPattern< MemorySpace >::ExcAccessToNonLocalElement (size_type arg1, size_type arg2, size_type arg3, size_type arg4)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::SparsityPattern< MemorySpace >::ExcAccessToNonPresentElement (size_type arg1, size_type arg2)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::ExcDifferentParallelPartitioning ()
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::ExcVectorTypeNotCompatible ()
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::ExcAccessToNonLocalElement (size_type arg1, size_type arg2, size_type arg3, size_type arg4)
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::ExcMissingIndexSet ()
 
static ::ExceptionBaseLinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::ExcTrilinosError (int arg1)
 
static ::ExceptionBaseTrilinosWrappers::MPI::Vector::ExcDifferentParallelPartitioning ()
 
static ::ExceptionBaseTrilinosWrappers::MPI::Vector::ExcTrilinosError (int arg1)
 
static ::ExceptionBaseTrilinosWrappers::MPI::Vector::ExcAccessToNonLocalElement (size_type arg1, size_type arg2, size_type arg3, size_type arg4)
 
static ::ExceptionBaseVectorMemory< VectorType >::ExcNotAllocatedHere ()
 
static ::ExceptionBaseinternal::ExcAccessToUninitializedField ()
 
static ::ExceptionBaseinternal::ExcMatrixFreeAccessToUninitializedMappingField (std::string arg1)
 
static ::ExceptionBaseinternal::FEPointEvaluation::ExcFEPointEvaluationAccessToUninitializedMappingField (std::string arg1)
 
static ::ExceptionBaseMeshWorker::LocalIntegrator< dim, spacedim, number >::ExcPureFunction ()
 
static ::ExceptionBaseMGTransferPrebuilt< VectorType >::ExcNoProlongation ()
 
static ::ExceptionBaseMGTransferPrebuilt< VectorType >::ExcMatricesNotBuilt ()
 
static ::ExceptionBaseMGTransferBlockBase::ExcMatricesNotBuilt ()
 
static ::ExceptionBaseMGTransferComponentBase::ExcMatricesNotBuilt ()
 
static ::ExceptionBaseExceptions::DataOutImplementation::ExcInvalidNumberOfSubdivisions (int arg1)
 
static ::ExceptionBaseExceptions::DataOutImplementation::ExcNoTriangulationSelected ()
 
static ::ExceptionBaseExceptions::DataOutImplementation::ExcNoDoFHandlerSelected ()
 
static ::ExceptionBaseExceptions::DataOutImplementation::ExcInvalidVectorSize (int arg1, int arg2, int arg3)
 
static ::ExceptionBaseExceptions::DataOutImplementation::ExcInvalidCharacter (std::string arg1, size_t arg2)
 
static ::ExceptionBaseExceptions::DataOutImplementation::ExcOldDataStillPresent ()
 
static ::ExceptionBaseExceptions::DataOutImplementation::ExcInvalidNumberOfNames (int arg1, int arg2)
 
static ::ExceptionBaseExceptions::DataOutImplementation::ExcIncompatibleDatasetNames ()
 
static ::ExceptionBaseExceptions::DataOutImplementation::ExcIncompatiblePatchLists ()
 
static ::ExceptionBaseExceptions::DataOutImplementation::ExcInvalidVectorDeclaration (int arg1, std::string arg2)
 
static ::ExceptionBaseExceptions::DataOutImplementation::ExcInvalidTensorDeclaration (int arg1, std::string arg2)
 
static ::ExceptionBaseDataOutRotation< dim, spacedim >::ExcRadialVariableHasNegativeValues (double arg1)
 
static ::ExceptionBaseDataOutStack< dim, spacedim >::ExcVectorNotDeclared (std::string arg1)
 
static ::ExceptionBaseDataOutStack< dim, spacedim >::ExcDataNotCleared ()
 
static ::ExceptionBaseDataOutStack< dim, spacedim >::ExcDataAlreadyAdded ()
 
static ::ExceptionBaseDataOutStack< dim, spacedim >::ExcNameAlreadyUsed (std::string arg1)
 
static ::ExceptionBaseDerivativeApproximation::ExcVectorLengthVsNActiveCells (int arg1, int arg2)
 
static ::ExceptionBaseDerivativeApproximation::ExcInsufficientDirections ()
 
static ::ExceptionBaseKellyErrorEstimator< dim, spacedim >::ExcInvalidComponentMask ()
 
static ::ExceptionBaseKellyErrorEstimator< dim, spacedim >::ExcInvalidCoefficient ()
 
static ::ExceptionBaseKellyErrorEstimator< dim, spacedim >::ExcInvalidBoundaryFunction (types::boundary_id arg1, int arg2, int arg3)
 
static ::ExceptionBaseKellyErrorEstimator< dim, spacedim >::ExcIncompatibleNumberOfElements (int arg1, int arg2)
 
static ::ExceptionBaseKellyErrorEstimator< dim, spacedim >::ExcNoSolutions ()
 
static ::ExceptionBaseKellyErrorEstimator< 1, spacedim >::ExcInvalidComponentMask ()
 
static ::ExceptionBaseKellyErrorEstimator< 1, spacedim >::ExcInvalidCoefficient ()
 
static ::ExceptionBaseKellyErrorEstimator< 1, spacedim >::ExcInvalidBoundaryFunction (types::boundary_id arg1, int arg2, int arg3)
 
static ::ExceptionBaseKellyErrorEstimator< 1, spacedim >::ExcIncompatibleNumberOfElements (int arg1, int arg2)
 
static ::ExceptionBaseKellyErrorEstimator< 1, spacedim >::ExcNoSolutions ()
 
static ::ExceptionBaseHistogram::ExcEmptyData ()
 
static ::ExceptionBaseHistogram::ExcIncompatibleArraySize (int arg1, int arg2)
 
static ::ExceptionBaseHistogram::ExcInvalidName (std::string arg1)
 
static ::ExceptionBaseMatrixCreator::ExcComponentMismatch ()
 
static ::ExceptionBaseMatrixTools::ExcBlocksDontMatch ()
 
static ::ExceptionBasePointValueHistory< dim >::ExcNoIndependent ()
 
static ::ExceptionBasePointValueHistory< dim >::ExcDataLostSync ()
 
static ::ExceptionBasePointValueHistory< dim >::ExcDoFHandlerRequired ()
 
static ::ExceptionBasePointValueHistory< dim >::ExcDoFHandlerChanged ()
 
static ::ExceptionBaseSolutionTransfer< dim, VectorType, spacedim >::ExcNotPrepared ()
 
static ::ExceptionBaseSolutionTransfer< dim, VectorType, spacedim >::ExcAlreadyPrepForRef ()
 
static ::ExceptionBaseSolutionTransfer< dim, VectorType, spacedim >::ExcAlreadyPrepForCoarseAndRef ()
 
static ::ExceptionBaseTimeDependent::ExcInvalidPosition ()
 
static ::ExceptionBaseTimeStepBase_Tria_Flags::RefinementFlags< dim >::ExcInvalidValue (double arg1)
 
static ::ExceptionBaseTimeStepBase_Tria_Flags::RefinementData< dim >::ExcInvalidValue (double arg1)
 
static ::ExceptionBaseTimeStepBase_Tria< dim >::ExcGridNotDeleted ()
 
static ::ExceptionBaseVectorTools::ExcPointNotAvailableHere ()
 
template<int dim>
static ::ExceptionBaseOpenCASCADE::ExcPointNotOnManifold (Point< dim > arg1)
 
template<int dim>
static ::ExceptionBaseOpenCASCADE::ExcProjectionFailed (Point< dim > arg1)
 
static ::ExceptionBaseOpenCASCADE::ExcOCCError (IFSelect_ReturnStatus arg1)
 
static ::ExceptionBaseOpenCASCADE::ExcEdgeIsDegenerate ()
 
static ::ExceptionBaseOpenCASCADE::ExcUnsupportedShape ()
 
static ::ExceptionBasePhysics::Notation::Kelvin::ExcNotationExcFullMatrixToTensorRowSize2 (int arg1, int arg2, int arg3)
 
static ::ExceptionBasePhysics::Notation::Kelvin::ExcNotationExcFullMatrixToTensorRowSize3 (int arg1, int arg2, int arg3, int arg4)
 
static ::ExceptionBasePhysics::Notation::Kelvin::ExcNotationExcFullMatrixToTensorColSize2 (int arg1, int arg2, int arg3)
 
static ::ExceptionBasePhysics::Notation::Kelvin::ExcNotationExcFullMatrixToTensorColSize3 (int arg1, int arg2, int arg3, int arg4)
 
static ::ExceptionBaseSUNDIALS::ARKode< VectorType >::ExcFunctionNotProvided (std::string arg1)
 
static ::ExceptionBaseSUNDIALS::ExcARKodeError (int arg1)
 
static ::ExceptionBaseSUNDIALS::IDA< VectorType >::ExcIDAError (int arg1)
 
static ::ExceptionBaseSUNDIALS::IDA< VectorType >::ExcFunctionNotProvided (std::string arg1)
 
static ::ExceptionBaseSUNDIALS::KINSOL< VectorType >::ExcKINSOLError (int arg1)
 
static ::ExceptionBaseSUNDIALS::KINSOL< VectorType >::ExcFunctionNotProvided (std::string arg1)
 
static ::ExceptionBaseTrilinosWrappers::ExcNOXNoConvergence ()
 
static ::ExceptionBaseGeometricUtilities::Coordinates::NegativeRadius (double arg1)
 
static ::ExceptionBaseGeometricUtilities::Coordinates::SphericalAzimuth (double arg1)
 
static ::ExceptionBaseGeometricUtilities::Coordinates::SphericalPolar (double arg1)
 
static ::ExceptionBaseUtilities::ExcInvalidNumber2StringConversersion (unsigned int arg1, unsigned int arg2)
 
static ::ExceptionBaseUtilities::ExcInvalidNumber (unsigned int arg1)
 
static ::ExceptionBaseUtilities::ExcCantConvertString (std::string arg1)
 
template<typename Number >
static ::ExceptionBaseExcNonMatchingElementsSetDofValuesByInterpolation (Number arg1, Number arg2)
 
static ::ExceptionBaseExcCellNotCartesian ()
 
static ::ExceptionBaseinternal::TriangulationImplementation::ExcInternalErrorOnCell (int arg1)
 
static ::ExceptionBaseinternal::TriangulationImplementation::ExcCellHasNegativeMeasure (int arg1)
 
static ::ExceptionBaseinternal::TriangulationImplementation::ExcInvalidVertexIndex (int arg1, int arg2, int arg3)
 
static ::ExceptionBaseinternal::TriangulationImplementation::ExcLineInexistant (int arg1, int arg2)
 
static ::ExceptionBaseinternal::TriangulationImplementation::ExcQuadInexistant (int arg1, int arg2, int arg3, int arg4)
 
static ::ExceptionBaseinternal::TriangulationImplementation::ExcInteriorLineCantBeBoundary (int arg1, int arg2, types::boundary_id arg3)
 
static ::ExceptionBaseinternal::TriangulationImplementation::ExcInteriorQuadCantBeBoundary (int arg1, int arg2, int arg3, int arg4, types::boundary_id arg5)
 
static ::ExceptionBaseinternal::TriangulationImplementation::ExcMultiplySetLineInfoOfLine (int arg1, int arg2)
 
static ::ExceptionBaseinternal::TriangulationImplementation::ExcInconsistentLineInfoOfLine (int arg1, int arg2, std::string arg3)
 
static ::ExceptionBaseinternal::TriangulationImplementation::ExcInconsistentQuadInfoOfQuad (int arg1, int arg2, int arg3, int arg4, std::string arg5)
 
static ::ExceptionBaseinternal::TriangulationImplementation::ExcMemoryInexact (int arg1, int arg2)
 
static ::ExceptionBaseNonMatching::internal::MeshClassifierImplementation::ExcReclassifyNotCalled ()
 
static ::ExceptionBaseNonMatching::internal::MeshClassifierImplementation::ExcTriangulationMismatch ()
 
static ::ExceptionBaseNonMatching::internal::DiscreteQuadratureGeneratorImplementation::ExcCellNotSet ()
 
static ::ExceptionBaseNonMatching::internal::DiscreteQuadratureGeneratorImplementation::ExcReferenceCellNotHypercube ()
 
static ::ExceptionBaseSUNDIALS::ExcSundialsSolverError (int arg1)
 

Exceptions

static ::ExceptionBaseDoFTools::ExcFiniteElementsDontMatch ()
 
static ::ExceptionBaseDoFTools::ExcGridNotCoarser ()
 
static ::ExceptionBaseDoFTools::ExcGridsDontMatch ()
 
static ::ExceptionBaseDoFTools::ExcNoFESelected ()
 
static ::ExceptionBaseDoFTools::ExcInvalidBoundaryIndicator ()
 

Data that supports the hp-FE implementation

static ::ExceptionBaseFEInterfaceValues< dim, spacedim >::ExcOnlyAvailableWithoutHP ()
 
static ::ExceptionBaseFEInterfaceValues< dim, spacedim >::ExcOnlyAvailableWithHP ()
 

Exceptions

static ::ExceptionBaseMapping< dim, spacedim >::ExcInvalidData ()
 
static ::ExceptionBaseMapping< dim, spacedim >::ExcTransformationFailed ()
 
static ::ExceptionBaseMapping< dim, spacedim >::ExcDistortedMappedCell (Point< spacedim > arg1, double arg2, int arg3)
 

Exceptions

static ::ExceptionBaseGridGenerator::ExcInvalidRadii ()
 
static ::ExceptionBaseGridGenerator::ExcInvalidRepetitions (int arg1)
 
static ::ExceptionBaseGridGenerator::ExcInvalidRepetitionsDimension (int arg1)
 
static ::ExceptionBaseGridGenerator::ExcInvalidInputOrientation ()
 

Exceptions

static ::ExceptionBaseGridTools::ExcInvalidNumberOfPartitions (int arg1)
 
static ::ExceptionBaseGridTools::ExcNonExistentSubdomain (int arg1)
 
static ::ExceptionBaseGridTools::ExcTriangulationHasBeenRefined ()
 
static ::ExceptionBaseGridTools::ExcScalingFactorNotPositive (double arg1)
 
static ::ExceptionBaseGridTools::ExcVertexNotUsed (unsigned int arg1)
 
static ::ExceptionBaseGridTools::ExcMeshNotOrientable ()
 

Exceptions

static ::ExceptionBaseTriangulation< dim, spacedim >::ExcInvalidLevel (int arg1, int arg2)
 
static ::ExceptionBaseTriangulation< dim, spacedim >::ExcTriangulationNotEmpty (int arg1, int arg2)
 
static ::ExceptionBaseTriangulation< dim, spacedim >::ExcGridReadError ()
 
static ::ExceptionBaseTriangulation< dim, spacedim >::ExcFacesHaveNoLevel ()
 
static ::ExceptionBaseTriangulation< dim, spacedim >::ExcEmptyLevel (int arg1)
 
static ::ExceptionBaseTriangulation< dim, spacedim >::ExcBoundaryIdNotFound (types::boundary_id arg1)
 
static ::ExceptionBaseTriangulation< dim, spacedim >::ExcInconsistentCoarseningFlags ()
 

Exceptions

static ::ExceptionBaseTriaRawIterator< Accessor >::ExcDereferenceInvalidCell (Accessor arg1)
 
static ::ExceptionBaseTriaRawIterator< Accessor >::ExcDereferenceInvalidObject (Accessor arg1)
 
static ::ExceptionBaseTriaRawIterator< Accessor >::ExcAdvanceInvalidObject ()
 
static ::ExceptionBaseTriaRawIterator< Accessor >::ExcInvalidComparison ()
 

Exceptions

static ::ExceptionBasehp::FECollection< dim, spacedim >::ExcNoFiniteElements ()
 

Data that supports the hp-FE implementation

static ::ExceptionBaseMeshWorker::ScratchData< dim, spacedim >::ExcOnlyAvailableWithoutHP ()
 
static ::ExceptionBaseMeshWorker::ScratchData< dim, spacedim >::ExcOnlyAvailableWithHP ()
 

Detailed Description

This module contains classes that are used in the exception mechanism of deal.II.

Brief overview

Exceptions are used in two different ways:

Detailed description

The error handling mechanism in deal.II is generally used in two ways. The first uses error checking in debug mode only and is useful for programs which are not fully tested. When the program shows no errors anymore, one may switch off error handling and get better performance by this, since checks for errors are done quite frequently in the library (a typical speed up is a factor of four!). This mode of exception generation is most useful for internal consistency checks such as range checking or checking of the validity of function arguments. Errors of this kind usually are programming errors and the program should abort with as detailed a message as possible, including location and reason for the generation of the exception.

The second mode is for error checks which should always be on, such as for I/O errors, failing memory requests and the like. It does not make much sense to turn this mode off, since this kind of errors may happen in tested and untested programs likewise. Exceptions of this kind do not terminate the program, rather they throw exceptions in the C++ manner, allowing the program to catch them and eventually do something about it. As it may be useful to have some information printed out if an exception could not be handled properly, additional information is passed along as for the first mode. The latter makes it necessary to provide a family of macros which enter this additional information into the exception class; this could in principle be done by the programmer himself each time by hand, but since the information can be obtained automatically, a macro is provided for this.

Both modes use exception classes, which need to have special features in additional to the C++ standard's std::exception class. Such a class is declared by the following lines of code:

DeclException2 (ExcDomain, int, int,
<< "Index= " << arg1 << "Upper Bound= " << arg2);
#define DeclException2(Exception2, type1, type2, outsequence)
Definition exceptions.h:539

This declares an exception class named ExcDomain, which has two variables as additional information (named arg1 and arg2 by default) and which outputs the given sequence (which is appended to an std::ostream variable's name, thus the weird syntax). There are other DeclExceptionN macros for exception classes with more or no parameters. By convention, the name of all exception classes starts with Exc... and most of them are declared locally to the class it is to be used in (a few very frequently found ones are also declared in the StandardExceptions namespace and are available everywhere). Declaring exceptions globally is possible but pollutes the global namespace, is less readable and most of the time unnecessary.

Since exception classes are declared the same way for both modes of error checking, it is possible to use an exception declared through the DeclExceptionN(...) macro family for both static as well as dynamic checks.

Use of the debug mode exceptions (static checks)

To use the exception mechanism for debug mode error checking, write lines like the following in your source code:

Assert (n<dim, ExcDomain(n,dim));
#define Assert(cond, exc)

which by macro expansion does essentially the following (though the actual code is slightly more complicated):

#ifdef DEBUG
if (!(cond))
{
// issue error of class ExcDomain(n,dim)
}
#else
// do nothing
#endif

That is, it issues an error only if the preprocessor variable DEBUG is set and if the given condition (in this case n < dim is violated).

If the exception was declared using the DeclException0 (...) macro, i.e., without any additional parameters, its name has nonetheless to be given with parentheses: Assert (i>m, ExcSomewhat());

How it works internally

If the DEBUG preprocessor directive is set, the call Assert (cond, exc); is basically converted by the preprocessor into the following sequence:

if (!(cond))
(__FILE__,
__LINE__,
__PRETTY_FUNCTION__,
#cond,
#exc,
exc);
void issue_error_noreturn(ExceptionHandling handling, const char *file, int line, const char *function, const char *cond, const char *exc_name, ExceptionType e)

(Note that function names and exact calling sequences may change over time, but the general principle remains the same.) I.e., if the given condition is violated, then the file and line in which the exception occurred as well as the condition itself and the call sequence of the exception object is passed to the deal_II_exceptions::internals::issue_error_noreturn() function. Additionally an object of the form given by exc is created (this is normally an unnamed object like in ExcDomain (n, dim) of class ExcDomain) and transferred to this function.

PRETTY_FUNCTION is a macro defined by some compilers and gives the name of the function. If another compiler is used, we try to set this function to something reasonable, if the compiler provides us with that, and "(not available)" otherwise.

In issue_error_noreturn, the given data is transferred into the exc object by calling the set_fields() function; Afterwards the program is either aborted (and information about the exception is printed to deallog) or the exception is thrown. The Assert macro does the first path (print and abort); AssertThrow does the second (throw). This behavior is consistent with the descriptions of static and dynamic assertions earlier in this document. If it can be obtained from the operating system, the output may also contain a stacktrace to show where the error happened. Several of the Tutorial programs programs show a typical output.

If the preprocessor variable DEBUG is not set then the Assert macro is expanded to {}.

Sometimes, there is no useful condition for an exception other than that the program flow should not have reached a certain point, e.g. a default section of a switch statement. In this case, raise the exception by the following construct:

static ::ExceptionBase & ExcInternalError()

See the step-7 and several other of the tutorial programs for a use of this construct.

As mentioned above, the program is terminated once a call to Assert fails. However, there is one case where we do not want to do this, namely when a C++ exception is active. The usual case where this happens is that someone throws an exception through the AssertThrow mechanism (see below) which, while the stack is unwound, leads to the destruction of other objects in stack frames above. If other objects refer to the objects being thus destroyed, some destructors raise an exception through Assert. If we would abort the program then, we would only ever see the message that an object is being destroyed which is still referenced from somewhere, but we would never see the original exception that triggered this. (You can see it in the debugger by putting a break point on the function __throw, but you cannot see it from the program itself.) In that case, we use a C++ standard library function to detect the presence of another active exception and do not terminate the program to allow that the thrown exception propagates to some place where its message can be displayed.

Since it is common that one failed assertion leads to a whole chain of others, we only ever print the very first message. If the program is then aborted, that is no problem. If it is not (since a C++ exception is active), only the first is displayed and a message about suppressed follow-up messages is shown.

Use of run-time exceptions (dynamic checks)

C++ has a mechanism to indicate that something exceptional has happened: exceptions that can be triggered by throw statements and captured by catch clauses, see for example https://en.wikipedia.org/wiki/C%2B%2B#Exception_handling and https://www.cplusplus.com/doc/tutorial/exceptions/ .

At some fundamental level, a typical C++ exception is an object that is placed in some special place, and then the function exits the current scope (e.g., the current function) through an exceptional return path. This is often enough to tell what problem triggered the exception, but more frequently it would be nice if one had more information: for example, in which line of the code the problem happened, or what non-existent entry of a sparse matrix the code wanted to write into.

Dynamic assertions in deal.II therefore extend this mechanism a bit. Typically, one would raise an exception by code such as

if (!(cond))
throw ExcSomething();

and catch it using the statement

try
{
do_something ();
}
catch (std::exception &e)
{
std::cerr << "Exception occurred:" << std::endl
<< e.what ()
<< std::endl;
do_something_to_receiver ();
}

std::exception is a standard C++ class providing basic functionality for exceptions, such as the virtual function what() that returns some information on the exception itself. This information is useful if an exception can't be handled properly, in which case as precise a description as possible should be printed.

The problem here is that to get significant and useful information out of what(), it is necessary to overload this function in our exception class and call the throw operator with additional arguments to the exception class. The first thing, overloading the what function is done using the DeclExceptionN macros, but putting the right information, which is the same as explained above for the Assert expansion, requires some work if one would want to write it down each time:

if (!(cond))
{
ExcSomething e(additional information);
e.set_fields (__FILE__, __LINE__, __PRETTY_FUNCTION__,
"condition as a string",
"name of condition as a string");
throw e;
};

For this purpose, the macro AssertThrow was invented. It does mainly the same job as does the Assert macro, but it does not abort the program; rather, it throws an exception as shown above. The mode of usage is

AssertThrow (cond, ExcSomething(additional information));
#define AssertThrow(cond, exc)

The condition to be checked is incorporated into the macro in order to allow passing the violated condition as a string. The expansion of the AssertThrow macro is not affected by the DEBUG preprocessor variable.

Description of the DeclExceptionN macro family

There is a whole family of DeclExceptionX macros where X is to be replaced by the number of additional parameters (0 to 5 presently). These macros are used to declare exception classes in the following way:

DeclException2 (ExcDomain,
int,
int,
<< " i=" << arg1 << ", m=" << arg2);

The first argument denotes the name of the exception class to be created. The next arguments are the types of the parameters (in this case there two types, corresponding to the X in DeclExceptionX) and finally the output sequence with which you can print additional information.

The syntax of the output sequence is a bit weird but gets clearer once you see how this macro is defined (again schematically, actual function names and definitions may change over time and be different):

class name : public ExceptionBase
{
public:
name (const type1 a1, const type2 a2) : arg1 (a1), arg2(a2)
{}
virtual void print_info (std::ostream &out) const
{
out << " " outsequence << std::endl;
}
private:
type1 arg1;
type2 arg2;
};

If declared as specified, you can later use this exception class in the following manner:

int i=5;
int m=3;
Assert (i<m, MyExc2(i,m));

and the output if the condition fails will be

--------------------------------------------------------
An error occurred in line <301> of file <exc-test.cc>.
The violated condition was:
i<m
The name and call sequence of the exception was:
MyExc2(i,m)
Additional Information:
i=5, m=3
--------------------------------------------------------

Obviously for the DeclException0(name) macro, no types and also no output sequence is allowed.

A corner case of Assert: The AssertNothrow macro

The default implementation of the Assert macro, as discussed above, prints detailed information about what exactly went wrong to the screen and then aborts the program. Aborting the program is useful because it allows easily finding the place where something went wrong – including all of the information how we got to that place – by running the program in a debugger.

On the other hand, there are cases where aborting a program may be undesirable and one needs to exit in a somewhat more graceful way – even if there is really not very much one can do in these cases to still produce a meaningful result. An example is if a deal.II program is run a one module in a bigger framework of software. Think, for example, of a case where a deal.II program computed the flow field that corresponds to a set of input variables provided by some optimization routine: if the optimizer on the outside provided a negative density as input (a condition one might want to check via Assert), then this clearly makes no sense, and the flow solver cannot produce a meaningful answer; but it should tell that to the optimizer nicely, rather than just aborting the entire process (optimizer and flow solver).

For this purpose, one can call deal_II_exceptions::disable_abort_on_exception() that switches what Assert does from aborting the program to essentially the same as AssertThrow does, namely using the C++ throw mechanism to raise an exception. This exception can then be caught at a higher level – e.g., in the optimization routine that sits atop the flow solver, and that can then decide what it wants to do with the situation.

This is all nice and good, but C++ does not allow throwing exceptions inside the destructors of classes, or in a function that is currently being called from a destructor higher up in the call stack. To this end, there is a separate macro, AssertNothrow, that can be used in destructors: It acts just like Assert usually does – in particular, it only checks the condition in debug mode – but it is immune to the effect of deal_II_exceptions::disable_abort_on_exception(): It will only ever abort the program, and never throw an exception.

Macro Definition Documentation

◆ DeclException0

#define DeclException0 (   Exception0)
Value:
\
static ::ExceptionBase &Exception0()

Declare an exception class derived from ExceptionBase without parameters.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 471 of file exceptions.h.

◆ DeclExceptionMsg

#define DeclExceptionMsg (   Exception,
  defaulttext 
)
Value:
\
\
static ::ExceptionBase &Exception()

Declare an exception class derived from ExceptionBase that can take one runtime argument, but if none is given in the place where you want to throw the exception, it simply reverts to the default text provided when declaring the exception class through this macro.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 494 of file exceptions.h.

◆ DeclException1

#define DeclException1 (   Exception1,
  type1,
  outsequence 
)
Value:
\
\
static ::ExceptionBase &Exception1(type1 arg1)

Declare an exception class derived from ExceptionBase with one additional parameter.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 516 of file exceptions.h.

◆ DeclException2

#define DeclException2 (   Exception2,
  type1,
  type2,
  outsequence 
)
Value:
\
\
static ::ExceptionBase &Exception2(type1 arg1, type2 arg2)

Declare an exception class derived from ExceptionBase with two additional parameters.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 539 of file exceptions.h.

◆ DeclException3

#define DeclException3 (   Exception3,
  type1,
  type2,
  type3,
  outsequence 
)
Value:
\
\
static ::ExceptionBase &Exception3(type1 arg1, type2 arg2, type3 arg3)

Declare an exception class derived from ExceptionBase with three additional parameters.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 562 of file exceptions.h.

◆ DeclException4

#define DeclException4 (   Exception4,
  type1,
  type2,
  type3,
  type4,
  outsequence 
)
Value:
\
\
static ::ExceptionBase &Exception4(type1 arg1, \
type2 arg2, \
type3 arg3, \
type4 arg4)

Declare an exception class derived from ExceptionBase with four additional parameters.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 585 of file exceptions.h.

◆ DeclException5

#define DeclException5 (   Exception5,
  type1,
  type2,
  type3,
  type4,
  type5,
  outsequence 
)
Value:
\
\
static ::ExceptionBase &Exception5( \
type1 arg1, type2 arg2, type3 arg3, type4 arg4, type5 arg5)

Declare an exception class derived from ExceptionBase with five additional parameters.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 611 of file exceptions.h.

◆ Assert

#define Assert (   cond,
  exc 
)
Value:
do \
{ \
if (!(cond)) \
Kokkos::abort(#cond); \
} \
while (false)

A macro that serves as the main routine in the exception mechanism for debug mode error checking. It asserts that a certain condition is fulfilled, otherwise issues an error and aborts the program.

A more detailed description can be found in the Exceptions and assertions module. It is first used in step-5 and step-6. See also the ExceptionBase class for more information.

Note
Active in DEBUG mode only
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 1638 of file exceptions.h.

◆ AssertNothrow

#define AssertNothrow (   cond,
  exc 
)
Value:
do \
{ \
if (__builtin_expect(!(cond), false)) \
::deal_II_exceptions::internals::issue_error_nothrow( \
__FILE__, __LINE__, __PRETTY_FUNCTION__, #cond, #exc, exc); \
} \
while (false)

A variant of the Assert macro above that exhibits the same runtime behavior as long as disable_abort_on_exception was not called.

However, if disable_abort_on_exception was called, this macro merely prints the exception that would be thrown to deallog and continues normally without throwing an exception.

A more detailed description can be found in the Exceptions and assertions module, in the discussion about the corner case at the bottom of the page.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.
Active in DEBUG mode only

Definition at line 1685 of file exceptions.h.

◆ AssertThrow

#define AssertThrow (   cond,
  exc 
)
Value:
do \
{ \
if (__builtin_expect(!(cond), false)) \
::deal_II_exceptions::internals::issue_error_noreturn( \
throw_on_exception, \
__FILE__, \
__LINE__, \
__PRETTY_FUNCTION__, \
#cond, \
#exc, \
exc); \
} \
while (false)

A macro that serves as the main routine in the exception mechanism for dynamic error checking. It asserts that a certain condition is fulfilled, otherwise throws an exception via the C++ throw mechanism. This exception can be caught via a catch clause, as is shown in step-6 and all following tutorial programs.

A more detailed description can be found in the Exceptions and assertions module. It is first used in step-9 and step-13. See also the ExceptionBase class for more information.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.
Active in both DEBUG and RELEASE modes

Definition at line 1739 of file exceptions.h.

◆ AssertDimension

#define AssertDimension (   dim1,
  dim2 
)
Value:
dim2), \
::ExcDimensionMismatch((dim1), (dim2)))
static ::ExceptionBase & ExcDimensionMismatch(std::size_t arg1, std::size_t arg2)
constexpr bool compare_for_equality(const T &t, const U &u)

Special assertion for dimension mismatch.

Since this is used very often and always repeats the arguments, we introduce this special assertion for ExcDimensionMismatch in order to keep the user codes shorter.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 1985 of file exceptions.h.

◆ AssertVectorVectorDimension

#define AssertVectorVectorDimension (   VEC,
  DIM1,
  DIM2 
)
Value:
AssertDimension(VEC.size(), DIM1); \
for (const auto &subvector : VEC) \
{ \
(void)subvector; \
AssertDimension(subvector.size(), DIM2); \
}
#define AssertDimension(dim1, dim2)

An assertion that tests whether vec has size dim1, and each entry of the vector is itself an array that has the size dim2.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 2008 of file exceptions.h.

◆ AssertIndexRange

#define AssertIndexRange (   index,
  range 
)
Value:
range), \
std::common_type_t<decltype(index), decltype(range)>)>>((index), \
0, \
(range)))
static ::ExceptionBase & ExcIndexRangeType(T arg1, T arg2, T arg3)
constexpr bool compare_less_than(const T &t, const U &u)
typename argument_type< F >::type argument_type_t

An assertion that tests that a given index is within the half-open range [0,range). It throws an exception object ExcIndexRange(index,0,range) if the assertion fails.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 2053 of file exceptions.h.

◆ AssertIsFinite

#define AssertIsFinite (   number)
Value:
::ExcNumberNotFinite(std::complex<double>(number)))
static ::ExceptionBase & ExcNumberNotFinite(std::complex< double > arg1)
bool is_finite(const double x)
Definition numbers.h:538

An assertion that checks whether a number is finite or not. We explicitly cast the number to std::complex to match the signature of the exception (see there for an explanation of why we use std::complex at all) and to satisfy the fact that std::complex has no implicit conversions.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 2080 of file exceptions.h.

◆ AssertThrowMPI

#define AssertThrowMPI (   error_code)     AssertThrow(error_code == MPI_SUCCESS, ::ExcMPI(error_code))

An assertion that checks whether or not an error code returned by an MPI function is equal to MPI_SUCCESS. If the check fails then an exception of type ExcMPI is thrown with the given error code as an argument.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.
Active only if deal.II is compiled with MPI

Definition at line 2112 of file exceptions.h.

◆ AssertCuda

#define AssertCuda (   error_code)
Value:
Assert(error_code == cudaSuccess, \
::ExcCudaError(cudaGetErrorString(error_code)))
static ::ExceptionBase & ExcCudaError(const char *arg1)

An assertion that checks that the error code produced by calling a CUDA routine is equal to cudaSuccess.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 2141 of file exceptions.h.

◆ AssertNothrowCuda

#define AssertNothrowCuda (   error_code)
Value:
AssertNothrow(error_code == cudaSuccess, \
::ExcCudaError(cudaGetErrorString(error_code)))
#define AssertNothrow(cond, exc)

The non-throwing equivalent of AssertCuda.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 2170 of file exceptions.h.

◆ AssertCudaKernel

#define AssertCudaKernel ( )
Value:
do \
{ \
cudaError_t local_error_code = cudaPeekAtLastError(); \
AssertCuda(local_error_code); \
local_error_code = cudaDeviceSynchronize(); \
AssertCuda(local_error_code); \
} \
while (false)

An assertion that checks that the kernel was launched and executed successfully.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 2200 of file exceptions.h.

◆ AssertCusparse

#define AssertCusparse (   error_code)
Value:
Assert( \
error_code == CUSPARSE_STATUS_SUCCESS, \
error_code)))
static ::ExceptionBase & ExcCusparseError(std::string arg1)
std::string get_cusparse_error_string(const cusparseStatus_t error_code)

An assertion that checks that the error code produced by calling a cuSPARSE routine is equal to CUSPARSE_STATUS_SUCCESS.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 2235 of file exceptions.h.

◆ AssertNothrowCusparse

#define AssertNothrowCusparse (   error_code)
Value:
error_code == CUSPARSE_STATUS_SUCCESS, \
error_code)))

The non-throwing equivalent of AssertCusparse.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 2267 of file exceptions.h.

◆ AssertCusolver

#define AssertCusolver (   error_code)
Value:
Assert( \
error_code == CUSOLVER_STATUS_SUCCESS, \
error_code)))
std::string get_cusolver_error_string(const cusolverStatus_t error_code)

An assertion that checks that the error code produced by calling a cuSOLVER routine is equal to CUSOLVER_STATUS_SUCCESS.

Note
This and similar macro names are examples of preprocessor definitions in the deal.II library that are not prefixed by a string that likely makes them unique to deal.II. As a consequence, it is possible that other libraries your code interfaces with define the same name, and the result will be name collisions (see https://en.wikipedia.org/wiki/Name_collision). One can #undef this macro, as well as all other macros defined by deal.II that are not prefixed with either DEAL or deal, by including the header deal.II/base/undefine_macros.h after all other deal.II headers have been included.

Definition at line 2300 of file exceptions.h.

Function Documentation

◆ ExcNameNotFound() [1/2]

static ::ExceptionBase & AnyData::ExcNameNotFound ( std::string  arg1)
static

An entry with this name does not exist in the AnyData object.

Note
The message that will be printed by this exception reads:
<< "No entry with the name " << arg1 << " exists."

◆ ExcTypeMismatch() [1/2]

static ::ExceptionBase & AnyData::ExcTypeMismatch ( std::string  arg1,
std::string  arg2 
)
static

The requested type and the stored type are different.

Note
The message that will be printed by this exception reads:
<< "The requested type " << arg1 << " and the stored type " << arg2 << " must coincide."

◆ ExcNameMismatch()

static ::ExceptionBase & AnyData::ExcNameMismatch ( int  arg1,
std::string  arg2 
)
static

Exception indicating that a function expected a vector to have a certain name, but we store a different name in that position.

Note
The message that will be printed by this exception reads:
<< "Name at position " << arg1 << " is not equal to " << arg2 << '.'

◆ ExcNameNotFound() [2/2]

static ::ExceptionBase & GeneralDataStorage::ExcNameNotFound ( std::string  arg1)
static

An entry with this name does not exist in the internal std::any map.

Note
The message that will be printed by this exception reads:
<< "No entry with the name " << arg1 << " exists."

◆ ExcNameHasBeenFound()

static ::ExceptionBase & GeneralDataStorage::ExcNameHasBeenFound ( std::string  arg1)
static

An entry with this name does not exist in the internal std::any map.

Note
The message that will be printed by this exception reads:
<< "An entry with the name " << arg1 << " already exists."

◆ ExcTypeMismatch() [2/2]

static ::ExceptionBase & GeneralDataStorage::ExcTypeMismatch ( std::string  arg1,
const char *  arg2,
const char *  arg3 
)
static

The requested type and the stored type are different.

Note
The message that will be printed by this exception reads:
<< "The stored type for entry with name \"" << arg1 << "\" is " << arg2 << " but you requested type " << arg3 << '.'

◆ ExcAlignedVectorChangeAfterReplication()

template<class T >
static ::ExceptionBase & AlignedVector< T >::ExcAlignedVectorChangeAfterReplication ( )
static

Exception message for changing the vector after a call to replicate_across_communicator().

Note
The message that will be printed by this exception reads:
"Changing the vector after a call to " "replicate_across_communicator() is not allowed."

◆ ExcRateColumnAlreadyExists()

static ::ExceptionBase & ConvergenceTable::ExcRateColumnAlreadyExists ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Rate column <" << arg1 << "> does already exist."

◆ ExcInvalidCombinationOfDimensions() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & DataOutBase::Patch< dim, spacedim >::ExcInvalidCombinationOfDimensions ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "It is not possible to have a structural dimension of " << arg1 << " to be larger than the space dimension of the surrounding" << " space " << arg2

◆ ExcInvalidCombinationOfDimensions() [2/2]

template<int spacedim>
static ::ExceptionBase & DataOutBase::Patch< 0, spacedim >::ExcInvalidCombinationOfDimensions ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "It is not possible to have a structural dimension of " << arg1 << " to be larger than the space dimension of the surrounding" << " space " << arg2

◆ ExcNotEnoughSpaceDimensionLabels()

static ::ExceptionBase & DataOutBase::GnuplotFlags::ExcNotEnoughSpaceDimensionLabels ( )
static

Exception to raise when there are not enough specified dimension labels.

Note
The message that will be printed by this exception reads:
"There should be at least one space dimension per spatial " "dimension (extras are ignored)."

◆ ExcInvalidDatasetSize()

static ::ExceptionBase & DataOutBase::ExcInvalidDatasetSize ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The number of points in this data set is " << arg1 << ", but we expected " << arg2 << " in each space direction."

◆ ExcNoPatches()

static ::ExceptionBase & DataOutBase::ExcNoPatches ( )
static

An output function did not receive any patches for writing.

Note
The message that will be printed by this exception reads:
"You are trying to write graphical data into a file, but " "no data is available in the intermediate format that " "the DataOutBase functions require. Did you forget to " "call a function such as DataOut::build_patches()?"

◆ ExcTecplotAPIError()

static ::ExceptionBase & DataOutBase::ExcTecplotAPIError ( )
static

Exception

Note
The message that will be printed by this exception reads:
"The error code of one of the Tecplot functions was " "not zero as expected."

◆ ExcErrorOpeningTecplotFile()

static ::ExceptionBase & DataOutBase::ExcErrorOpeningTecplotFile ( char *  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "There was an error opening Tecplot file " << arg1 << " for output."

◆ ExcIncompatibleDatasetNames() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & DataOutReader< dim, spacedim >::ExcIncompatibleDatasetNames ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are trying to merge two sets of patches for which the " "declared names of the variables do not match."

◆ ExcIncompatiblePatchLists() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & DataOutReader< dim, spacedim >::ExcIncompatiblePatchLists ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are trying to merge two sets of patches for which the " "number of subdivisions or the number of vector components " "do not match."

◆ ExcIncompatibleDimensions()

template<int dim, int spacedim = dim>
static ::ExceptionBase & DataOutReader< dim, spacedim >::ExcIncompatibleDimensions ( int  arg1,
int  arg2,
int  arg3,
int  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Either the dimensions <" << arg1 << "> and <" << arg2 << "> or the space dimensions <" << arg3 << "> and <" << arg4 << "> do not match!"

◆ ExcInvalidTensorIndex()

template<int order, int dim, int spacedim, typename Number = double>
static ::ExceptionBase & DerivativeForm< order, dim, spacedim, Number >::ExcInvalidTensorIndex ( int  arg1)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "Invalid DerivativeForm index " << arg1

◆ ExcDivideByZero()

static ::ExceptionBase & StandardExceptions::ExcDivideByZero ( )
staticprivate

Exception denoting a division by zero.

Note
The message that will be printed by this exception reads:
"A piece of code is attempting a division by zero. This is " "likely going to lead to results that make no sense."

◆ ExcNumberNotFinite()

static ::ExceptionBase & StandardExceptions::ExcNumberNotFinite ( std::complex< double >  arg1)
staticprivate

Exception raised if a number is not finite.

This exception should be used to catch infinite or not a number results of arithmetic operations that do not result from a division by zero (use ExcDivideByZero for those).

The exception uses std::complex as its argument to ensure that we can use it for all scalar arguments (real or complex-valued).

Note
The message that will be printed by this exception reads:
<< "In a significant number of places, deal.II checks that some intermediate " << "value is a finite number (as opposed to plus or minus infinity, or " << "NaN/Not a Number). In the current function, we encountered a number " << "that is not finite (its value is " << arg1 << " and therefore " << "violates the current assertion).\n\n" << "This may be due to the fact that some operation in this function " << "created such a value, or because one of the arguments you passed " << "to the function already had this value from some previous " << "operation. In the latter case, this function only triggered the " << "error but may not actually be responsible for the computation of " << "the number that is not finite.\n\n" << "There are two common cases where this situation happens. First, your " << "code (or something in deal.II) divides by zero in a place where this " << "should not happen. Or, you are trying to solve a linear system " << "with an unsuitable solver (such as an indefinite or non-symmetric " << "linear system using a Conjugate Gradient solver); such attempts " << "oftentimes yield an operation somewhere that tries to divide " << "by zero or take the square root of a negative value.\n\n" << "In any case, when trying to find the source of the error, " << "recall that the location where you are getting this error is " << "simply the first place in the program where there is a check " << "that a number (e.g., an element of a solution vector) is in fact " << "finite, but that the actual error that computed the number " << "may have happened far earlier. To find this location, you " << "may want to add checks for finiteness in places of your " << "program visited before the place where this error is produced. " << "One way to check for finiteness is to use the 'AssertIsFinite' " << "macro."

◆ ExcOutOfMemory()

static ::ExceptionBase & StandardExceptions::ExcOutOfMemory ( std::size_t  arg1)
staticprivate

Trying to allocate a new object failed due to lack of free memory.

Note
The message that will be printed by this exception reads:
"Your program tried to allocate some memory but this " "allocation failed. Typically, this either means that " "you simply do not have enough memory in your system, " "or that you are (erroneously) trying to allocate " "a chunk of memory that is simply beyond all reasonable " "size, for example because the size of the object has " "been computed incorrectly." "\n\n" "In the current case, the request was for " << arg1 << " bytes."

◆ ExcMemoryLeak()

static ::ExceptionBase & StandardExceptions::ExcMemoryLeak ( int  arg1)
staticprivate

A memory handler reached a point where all allocated objects should have been released. Since this exception is thrown, some were still allocated.

Note
The message that will be printed by this exception reads:
<< "Destroying memory handler while " << arg1 << " objects are still allocated."

◆ ExcIO()

static ::ExceptionBase & StandardExceptions::ExcIO ( )
staticprivate

An error occurred reading or writing a file.

Note
The message that will be printed by this exception reads:
"An input/output error has occurred. There are a number of " "reasons why this may be happening, both for reading and " "writing operations." "\n\n" "If this happens during an operation that tries to read " "data: First, you may be " "trying to read from a file that doesn't exist or that is " "not readable given its file permissions. Second, deal.II " "uses this error at times if it tries to " "read information from a file but where the information " "in the file does not correspond to the expected format. " "An example would be a truncated file, or a mesh file " "that contains not only sections that describe the " "vertices and cells, but also sections for additional " "data that deal.II does not understand." "\n\n" "If this happens during an operation that tries to write " "data: you may be trying to write to a file to which file " "or directory permissions do not allow you to write. A " "typical example is where you specify an output file in " "a directory that does not exist."

◆ ExcFileNotOpen()

static ::ExceptionBase & StandardExceptions::ExcFileNotOpen ( std::string  arg1)
staticprivate

An error occurred opening the named file.

The constructor takes a single argument of type std::string naming the file.

Note
The message that will be printed by this exception reads:
<< "Could not open file " << arg1 << "." "\n\n" "If this happens during an operation that tries to read " "data: you may be " "trying to read from a file that doesn't exist or that is " "not readable given its file permissions." "\n\n" "If this happens during an operation that tries to write " "data: you may be trying to write to a file to which file " "or directory permissions do not allow you to write. A " "typical example is where you specify an output file in " "a directory that does not exist."

◆ ExcNotImplemented()

static ::ExceptionBase & StandardExceptions::ExcNotImplemented ( )
staticprivate

Exception denoting a part of the library or application program that has not yet been implemented. In many cases, this only indicates that there wasn't much need for something yet, not that this is difficult to implement. It is therefore quite worth the effort to take a look at the corresponding place and see whether it can be implemented without too much effort.

Note
The message that will be printed by this exception reads:
"You are trying to use functionality in deal.II that is " "currently not implemented. In many cases, this indicates " "that there simply didn't appear much of a need for it, or " "that the author of the original code did not have the " "time to implement a particular case. If you hit this " "exception, it is therefore worth the time to look into " "the code to find out whether you may be able to " "implement the missing functionality. If you do, please " "consider providing a patch to the deal.II development " "sources (see the deal.II website on how to contribute)."

◆ ExcInternalError()

static ::ExceptionBase & StandardExceptions::ExcInternalError ( )
staticprivate

This exception usually indicates that some condition which the programmer thinks must be satisfied at a certain point in an algorithm, is not fulfilled. This might be due to some programming error above, due to changes to the algorithm that did not preserve this assertion, or due to assumptions the programmer made that are not valid at all (i.e. the exception is thrown although there is no error here). Within the library, this exception is most often used when we write some kind of complicated algorithm and are not yet sure whether we got it right; we then put in assertions after each part of the algorithm that check for some conditions that should hold there, and throw an exception if they do not.

We usually leave in these assertions even after we are confident that the implementation is correct, since if someone later changes or extends the algorithm, these exceptions will indicate to them if they violate assumptions that are used later in the algorithm. Furthermore, it sometimes happens that an algorithm does not work in very rare corner cases. These cases will then be trapped sooner or later by the exception, so that the algorithm can then be fixed for these cases as well.

Note
The message that will be printed by this exception reads:
"This exception -- which is used in many places in the " "library -- usually indicates that some condition which " "the author of the code thought must be satisfied at a " "certain point in an algorithm, is not fulfilled. An " "example would be that the first part of an algorithm " "sorts elements of an array in ascending order, and " "a second part of the algorithm later encounters an " "element that is not larger than the previous one." "\n\n" "There is usually not very much you can do if you " "encounter such an exception since it indicates an error " "in deal.II, not in your own program. Try to come up with " "the smallest possible program that still demonstrates " "the error and contact the deal.II mailing lists with it " "to obtain help."

◆ ExcPureFunctionCalled()

static ::ExceptionBase & StandardExceptions::ExcPureFunctionCalled ( )
staticprivate

This exception is used in functions that may not be called (i.e. in pure functions) but could not be declared pure since the class is intended to be used anyway, even though the respective function may only be called if a derived class is used.

Note
The message that will be printed by this exception reads:
"You (or a place in the library) are trying to call a " "function that is declared as a virtual function in a " "base class but that has not been overridden in your " "derived class." "\n\n" "This exception happens in cases where the base class " "cannot provide a useful default implementation for " "the virtual function, but where we also do not want " "to mark the function as abstract (i.e., with '=0' at the end) " "because the function is not essential to the class in many " "contexts. In cases like this, the base class provides " "a dummy implementation that makes the compiler happy, but " "that then throws the current exception." "\n\n" "A concrete example would be the 'Function' class. It declares " "the existence of 'value()' and 'gradient()' member functions, " "and both are marked as 'virtual'. Derived classes have to " "override these functions for the values and gradients of a " "particular function. On the other hand, not every function " "has a gradient, and even for those that do, not every program " "actually needs to evaluate it. Consequently, there is no " "*requirement* that a derived class actually override the " "'gradient()' function (as there would be had it been marked " "as abstract). But, since the base class cannot know how to " "compute the gradient, if a derived class does not override " "the 'gradient()' function and it is called anyway, then the " "default implementation in the base class will simply throw " "an exception." "\n\n" "The exception you see is what happens in cases such as the " "one just illustrated. To fix the problem, you need to " "investigate whether the function being called should indeed have " "been called; if the answer is 'yes', then you need to " "implement the missing override in your class."

◆ ExcFunctionNotProvided() [1/4]

static ::ExceptionBase & StandardExceptions::ExcFunctionNotProvided ( std::string  arg1)
staticprivate

This exception is used if some user function is not provided.

Note
The message that will be printed by this exception reads:
<< "Please provide an implementation for the function \"" << arg1 << "\""

◆ ExcFunctionNonzeroReturn()

static ::ExceptionBase & StandardExceptions::ExcFunctionNonzeroReturn ( std::string  arg1,
int  arg2 
)
staticprivate

This exception is used if some user function returns nonzero exit codes.

Note
The message that will be printed by this exception reads:
<< "The function \"" << arg1 << "\" returned the nonzero value " << arg2 << ", but the calling site expected the return value to be zero. " "This error often happens when the function in question is a 'callback', " "that is a user-provided function called from somewhere within deal.II " "or within an external library such as PETSc, Trilinos, SUNDIALS, etc., " "that expect these callbacks to indicate errors via nonzero return " "codes."

◆ ExcNotInitialized()

static ::ExceptionBase & StandardExceptions::ExcNotInitialized ( )
staticprivate

This exception is used if some object is found uninitialized.

◆ ExcInvalidState() [1/2]

static ::ExceptionBase & StandardExceptions::ExcInvalidState ( )
staticprivate

The object is in a state not suitable for this operation.

◆ ExcImpossibleInDim()

static ::ExceptionBase & StandardExceptions::ExcImpossibleInDim ( int  arg1)
staticprivate

This exception is raised if a functionality is not possible in the given dimension. Mostly used to throw function calls in 1d.

The constructor takes a single int, denoting the dimension.

Note
The message that will be printed by this exception reads:
<< "You are trying to execute functionality that is " << "impossible in " << arg1 << "d or simply does not make any sense."

◆ ExcImpossibleInDimSpacedim()

static ::ExceptionBase & StandardExceptions::ExcImpossibleInDimSpacedim ( int  arg1,
int  arg2 
)
staticprivate

This exception is raised if a functionality is not possible in the given combination of dimension and space-dimension.

The constructor takes two int, denoting the dimension and the space dimension.

Note
The message that will be printed by this exception reads:
<< "You are trying to execute functionality that is " << "impossible in dimensions <" << arg1 << ',' << arg2 << "> or simply does not make any sense."

◆ ExcZero()

static ::ExceptionBase & StandardExceptions::ExcZero ( )
staticprivate

A number is zero, but it should not be here.

Note
The message that will be printed by this exception reads:
"In a check in the code, deal.II encountered a zero in " "a place where this does not make sense. See the condition " "that was being checked and that is printed further up " "in the error message to get more information on what " "the erroneous zero corresponds to."

◆ ExcEmptyObject() [1/2]

static ::ExceptionBase & StandardExceptions::ExcEmptyObject ( )
staticprivate

The object should have been filled with something before this member function is called.

Note
The message that will be printed by this exception reads:
"The object you are trying to access is empty but it makes " "no sense to attempt the operation you are trying on an " "empty object."

◆ ExcDimensionMismatch()

static ::ExceptionBase & StandardExceptions::ExcDimensionMismatch ( std::size_t  arg1,
std::size_t  arg2 
)
staticprivate

This exception is raised whenever the sizes of two objects were assumed to be equal, but were not.

Parameters to the constructor are the first and second size, both of type int.

Note
The message that will be printed by this exception reads:
<< "Two sizes or dimensions were supposed to be equal, " << "but aren't. They are " << arg1 << " and " << arg2 << '.'

◆ ExcDimensionMismatch2()

static ::ExceptionBase & StandardExceptions::ExcDimensionMismatch2 ( std::size_t  arg1,
std::size_t  arg2,
std::size_t  arg3 
)
staticprivate

The first dimension should be either equal to the second or the third, but it is neither.

Note
The message that will be printed by this exception reads:
<< "The size or dimension of one object, " << arg1 << " was supposed to be " << "equal to one of two values, but isn't. The two possible " << "values are " << arg2 << " and " << arg3 << '.'

◆ ExcIndexRange() [1/2]

static ::ExceptionBase & StandardExceptions::ExcIndexRange ( std::size_t  arg1,
std::size_t  arg2,
std::size_t  arg3 
)
staticprivate

This exception indicates that an index is not within the expected range. For example, it may be that you are trying to access an element of a vector which does not exist.

The constructor takes three std::size_t arguments, namely

  1. the violating index
  2. the lower bound
  3. the upper bound plus one
Note
The message that will be printed by this exception reads:
<< "Index " << arg1 << " is not in the half-open range [" << arg2 << ',' << arg3 << ")." << (arg2 == arg3 ? " In the current case, this half-open range is in fact empty, " "suggesting that you are accessing an element of an empty " "collection such as a vector that has not been set to the " "correct size." : "")

◆ ExcIndexRangeType()

template<typename T >
static ::ExceptionBase & StandardExceptions::ExcIndexRangeType ( arg1,
arg2,
arg3 
)
staticprivate

This exception indicates that an index is not within the expected range. For example, it may be that you are trying to access an element of a vector which does not exist.

The constructor takes three arguments, namely

  1. the violating index
  2. the lower bound
  3. the upper bound plus one

This generic exception differs from ExcIndexRange by allowing to specify the type of indices.

Note
The message that will be printed by this exception reads:
<< "Index " << arg1 << " is not in the half-open range [" << arg2 << ',' << arg3 << ")." << (arg2 == arg3 ? " In the current case, this half-open range is in fact empty, " "suggesting that you are accessing an element of an empty " "collection such as a vector that has not been set to the " "correct size." : "")

◆ ExcLowerRange()

static ::ExceptionBase & StandardExceptions::ExcLowerRange ( int  arg1,
int  arg2 
)
staticprivate

A number is too small.

Note
The message that will be printed by this exception reads:
<< "Number " << arg1 << " must be larger than or equal " << arg2 << '.'

◆ ExcLowerRangeType()

template<typename T >
static ::ExceptionBase & StandardExceptions::ExcLowerRangeType ( arg1,
arg2 
)
staticprivate

A generic exception definition for the ExcLowerRange above.

Note
The message that will be printed by this exception reads:
<< "Number " << arg1 << " must be larger than or equal " << arg2 << '.'

◆ ExcNotMultiple()

static ::ExceptionBase & StandardExceptions::ExcNotMultiple ( int  arg1,
int  arg2 
)
staticprivate

This exception indicates that the first argument should be an integer multiple of the second, but is not.

Note
The message that will be printed by this exception reads:
<< "Division " << arg1 << " by " << arg2 << " has remainder different from zero."

◆ ExcInvalidIterator()

static ::ExceptionBase & StandardExceptions::ExcInvalidIterator ( )
staticprivate

This exception is thrown if the iterator you access has corrupted data. It might for instance be, that the container it refers does not have an entry at the point the iterator refers.

Typically, this will be an internal error of deal.II, because the increment and decrement operators should never yield an invalid iterator.

Note
The message that will be printed by this exception reads:
"You are trying to use an iterator, but the iterator is " "in an invalid state. This may indicate that the iterator " "object has not been initialized, or that it has been " "moved beyond the end of the range of valid elements."

◆ ExcIteratorPastEnd()

static ::ExceptionBase & StandardExceptions::ExcIteratorPastEnd ( )
staticprivate

This exception is thrown if the iterator you incremented or decremented was already at its final state.

Note
The message that will be printed by this exception reads:
"You are trying to use an iterator, but the iterator is " "pointing past the end of the range of valid elements. " "It is not valid to dereference the iterator in this " "case."

◆ ExcMessage()

static ::ExceptionBase & StandardExceptions::ExcMessage ( std::string  arg1)
staticprivate

This exception works around a design flaw in the DeclException0 macro: exceptions declared through DeclException0 do not allow one to specify a message that is displayed when the exception is raised, as opposed to the other exceptions which allow to show a text along with the given parameters.

When throwing this exception, you can give a message as a std::string as argument to the exception that is then displayed. The argument can, of course, be constructed at run-time, for example including the name of a file that can't be opened, or any other text you may want to assemble from different pieces.

Note
The message that will be printed by this exception reads:
<< arg1

◆ ExcGhostsPresent()

static ::ExceptionBase & StandardExceptions::ExcGhostsPresent ( )
staticprivate

Parallel vectors with ghost elements are read-only vectors.

Note
The message that will be printed by this exception reads:
"You are trying an operation on a vector that is only " "allowed if the vector has no ghost elements, but the " "vector you are operating on does have ghost elements." "\n\n" "Specifically, there are two kinds of operations that " "are typically not allowed on vectors with ghost elements. " "First, vectors with ghost elements are read-only " "and cannot appear in operations that write into these " "vectors. Second, reduction operations (such as computing " "the norm of a vector, or taking dot products between " "vectors) are not allowed to ensure that each vector " "element is counted only once (as opposed to once for " "the owner of the element plus once for each process " "on which the element is stored as a ghost copy)." "\n\n" "See the glossary entry on 'Ghosted vectors' for more " "information."

◆ ExcGridHasInvalidCell()

static ::ExceptionBase & StandardExceptions::ExcGridHasInvalidCell ( int  arg1)
staticprivate

Exception indicating that one of the cells in the input to Triangulation::create_triangulation() or a related function cannot be used.

Note
The message that will be printed by this exception reads:
<< "Something went wrong when making cell " << arg1 << ". Read the docs and the source code " << "for more information."

◆ ExcScalarAssignmentOnlyForZeroValue()

static ::ExceptionBase & StandardExceptions::ExcScalarAssignmentOnlyForZeroValue ( )
staticprivate

Some of our numerical classes allow for setting all entries to zero using the assignment operator =.

In many cases, this assignment operator makes sense only for the argument zero. In other cases, this exception is thrown.

Note
The message that will be printed by this exception reads:
"You are trying an operation of the form 'vector = C', " "'matrix = C', or 'tensor = C' with a nonzero scalar value " "'C'. However, such assignments are only allowed if the " "C is zero, since the semantics for assigning any other " "value are not clear. For example: one could interpret " "assigning a matrix a value of 1 to mean the matrix has a " "norm of 1, the matrix is the identity matrix, or the " "matrix contains only 1s. Similar problems exist with " "vectors and tensors. Hence, to avoid this ambiguity, such " "assignments are not permitted."

◆ ExcNeedsLAPACK()

static ::ExceptionBase & StandardExceptions::ExcNeedsLAPACK ( )
staticprivate

This function requires support for the LAPACK library.

Note
The message that will be printed by this exception reads:
"You are attempting to use functionality that is only available " "if deal.II was configured to use LAPACK, but cmake did not " "find a valid LAPACK library."

◆ ExcNeedsHDF5()

static ::ExceptionBase & StandardExceptions::ExcNeedsHDF5 ( )
staticprivate

This function requires support for the HDF5 library.

Note
The message that will be printed by this exception reads:
"You are attempting to use functionality that requires that deal.II is configured " "with HDF5 support. However, when you called 'cmake', HDF5 support " "was not detected."

◆ ExcNeedsMPI()

static ::ExceptionBase & StandardExceptions::ExcNeedsMPI ( )
staticprivate

This function requires support for the MPI library.

Note
The message that will be printed by this exception reads:
"You are attempting to use functionality that is only available " "if deal.II was configured to use MPI."

◆ ExcNeedsFunctionparser()

static ::ExceptionBase & StandardExceptions::ExcNeedsFunctionparser ( )
staticprivate

This function requires support for the FunctionParser library.

Note
The message that will be printed by this exception reads:
"You are attempting to use functionality that is only available " "if deal.II was configured to use the function parser which " "relies on the muparser library, but cmake did not " "find a valid muparser library on your system and also did " "not choose the one that comes bundled with deal.II."

◆ ExcNeedsAssimp()

static ::ExceptionBase & StandardExceptions::ExcNeedsAssimp ( )
staticprivate

This function requires support for the Assimp library.

Note
The message that will be printed by this exception reads:
"You are attempting to use functionality that is only available " "if deal.II was configured to use Assimp, but cmake did not " "find a valid Assimp library."

◆ ExcCudaError()

static ::ExceptionBase & StandardExceptions::ExcCudaError ( const char *  arg1)
staticprivate

This exception is raised if an error happened in a CUDA kernel.

The constructor takes a single char*, the output of cudaGetErrorString.

Note
The message that will be printed by this exception reads:
<< arg1

◆ ExcCusparseError()

static ::ExceptionBase & StandardExceptions::ExcCusparseError ( std::string  arg1)
staticprivate

This exception is raised if an error happened in a cuSPARSE function.

Note
The message that will be printed by this exception reads:
<< "There was an error in a cuSPARSE function: " << arg1

◆ ExcNeedsExodusII()

static ::ExceptionBase & StandardExceptions::ExcNeedsExodusII ( )
staticprivate

This function requires support for the Exodus II library.

Note
The message that will be printed by this exception reads:
"You are attempting to use functionality that is only available if deal.II " "was configured to use Trilinos' SEACAS library (which provides ExodusII), " "but cmake did not find a valid SEACAS library."

◆ ExcNeedsCGAL()

static ::ExceptionBase & StandardExceptions::ExcNeedsCGAL ( )
staticprivate

This function requires support for the CGAL library.

Note
The message that will be printed by this exception reads:
"You are attempting to use functionality that is only available " "if deal.II was configured to use CGAL, but cmake did not " "find a valid CGAL library."

◆ RecoverableUserCallbackError()

static ::ExceptionBase & StandardExceptions::RecoverableUserCallbackError ( )
staticprivate

An exception to be thrown in user call-backs. See the glossary entry on user call-back functions for more information.

Note
The message that will be printed by this exception reads:
"A user call-back function encountered a recoverable error, " "but the underlying library that called the call-back did not " "manage to recover from the error and aborted its operation." "\n\n" "See the glossary entry on user call-back functions for more " "information."

◆ ExcCSplineEmpty()

static ::ExceptionBase & Functions::ExcCSplineEmpty ( int  arg1)
static
Note
The message that will be printed by this exception reads:
<< "Interpolation points vector size can not be <" << arg1 << ">."

◆ ExcCSplineSizeMismatch()

static ::ExceptionBase & Functions::ExcCSplineSizeMismatch ( int  arg1,
int  arg2 
)
static
Note
The message that will be printed by this exception reads:
<< "The size of interpolation points <" << arg1 << "> is different from the size of interpolation values <" << arg2 << ">."

◆ ExcCSplineOrder()

static ::ExceptionBase & Functions::ExcCSplineOrder ( int  arg1,
double  arg2,
double  arg3 
)
static
Note
The message that will be printed by this exception reads:
<< "The input interpolation points are not strictly ordered : " << std::endl << "x[" << arg1 << "] = " << arg2 << " >= x[" << (arg1 + 1) << "] = " << arg3 << '.'

◆ ExcCSplineRange()

static ::ExceptionBase & Functions::ExcCSplineRange ( double  arg1,
double  arg2,
double  arg3 
)
static
Note
The message that will be printed by this exception reads:
<< "Spline function can not be evaluated outside of the interpolation range: " << std::endl << arg1 << " is not in [" << arg2 << ';' << arg3 << "]."

◆ ExcParseError() [1/3]

template<int dim>
static ::ExceptionBase & FunctionParser< dim >::ExcParseError ( int  arg1,
std::string  arg2 
)
static
Note
The message that will be printed by this exception reads:
<< "Parsing Error at Column " << arg1 << ". The parser said: " << arg2

◆ ExcInvalidExpressionSize() [1/2]

template<int dim>
static ::ExceptionBase & FunctionParser< dim >::ExcInvalidExpressionSize ( int  arg1,
int  arg2 
)
static
Note
The message that will be printed by this exception reads:
<< "The number of components (" << arg1 << ") is not equal to the number of expressions (" << arg2 << ")."

◆ ExcInvalidRefinementCase()

template<int dim>
static ::ExceptionBase & RefinementCase< dim >::ExcInvalidRefinementCase ( int  arg1)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "The refinement flags given (" << arg1 << ") contain set bits that do not " << "make sense for the space dimension of the object to which they are applied."

◆ ExcInvalidSubfaceCase()

template<int dim>
static ::ExceptionBase & internal::SubfaceCase< dim >::ExcInvalidSubfaceCase ( int  arg1)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "The subface case given (" << arg1 << ") does not make sense " << "for the space dimension of the object to which they are applied."

◆ ExcInvalidCoordinate()

template<int dim>
static ::ExceptionBase & GeometryInfo< dim >::ExcInvalidCoordinate ( double  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The coordinates must satisfy 0 <= x_i <= 1, " << "but here we have x_i=" << arg1

◆ ExcInvalidSubface()

template<int dim>
static ::ExceptionBase & GeometryInfo< dim >::ExcInvalidSubface ( int  arg1,
int  arg2,
int  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "RefinementCase<dim> " << arg1 << ": face " << arg2 << " has no subface " << arg3

◆ ExcIndexNotPresent() [1/2]

static ::ExceptionBase & IndexSet::ExcIndexNotPresent ( size_type  arg1)
static
Note
The message that will be printed by this exception reads:
<< "The global index " << arg1 << " is not an element of this set."

◆ ExcParseError() [2/3]

static ::ExceptionBase & internal::FunctionParser::ExcParseError ( int  arg1,
std::string  arg2 
)
static
Note
The message that will be printed by this exception reads:
<< "Parsing Error at Column " << arg1 << ". The parser said: " << arg2

◆ ExcEntryAlreadyExists() [1/2]

static ::ExceptionBase & ParameterHandler::ExcEntryAlreadyExists ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The following entry already exists: " << arg1 << '.'

◆ ExcValueDoesNotMatchPattern()

static ::ExceptionBase & ParameterHandler::ExcValueDoesNotMatchPattern ( std::string  arg1,
std::string  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The string <" << arg1 << "> does not match the given pattern <" << arg2 << ">."

◆ ExcAlreadyAtTopLevel()

static ::ExceptionBase & ParameterHandler::ExcAlreadyAtTopLevel ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You can't leave a subsection if you are already at the top level " "of the subsection hierarchy."

◆ ExcEntryUndeclared()

static ::ExceptionBase & ParameterHandler::ExcEntryUndeclared ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You can't ask for entry <" << arg1 << "> you have not yet declared."

◆ ExcUnbalancedSubsections()

static ::ExceptionBase & ParameterHandler::ExcUnbalancedSubsections ( std::string  arg1,
std::string  arg2 
)
static

Exception for when there are an unequal number of 'subsection' and 'end' statements. The first argument is the name of the file and the second argument is a formatted list of the subsection path before and after entering the parser.

Note
The message that will be printed by this exception reads:
<< "There are unequal numbers of 'subsection' and 'end' " "statements in the parameter file <" << arg1 << ">." << (arg2.size() > 0 ? "\n" + arg2 : "")

◆ ExcNoSubsection()

static ::ExceptionBase & ParameterHandler::ExcNoSubsection ( int  arg1,
std::string  arg2,
std::string  arg3 
)
static

Exception for when, during parsing of a parameter file, the parser encounters a subsection in the file that was not previously declared.

Note
The message that will be printed by this exception reads:
<< "Line <" << arg1 << "> of file <" << arg2 << ">: You are trying to enter a subsection '" << arg3 << "', but the ParameterHandler object does " << "not know of any such subsection."

◆ ExcCannotParseLine()

static ::ExceptionBase & ParameterHandler::ExcCannotParseLine ( int  arg1,
std::string  arg2,
std::string  arg3 
)
static

General exception for a line that could not be parsed, taking, as arguments, the line number, file name, and a brief description of why the line cannot be parsed.

Note
The message that will be printed by this exception reads:
<< "Line <" << arg1 << "> of file <" << arg2 << ">: " << arg3

◆ ExcInvalidEntryForPattern()

static ::ExceptionBase & ParameterHandler::ExcInvalidEntryForPattern ( int  arg1,
std::string  arg2,
std::string  arg3,
std::string  arg4,
std::string  arg5 
)
static

Exception for an entry in a parameter file that does not match the provided pattern. The arguments are, in order, the line number, file name, entry value, entry name, and a description of the pattern.

Note
The message that will be printed by this exception reads:
<< "Line <" << arg1 << "> of file <" << arg2 << ">:\n" " The entry value \n" << " " << arg3 << '
' << " for the entry named\n" << " " << arg4 << '
' << " does not match the given pattern:\n" << " " << arg5

◆ ExcInvalidXMLParameterFile()

static ::ExceptionBase & ParameterHandler::ExcInvalidXMLParameterFile ( )
static

Exception for when an XML file cannot be read at all. This happens when there is no top-level XML element called "ParameterHandler" or when there are multiple top level elements.

Note
The message that will be printed by this exception reads:
"The provided file could not be parsed as a " "ParameterHandler description."

◆ ExcCannotOpenIncludeStatementFile()

static ::ExceptionBase & ParameterHandler::ExcCannotOpenIncludeStatementFile ( int  arg1,
std::string  arg2,
std::string  arg3 
)
static

Exception for when the file given in an include statement cannot be open. The arguments are, in order, the line number of the include statement, current parameter file name, and the name of the file intended for inclusion.

Note
The message that will be printed by this exception reads:
<< "Line <" << arg1 << "> of file <" << arg2 << ">: This line " "contains an 'include' or 'INCLUDE' statement, but the given " "file to include <" << arg3 << "> cannot be opened."

◆ ExcIndexNotPresent() [2/2]

static ::ExceptionBase & Utilities::MPI::Partitioner::ExcIndexNotPresent ( types::global_dof_index  arg1,
unsigned int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Global index " << arg1 << " neither owned nor ghost on proc " << arg2 << '.'

◆ ExcGhostIndexArrayHasWrongSize()

static ::ExceptionBase & Utilities::MPI::Partitioner::ExcGhostIndexArrayHasWrongSize ( unsigned int  arg1,
unsigned int  arg2,
unsigned int  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The size of the ghost index array (" << arg1 << ") must either equal the number of ghost in the " << "partitioner (" << arg2 << ") or be equal in size to a more comprehensive index" << "set which contains " << arg3 << " elements for this partitioner."

◆ ExcNoClass()

static ::ExceptionBase & PathSearch::ExcNoClass ( std::string  arg1)
static

This class was not registered in the path search mechanism.

Note
The message that will be printed by this exception reads:
<< "The class " << arg1 << " must be registered before referring it in PathSearch."

◆ ExcFileNotFound()

static ::ExceptionBase & PathSearch::ExcFileNotFound ( std::string  arg1,
std::string  arg2 
)
static

The PathSearch class could not find a file with this name in its path list.

Note
The message that will be printed by this exception reads:
<< "The file \"" << arg1 << "\" was not found in the path for " << "files of class " << arg2 << '.'

◆ ExcInvalidRange() [1/2]

static ::ExceptionBase & Patterns::List::ExcInvalidRange ( int  arg1,
int  arg2 
)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "The values " << arg1 << " and " << arg2 << " do not form a valid range."

◆ ExcInvalidRange() [2/2]

static ::ExceptionBase & Patterns::Map::ExcInvalidRange ( int  arg1,
int  arg2 
)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "The values " << arg1 << " and " << arg2 << " do not form a valid range."

◆ ExcCommasNotAllowed()

static ::ExceptionBase & Patterns::MultipleSelection::ExcCommasNotAllowed ( int  arg1)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "A comma was found at position " << arg1 << " of your input string, but commas are not allowed here."

◆ ExcNoMatch()

static ::ExceptionBase & Patterns::Tools::ExcNoMatch ( std::string  arg1,
std::string  arg2 
)
staticprivate

Exception.

Note
The message that will be printed by this exception reads:
<< "The string \"" << arg1 << "\" does not match the pattern \"" << arg2 << "\""

◆ ExcInvalidQuadratureFormula()

template<int dim>
static ::ExceptionBase & QIterated< dim >::ExcInvalidQuadratureFormula ( )
static

Exception

Note
The message that will be printed by this exception reads:
"The quadrature formula you provided cannot be used " "as the basis for iteration."

◆ ExcCellDataTypeMismatch()

template<typename CellIteratorType , typename DataType >
static ::ExceptionBase & CellDataStorage< CellIteratorType, DataType >::ExcCellDataTypeMismatch ( )
staticprivate
Note
The message that will be printed by this exception reads:
"Cell data is being retrieved with a type which is different than the type used to initialize it"

◆ ExcTriangulationMismatch() [1/3]

template<typename CellIteratorType , typename DataType >
static ::ExceptionBase & CellDataStorage< CellIteratorType, DataType >::ExcTriangulationMismatch ( )
staticprivate
Note
The message that will be printed by this exception reads:
"The provided cell iterator does not belong to the triangulation that corresponds to the CellDataStorage object."

◆ ExcInvalidQGaussOrder()

template<int dim>
static ::ExceptionBase & QuadratureSelector< dim >::ExcInvalidQGaussOrder ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to generate a QGauss object with an invalid " << "number " << arg1 << " of quadrature points in each coordinate " << "direction. This number must be greater than or equal " << "to 1."

◆ ExcInvalidOrder()

template<int dim>
static ::ExceptionBase & QuadratureSelector< dim >::ExcInvalidOrder ( std::string  arg1,
unsigned int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to generate a " << arg1 << " object; no order is needed for objects of this kind, but " << arg2 << " was given as argument."

◆ ExcInvalidQuadrature()

template<int dim>
static ::ExceptionBase & QuadratureSelector< dim >::ExcInvalidQuadrature ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< arg1 << " is not a valid name for a quadrature rule."

◆ ExcInUse()

static ::ExceptionBase & Subscriptor::ExcInUse ( int  arg1,
std::string  arg2,
std::string  arg3 
)
static

Exception: Object may not be deleted, since it is used.

Note
The message that will be printed by this exception reads:
<< "Object of class " << arg2 << " is still used by " << arg1 << " other objects." << "\n\n" << "(Additional information: " << arg3 << ")\n\n" << "See the entry in the Frequently Asked Questions of " << "deal.II (linked to from http://www.dealii.org/) for " << "a lot more information on what this error means and " << "how to fix programs in which it happens."

◆ ExcNoSubscriber()

static ::ExceptionBase & Subscriptor::ExcNoSubscriber ( std::string  arg1,
std::string  arg2 
)
static

A subscriber with the identification string given to Subscriptor::unsubscribe() did not subscribe to the object.

Note
The message that will be printed by this exception reads:
<< "No subscriber with identifier <" << arg2 << "> subscribes to this object of class " << arg1 << ". Consequently, it cannot be unsubscribed."

◆ ExcIndexRange() [2/2]

template<int N, typename T , bool C, unsigned int P>
static ::ExceptionBase & internal::TableBaseAccessors::Accessor< N, T, C, P >::ExcIndexRange ( size_type  arg1,
size_type  arg2,
size_type  arg3 
)
static

Exception for range check. Do not use global exception since this way we can output which index is the wrong one.

Note
The message that will be printed by this exception reads:
<< "Index " << N - P + 1 << "has a value of " << arg1 << " but needs to be in the range [" << arg2 << ',' << arg3 << "[."

◆ ExcColumnNotExistent()

static ::ExceptionBase & TableHandler::ExcColumnNotExistent ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Column <" << arg1 << "> does not exist."

◆ ExcSuperColumnNotExistent()

static ::ExceptionBase & TableHandler::ExcSuperColumnNotExistent ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Supercolumn <" << arg1 << "> does not exist."

◆ ExcColumnOrSuperColumnNotExistent()

static ::ExceptionBase & TableHandler::ExcColumnOrSuperColumnNotExistent ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Column or supercolumn <" << arg1 << "> does not exist."

◆ ExcWrongNumberOfDataEntries()

static ::ExceptionBase & TableHandler::ExcWrongNumberOfDataEntries ( std::string  arg1,
int  arg2,
std::string  arg3,
int  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Column <" << arg1 << "> has " << arg2 << " rows, but Column <" << arg3 << "> has " << arg4 << " rows."

◆ ExcUndefinedTexFormat()

static ::ExceptionBase & TableHandler::ExcUndefinedTexFormat ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< '<' << arg1 << "> is not a tex column format. Use " << "'l', 'c', or 'r' to indicate left, centered, or " << "right aligned text."

◆ ExcParseError() [3/3]

template<int rank, int dim, typename Number = double>
static ::ExceptionBase & TensorFunctionParser< rank, dim, Number >::ExcParseError ( int  arg1,
std::string  arg2 
)
static
Note
The message that will be printed by this exception reads:
<< "Parsing Error at Column " << arg1 << ". The parser said: " << arg2

◆ ExcInvalidExpressionSize() [2/2]

template<int rank, int dim, typename Number = double>
static ::ExceptionBase & TensorFunctionParser< rank, dim, Number >::ExcInvalidExpressionSize ( int  arg1,
int  arg2 
)
static
Note
The message that will be printed by this exception reads:
<< "The number of components (" << arg1 << ") is not equal to the number of expressions (" << arg2 << ")."

◆ ExcNoTask()

template<typename RT = void>
static ::ExceptionBase & Threads::Task< RT >::ExcNoTask ( )
static

Exception

Note
The message that will be printed by this exception reads:
"The current object is not associated with a task that " "can be joined. It may have been detached, or you " "may have already joined it in the past."

◆ ExcRequiresADNumberSpecialization()

static ::ExceptionBase & Differentiation::AD::ExcRequiresADNumberSpecialization ( )
static

Exception denoting that a class requires some specialization in order to be used.

Note
The message that will be printed by this exception reads:
"This function is called in a class that is expected to be specialized " "for auto-differentiable numbers."

◆ ExcRequiresADOLC()

static ::ExceptionBase & Differentiation::AD::ExcRequiresADOLC ( )
static

Exception denoting that ADOL-C is a required feature.

Note
The message that will be printed by this exception reads:
"This function is only available if deal.II is compiled with ADOL-C."

◆ ExcSupportedDerivativeLevels()

static ::ExceptionBase & Differentiation::AD::ExcSupportedDerivativeLevels ( std::size_t  arg1,
std::size_t  arg2 
)
static

This exception is raised whenever the an auto-differentiable number does not support the required number of derivative operations

The first parameter to the constructor is the number of derivative operations that it provides, and the second is the minimum number that are required. Both parameters are of type int.

Note
The message that will be printed by this exception reads:
<< "The number of derivative levels that this auto-differentiable number type supports is " << arg1 << ", but to perform the intended operation the number must support at least " << arg2 << " levels."

◆ ExcADOLCAdvancedBranching()

static ::ExceptionBase & ExcADOLCAdvancedBranching ( )
static

An exception which states that a function has been disabled due to the configuration of ADOL-C with the advanced branching feature enabled.

Note
The message that will be printed by this exception reads:
"This function has not yet been implemented for taped ADOL-C " "numbers when the advanced branching feature is activated."

◆ ExcSymEngineParserError()

static ::ExceptionBase & Differentiation::SD::ExcSymEngineParserError ( std::string  arg1)
static

An exception to indicate that the string sent to the SymEngine parser is not valid.

Note
The message that will be printed by this exception reads:
<< "The string '" << arg1 << "' could not be parsed successfully. Are you sure that (1) it " << "consists of legitimate operations and syntax, and (2) you've " << "previously declared all symbolic variables that are present " << "in the expression?"

◆ ExcSymEngineLLVMNotAvailable()

static ::ExceptionBase & Differentiation::SD::ExcSymEngineLLVMNotAvailable ( )
static

An exception to indicate that the SymEngine library has not been built against the LLVM compiler.

Note
The message that will be printed by this exception reads:
"SymEngine has not been built with LLVM support."

◆ ExcSymEngineLLVMReturnTypeNotSupported()

static ::ExceptionBase & Differentiation::SD::ExcSymEngineLLVMReturnTypeNotSupported ( )
static

An exception to indicate that SymEngine's LLVM optimizer doesn't work with the desired return type.

Note
The message that will be printed by this exception reads:
"The SymEngine LLVM optimizer does not (yet) support the " "selected return type."

◆ ExcInvalidObject() [1/2]

template<int structdim, int dim, int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcInvalidObject ( )
static

Exceptions for child classes

Note
The message that will be printed by this exception reads:
"This accessor object has not been " "associated with any DoFHandler object."

◆ ExcVectorNotEmpty() [1/2]

template<int structdim, int dim, int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcVectorNotEmpty ( )
static

Exception

◆ ExcVectorDoesNotMatch() [1/2]

template<int structdim, int dim, int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcVectorDoesNotMatch ( )
static

Exception

◆ ExcMatrixDoesNotMatch() [1/2]

template<int structdim, int dim, int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcMatrixDoesNotMatch ( )
static

Exception

◆ ExcNotActive() [1/2]

template<int structdim, int dim, int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcNotActive ( )
static

A function has been called for a cell which should be active, but is refined.

◆ ExcCantCompareIterators() [1/3]

template<int structdim, int dim, int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< structdim, dim, spacedim, level_dof_access >::ExcCantCompareIterators ( )
static

Exception

◆ ExcInvalidObject() [2/2]

template<int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< 0, 1, spacedim, level_dof_access >::ExcInvalidObject ( )
static

Exceptions for child classes

Note
The message that will be printed by this exception reads:
"This accessor object has not been " "associated with any DoFHandler object."

◆ ExcVectorNotEmpty() [2/2]

template<int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< 0, 1, spacedim, level_dof_access >::ExcVectorNotEmpty ( )
static

Exception

◆ ExcVectorDoesNotMatch() [2/2]

template<int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< 0, 1, spacedim, level_dof_access >::ExcVectorDoesNotMatch ( )
static

Exception

◆ ExcMatrixDoesNotMatch() [2/2]

template<int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< 0, 1, spacedim, level_dof_access >::ExcMatrixDoesNotMatch ( )
static

Exception

◆ ExcNotActive() [2/2]

template<int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< 0, 1, spacedim, level_dof_access >::ExcNotActive ( )
static

A function has been called for a cell which should be active, but is refined.

◆ ExcCantCompareIterators() [2/3]

template<int spacedim, bool level_dof_access>
static ::ExceptionBase & DoFAccessor< 0, 1, spacedim, level_dof_access >::ExcCantCompareIterators ( )
static

Exception

◆ ExcNoFESelected() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & DoFHandler< dim, spacedim >::ExcNoFESelected ( )
static

Exception

◆ ExcInvalidBoundaryIndicator() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & DoFHandler< dim, spacedim >::ExcInvalidBoundaryIndicator ( )
static

Exception

◆ ExcInvalidLevel() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & DoFHandler< dim, spacedim >::ExcInvalidLevel ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The given level " << arg1 << " is not in the valid range!"

◆ ExcNewNumbersNotConsecutive()

template<int dim, int spacedim = dim>
static ::ExceptionBase & DoFHandler< dim, spacedim >::ExcNewNumbersNotConsecutive ( types::global_dof_index  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The given list of new dof indices is not consecutive: " << "the index " << arg1 << " does not exist."

◆ ExcInvalidFEIndex()

template<int dim, int spacedim = dim>
static ::ExceptionBase & DoFHandler< dim, spacedim >::ExcInvalidFEIndex ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The mesh contains a cell with an active FE index of " << arg1 << ", but the finite element collection only has " << arg2 << " elements"

◆ ExcOnlyAvailableWithHP() [1/3]

template<int dim, int spacedim = dim>
static ::ExceptionBase & DoFHandler< dim, spacedim >::ExcOnlyAvailableWithHP ( )
static

Exception used when a certain feature doesn't make sense when DoFHandler does not hp-capabilities.

Note
The message that will be printed by this exception reads:
"The current function doesn't make sense when used with a " "DoFHandler without hp-capabilities."

◆ ExcNotImplementedWithHP()

template<int dim, int spacedim = dim>
static ::ExceptionBase & DoFHandler< dim, spacedim >::ExcNotImplementedWithHP ( )
static

Exception used when a certain feature is not implemented when the DoFHandler has hp-capabilities.

Note
The message that will be printed by this exception reads:
"The current function has not yet been implemented for a " "DoFHandler with hp-capabilities."

◆ ExcNoDominatedFiniteElementOnChildren()

static ::ExceptionBase & internal::hp::DoFHandlerImplementation::ExcNoDominatedFiniteElementOnChildren ( )
static

Exception

Note
The message that will be printed by this exception reads:
"No FiniteElement has been found in your FECollection that is " "dominated by all children of a cell you are trying to coarsen!"

◆ ExcDoFHandlerNotInitialized()

static ::ExceptionBase & DoFRenumbering::ExcDoFHandlerNotInitialized ( )
static

Exception

Note
The message that will be printed by this exception reads:
"The DoFHandler on which this function should work has not " "been initialized, i.e., it doesn't appear that DoF indices " "have been distributed on it."

◆ ExcInvalidComponentOrder()

static ::ExceptionBase & DoFRenumbering::ExcInvalidComponentOrder ( )
static

Exception

◆ ExcNotDGFEM()

static ::ExceptionBase & DoFRenumbering::ExcNotDGFEM ( )
static

The function is only implemented for Discontinuous Galerkin Finite elements.

◆ ExcFiniteElementsDontMatch()

static ::ExceptionBase & DoFTools::ExcFiniteElementsDontMatch ( )
static
Todo:
Write description

◆ ExcGridNotCoarser()

static ::ExceptionBase & DoFTools::ExcGridNotCoarser ( )
static
Todo:
Write description

◆ ExcGridsDontMatch()

static ::ExceptionBase & DoFTools::ExcGridsDontMatch ( )
static
Todo:
Write description

Exception

◆ ExcNoFESelected() [2/2]

static ::ExceptionBase & DoFTools::ExcNoFESelected ( )
static

The DoFHandler was not initialized with a finite element. Please call DoFHandler::distribute_dofs() first.

◆ ExcInvalidBoundaryIndicator() [2/2]

static ::ExceptionBase & DoFTools::ExcInvalidBoundaryIndicator ( )
static
Todo:
Write description

◆ ExcNoComponentSelected()

static ::ExceptionBase & ComponentMask::ExcNoComponentSelected ( )
static

Exception

Note
The message that will be printed by this exception reads:
"The number of selected components in a mask " "must be greater than zero."

◆ ExcShapeFunctionNotPrimitive() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & FiniteElement< dim, spacedim >::ExcShapeFunctionNotPrimitive ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The shape function with index " << arg1 << " is not primitive, i.e. it is vector-valued and " << "has more than one non-zero vector component. This " << "function cannot be called for these shape functions. " << "Maybe you want to use the same function with the " << "_component suffix?"

◆ ExcFENotPrimitive() [1/3]

template<int dim, int spacedim = dim>
static ::ExceptionBase & FiniteElement< dim, spacedim >::ExcFENotPrimitive ( )
static

Exception

◆ ExcUnitShapeValuesDoNotExist()

template<int dim, int spacedim = dim>
static ::ExceptionBase & FiniteElement< dim, spacedim >::ExcUnitShapeValuesDoNotExist ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are trying to access the values or derivatives of shape functions " "on the reference cell of an element that does not define its shape " "functions through mapping from the reference cell. Consequently, " "you cannot ask for shape function values or derivatives on the " "reference cell."

◆ ExcFEHasNoSupportPoints()

template<int dim, int spacedim = dim>
static ::ExceptionBase & FiniteElement< dim, spacedim >::ExcFEHasNoSupportPoints ( )
static

Attempt to access support points of a finite element that is not Lagrangian.

Note
The message that will be printed by this exception reads:
"You are trying to access the support points of a finite " "element that either has no support points at all, or for " "which the corresponding tables have not been implemented."

◆ ExcEmbeddingVoid()

template<int dim, int spacedim = dim>
static ::ExceptionBase & FiniteElement< dim, spacedim >::ExcEmbeddingVoid ( )
static

Attempt to access embedding matrices of a finite element that did not implement these matrices.

Note
The message that will be printed by this exception reads:
"You are trying to access the matrices that describe how " "to embed a finite element function on one cell into the " "finite element space on one of its children (i.e., the " "'embedding' or 'prolongation' matrices). However, the " "current finite element can either not define this sort of " "operation, or it has not yet been implemented."

◆ ExcProjectionVoid()

template<int dim, int spacedim = dim>
static ::ExceptionBase & FiniteElement< dim, spacedim >::ExcProjectionVoid ( )
static

Attempt to access restriction matrices of a finite element that did not implement these matrices.

Exception

Note
The message that will be printed by this exception reads:
"You are trying to access the matrices that describe how " "to restrict a finite element function from the children " "of one cell to the finite element space defined on their " "parent (i.e., the 'restriction' or 'projection' matrices). " "However, the current finite element can either not define " "this sort of operation, or it has not yet been " "implemented."

◆ ExcWrongInterfaceMatrixSize()

template<int dim, int spacedim = dim>
static ::ExceptionBase & FiniteElement< dim, spacedim >::ExcWrongInterfaceMatrixSize ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The interface matrix has a size of " << arg1 << 'x' << arg2 << ", which is not reasonable for the current element " "in the present dimension."

◆ ExcInterpolationNotImplemented()

template<int dim, int spacedim = dim>
static ::ExceptionBase & FiniteElement< dim, spacedim >::ExcInterpolationNotImplemented ( )
static

Exception

◆ ExcOnlyAvailableWithoutHP() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & FEInterfaceValues< dim, spacedim >::ExcOnlyAvailableWithoutHP ( )
staticprivate

Exception used when a certain feature doesn't make sense when FEInterfaceValues does has hp-capabilities enabled.

Note
The message that will be printed by this exception reads:
"The current function doesn't make sense when used with a " "FEInterfaceValues object with hp-capabilities."

◆ ExcOnlyAvailableWithHP() [2/3]

template<int dim, int spacedim = dim>
static ::ExceptionBase & FEInterfaceValues< dim, spacedim >::ExcOnlyAvailableWithHP ( )
staticprivate

Exception used when a certain feature doesn't make sense when FEInterfaceValues does not have hp-capabilities enabled.

Note
The message that will be printed by this exception reads:
"The current function doesn't make sense when used with a " "FEInterfaceValues object without hp-capabilities."

◆ ExcFEQCannotHaveDegree0()

template<int dim, int spacedim = dim>
static ::ExceptionBase & FE_Q_Base< dim, spacedim >::ExcFEQCannotHaveDegree0 ( )
static

Attempt to construct an FE_Q object of degree 0

Note
The message that will be printed by this exception reads:
"FE_Q can only be used for polynomial degrees " "greater than zero. If you want an element of polynomial " "degree zero, then it cannot be continuous and you " "will want to use FE_DGQ<dim>(0)."

◆ ExcInvalidFEName()

static ::ExceptionBase & FETools::ExcInvalidFEName ( std::string  arg1)
static

The string used for get_fe_by_name() cannot be translated to a finite element.

Either the string is badly formatted or you are using a custom element that must be added using add_fe_name() first.

Note
The message that will be printed by this exception reads:
<< "Can't re-generate a finite element from the string '" << arg1 << "'."

◆ ExcInvalidFEDimension()

static ::ExceptionBase & FETools::ExcInvalidFEDimension ( char  arg1,
int  arg2 
)
static

The string used for get_fe_by_name() cannot be translated to a finite element.

Dimension arguments in finite element names should be avoided. If they are there, the dimension should be dim or d. Here, you gave a numeric dimension argument, which does not match the template dimension of the finite element class.

Note
The message that will be printed by this exception reads:
<< "The dimension " << arg1 << " in the finite element string must match " << "the space dimension " << arg2 << '.'

◆ ExcInvalidFE()

static ::ExceptionBase & FETools::ExcInvalidFE ( )
static

Exception

◆ ExcFENotPrimitive() [2/3]

static ::ExceptionBase & FETools::ExcFENotPrimitive ( )
static

The finite element must be primitive.

◆ ExcTriangulationMismatch() [2/3]

static ::ExceptionBase & FETools::ExcTriangulationMismatch ( )
static

Exception

◆ ExcHangingNodesNotAllowed()

static ::ExceptionBase & FETools::ExcHangingNodesNotAllowed ( )
static

A continuous element is used on a mesh with hanging nodes, but the constraint matrices are missing.

Note
The message that will be printed by this exception reads:
"You are using continuous elements on a grid with " "hanging nodes but without providing hanging node " "constraints. Use the respective function with " "additional AffineConstraints argument(s), instead."

◆ ExcGridNotRefinedAtLeastOnce()

static ::ExceptionBase & FETools::ExcGridNotRefinedAtLeastOnce ( )
static

You need at least two grid levels.

◆ ExcMatrixDimensionMismatch()

static ::ExceptionBase & FETools::ExcMatrixDimensionMismatch ( int  arg1,
int  arg2,
int  arg3,
int  arg4 
)
static

The dimensions of the matrix used did not match the expected dimensions.

Note
The message that will be printed by this exception reads:
<< "This is a " << arg1 << 'x' << arg2 << " matrix, " << "but should be a " << arg3 << 'x' << arg4 << " matrix."

◆ ExcLeastSquaresError()

static ::ExceptionBase & FETools::ExcLeastSquaresError ( double  arg1)
static

Exception thrown if an embedding matrix was computed inaccurately.

Note
The message that will be printed by this exception reads:
<< "Least squares fit leaves a gap of " << arg1

◆ ExcNotGreaterThan()

static ::ExceptionBase & FETools::ExcNotGreaterThan ( int  arg1,
int  arg2 
)
static

Exception thrown if one variable may not be greater than another.

Note
The message that will be printed by this exception reads:
<< arg1 << " must be greater than " << arg2

◆ ExcReinitCalledWithBoundaryFace()

template<int dim, int spacedim = dim>
static ::ExceptionBase & FESubfaceValues< dim, spacedim >::ExcReinitCalledWithBoundaryFace ( )
static
Todo:
Document this

◆ ExcFaceHasNoSubfaces()

template<int dim, int spacedim = dim>
static ::ExceptionBase & FESubfaceValues< dim, spacedim >::ExcFaceHasNoSubfaces ( )
static
Todo:
Document this

◆ ExcAccessToUninitializedField() [1/2]

template<int dim, int spacedim>
static ::ExceptionBase & FEValuesBase< dim, spacedim >::ExcAccessToUninitializedField ( std::string  arg1)
static

This exception is thrown if FEValuesBase is asked to return the value of a field which was not required by the UpdateFlags for this FEValuesBase.

Note
The message that will be printed by this exception reads:
<< "You are requesting information from an FEValues/FEFaceValues/FESubfaceValues " << "object for which this kind of information has not been computed. What " << "information these objects compute is determined by the update_* flags you " << "pass to the constructor. Here, the operation you are attempting requires " << "the <" << arg1 << "> flag to be set, but it was apparently not specified " << "upon construction."

◆ ExcNotReinited()

template<int dim, int spacedim>
static ::ExceptionBase & FEValuesBase< dim, spacedim >::ExcNotReinited ( )
static

FEValues::reinit() has not been called for any cell.

Note
The message that will be printed by this exception reads:
"FEValues object is not reinit'ed to any cell"

◆ ExcFEDontMatch()

template<int dim, int spacedim>
static ::ExceptionBase & FEValuesBase< dim, spacedim >::ExcFEDontMatch ( )
static

Mismatch between the FEValues FiniteElement and cell->get_dof_handler().get_fe()

Note
The message that will be printed by this exception reads:
"The FiniteElement you provided to FEValues and the FiniteElement that belongs " "to the DoFHandler that provided the cell iterator do not match."

◆ ExcShapeFunctionNotPrimitive() [2/2]

template<int dim, int spacedim>
static ::ExceptionBase & FEValuesBase< dim, spacedim >::ExcShapeFunctionNotPrimitive ( int  arg1)
static

A given shape function is not primitive, but it needs to be.

Note
The message that will be printed by this exception reads:
<< "The shape function with index " << arg1 << " is not primitive, i.e. it is vector-valued and " << "has more than one non-zero vector component. This " << "function cannot be called for these shape functions. " << "Maybe you want to use the same function with the " << "_component suffix?"

◆ ExcFENotPrimitive() [3/3]

template<int dim, int spacedim>
static ::ExceptionBase & FEValuesBase< dim, spacedim >::ExcFENotPrimitive ( )
static

The given FiniteElement is not a primitive element, see FiniteElement::is_primitive().

Note
The message that will be printed by this exception reads:
"The given FiniteElement is not a primitive element but the requested operation " "only works for those. See FiniteElement::is_primitive() for more information."

◆ ExcNeedsDoFHandler()

template<int dim, int spacedim>
static ::ExceptionBase & FEValuesBase< dim, spacedim >::CellIteratorWrapper::ExcNeedsDoFHandler ( )
static
Note
The message that will be printed by this exception reads:
"You have previously called the FEValues::reinit() function with a " "cell iterator of type Triangulation<dim,spacedim>::cell_iterator. However, " "when you do this, you cannot call some functions in the FEValues " "class, such as the get_function_values/gradients/hessians/third_derivatives " "functions. If you need these functions, then you need to call " "FEValues::reinit() with an iterator type that allows to extract " "degrees of freedom, such as DoFHandler<dim,spacedim>::cell_iterator."

◆ ExcInvalidData()

template<int dim, int spacedim = dim>
static ::ExceptionBase & Mapping< dim, spacedim >::ExcInvalidData ( )
static

Exception

◆ ExcTransformationFailed()

template<int dim, int spacedim = dim>
static ::ExceptionBase & Mapping< dim, spacedim >::ExcTransformationFailed ( )
static

Computing the mapping between a real space point and a point in reference space failed, typically because the given point lies outside the cell where the inverse mapping is not unique.

Note
The message that will be printed by this exception reads:
"Computing the mapping between a real space point and a point in reference " "space failed, typically because the given point lies outside the cell " "where the inverse mapping is not unique."

◆ ExcDistortedMappedCell()

template<int dim, int spacedim = dim>
static ::ExceptionBase & Mapping< dim, spacedim >::ExcDistortedMappedCell ( Point< spacedim >  arg1,
double  arg2,
int  arg3 
)
static

deal.II assumes the Jacobian determinant to be positive. When the cell geometry is distorted under the image of the mapping, the mapping becomes invalid and this exception is thrown.

Note
The message that will be printed by this exception reads:
<< "The image of the mapping applied to cell with center [" << arg1 << "] is distorted. The cell geometry or the " << "mapping are invalid, giving a non-positive volume " << "fraction of " << arg2 << " in quadrature point " << arg3 << '.'

◆ ExcInactiveCell() [1/3]

template<int dim, int spacedim = dim, typename VectorType = Vector<double>>
static ::ExceptionBase & MappingFEField< dim, spacedim, VectorType >::ExcInactiveCell ( )
static

Exception

◆ ExcInactiveCell() [2/3]

template<int dim, typename VectorType = Vector<double>, int spacedim = dim>
static ::ExceptionBase & MappingQ1Eulerian< dim, VectorType, spacedim >::ExcInactiveCell ( )
static

Exception.

◆ ExcInactiveCell() [3/3]

template<int dim, typename VectorType = Vector<double>, int spacedim = dim>
static ::ExceptionBase & MappingQEulerian< dim, VectorType, spacedim >::ExcInactiveCell ( )
static

Exception which is thrown when the mapping is being evaluated at non-active cell.

◆ ExcInvalidElement()

template<typename BaseIterator >
static ::ExceptionBase & FilteredIterator< BaseIterator >::ExcInvalidElement ( BaseIterator  arg1)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "The element " << arg1 << " with which you want to compare or which you want to" << " assign from is invalid since it does not satisfy the predicate."

◆ ExcInvalidRadii()

static ::ExceptionBase & GridGenerator::ExcInvalidRadii ( )
static

Exception

◆ ExcInvalidRepetitions()

static ::ExceptionBase & GridGenerator::ExcInvalidRepetitions ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The number of repetitions " << arg1 << " must be >=1."

◆ ExcInvalidRepetitionsDimension()

static ::ExceptionBase & GridGenerator::ExcInvalidRepetitionsDimension ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The vector of repetitions must have " << arg1 << " elements."

◆ ExcInvalidInputOrientation()

static ::ExceptionBase & GridGenerator::ExcInvalidInputOrientation ( )
static

Exception for input that is not properly oriented.

Note
The message that will be printed by this exception reads:
"The input to this function is oriented in a way that will" " cause all cells to have negative measure."

◆ ExcUnknownSectionType()

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcUnknownSectionType ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The section type <" << arg1 << "> in an UNV " << "input file is not implemented."

◆ ExcUnknownElementType()

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcUnknownElementType ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The element type <" << arg1 << "> in an UNV " << "input file is not implemented."

◆ ExcUnknownIdentifier()

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcUnknownIdentifier ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The identifier <" << arg1 << "> as name of a " << "part in an UCD input file is unknown or the " << "respective input routine is not implemented." << "(Maybe the space dimension of triangulation and " << "input file do not match?"

◆ ExcNoTriangulationSelected() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcNoTriangulationSelected ( )
static

Exception

Note
The message that will be printed by this exception reads:
"No Triangulation has been attached to this GridIn object " "so that nothing can be filled during any read function " "calls. Please pass a reference to the Triangulation tria " "to be filled in the constructor GridIn(tria) or attach " "it with the function call GridIn::attach_triangulation()."

◆ ExcInvalidVertexIndex() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcInvalidVertexIndex ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "While creating cell " << arg1 << ", you are referencing a vertex with index " << arg2 << " but no vertex with this index has been described in the input file."

◆ ExcInvalidVertexIndexGmsh()

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcInvalidVertexIndexGmsh ( int  arg1,
int  arg2,
int  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "While creating cell " << arg1 << " (which is numbered as " << arg2 << " in the input file), you are referencing a vertex with index " << arg3 << " but no vertex with this index has been described in the input file."

◆ ExcInvalidDBMeshFormat()

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcInvalidDBMeshFormat ( )
static

Exception

◆ ExcInvalidDBMESHInput()

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcInvalidDBMESHInput ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The string <" << arg1 << "> is not recognized at the present" << " position of a DB Mesh file."

◆ ExcDBMESHWrongDimension()

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcDBMESHWrongDimension ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The specified dimension " << arg1 << " is not the same as that of the triangulation to be created."

◆ ExcInvalidGMSHInput()

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcInvalidGMSHInput ( std::string  arg1)
static
Note
The message that will be printed by this exception reads:
<< "The string <" << arg1 << "> is not recognized at the present" << " position of a Gmsh Mesh file."

◆ ExcGmshUnsupportedGeometry()

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcGmshUnsupportedGeometry ( int  arg1)
static
Note
The message that will be printed by this exception reads:
<< "The Element Identifier <" << arg1 << "> is not " << "supported in the deal.II library when " << "reading meshes in " << dim << " dimensions.\n" << "Supported elements are: \n" << "ELM-TYPE\n" << "1 Line (2 nodes, 1 edge).\n" << "3 Quadrilateral (4 nodes, 4 edges).\n" << "5 Hexahedron (8 nodes, 12 edges, 6 faces) when in 3d.\n" << "15 Point (1 node, ignored when read)"

◆ ExcGmshNoCellInformation()

template<int dim, int spacedim = dim>
static ::ExceptionBase & GridIn< dim, spacedim >::ExcGmshNoCellInformation ( unsigned int  arg1,
unsigned int  arg2 
)
static
Note
The message that will be printed by this exception reads:
"While reading a gmsh file, the reader function did not find " "any cells. This sometimes happens if the file only contains a " "surface mesh, but not a volume mesh." "\n\n" "The reader function did find " + std::to_string(arg1) + " lines and " + std::to_string(arg2) + " facets (surface triangles or quadrilaterals)."

◆ ExcInvalidState() [2/2]

static ::ExceptionBase & GridOut::ExcInvalidState ( )
static

Exception

◆ ExcNegativeCriteria()

static ::ExceptionBase & GridRefinement::ExcNegativeCriteria ( )
static

An exception thrown if the vector with cell criteria contains negative values

◆ ExcInvalidParameterValue()

static ::ExceptionBase & GridRefinement::ExcInvalidParameterValue ( )
static

One of the threshold parameters causes trouble. Or the refinement and coarsening thresholds overlap.

◆ ExcInvalidNumberOfPartitions() [1/4]

static ::ExceptionBase & GridTools::ExcInvalidNumberOfPartitions ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The number of partitions you gave is " << arg1 << ", but must be greater than zero."

◆ ExcNonExistentSubdomain()

static ::ExceptionBase & GridTools::ExcNonExistentSubdomain ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The subdomain id " << arg1 << " has no cells associated with it."

◆ ExcTriangulationHasBeenRefined()

static ::ExceptionBase & GridTools::ExcTriangulationHasBeenRefined ( )
static

Exception

◆ ExcScalingFactorNotPositive()

static ::ExceptionBase & GridTools::ExcScalingFactorNotPositive ( double  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The scaling factor must be positive, but it is " << arg1 << '.'

◆ ExcVertexNotUsed()

static ::ExceptionBase & GridTools::ExcVertexNotUsed ( unsigned int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The given vertex with index " << arg1 << " is not used in the given triangulation."

◆ ExcMeshNotOrientable()

static ::ExceptionBase & GridTools::ExcMeshNotOrientable ( )
static

An exception that is thrown whenever the edges of a mesh are not orientable.

Note
The message that will be printed by this exception reads:
"The edges of the mesh are not consistently orientable."

◆ ExcInvalidKey()

template<typename MeshType >
static ::ExceptionBase & InterGridMap< MeshType >::ExcInvalidKey ( cell_iterator  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The iterator " << arg1 << " is not valid as key for " << "this map."

◆ ExcIncompatibleGrids()

template<typename MeshType >
static ::ExceptionBase & InterGridMap< MeshType >::ExcIncompatibleGrids ( )
static

Exception

◆ ExcPeriodicBox()

template<int dim, int spacedim = dim>
static ::ExceptionBase & FlatManifold< dim, spacedim >::ExcPeriodicBox ( int  arg1,
Point< spacedim >  arg2,
double  arg3 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "The component number " << arg1 << " of the point [ " << arg2 << " ] is not in the interval [ 0, " << arg3 << "), bailing out."

◆ ExcTriaNotEmpty()

template<int dim, int spacedim = dim>
static ::ExceptionBase & PersistentTriangulation< dim, spacedim >::ExcTriaNotEmpty ( )
static

Exception.

◆ ExcFlagsNotCleared()

template<int dim, int spacedim = dim>
static ::ExceptionBase & PersistentTriangulation< dim, spacedim >::ExcFlagsNotCleared ( )
static

Exception.

◆ ExcNonMatchingReferenceCellTypes()

static ::ExceptionBase & internal::ExcNonMatchingReferenceCellTypes ( ReferenceCell  arg1,
ReferenceCell  arg2 
)
staticprivate

This exception is raised whenever the types of two reference cell objects were assumed to be equal, but were not.

Parameters to the constructor are the first and second reference cells, both of type ReferenceCell.

Note
The message that will be printed by this exception reads:
<< "The reference-cell type used on this cell (" << arg1.to_string() << ") does not match the reference-cell type of the finite element " << "associated with this cell (" << arg2.to_string() << "). " << "Did you accidentally use simplex elements on hypercube meshes " << "(or the other way around), or are you using a mixed mesh and " << "assigned a simplex element to a hypercube cell (or the other " << "way around) via the active_fe_index?"

◆ ExcInvalidLevel() [2/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & Triangulation< dim, spacedim >::ExcInvalidLevel ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You are requesting information from refinement level " << arg1 << " of a triangulation, but this triangulation only has " << arg2 << " refinement levels. The given level " << arg1 << " must be *less* than " << arg2 << '.'

◆ ExcTriangulationNotEmpty()

template<int dim, int spacedim = dim>
static ::ExceptionBase & Triangulation< dim, spacedim >::ExcTriangulationNotEmpty ( int  arg1,
int  arg2 
)
static

The function raising this exception can only operate on an empty Triangulation, i.e., a Triangulation without grid cells.

Note
The message that will be printed by this exception reads:
<< "You are trying to perform an operation on a triangulation " << "that is only allowed if the triangulation is currently empty. " << "However, it currently stores " << arg1 << " vertices and has " << "cells on " << arg2 << " levels."

◆ ExcGridReadError()

template<int dim, int spacedim = dim>
static ::ExceptionBase & Triangulation< dim, spacedim >::ExcGridReadError ( )
static

Trying to re-read a grid, an error occurred.

◆ ExcFacesHaveNoLevel() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & Triangulation< dim, spacedim >::ExcFacesHaveNoLevel ( )
static

Exception

◆ ExcEmptyLevel()

template<int dim, int spacedim = dim>
static ::ExceptionBase & Triangulation< dim, spacedim >::ExcEmptyLevel ( int  arg1)
static

The triangulation level you accessed is empty.

Note
The message that will be printed by this exception reads:
<< "You tried to do something on level " << arg1 << ", but this level is empty."

◆ ExcBoundaryIdNotFound()

template<int dim, int spacedim = dim>
static ::ExceptionBase & Triangulation< dim, spacedim >::ExcBoundaryIdNotFound ( types::boundary_id  arg1)
static

Exception

Requested boundary_id not found

Note
The message that will be printed by this exception reads:
<< "The given boundary_id " << arg1 << " is not defined in this Triangulation!"

◆ ExcInconsistentCoarseningFlags()

template<int dim, int spacedim = dim>
static ::ExceptionBase & Triangulation< dim, spacedim >::ExcInconsistentCoarseningFlags ( )
static

Exception

Note
The message that will be printed by this exception reads:
"A cell is flagged for coarsening, but either not all of its siblings " "are active or flagged for coarsening as well. Please clean up all " "coarsen flags on your triangulation via " "Triangulation::prepare_coarsening_and_refinement() beforehand!"

◆ ExcCellNotUsed()

static ::ExceptionBase & TriaAccessorExceptions::ExcCellNotUsed ( )
static
Note
The message that will be printed by this exception reads:
"The operation you are attempting can only be performed for " "(cell, face, or edge) iterators that point to valid " "objects. These objects need not necessarily be active, " "i.e., have no children, but they need to be part of a " "triangulation. (The objects pointed to by an iterator " "may -- after coarsening -- also be objects that used " "to be part of a triangulation, but are now no longer " "used. Their memory location may have been retained " "for re-use upon the next mesh refinement, but is " "currently unused.)"

◆ ExcCellNotActive()

static ::ExceptionBase & TriaAccessorExceptions::ExcCellNotActive ( )
static

The cell is not an active cell, but it already has children. Some operations, like setting refinement flags or accessing degrees of freedom are only possible on active cells.

Note
The message that will be printed by this exception reads:
"The operation you are attempting can only be performed for " "(cell, face, or edge) iterators that point to 'active' " "objects. 'Active' objects are those that do not have " "children (in the case of cells), or that are part of " "an active cell (in the case of faces or edges). However, " "the object on which you are trying the current " "operation is not 'active' in this sense."

◆ ExcCellHasNoChildren()

static ::ExceptionBase & TriaAccessorExceptions::ExcCellHasNoChildren ( )
static

Trying to access the children of a cell which is in fact active.

Note
The message that will be printed by this exception reads:
"The operation you are attempting can only be performed for " "(cell, face, or edge) iterators that have children, " "but the object on which you are trying the current " "operation does not have any."

◆ ExcCellHasNoParent()

static ::ExceptionBase & TriaAccessorExceptions::ExcCellHasNoParent ( )
static

Trying to access the parent of a cell which is in the coarsest level of the triangulation.

Note
The message that will be printed by this exception reads:
"The operation you are attempting can only be performed for " "(cell, face, or edge) iterators that have a parent object, " "but the object on which you are trying the current " "operation does not have one -- i.e., it is on the " "coarsest level of the triangulation."

◆ ExcCantSetChildren()

static ::ExceptionBase & TriaAccessorExceptions::ExcCantSetChildren ( int  arg1)
static
Note
The message that will be printed by this exception reads:
<< "You can only set the child index if the cell does not " << "currently have children registered; or you can clear it. " << "The given index was " << arg1 << " (-1 means: clear children)."

◆ ExcDereferenceInvalidObject() [1/2]

template<typename AccessorType >
static ::ExceptionBase & TriaAccessorExceptions::ExcDereferenceInvalidObject ( AccessorType  arg1)
static
Note
The message that will be printed by this exception reads:
<< "You tried to dereference an iterator for which this " << "is not possible. More information on this iterator: " << "index=" << arg1.index() << ", state=" << (arg1.state() == IteratorState::valid ? "valid" : (arg1.state() == IteratorState::past_the_end ? "past_the_end" : "invalid"))

◆ ExcCantCompareIterators() [3/3]

static ::ExceptionBase & TriaAccessorExceptions::ExcCantCompareIterators ( )
static
Note
The message that will be printed by this exception reads:
"Iterators can only be compared if they point to the same " "triangulation, or if neither of them are associated " "with a triangulation."

◆ ExcNeighborIsCoarser()

static ::ExceptionBase & TriaAccessorExceptions::ExcNeighborIsCoarser ( )
static

◆ ExcNeighborIsNotCoarser()

static ::ExceptionBase & TriaAccessorExceptions::ExcNeighborIsNotCoarser ( )
static

◆ ExcFacesHaveNoLevel() [2/2]

static ::ExceptionBase & TriaAccessorExceptions::ExcFacesHaveNoLevel ( )
static

You are trying to access the level of a face, but faces have no inherent level. The level of a face can only be determined by the level of an adjacent face, which in turn implies that a face can have several levels.

◆ ExcNoPeriodicNeighbor()

static ::ExceptionBase & TriaAccessorExceptions::ExcNoPeriodicNeighbor ( )
static

You are trying to get the periodic neighbor for a face, which does not have a periodic neighbor. For more information on this, refer to entry for periodic boundaries.

◆ ExcSetOnlyEvenChildren()

static ::ExceptionBase & TriaAccessorExceptions::ExcSetOnlyEvenChildren ( int  arg1)
static
Note
The message that will be printed by this exception reads:
<< "You can only set the child index of an even numbered child." << "The number of the child given was " << arg1 << '.'

◆ ExcRefineCellNotActive()

template<int dim, int spacedim = dim>
static ::ExceptionBase & CellAccessor< dim, spacedim >::ExcRefineCellNotActive ( )
static

◆ ExcCellFlaggedForRefinement()

template<int dim, int spacedim = dim>
static ::ExceptionBase & CellAccessor< dim, spacedim >::ExcCellFlaggedForRefinement ( )
static

◆ ExcCellFlaggedForCoarsening()

template<int dim, int spacedim = dim>
static ::ExceptionBase & CellAccessor< dim, spacedim >::ExcCellFlaggedForCoarsening ( )
static

◆ ExcDereferenceInvalidCell()

template<typename Accessor >
static ::ExceptionBase & TriaRawIterator< Accessor >::ExcDereferenceInvalidCell ( Accessor  arg1)
static

Exception for TriaObjects with level, i.e. cells.

Note
The message that will be printed by this exception reads:
<< "You tried to dereference a cell iterator for which this " << "is not possible. More information on this iterator: " << "level=" << arg1.level() << ", index=" << arg1.index() << ", state=" << (arg1.state() == IteratorState::valid ? "valid" : (arg1.state() == IteratorState::past_the_end ? "past_the_end" : "invalid"))

◆ ExcDereferenceInvalidObject() [2/2]

template<typename Accessor >
static ::ExceptionBase & TriaRawIterator< Accessor >::ExcDereferenceInvalidObject ( Accessor  arg1)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "You tried to dereference an iterator for which this " << "is not possible. More information on this iterator: " << "index=" << arg1.index() << ", state=" << (arg1.state() == IteratorState::valid ? "valid" : (arg1.state() == IteratorState::past_the_end ? "past_the_end" : "invalid"))

◆ ExcAdvanceInvalidObject()

template<typename Accessor >
static ::ExceptionBase & TriaRawIterator< Accessor >::ExcAdvanceInvalidObject ( )
static

Exception

◆ ExcInvalidComparison()

template<typename Accessor >
static ::ExceptionBase & TriaRawIterator< Accessor >::ExcInvalidComparison ( )
static

Exception

◆ ExcAssignmentOfUnusedObject()

template<typename Accessor >
static ::ExceptionBase & TriaIterator< Accessor >::ExcAssignmentOfUnusedObject ( )
static

Exception

◆ ExcAssignmentOfInactiveObject()

template<typename Accessor >
static ::ExceptionBase & TriaActiveIterator< Accessor >::ExcAssignmentOfInactiveObject ( )
static

Exception

◆ ExcPointerIndexClash()

static ::ExceptionBase & internal::TriangulationImplementation::TriaObjects::ExcPointerIndexClash ( )
static

Triangulation objects can either access a user pointer or a user index. What you tried to do is trying to access one of those after using the other.

◆ ExcNoFiniteElements()

template<int dim, int spacedim = dim>
static ::ExceptionBase & hp::FECollection< dim, spacedim >::ExcNoFiniteElements ( )
static

Exception

◆ ExcNoQuadrature()

template<int dim>
static ::ExceptionBase & hp::QCollection< dim >::ExcNoQuadrature ( )
static

Exception

◆ ExcMatrixIsClosed()

template<typename number = double>
static ::ExceptionBase & AffineConstraints< number >::ExcMatrixIsClosed ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are attempting an operation on an AffineConstraints object " "that requires the object to not be 'closed', i.e., for which you " "must not already have called the close() member function. But the " "object is already closed, and so the operation can not be " "performed."

◆ ExcMatrixNotClosed()

template<typename number = double>
static ::ExceptionBase & AffineConstraints< number >::ExcMatrixNotClosed ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are attempting an operation on an AffineConstraints object " "that requires the object to be 'closed', i.e., for which you " "needed to call the close() member function. But the object " "is not currently closed, and so the operation can not be " "performed."

◆ ExcLineInexistant() [1/2]

template<typename number = double>
static ::ExceptionBase & AffineConstraints< number >::ExcLineInexistant ( size_type  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The specified line " << arg1 << " does not exist."

◆ ExcEntryAlreadyExists() [2/2]

template<typename number = double>
static ::ExceptionBase & AffineConstraints< number >::ExcEntryAlreadyExists ( size_type  arg1,
size_type  arg2,
number  arg3,
number  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The entry for the indices " << arg1 << " and " << arg2 << " already exists, but the values " << arg3 << " (old) and " << arg4 << " (new) differ " << "by " << (arg4 - arg3) << '.'

◆ ExcDoFConstrainedToConstrainedDoF()

template<typename number = double>
static ::ExceptionBase & AffineConstraints< number >::ExcDoFConstrainedToConstrainedDoF ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to constrain DoF " << arg1 << " to DoF " << arg2 << ", but that one is also constrained. This is not allowed!"

◆ ExcDoFIsConstrainedFromBothObjects()

template<typename number = double>
static ::ExceptionBase & AffineConstraints< number >::ExcDoFIsConstrainedFromBothObjects ( size_type  arg1)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "Degree of freedom " << arg1 << " is constrained from both object in a merge operation."

◆ ExcDoFIsConstrainedToConstrainedDoF()

template<typename number = double>
static ::ExceptionBase & AffineConstraints< number >::ExcDoFIsConstrainedToConstrainedDoF ( size_type  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "In the given argument a degree of freedom is constrained " << "to another DoF with number " << arg1 << ", which however is constrained by this object. This is not" << " allowed."

◆ ExcRowNotStoredHere()

template<typename number = double>
static ::ExceptionBase & AffineConstraints< number >::ExcRowNotStoredHere ( size_type  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The index set given to this constraints object indicates " << "constraints for degree of freedom " << arg1 << " should not be stored by this object, but a constraint " << "is being added."

◆ ExcColumnNotStoredHere()

template<typename number = double>
static ::ExceptionBase & AffineConstraints< number >::ExcColumnNotStoredHere ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The index set given to this constraints object indicates " << "constraints using degree of freedom " << arg2 << " should not be stored by this object, but a constraint " << "for degree of freedom " << arg1 << " uses it."

◆ ExcIncorrectConstraint()

template<typename number = double>
static ::ExceptionBase & AffineConstraints< number >::ExcIncorrectConstraint ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "While distributing the constraint for DoF " << arg1 << ", it turns out that one of the processors " << "who own the " << arg2 << " degrees of freedom that x_" << arg1 << " is constrained against does not know about " << "the constraint on x_" << arg1 << ". Did you not initialize the AffineConstraints container " << "with the appropriate locally_relevant set so " << "that every processor who owns a DoF that constrains " << "another DoF also knows about this constraint?"

◆ ArpackExcInvalidNumberofEigenvalues()

static ::ExceptionBase & ArpackSolver::ArpackExcInvalidNumberofEigenvalues ( int  arg1,
int  arg2 
)
staticprivate

Exceptions.

Note
The message that will be printed by this exception reads:
<< "Number of wanted eigenvalues " << arg1 << " is larger that the size of the matrix " << arg2

◆ ArpackExcInvalidEigenvectorSize()

static ::ExceptionBase & ArpackSolver::ArpackExcInvalidEigenvectorSize ( int  arg1,
int  arg2 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Number of wanted eigenvalues " << arg1 << " is larger that the size of eigenvectors " << arg2

◆ ArpackExcInvalidEigenvectorSizeNonsymmetric()

static ::ExceptionBase & ArpackSolver::ArpackExcInvalidEigenvectorSizeNonsymmetric ( int  arg1,
int  arg2 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "To store the real and complex parts of " << arg1 << " eigenvectors in real-valued vectors, their size (currently set to " << arg2 << ") should be greater than or equal to " << arg1 + 1

◆ ArpackExcInvalidEigenvalueSize()

static ::ExceptionBase & ArpackSolver::ArpackExcInvalidEigenvalueSize ( int  arg1,
int  arg2 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Number of wanted eigenvalues " << arg1 << " is larger that the size of eigenvalues " << arg2

◆ ArpackExcInvalidNumberofArnoldiVectors()

static ::ExceptionBase & ArpackSolver::ArpackExcInvalidNumberofArnoldiVectors ( int  arg1,
int  arg2 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Number of Arnoldi vectors " << arg1 << " is larger that the size of the matrix " << arg2

◆ ArpackExcSmallNumberofArnoldiVectors()

static ::ExceptionBase & ArpackSolver::ArpackExcSmallNumberofArnoldiVectors ( int  arg1,
int  arg2 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Number of Arnoldi vectors " << arg1 << " is too small to obtain " << arg2 << " eigenvalues"

◆ ArpackExcArpackIdo()

static ::ExceptionBase & ArpackSolver::ArpackExcArpackIdo ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "This ido " << arg1 << " is not supported. Check documentation of ARPACK"

◆ ArpackExcArpackMode()

static ::ExceptionBase & ArpackSolver::ArpackExcArpackMode ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "This mode " << arg1 << " is not supported. Check documentation of ARPACK"

◆ ArpackExcArpackInfodsaupd()

static ::ExceptionBase & ArpackSolver::ArpackExcArpackInfodsaupd ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Error with dsaupd, info " << arg1 << ". Check documentation of ARPACK"

◆ ArpackExcArpackInfodnaupd()

static ::ExceptionBase & ArpackSolver::ArpackExcArpackInfodnaupd ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Error with dnaupd, info " << arg1 << ". Check documentation of ARPACK"

◆ ArpackExcArpackInfodseupd()

static ::ExceptionBase & ArpackSolver::ArpackExcArpackInfodseupd ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Error with dseupd, info " << arg1 << ". Check documentation of ARPACK"

◆ ArpackExcArpackInfodneupd()

static ::ExceptionBase & ArpackSolver::ArpackExcArpackInfodneupd ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Error with dneupd, info " << arg1 << ". Check documentation of ARPACK"

◆ ArpackExcArpackInfoMaxIt()

static ::ExceptionBase & ArpackSolver::ArpackExcArpackInfoMaxIt ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Maximum number " << arg1 << " of iterations reached."

◆ ArpackExcArpackNoShifts()

static ::ExceptionBase & ArpackSolver::ArpackExcArpackNoShifts ( )
staticprivate
Note
The message that will be printed by this exception reads:
"No shifts could be applied during implicit" " Arnoldi update, try increasing the number of" " Arnoldi vectors."

◆ ExcIncompatibleRowNumbers() [1/3]

template<typename MatrixType >
static ::ExceptionBase & BlockMatrixBase< MatrixType >::ExcIncompatibleRowNumbers ( int  arg1,
int  arg2,
int  arg3,
int  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The blocks [" << arg1 << ',' << arg2 << "] and [" << arg3 << ',' << arg4 << "] have differing row numbers."

◆ ExcIncompatibleColNumbers() [1/3]

template<typename MatrixType >
static ::ExceptionBase & BlockMatrixBase< MatrixType >::ExcIncompatibleColNumbers ( int  arg1,
int  arg2,
int  arg3,
int  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The blocks [" << arg1 << ',' << arg2 << "] and [" << arg3 << ',' << arg4 << "] have differing column numbers."

◆ ExcBlockDimensionMismatch()

template<typename number >
static ::ExceptionBase & BlockSparseMatrix< number >::ExcBlockDimensionMismatch ( )
static

Exception

◆ ExcNeedsCollectSizes()

template<typename SparsityPatternType >
static ::ExceptionBase & BlockSparsityPatternBase< SparsityPatternType >::ExcNeedsCollectSizes ( )
static

Exception

Note
The message that will be printed by this exception reads:
"The number of rows and columns (returned by n_rows() and n_cols()) does " "not match their directly computed values. This typically means that a " "call to collect_sizes() is missing."

◆ ExcIncompatibleRowNumbers() [2/3]

template<typename SparsityPatternType >
static ::ExceptionBase & BlockSparsityPatternBase< SparsityPatternType >::ExcIncompatibleRowNumbers ( int  arg1,
int  arg2,
int  arg3,
int  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The blocks [" << arg1 << ',' << arg2 << "] and [" << arg3 << ',' << arg4 << "] have differing row numbers."

◆ ExcIncompatibleColNumbers() [2/3]

template<typename SparsityPatternType >
static ::ExceptionBase & BlockSparsityPatternBase< SparsityPatternType >::ExcIncompatibleColNumbers ( int  arg1,
int  arg2,
int  arg3,
int  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The blocks [" << arg1 << ',' << arg2 << "] and [" << arg3 << ',' << arg4 << "] have differing column numbers."

◆ ExcIteratorRangeDoesNotMatchVectorSize() [1/4]

template<typename Number >
static ::ExceptionBase & BlockVector< Number >::ExcIteratorRangeDoesNotMatchVectorSize ( )
static

Exception

◆ ExcPointerToDifferentVectors()

template<typename BlockVectorType , bool Constness>
static ::ExceptionBase & internal::BlockVectorIterators::Iterator< BlockVectorType, Constness >::ExcPointerToDifferentVectors ( )
static

Exception thrown when one performs arithmetical comparisons on iterators belonging to two different block vectors.

Note
The message that will be printed by this exception reads:
"Your program tried to compare iterators pointing to " "different block vectors. There is no reasonable way " "to do this."

◆ ExcInvalidIndex() [1/7]

template<typename number >
static ::ExceptionBase & ChunkSparseMatrix< number >::ExcInvalidIndex ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You are trying to access the matrix entry with index <" << arg1 << ',' << arg2 << ">, but this entry does not exist in the sparsity pattern " "of this matrix." "\n\n" "The most common cause for this problem is that you used " "a method to build the sparsity pattern that did not " "(completely) take into account all of the entries you " "will later try to write into. An example would be " "building a sparsity pattern that does not include " "the entries you will write into due to constraints " "on degrees of freedom such as hanging nodes or periodic " "boundary conditions. In such cases, building the " "sparsity pattern will succeed, but you will get errors " "such as the current one at one point or other when " "trying to write into the entries of the matrix."

◆ ExcDifferentChunkSparsityPatterns()

template<typename number >
static ::ExceptionBase & ChunkSparseMatrix< number >::ExcDifferentChunkSparsityPatterns ( )
static

Exception

◆ ExcIteratorRange() [1/4]

template<typename number >
static ::ExceptionBase & ChunkSparseMatrix< number >::ExcIteratorRange ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The iterators denote a range of " << arg1 << " elements, but the given number of rows was " << arg2

◆ ExcSourceEqualsDestination() [1/6]

template<typename number >
static ::ExceptionBase & ChunkSparseMatrix< number >::ExcSourceEqualsDestination ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are attempting an operation on two vectors that " "are the same object, but the operation requires that the " "two objects are in fact different."

◆ ExcInvalidNumber() [1/2]

static ::ExceptionBase & ChunkSparsityPattern::ExcInvalidNumber ( size_type  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The provided number is invalid here: " << arg1

◆ ExcInvalidIndex() [2/7]

static ::ExceptionBase & ChunkSparsityPattern::ExcInvalidIndex ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The given index " << arg1 << " should be less than " << arg2 << '.'

◆ ExcNotEnoughSpace() [1/2]

static ::ExceptionBase & ChunkSparsityPattern::ExcNotEnoughSpace ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Upon entering a new entry to row " << arg1 << ": there was no free entry any more. " << std::endl << "(Maximum number of entries for this row: " << arg2 << "; maybe the matrix is already compressed?)"

◆ ExcNotCompressed() [1/2]

static ::ExceptionBase & ChunkSparsityPattern::ExcNotCompressed ( )
static

The operation is only allowed after the SparsityPattern has been set up and compress() was called.

Note
The message that will be printed by this exception reads:
"The operation you attempted is only allowed after the SparsityPattern " "has been set up and compress() was called."

◆ ExcMatrixIsCompressed() [1/2]

static ::ExceptionBase & ChunkSparsityPattern::ExcMatrixIsCompressed ( )
static

This operation changes the structure of the SparsityPattern and is not possible after compress() has been called.

Note
The message that will be printed by this exception reads:
"The operation you attempted changes the structure of the SparsityPattern " "and is not possible after compress() has been called."

◆ ExcEmptyObject() [2/2]

static ::ExceptionBase & ChunkSparsityPattern::ExcEmptyObject ( )
static

Exception

◆ ExcIteratorRange() [2/4]

static ::ExceptionBase & ChunkSparsityPattern::ExcIteratorRange ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The iterators denote a range of " << arg1 << " elements, but the given number of rows was " << arg2

◆ ExcMETISNotInstalled() [1/2]

static ::ExceptionBase & ChunkSparsityPattern::ExcMETISNotInstalled ( )
static

Exception

◆ ExcInvalidNumberOfPartitions() [2/4]

static ::ExceptionBase & ChunkSparsityPattern::ExcInvalidNumberOfPartitions ( size_type  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The number of partitions you gave is " << arg1 << ", but must be greater than zero."

◆ ExcInvalidArraySize() [1/2]

static ::ExceptionBase & ChunkSparsityPattern::ExcInvalidArraySize ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The array has size " << arg1 << " but should have size " << arg2

◆ ExcVectorTypeNotCompatible() [1/5]

template<typename Number >
static ::ExceptionBase & LinearAlgebra::CUDAWrappers::Vector< Number >::ExcVectorTypeNotCompatible ( )
static

Attempt to perform an operation between two incompatible vector types.

◆ DummyAccessor() [1/2]

static ::ExceptionBase & DynamicSparsityPatternIterators::Accessor::DummyAccessor ( )
staticprotected
Note
The message that will be printed by this exception reads:
"The instance of this class was initialized" " without DynamicSparsityPattern object, which" " means that it is a dummy accessor that can" " not do any operations."

◆ ExcNotQuadratic()

static ::ExceptionBase & LACExceptions::ExcNotQuadratic ( )
static

This function only works for quadratic matrices.

Note
The message that will be printed by this exception reads:
"This function only works for quadratic objects!"

◆ ExcSingular()

static ::ExceptionBase & LACExceptions::ExcSingular ( )
static

The operation cannot be finished since the matrix is singular.

◆ ExcDifferentBlockIndices()

static ::ExceptionBase & LACExceptions::ExcDifferentBlockIndices ( )
static

Block indices of two block objects are different.

◆ ExcNeedsSparsityPattern()

static ::ExceptionBase & LACExceptions::ExcNeedsSparsityPattern ( )
static

The operation requires a sparsity pattern.

Note
The message that will be printed by this exception reads:
"This function requires that the current object have a " "sparsity pattern attached to it, but no sparsity pattern " "is available. This usually means that there is a missing " "reinit() call which would have added the sparsity pattern."

◆ ExcTrilinosError() [1/10]

static ::ExceptionBase & LACExceptions::ExcTrilinosError ( int  arg1)
static

An error of a Trilinos function was encountered. Check the Trilinos documentation for details.

Note
The message that will be printed by this exception reads:
<< "An error with error number " << arg1 << " occurred while calling a Trilinos function"

◆ ExcEmptyMatrix()

template<typename number >
static ::ExceptionBase & FullMatrix< number >::ExcEmptyMatrix ( )
static

Exception

◆ ExcNotRegular()

template<typename number >
static ::ExceptionBase & FullMatrix< number >::ExcNotRegular ( number  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The maximal pivot is " << arg1 << ", which is below the threshold. The matrix may be singular."

◆ ExcInvalidDestination()

template<typename number >
static ::ExceptionBase & FullMatrix< number >::ExcInvalidDestination ( size_type  arg1,
size_type  arg2,
size_type  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Target region not in matrix: size in this direction=" << arg1 << ", size of new matrix=" << arg2 << ", offset=" << arg3

◆ ExcSourceEqualsDestination() [2/6]

template<typename number >
static ::ExceptionBase & FullMatrix< number >::ExcSourceEqualsDestination ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are attempting an operation on two vectors that " "are the same object, but the operation requires that the " "two objects are in fact different."

◆ ExcMatrixNotPositiveDefinite()

template<typename number >
static ::ExceptionBase & FullMatrix< number >::ExcMatrixNotPositiveDefinite ( )
static

Exception

◆ ExcVectorTypeNotCompatible() [2/5]

template<typename Number >
static ::ExceptionBase & LinearAlgebra::distributed::BlockVector< Number >::ExcVectorTypeNotCompatible ( )
static

Attempt to perform an operation between two incompatible vector types.

◆ ExcIteratorRangeDoesNotMatchVectorSize() [2/4]

template<typename Number >
static ::ExceptionBase & LinearAlgebra::distributed::BlockVector< Number >::ExcIteratorRangeDoesNotMatchVectorSize ( )
static

Exception

◆ ExcVectorTypeNotCompatible() [3/5]

template<typename Number , typename MemorySpace = MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::distributed::Vector< Number, MemorySpace >::ExcVectorTypeNotCompatible ( )
static

Attempt to perform an operation between two incompatible vector types.

◆ ExcNonMatchingElements()

template<typename Number , typename MemorySpace = MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::distributed::Vector< Number, MemorySpace >::ExcNonMatchingElements ( Number  arg1,
Number  arg2,
unsigned int  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Called compress(VectorOperation::insert), but" << " the element received from a remote processor, value " << std::setprecision(16) << arg1 << ", does not match with the value " << std::setprecision(16) << arg2 << " on the owner processor " << arg3

◆ ExcAccessToNonLocalElement() [1/7]

template<typename Number , typename MemorySpace = MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::distributed::Vector< Number, MemorySpace >::ExcAccessToNonLocalElement ( size_type  arg1,
size_type  arg2,
size_type  arg3,
size_type  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access element " << arg1 << " of a distributed vector, but this element is not " << "stored on the current processor. Note: The range of " << "locally owned elements is [" << arg2 << ',' << arg3 << "], and there are " << arg4 << " ghost elements " << "that this vector can access." << "\n\n" << "A common source for this kind of problem is that you " << "are passing a 'fully distributed' vector into a function " << "that needs read access to vector elements that correspond " << "to degrees of freedom on ghost cells (or at least to " << "'locally active' degrees of freedom that are not also " << "'locally owned'). You need to pass a vector that has these " << "elements as ghost entries."

◆ ExcErrorCode()

static ::ExceptionBase & LAPACKSupport::ExcErrorCode ( std::string  arg1,
types::blas_int  arg2 
)
static

A LAPACK function returned an error code.

Note
The message that will be printed by this exception reads:
<< "The function " << arg1 << " returned with an error code " << arg2

◆ ExcState()

static ::ExceptionBase & LAPACKSupport::ExcState ( State  arg1)
static

Exception thrown when a matrix is not in a suitable state for an operation. For instance, a LAPACK routine may have left the matrix in an unusable state, then vmult does not make sense anymore.

Note
The message that will be printed by this exception reads:
<< "The function cannot be called while the matrix is in state " << state_name(arg1)

◆ ExcProperty()

static ::ExceptionBase & LAPACKSupport::ExcProperty ( Property  arg1)
static

Exception thrown when a matrix does not have suitable properties for an operation.

Note
The message that will be printed by this exception reads:
<< "The function cannot be called with a " << property_name(arg1) << " matrix."

◆ ExcMissing()

static ::ExceptionBase & LAPACKSupport::ExcMissing ( std::string  arg1)
static

This exception is thrown if a certain LAPACK function is not available because no LAPACK installation was detected during configuration.

Note
The message that will be printed by this exception reads:
<< "When you ran 'cmake' during installation of deal.II, no suitable " << "installation of the BLAS or LAPACK library could be found. " << "Consequently, the function <" << arg1 << "> can not be called. " << "Refer to the readme at https://dealii.org/current/readme.html for " << "information on how to ensure that deal.II picks up an existing " << "BLAS and LAPACK installation at configuration time."

◆ ExcBlockIndexMismatch()

template<typename MatrixType >
static ::ExceptionBase & MatrixBlock< MatrixType >::ExcBlockIndexMismatch ( size_type  arg1,
size_type  arg2 
)
static

The block number computed from an index by using BlockIndices does not match the block coordinates stored in this object.

Note
The message that will be printed by this exception reads:
<< "Block index " << arg1 << " does not match " << arg2

◆ PArpackExcConvergedEigenvectors()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcConvergedEigenvectors ( int  arg1,
int  arg2 
)
staticprivate

PArpackExcInfoPdnaupds.

Note
The message that will be printed by this exception reads:
<< arg1 << " eigenpairs were requested, but only " << arg2 << " converged"

◆ PArpackExcInvalidNumberofEigenvalues()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcInvalidNumberofEigenvalues ( int  arg1,
int  arg2 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Number of wanted eigenvalues " << arg1 << " is larger that the size of the matrix " << arg2

◆ PArpackExcInvalidEigenvectorSize()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcInvalidEigenvectorSize ( int  arg1,
int  arg2 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Number of wanted eigenvalues " << arg1 << " is larger that the size of eigenvectors " << arg2

◆ PArpackExcInvalidEigenvectorSizeNonsymmetric()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcInvalidEigenvectorSizeNonsymmetric ( int  arg1,
int  arg2 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "To store the real and complex parts of " << arg1 << " eigenvectors in real-valued vectors, their size (currently set to " << arg2 << ") should be greater than or equal to " << arg1 + 1

◆ PArpackExcInvalidEigenvalueSize()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcInvalidEigenvalueSize ( int  arg1,
int  arg2 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Number of wanted eigenvalues " << arg1 << " is larger that the size of eigenvalues " << arg2

◆ PArpackExcInvalidNumberofArnoldiVectors()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcInvalidNumberofArnoldiVectors ( int  arg1,
int  arg2 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Number of Arnoldi vectors " << arg1 << " is larger that the size of the matrix " << arg2

◆ PArpackExcSmallNumberofArnoldiVectors()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcSmallNumberofArnoldiVectors ( int  arg1,
int  arg2 
)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Number of Arnoldi vectors " << arg1 << " is too small to obtain " << arg2 << " eigenvalues"

◆ PArpackExcIdo()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcIdo ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "This ido " << arg1 << " is not supported. Check documentation of ARPACK"

◆ PArpackExcMode()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcMode ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "This mode " << arg1 << " is not supported. Check documentation of ARPACK"

◆ PArpackExcInfoPdnaupd()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcInfoPdnaupd ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Error with Pdnaupd, info " << arg1 << ". Check documentation of ARPACK"

◆ PArpackExcInfoPdneupd()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcInfoPdneupd ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Error with Pdneupd, info " << arg1 << ". Check documentation of ARPACK"

◆ PArpackExcInfoMaxIt()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcInfoMaxIt ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "Maximum number " << arg1 << " of iterations reached."

◆ PArpackExcNoShifts()

template<typename VectorType >
static ::ExceptionBase & PArpackSolver< VectorType >::PArpackExcNoShifts ( int  arg1)
staticprivate
Note
The message that will be printed by this exception reads:
<< "No shifts could be applied during implicit" << " Arnoldi update, try increasing the number of" << " Arnoldi vectors."

◆ ExcIteratorRangeDoesNotMatchVectorSize() [3/4]

static ::ExceptionBase & PETScWrappers::MPI::BlockVector::ExcIteratorRangeDoesNotMatchVectorSize ( )
static

Exception

◆ ExcNonMatchingBlockVectors() [1/2]

static ::ExceptionBase & PETScWrappers::MPI::BlockVector::ExcNonMatchingBlockVectors ( )
static

Exception

◆ ExcBeyondEndOfMatrix() [1/3]

static ::ExceptionBase & PETScWrappers::MatrixIterators::const_iterator::Accessor::ExcBeyondEndOfMatrix ( )
static

Exception

◆ ExcAccessToNonlocalRow() [1/6]

static ::ExceptionBase & PETScWrappers::MatrixIterators::const_iterator::Accessor::ExcAccessToNonlocalRow ( int  arg1,
int  arg2,
int  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access row " << arg1 << " of a distributed matrix, but only rows " << arg2 << " through " << arg3 << " are stored locally and can be accessed."

◆ ExcInvalidIndexWithinRow() [1/5]

static ::ExceptionBase & PETScWrappers::MatrixIterators::const_iterator::ExcInvalidIndexWithinRow ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Attempt to access element " << arg2 << " of row " << arg1 << " which doesn't have that many elements."

◆ ExcSourceEqualsDestination() [3/6]

static ::ExceptionBase & PETScWrappers::MatrixBase::ExcSourceEqualsDestination ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are attempting an operation on two vectors that " "are the same object, but the operation requires that the " "two objects are in fact different."

◆ ExcWrongMode()

static ::ExceptionBase & PETScWrappers::MatrixBase::ExcWrongMode ( int  arg1,
int  arg2 
)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "You tried to do a " << (arg1 == 1 ? "'set'" : (arg1 == 2 ? "'add'" : "???")) << " operation but the matrix is currently in " << (arg2 == 1 ? "'set'" : (arg2 == 2 ? "'add'" : "???")) << " mode. You first have to call 'compress()'."

◆ ExcLocalRowsTooLarge()

static ::ExceptionBase & PETScWrappers::MPI::SparseMatrix::ExcLocalRowsTooLarge ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The number of local rows " << arg1 << " must be larger than the total number of rows " << arg2

◆ ExcWrongBlockSize()

template<typename MatrixType , typename inverse_type = typename MatrixType::value_type>
static ::ExceptionBase & PreconditionBlock< MatrixType, inverse_type >::ExcWrongBlockSize ( int  arg1,
int  arg2 
)
static

For non-overlapping block preconditioners, the block size must divide the matrix size. If not, this exception gets thrown.

Note
The message that will be printed by this exception reads:
<< "The blocksize " << arg1 << " and the size of the matrix " << arg2 << " do not match."

◆ ExcInverseMatricesAlreadyExist()

template<typename MatrixType , typename inverse_type = typename MatrixType::value_type>
static ::ExceptionBase & PreconditionBlock< MatrixType, inverse_type >::ExcInverseMatricesAlreadyExist ( )
static

Exception

◆ ExcDiagonalsNotStored()

template<typename number >
static ::ExceptionBase & PreconditionBlockBase< number >::ExcDiagonalsNotStored ( )
static

You are trying to access a diagonal block (not its inverse), but you decided not to store the diagonal blocks.

◆ ExcInverseNotAvailable()

template<typename number >
static ::ExceptionBase & PreconditionBlockBase< number >::ExcInverseNotAvailable ( )
static

You are accessing a diagonal block, assuming that it has a certain type. But, the method used for inverting the diagonal blocks does not use this type

◆ ExcNoMatrixGivenToUse()

template<typename MatrixType = SparseMatrix<double>, typename VectorType = ::Vector<double>>
static ::ExceptionBase & PreconditionSelector< MatrixType, VectorType >::ExcNoMatrixGivenToUse ( )
static

Exception.

◆ ExcSLEPcWrappersUsageError()

static ::ExceptionBase & SLEPcWrappers::SolverBase::ExcSLEPcWrappersUsageError ( )
static

Exception. Standard exception.

◆ ExcSLEPcError()

static ::ExceptionBase & SLEPcWrappers::SolverBase::ExcSLEPcError ( int  arg1)
static

Exception. SLEPc error with error number.

Note
The message that will be printed by this exception reads:
<< " An error with error number " << arg1 << " occurred while calling a SLEPc function"

◆ ExcSLEPcEigenvectorConvergenceMismatchError()

static ::ExceptionBase & SLEPcWrappers::SolverBase::ExcSLEPcEigenvectorConvergenceMismatchError ( int  arg1,
int  arg2 
)
static

Exception. Convergence failure on the number of eigenvectors.

Note
The message that will be printed by this exception reads:
<< " The number of converged eigenvectors is " << arg1 << " but " << arg2 << " were requested. "

◆ ExcHistoryDataRequired()

static ::ExceptionBase & SolverControl::ExcHistoryDataRequired ( )
static

This exception is thrown if a function operating on the vector of history data of a SolverControl object is called, but storage of history data was not enabled by enable_history_data().

◆ ExcTooFewTmpVectors()

template<typename VectorType = Vector<double>>
static ::ExceptionBase & SolverGMRES< VectorType >::ExcTooFewTmpVectors ( int  arg1)
static
Note
The message that will be printed by this exception reads:
<< "The number of temporary vectors you gave (" << arg1 << ") is too small. It should be at least 10 for " << "any results, and much more for reasonable ones."

◆ ExcPreconditionerNotDefinite()

template<typename VectorType = Vector<double>>
static ::ExceptionBase & SolverMinRes< VectorType >::ExcPreconditionerNotDefinite ( )
static

Exception

◆ ExcSolverDoesNotExist()

template<typename VectorType = Vector<double>>
static ::ExceptionBase & SolverSelector< VectorType >::ExcSolverDoesNotExist ( std::string  arg1)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "Solver " << arg1 << " does not exist. Use one of " << std::endl << get_solver_names()

◆ ExcInvalidStrengthening() [1/3]

template<typename number >
static ::ExceptionBase & SparseLUDecomposition< number >::ExcInvalidStrengthening ( double  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The strengthening parameter " << arg1 << " is not greater or equal than zero!"

◆ ExcUMFPACKError()

static ::ExceptionBase & SparseDirectUMFPACK::ExcUMFPACKError ( std::string  arg1,
int  arg2 
)
static

One of the UMFPack routines threw an error. The error code is included in the output and can be looked up in the UMFPack user manual. The name of the routine is included for reference.

Note
The message that will be printed by this exception reads:
<< "UMFPACK routine " << arg1 << " returned error status " << arg2 << '.' << "\n\n" << ("A complete list of error codes can be found in the file " "<bundled/umfpack/UMFPACK/Include/umfpack.h>." "\n\n" "That said, the two most common errors that can happen are " "that your matrix cannot be factorized because it is " "rank deficient, and that UMFPACK runs out of memory " "because your problem is too large." "\n\n" "The first of these cases most often happens if you " "forget terms in your bilinear form necessary to ensure " "that the matrix has full rank, or if your equation has a " "spatially variable coefficient (or nonlinearity) that is " "supposed to be strictly positive but, for whatever " "reasons, is negative or zero. In either case, you probably " "want to check your assembly procedure. Similarly, a " "matrix can be rank deficient if you forgot to apply the " "appropriate boundary conditions. For example, the " "Laplace equation for a problem where only Neumann boundary " "conditions are posed (or where you forget to apply Dirichlet " "boundary conditions) has exactly one eigenvalue equal to zero " "and its rank is therefore deficient by one. Finally, the matrix " "may be rank deficient because you are using a quadrature " "formula with too few quadrature points." "\n\n" "The other common situation is that you run out of memory. " "On a typical laptop or desktop, it should easily be possible " "to solve problems with 100,000 unknowns in 2d. If you are " "solving problems with many more unknowns than that, in " "particular if you are in 3d, then you may be running out " "of memory and you will need to consider iterative " "solvers instead of the direct solver employed by " "UMFPACK.")

◆ ExcInvalidStrengthening() [2/3]

template<typename number >
static ::ExceptionBase & SparseILU< number >::ExcInvalidStrengthening ( double  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The strengthening parameter " << arg1 << " is not greater or equal than zero!"

◆ ExcZeroPivot()

template<typename number >
static ::ExceptionBase & SparseILU< number >::ExcZeroPivot ( size_type  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "While computing the ILU decomposition, the algorithm " "found a zero pivot on the diagonal of row " << arg1 << ". This must stop the ILU algorithm because it means " "that the matrix for which you try to compute a " "decomposition is singular."

◆ ExcInvalidIndex() [3/7]

template<typename number >
static ::ExceptionBase & SparseMatrix< number >::ExcInvalidIndex ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You are trying to access the matrix entry with index <" << arg1 << ',' << arg2 << ">, but this entry does not exist in the sparsity pattern " "of this matrix." "\n\n" "The most common cause for this problem is that you used " "a method to build the sparsity pattern that did not " "(completely) take into account all of the entries you " "will later try to write into. An example would be " "building a sparsity pattern that does not include " "the entries you will write into due to constraints " "on degrees of freedom such as hanging nodes or periodic " "boundary conditions. In such cases, building the " "sparsity pattern will succeed, but you will get errors " "such as the current one at one point or other when " "trying to write into the entries of the matrix."

◆ ExcDifferentSparsityPatterns()

template<typename number >
static ::ExceptionBase & SparseMatrix< number >::ExcDifferentSparsityPatterns ( )
static

Exception

Note
The message that will be printed by this exception reads:
"When copying one sparse matrix into another, " "or when adding one sparse matrix to another, " "both matrices need to refer to the same " "sparsity pattern."

◆ ExcIteratorRange() [3/4]

template<typename number >
static ::ExceptionBase & SparseMatrix< number >::ExcIteratorRange ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The iterators denote a range of " << arg1 << " elements, but the given number of rows was " << arg2

◆ ExcSourceEqualsDestination() [4/6]

template<typename number >
static ::ExceptionBase & SparseMatrix< number >::ExcSourceEqualsDestination ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are attempting an operation on two vectors that " "are the same object, but the operation requires that the " "two objects are in fact different."

◆ ExcNoDiagonal()

template<typename number >
static ::ExceptionBase & SparseMatrixEZ< number >::ExcNoDiagonal ( )
static

Exception for missing diagonal entry.

◆ ExcInvalidEntry()

template<typename number >
static ::ExceptionBase & SparseMatrixEZ< number >::ExcInvalidEntry ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The entry with index (" << arg1 << ',' << arg2 << ") does not exist."

◆ ExcEntryAllocationFailure()

template<typename number >
static ::ExceptionBase & SparseMatrixEZ< number >::ExcEntryAllocationFailure ( int  arg1,
int  arg2 
)
static
Note
The message that will be printed by this exception reads:
<< "An entry with index (" << arg1 << ',' << arg2 << ") cannot be allocated."

◆ ExcStrengthenDiagonalTooSmall()

template<typename number >
static ::ExceptionBase & SparseMIC< number >::ExcStrengthenDiagonalTooSmall ( )
static

Exception

◆ ExcInvalidStrengthening() [3/3]

template<typename number >
static ::ExceptionBase & SparseMIC< number >::ExcInvalidStrengthening ( double  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The strengthening parameter " << arg1 << " is not greater or equal than zero!"

◆ ExcDecompositionNotStable()

template<typename number >
static ::ExceptionBase & SparseMIC< number >::ExcDecompositionNotStable ( int  arg1,
double  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The diagonal element (" << arg1 << ',' << arg1 << ") is " << arg2 << ", but must be positive"

◆ DummyAccessor() [2/2]

static ::ExceptionBase & SparsityPatternIterators::Accessor::DummyAccessor ( )
staticprotected
Note
The message that will be printed by this exception reads:
"The instance of this class was initialized" " without SparsityPattern object, which" " means that it is a dummy accessor that can" " not do any operations."

◆ ExcIteratorRange() [4/4]

static ::ExceptionBase & SparsityPattern::ExcIteratorRange ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The iterators denote a range of " << arg1 << " elements, but the given number of rows was " << arg2

◆ ExcInvalidNumberOfPartitions() [3/4]

static ::ExceptionBase & SparsityPattern::ExcInvalidNumberOfPartitions ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The number of partitions you gave is " << arg1 << ", but must be greater than zero."

◆ ExcNotEnoughSpace() [2/2]

static ::ExceptionBase & SparsityPattern::ExcNotEnoughSpace ( int  arg1,
int  arg2 
)
static

You tried to add an element to a row, but there was no space left.

Note
The message that will be printed by this exception reads:
<< "Upon entering a new entry to row " << arg1 << ": there was no free entry any more. " << std::endl << "(Maximum number of entries for this row: " << arg2 << "; maybe the matrix is already compressed?)"

◆ ExcMatrixIsCompressed() [2/2]

static ::ExceptionBase & SparsityPattern::ExcMatrixIsCompressed ( )
static

This operation changes the structure of the SparsityPattern and is not possible after compress() has been called.

Note
The message that will be printed by this exception reads:
"The operation you attempted changes the structure of the SparsityPattern " "and is not possible after compress() has been called."

◆ ExcNotCompressed() [2/2]

static ::ExceptionBase & SparsityPattern::ExcNotCompressed ( )
static

The operation is only allowed after the SparsityPattern has been set up and compress() was called.

Note
The message that will be printed by this exception reads:
"The operation you attempted is only allowed after the SparsityPattern " "has been set up and compress() was called."

◆ ExcMETISNotInstalled() [2/2]

static ::ExceptionBase & SparsityTools::ExcMETISNotInstalled ( )
static

Exception

Note
The message that will be printed by this exception reads:
"The function you called requires METIS, but you did not " "configure deal.II with METIS."

◆ ExcInvalidNumberOfPartitions() [4/4]

static ::ExceptionBase & SparsityTools::ExcInvalidNumberOfPartitions ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The number of partitions you gave is " << arg1 << ", but must be greater than zero."

◆ ExcMETISError()

static ::ExceptionBase & SparsityTools::ExcMETISError ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< " An error with error number " << arg1 << " occurred while calling a METIS function"

◆ ExcInvalidArraySize() [2/2]

static ::ExceptionBase & SparsityTools::ExcInvalidArraySize ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The array has size " << arg1 << " but should have size " << arg2

◆ ExcZOLTANNotInstalled()

static ::ExceptionBase & SparsityTools::ExcZOLTANNotInstalled ( )
static

Exception

Note
The message that will be printed by this exception reads:
"The function you called requires ZOLTAN, but you did not " "configure deal.II with ZOLTAN or zoltan_cpp.h is not available."

◆ ExcIncompatibleRowNumbers() [3/3]

static ::ExceptionBase & TrilinosWrappers::BlockSparseMatrix::ExcIncompatibleRowNumbers ( int  arg1,
int  arg2,
int  arg3,
int  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The blocks [" << arg1 << ',' << arg2 << "] and [" << arg3 << ',' << arg4 << "] have differing row numbers."

◆ ExcIncompatibleColNumbers() [3/3]

static ::ExceptionBase & TrilinosWrappers::BlockSparseMatrix::ExcIncompatibleColNumbers ( int  arg1,
int  arg2,
int  arg3,
int  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The blocks [" << arg1 << ',' << arg2 << "] and [" << arg3 << ',' << arg4 << "] have differing column numbers."

◆ ExcDifferentParallelPartitioning() [1/3]

static ::ExceptionBase & LinearAlgebra::EpetraWrappers::Vector::ExcDifferentParallelPartitioning ( )
static

The vectors have different partitioning, i.e. their IndexSet objects don't represent the same indices.

◆ ExcVectorTypeNotCompatible() [4/5]

static ::ExceptionBase & LinearAlgebra::EpetraWrappers::Vector::ExcVectorTypeNotCompatible ( )
static

Attempt to perform an operation between two incompatible vector types.

◆ ExcTrilinosError() [2/10]

static ::ExceptionBase & LinearAlgebra::EpetraWrappers::Vector::ExcTrilinosError ( int  arg1)
static

Exception thrown by an error in Trilinos.

Note
The message that will be printed by this exception reads:
<< "An error with error number " << arg1 << " occurred while calling a Trilinos function"

◆ ExcIteratorRangeDoesNotMatchVectorSize() [4/4]

static ::ExceptionBase & TrilinosWrappers::MPI::BlockVector::ExcIteratorRangeDoesNotMatchVectorSize ( )
static

Exception

◆ ExcNonMatchingBlockVectors() [2/2]

static ::ExceptionBase & TrilinosWrappers::MPI::BlockVector::ExcNonMatchingBlockVectors ( )
static

Exception

◆ ExcNonMatchingMaps()

static ::ExceptionBase & TrilinosWrappers::PreconditionBase::ExcNonMatchingMaps ( std::string  arg1)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "The sparse matrix the preconditioner is based on " << "uses a map that is not compatible to the one in vector " << arg1 << ". Check preconditioner and matrix setup."

◆ ExcTrilinosError() [3/10]

static ::ExceptionBase & TrilinosWrappers::SolverBase::ExcTrilinosError ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "An error with error number " << arg1 << " occurred while calling a Trilinos function"

◆ ExcTrilinosError() [4/10]

static ::ExceptionBase & TrilinosWrappers::SolverDirect::ExcTrilinosError ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "An error with error number " << arg1 << " occurred while calling a Trilinos function"

◆ ExcBeyondEndOfMatrix() [2/3]

static ::ExceptionBase & TrilinosWrappers::SparseMatrixIterators::ExcBeyondEndOfMatrix ( )
static

Exception

◆ ExcAccessToNonlocalRow() [2/6]

static ::ExceptionBase & TrilinosWrappers::SparseMatrixIterators::ExcAccessToNonlocalRow ( std::size_t  arg1,
std::size_t  arg2,
std::size_t  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access row " << arg1 << " of a distributed sparsity pattern, " << " but only rows " << arg2 << " through " << arg3 << " are stored locally and can be accessed."

◆ ExcInvalidIndexWithinRow() [2/5]

template<bool Constness>
static ::ExceptionBase & TrilinosWrappers::SparseMatrixIterators::Iterator< Constness >::ExcInvalidIndexWithinRow ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Attempt to access element " << arg2 << " of row " << arg1 << " which doesn't have that many elements."

◆ ExcAccessToNonlocalRow() [3/6]

static ::ExceptionBase & TrilinosWrappers::SparseMatrix::ExcAccessToNonlocalRow ( std::size_t  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access row " << arg1 << " of a non-contiguous locally owned row set." << " The row " << arg1 << " is not stored locally and can't be accessed."

◆ ExcTrilinosError() [5/10]

static ::ExceptionBase & TrilinosWrappers::SparseMatrix::ExcTrilinosError ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "An error with error number " << arg1 << " occurred while calling a Trilinos function. " "\n\n" "For historical reasons, many Trilinos functions express " "errors by returning specific integer values to indicate " "certain errors. Unfortunately, different Trilinos functions " "often use the same integer values for different kinds of " "errors, and in most cases it is also not documented what " "each error code actually means. As a consequence, it is often " "difficult to say what a particular error (in this case, " "the error with integer code '" << arg1 << "') represents and how one should fix a code to avoid it. " "The best one can often do is to look up the call stack to " "see which deal.II function generated the error, and which " "Trilinos function the error code had originated from; " "then look up the Trilinos source code of that function (for " "example on github) to see what code path set that error " "code. Short of going through all of that, the only other " "option is to guess the cause of the error from " "the context in which the error appeared."

◆ ExcInvalidIndex() [4/7]

static ::ExceptionBase & TrilinosWrappers::SparseMatrix::ExcInvalidIndex ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The entry with index <" << arg1 << ',' << arg2 << "> does not exist."

◆ ExcSourceEqualsDestination() [5/6]

static ::ExceptionBase & TrilinosWrappers::SparseMatrix::ExcSourceEqualsDestination ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are attempting an operation on two vectors that " "are the same object, but the operation requires that the " "two objects are in fact different."

◆ ExcMatrixNotCompressed() [1/2]

static ::ExceptionBase & TrilinosWrappers::SparseMatrix::ExcMatrixNotCompressed ( )
static

Exception

◆ ExcAccessToNonLocalElement() [2/7]

static ::ExceptionBase & TrilinosWrappers::SparseMatrix::ExcAccessToNonLocalElement ( size_type  arg1,
size_type  arg2,
size_type  arg3,
size_type  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access element (" << arg1 << '/' << arg2 << ')' << " of a distributed matrix, but only rows in range [" << arg3 << ',' << arg4 << "] are stored locally and can be accessed."

◆ ExcAccessToNonPresentElement() [1/3]

static ::ExceptionBase & TrilinosWrappers::SparseMatrix::ExcAccessToNonPresentElement ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access element (" << arg1 << '/' << arg2 << ')' << " of a sparse matrix, but it appears to not" << " exist in the Trilinos sparsity pattern."

◆ ExcBeyondEndOfSparsityPattern() [1/2]

static ::ExceptionBase & TrilinosWrappers::SparsityPatternIterators::Accessor::ExcBeyondEndOfSparsityPattern ( )
static

Exception

◆ ExcAccessToNonlocalRow() [4/6]

static ::ExceptionBase & TrilinosWrappers::SparsityPatternIterators::Accessor::ExcAccessToNonlocalRow ( size_type  arg1,
size_type  arg2,
size_type  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access row " << arg1 << " of a distributed sparsity pattern, " << " but only rows " << arg2 << " through " << arg3 << " are stored locally and can be accessed."

◆ ExcInvalidIndexWithinRow() [3/5]

static ::ExceptionBase & TrilinosWrappers::SparsityPatternIterators::Iterator::ExcInvalidIndexWithinRow ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Attempt to access element " << arg2 << " of row " << arg1 << " which doesn't have that many elements."

◆ ExcTrilinosError() [6/10]

static ::ExceptionBase & TrilinosWrappers::SparsityPattern::ExcTrilinosError ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "An error with error number " << arg1 << " occurred while calling a Trilinos function"

◆ ExcInvalidIndex() [5/7]

static ::ExceptionBase & TrilinosWrappers::SparsityPattern::ExcInvalidIndex ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The entry with index <" << arg1 << ',' << arg2 << "> does not exist."

◆ ExcAccessToNonLocalElement() [3/7]

static ::ExceptionBase & TrilinosWrappers::SparsityPattern::ExcAccessToNonLocalElement ( size_type  arg1,
size_type  arg2,
size_type  arg3,
size_type  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access element (" << arg1 << '/' << arg2 << ')' << " of a distributed matrix, but only rows in range [" << arg3 << ',' << arg4 << "] are stored locally and can be accessed."

◆ ExcAccessToNonPresentElement() [2/3]

static ::ExceptionBase & TrilinosWrappers::SparsityPattern::ExcAccessToNonPresentElement ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access element (" << arg1 << '/' << arg2 << ')' << " of a sparse matrix, but it appears to not" << " exist in the Trilinos sparsity pattern."

◆ ExcTrilinosAmesos2SolverUnsupported()

static ::ExceptionBase & LinearAlgebra::TpetraWrappers::ExcTrilinosAmesos2SolverUnsupported ( std::string  arg1)
static

The chosen Solver is not supported or configured with Amesos2.

Note
The message that will be printed by this exception reads:
<< "You tried to select the solver type <" << arg1 << ">\n" << "but this solver is not supported by Trilinos/Amesos2\n" << "due to one of the following reasons:\n" << "* This solver does not exist\n" << "* This solver is not (yet) supported by Trilinos/Amesos2\n" << "* Trilinos/Amesos2 was not configured for its use."

◆ ExcTrilinosError() [7/10]

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SolverDirectBase< Number, MemorySpace >::ExcTrilinosError ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "An error with error number " << arg1 << " occurred while calling a Trilinos function"

◆ ExcAccessToNonlocalRow() [5/6]

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcAccessToNonlocalRow ( std::size_t  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access row " << arg1 << " of a non-contiguous locally owned row set." << " The row " << arg1 << " is not stored locally and can't be accessed."

◆ ExcMatrixNotCompressed() [2/2]

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcMatrixNotCompressed ( )
static

Exception

◆ ExcSourceEqualsDestination() [6/6]

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcSourceEqualsDestination ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are attempting an operation on two vectors that " "are the same object, but the operation requires that the " "two objects are in fact different."

◆ ExcColMapMissmatch()

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcColMapMissmatch ( )
static
Note
The message that will be printed by this exception reads:
"The column partitioning of a matrix does not match " "the partitioning of a vector you are trying to " "multiply it with. Are you multiplying the " "matrix with a vector that has ghost elements?"

◆ ExcDomainMapMissmatch()

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcDomainMapMissmatch ( )
static
Note
The message that will be printed by this exception reads:
"The row partitioning of a matrix does not match " "the partitioning of a vector you are trying to " "put the result of a matrix-vector product in. " "Are you trying to put the product of the " "matrix with a vector into a vector that has " "ghost elements?"

◆ ExcInvalidIndex() [6/7]

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcInvalidIndex ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The entry with index <" << arg1 << ',' << arg2 << "> does not exist."

◆ ExcAccessToNonLocalElement() [4/7]

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparseMatrix< Number, MemorySpace >::ExcAccessToNonLocalElement ( size_type  arg1,
size_type  arg2,
size_type  arg3,
size_type  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access element (" << arg1 << '/' << arg2 << ')' << " of a distributed matrix, but only rows in range [" << arg3 << ',' << arg4 << "] are stored locally and can be accessed."

◆ ExcBeyondEndOfMatrix() [3/3]

static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparseMatrixIterators::ExcBeyondEndOfMatrix ( )
static

Exception

◆ ExcInvalidIndexWithinRow() [4/5]

template<typename Number , typename MemorySpace , bool Constness>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparseMatrixIterators::Iterator< Number, MemorySpace, Constness >::ExcInvalidIndexWithinRow ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Attempt to access element " << arg2 << " of row " << arg1 << " which doesn't have that many elements."

◆ ExcBeyondEndOfSparsityPattern() [2/2]

template<typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparsityPatternIterators::Accessor< MemorySpace >::ExcBeyondEndOfSparsityPattern ( )
static

Exception

◆ ExcAccessToNonlocalRow() [6/6]

template<typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparsityPatternIterators::Accessor< MemorySpace >::ExcAccessToNonlocalRow ( size_type  arg1,
size_type  arg2,
size_type  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access row " << arg1 << " of a distributed sparsity pattern, " << " but only rows " << arg2 << " through " << arg3 << " are stored locally and can be accessed."

◆ ExcInvalidIndexWithinRow() [5/5]

template<typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparsityPatternIterators::Iterator< MemorySpace >::ExcInvalidIndexWithinRow ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Attempt to access element " << arg2 << " of row " << arg1 << " which doesn't have that many elements."

◆ ExcTrilinosError() [8/10]

template<typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparsityPattern< MemorySpace >::ExcTrilinosError ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "An error with error number " << arg1 << " occurred while calling a Trilinos function"

◆ ExcInvalidIndex() [7/7]

template<typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparsityPattern< MemorySpace >::ExcInvalidIndex ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The entry with index <" << arg1 << ',' << arg2 << "> does not exist."

◆ ExcAccessToNonLocalElement() [5/7]

template<typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparsityPattern< MemorySpace >::ExcAccessToNonLocalElement ( size_type  arg1,
size_type  arg2,
size_type  arg3,
size_type  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access element (" << arg1 << '/' << arg2 << ')' << " of a distributed matrix, but only rows in range [" << arg3 << ',' << arg4 << "] are stored locally and can be accessed."

◆ ExcAccessToNonPresentElement() [3/3]

template<typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::SparsityPattern< MemorySpace >::ExcAccessToNonPresentElement ( size_type  arg1,
size_type  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to access element (" << arg1 << '/' << arg2 << ')' << " of a sparse matrix, but it appears to not" << " exist in the Trilinos sparsity pattern."

◆ ExcDifferentParallelPartitioning() [2/3]

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::ExcDifferentParallelPartitioning ( )
static

The vectors have different partitioning, i.e. their IndexSet objects don't represent the same indices.

◆ ExcVectorTypeNotCompatible() [5/5]

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::ExcVectorTypeNotCompatible ( )
static

Attempt to perform an operation between two incompatible vector types.

◆ ExcAccessToNonLocalElement() [6/7]

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::ExcAccessToNonLocalElement ( size_type  arg1,
size_type  arg2,
size_type  arg3,
size_type  arg4 
)
static
Note
The message that will be printed by this exception reads:
<< "You are trying to access element " << arg1 << " of a distributed vector, but this element is not stored " << "on the current processor. Note: There are " << arg2 << " elements stored " << "on the current processor from within the range [" << arg3 << ',' << arg4 << "] but Trilinos vectors need not store contiguous " << "ranges on each processor, and not every element in " << "this range may in fact be stored locally." << "\n\n" << "A common source for this kind of problem is that you " << "are passing a 'fully distributed' vector into a function " << "that needs read access to vector elements that correspond " << "to degrees of freedom on ghost cells (or at least to " << "'locally active' degrees of freedom that are not also " << "'locally owned'). You need to pass a vector that has these " << "elements as ghost entries."

◆ ExcMissingIndexSet()

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::ExcMissingIndexSet ( )
static

Missing index set.

Note
The message that will be printed by this exception reads:
"To compress a vector, a locally_relevant_dofs " "index set, and a locally_owned_dofs index set " "must be provided. These index sets must be " "provided either when the vector is initialized " "or when compress is called. See the documentation " "of compress() for more information."

◆ ExcTrilinosError() [9/10]

template<typename Number , typename MemorySpace = ::MemorySpace::Host>
static ::ExceptionBase & LinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::ExcTrilinosError ( int  arg1)
static

Exception thrown by an error in Trilinos.

Note
The message that will be printed by this exception reads:
<< "An error with error number " << arg1 << " occurred while calling a Trilinos function"

◆ ExcDifferentParallelPartitioning() [3/3]

static ::ExceptionBase & TrilinosWrappers::MPI::Vector::ExcDifferentParallelPartitioning ( )
static

Exception

◆ ExcTrilinosError() [10/10]

static ::ExceptionBase & TrilinosWrappers::MPI::Vector::ExcTrilinosError ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "An error with error number " << arg1 << " occurred while calling a Trilinos function"

◆ ExcAccessToNonLocalElement() [7/7]

static ::ExceptionBase & TrilinosWrappers::MPI::Vector::ExcAccessToNonLocalElement ( size_type  arg1,
size_type  arg2,
size_type  arg3,
size_type  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You are trying to access element " << arg1 << " of a distributed vector, but this element is not stored " << "on the current processor. Note: There are " << arg2 << " elements stored " << "on the current processor from within the range [" << arg3 << ',' << arg4 << "] but Trilinos vectors need not store contiguous " << "ranges on each processor, and not every element in " << "this range may in fact be stored locally." << "\n\n" << "A common source for this kind of problem is that you " << "are passing a 'fully distributed' vector into a function " << "that needs read access to vector elements that correspond " << "to degrees of freedom on ghost cells (or at least to " << "'locally active' degrees of freedom that are not also " << "'locally owned'). You need to pass a vector that has these " << "elements as ghost entries."

◆ ExcNotAllocatedHere()

template<typename VectorType = ::Vector<double>>
static ::ExceptionBase & VectorMemory< VectorType >::ExcNotAllocatedHere ( )
static

Vector was not allocated from this memory pool.

Note
The message that will be printed by this exception reads:
"You are trying to deallocate a vector from a memory pool, but this " "vector has not actually been allocated by the same pool before."

◆ ExcAccessToUninitializedField() [2/2]

static ::ExceptionBase & internal::ExcAccessToUninitializedField ( )
static

◆ ExcMatrixFreeAccessToUninitializedMappingField()

static ::ExceptionBase & internal::ExcMatrixFreeAccessToUninitializedMappingField ( std::string  arg1)
static
Note
The message that will be printed by this exception reads:
<< "You are requesting information from an FEEvaluation/FEFaceEvaluation " << "object for which this kind of information has not been computed. What " << "information these objects compute is determined by the update_* flags " << "you pass to MatrixFree::reinit() via MatrixFree::AdditionalData. " << "Here, the operation you are attempting requires the <" << arg1 << "> flag to be set, but it was apparently not specified " << "upon initialization."

◆ ExcFEPointEvaluationAccessToUninitializedMappingField()

static ::ExceptionBase & internal::FEPointEvaluation::ExcFEPointEvaluationAccessToUninitializedMappingField ( std::string  arg1)
static
Note
The message that will be printed by this exception reads:
<< "You are requesting information from an FEPointEvaluationBase " << "object for which this kind of information has not been computed. " << "What information these objects compute is determined by the update_* " << "flags you pass to MappingInfo() in the Constructor. Here, " << "the operation you are attempting requires the <" << arg1 << "> flag to be set, but it was apparently not specified " << "upon initialization."

◆ ExcPureFunction()

template<int dim, int spacedim = dim, typename number = double>
static ::ExceptionBase & MeshWorker::LocalIntegrator< dim, spacedim, number >::ExcPureFunction ( )
static

This error is thrown if one of the virtual functions cell(), boundary(), or face() is called without being overloaded in a derived class. Consider setting use_cell, use_boundary, and use_face to false, respectively.

◆ ExcOnlyAvailableWithoutHP() [2/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & MeshWorker::ScratchData< dim, spacedim >::ExcOnlyAvailableWithoutHP ( )
staticprivate

Exception used when a certain feature doesn't make sense when ScratchData does has hp-capabilities enabled.

Note
The message that will be printed by this exception reads:
"The current function doesn't make sense when used with a " "ScratchData object with hp-capabilities."

◆ ExcOnlyAvailableWithHP() [3/3]

template<int dim, int spacedim = dim>
static ::ExceptionBase & MeshWorker::ScratchData< dim, spacedim >::ExcOnlyAvailableWithHP ( )
staticprivate

Exception used when a certain feature doesn't make sense when ScratchData does not have hp-capabilities enabled.

Note
The message that will be printed by this exception reads:
"The current function doesn't make sense when used with a " "ScratchData object without hp-capabilities."

◆ ExcNoProlongation()

template<typename VectorType >
static ::ExceptionBase & MGTransferPrebuilt< VectorType >::ExcNoProlongation ( )
static

Finite element does not provide prolongation matrices.

◆ ExcMatricesNotBuilt() [1/3]

template<typename VectorType >
static ::ExceptionBase & MGTransferPrebuilt< VectorType >::ExcMatricesNotBuilt ( )
static

You have to call build() before using this object.

◆ ExcMatricesNotBuilt() [2/3]

static ::ExceptionBase & MGTransferBlockBase::ExcMatricesNotBuilt ( )
staticprotected

Call build() function first.

◆ ExcMatricesNotBuilt() [3/3]

static ::ExceptionBase & MGTransferComponentBase::ExcMatricesNotBuilt ( )
staticprotected

Call build() function first.

◆ ExcInvalidNumberOfSubdivisions()

static ::ExceptionBase & Exceptions::DataOutImplementation::ExcInvalidNumberOfSubdivisions ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The number of subdivisions per patch, " << arg1 << ", is not valid. It needs to be greater or equal to " "one, or zero if you want it to be determined " "automatically."

◆ ExcNoTriangulationSelected() [2/2]

static ::ExceptionBase & Exceptions::DataOutImplementation::ExcNoTriangulationSelected ( )
static

Exception

Note
The message that will be printed by this exception reads:
"For the operation you are attempting, you first need to " "tell the DataOut or related object which DoFHandler or " "triangulation you would like to work on. This is " "generally done using the 'attach_dof_handler()' or " "'attach_triangulation()' member functions."

◆ ExcNoDoFHandlerSelected()

static ::ExceptionBase & Exceptions::DataOutImplementation::ExcNoDoFHandlerSelected ( )
static

Exception

Note
The message that will be printed by this exception reads:
"For the operation you are attempting, you first need to " "tell the DataOut or related object which DoFHandler " "you would like to work on. This is " "generally done using the 'attach_dof_handler()' " "member function."

◆ ExcInvalidVectorSize()

static ::ExceptionBase & Exceptions::DataOutImplementation::ExcInvalidVectorSize ( int  arg1,
int  arg2,
int  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The vector has size " << arg1 << " but the DoFHandler object says that there are " << arg2 << " degrees of freedom and there are " << arg3 << " active cells. The size of your vector needs to be" << " either equal to the number of degrees of freedom (when" << " the data is of type type_dof_data), or equal to the" << " number of active cells (when the data is of type " << " type_cell_data)."

◆ ExcInvalidCharacter()

static ::ExceptionBase & Exceptions::DataOutImplementation::ExcInvalidCharacter ( std::string  arg1,
size_t  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Please use only the characters [a-zA-Z0-9_<>()] for" << std::endl << "description strings since some graphics formats will only accept these." << std::endl << "The string you gave was <" << arg1 << ">, within which the invalid character is <" << arg1[arg2] << ">." << std::endl

◆ ExcOldDataStillPresent()

static ::ExceptionBase & Exceptions::DataOutImplementation::ExcOldDataStillPresent ( )
static

Exception

Note
The message that will be printed by this exception reads:
"When attaching a triangulation or DoFHandler object, it is " "not allowed if old data vectors are still referenced. If " "you want to reuse an object of the current type, you first " "need to call the 'clear_data_vector()' function."

◆ ExcInvalidNumberOfNames()

static ::ExceptionBase & Exceptions::DataOutImplementation::ExcInvalidNumberOfNames ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You have to give one name per component in your " << "data vector. The number you gave was " << arg1 << ", but the number of components is " << arg2 << '.'

◆ ExcIncompatibleDatasetNames() [2/2]

static ::ExceptionBase & Exceptions::DataOutImplementation::ExcIncompatibleDatasetNames ( )
static

Exception

Note
The message that will be printed by this exception reads:
"While merging sets of patches, the two sets to be merged " "need to refer to data that agrees on the names of the " "various variables represented. In other words, you " "cannot merge sets of patches that originate from " "entirely unrelated simulations."

◆ ExcIncompatiblePatchLists() [2/2]

static ::ExceptionBase & Exceptions::DataOutImplementation::ExcIncompatiblePatchLists ( )
static

Exception

Note
The message that will be printed by this exception reads:
"While merging sets of patches, the two sets to be merged " "need to refer to data that agrees on the number of " "subdivisions and other properties. In other words, you " "cannot merge sets of patches that originate from " "entirely unrelated simulations."

◆ ExcInvalidVectorDeclaration()

static ::ExceptionBase & Exceptions::DataOutImplementation::ExcInvalidVectorDeclaration ( int  arg1,
std::string  arg2 
)
static
Note
The message that will be printed by this exception reads:
<< "When declaring that a number of components in a data " << "set to be output logically form a vector instead of " << "simply a set of scalar fields, you need to specify " << "this for all relevant components. Furthermore, " << "vectors must always consist of exactly <dim> " << "components. However, the vector component at " << "position " << arg1 << " with name <" << arg2 << "> does not satisfy these conditions."

◆ ExcInvalidTensorDeclaration()

static ::ExceptionBase & Exceptions::DataOutImplementation::ExcInvalidTensorDeclaration ( int  arg1,
std::string  arg2 
)
static
Note
The message that will be printed by this exception reads:
<< "When declaring that a number of components in a data " << "set to be output logically form a tensor instead of " << "simply a set of scalar fields, you need to specify " << "this for all relevant components. Furthermore, " << "tensors must always consist of exactly <dim*dim> " << "components. However, the tensor component at " << "position " << arg1 << " with name <" << arg2 << "> does not satisfy these conditions."

◆ ExcRadialVariableHasNegativeValues()

template<int dim, int spacedim = dim>
static ::ExceptionBase & DataOutRotation< dim, spacedim >::ExcRadialVariableHasNegativeValues ( double  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You are attempting to use this class on a triangulation " "in which some vertices have a negative radial coordinate " "value of " << arg1 << ". If you rotate such a triangulation around an " "axis, you will get (dim+1)-dimensional meshes " "that are not likely what you hoped to see."

◆ ExcVectorNotDeclared()

template<int dim, int spacedim = dim>
static ::ExceptionBase & DataOutStack< dim, spacedim >::ExcVectorNotDeclared ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The data vector for which the first component has the name " << arg1 << " has not been added before."

◆ ExcDataNotCleared()

template<int dim, int spacedim = dim>
static ::ExceptionBase & DataOutStack< dim, spacedim >::ExcDataNotCleared ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You cannot start a new time/parameter step before calling " "finish_parameter_value() on the previous step."

◆ ExcDataAlreadyAdded()

template<int dim, int spacedim = dim>
static ::ExceptionBase & DataOutStack< dim, spacedim >::ExcDataAlreadyAdded ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You cannot declare additional vectors after already calling " "build_patches(). All data vectors need to be declared " "before you call this function the first time."

◆ ExcNameAlreadyUsed()

template<int dim, int spacedim = dim>
static ::ExceptionBase & DataOutStack< dim, spacedim >::ExcNameAlreadyUsed ( std::string  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You tried to declare a component of a data vector with " << "the name <" << arg1 << ">, but that name is already used."

◆ ExcVectorLengthVsNActiveCells()

static ::ExceptionBase & DerivativeApproximation::ExcVectorLengthVsNActiveCells ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The output vector needs to have a size equal " "to the number of active cells of your triangulation " "but has length " << arg1 << "There are " << arg2 << " active cells in your triangulation."

◆ ExcInsufficientDirections()

static ::ExceptionBase & DerivativeApproximation::ExcInsufficientDirections ( )
static

Exception

Note
The message that will be printed by this exception reads:
"While computing a finite difference approximation to " "derivatives, the algorithm encountered a cell on which " "the number of linearly " "independent directions that span the matrix Y (discussed " "in the documentation of the DerivativeApproximation " "class) is not equal to dim. The matrix Y then is " "rank deficient and can not be inverted. A common reason " "why this might be happening is if a cell has neither " "left/right (or up/down, or front/back) neighbors, for " "example because the mesh is too coarse."

◆ ExcInvalidComponentMask() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & KellyErrorEstimator< dim, spacedim >::ExcInvalidComponentMask ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You provided a ComponentMask argument that is invalid. " "Component masks need to be either default constructed " "(in which case they indicate that every component is " "selected) or need to have a length equal to the number " "of vector components of the finite element in use " "by the DoFHandler object. In the latter case, at " "least one component needs to be selected."

◆ ExcInvalidCoefficient() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & KellyErrorEstimator< dim, spacedim >::ExcInvalidCoefficient ( )
static

Exception

Note
The message that will be printed by this exception reads:
"If you do specify the argument for a (possibly " "spatially variable) coefficient function for this function, " "then it needs to refer to a coefficient that is either " "scalar (has one vector component) or has as many vector " "components as there are in the finite element used by " "the DoFHandler argument."

◆ ExcInvalidBoundaryFunction() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & KellyErrorEstimator< dim, spacedim >::ExcInvalidBoundaryFunction ( types::boundary_id  arg1,
int  arg2,
int  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You provided a function map that for boundary indicator " << arg1 << " specifies a function with " << arg2 << " vector components. However, the finite " "element in use has " << arg3 << " components, and these two numbers need to match."

◆ ExcIncompatibleNumberOfElements() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & KellyErrorEstimator< dim, spacedim >::ExcIncompatibleNumberOfElements ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The number of input vectors, " << arg1 << " needs to be equal to the number of output vectors, " << arg2 << ". This is not the case in your call of this function."

◆ ExcNoSolutions() [1/2]

template<int dim, int spacedim = dim>
static ::ExceptionBase & KellyErrorEstimator< dim, spacedim >::ExcNoSolutions ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You need to specify at least one solution vector as " "input."

◆ ExcInvalidComponentMask() [2/2]

template<int spacedim>
static ::ExceptionBase & KellyErrorEstimator< 1, spacedim >::ExcInvalidComponentMask ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You provided a ComponentMask argument that is invalid. " "Component masks need to be either default constructed " "(in which case they indicate that every component is " "selected) or need to have a length equal to the number " "of vector components of the finite element in use " "by the DoFHandler object. In the latter case, at " "least one component needs to be selected."

◆ ExcInvalidCoefficient() [2/2]

template<int spacedim>
static ::ExceptionBase & KellyErrorEstimator< 1, spacedim >::ExcInvalidCoefficient ( )
static

Exception

Note
The message that will be printed by this exception reads:
"If you do specify the argument for a (possibly " "spatially variable) coefficient function for this function, " "then it needs to refer to a coefficient that is either " "scalar (has one vector component) or has as many vector " "components as there are in the finite element used by " "the DoFHandler argument."

◆ ExcInvalidBoundaryFunction() [2/2]

template<int spacedim>
static ::ExceptionBase & KellyErrorEstimator< 1, spacedim >::ExcInvalidBoundaryFunction ( types::boundary_id  arg1,
int  arg2,
int  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "You provided a function map that for boundary indicator " << arg1 << " specifies a function with " << arg2 << " vector components. However, the finite " "element in use has " << arg3 << " components, and these two numbers need to match."

◆ ExcIncompatibleNumberOfElements() [2/2]

template<int spacedim>
static ::ExceptionBase & KellyErrorEstimator< 1, spacedim >::ExcIncompatibleNumberOfElements ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The number of input vectors, " << arg1 << " needs to be equal to the number of output vectors, " << arg2 << ". This is not the case in your call of this function."

◆ ExcNoSolutions() [2/2]

template<int spacedim>
static ::ExceptionBase & KellyErrorEstimator< 1, spacedim >::ExcNoSolutions ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You need to specify at least one solution vector as " "input."

◆ ExcEmptyData()

static ::ExceptionBase & Histogram::ExcEmptyData ( )
static

Exception.

Note
The message that will be printed by this exception reads:
"Your input argument to this function does not appear to " "have any data in it."

◆ ExcIncompatibleArraySize()

static ::ExceptionBase & Histogram::ExcIncompatibleArraySize ( int  arg1,
int  arg2 
)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "The two array sizes " << arg1 << " and " << arg2 << " must match, but don't."

◆ ExcInvalidName()

static ::ExceptionBase & Histogram::ExcInvalidName ( std::string  arg1)
static

Exception.

Note
The message that will be printed by this exception reads:
<< "The given name <" << arg1 << "> does not match any of the known formats."

◆ ExcComponentMismatch()

static ::ExceptionBase & MatrixCreator::ExcComponentMismatch ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are providing either a right hand side function or a " "coefficient with a number of vector components that is " "inconsistent with the rest of the arguments. If you do " "provide a coefficient or right hand side function, then " "it either needs to have as many components as the finite " "element in use, or only a single vector component. In " "the latter case, the same value will be taken for " "each vector component of the finite element."

◆ ExcBlocksDontMatch()

static ::ExceptionBase & MatrixTools::ExcBlocksDontMatch ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are providing a matrix whose subdivision into " "blocks in either row or column direction does not use " "the same blocks sizes as the solution vector or " "right hand side vectors, respectively."

◆ ExcNoIndependent()

template<int dim>
static ::ExceptionBase & PointValueHistory< dim >::ExcNoIndependent ( )
static

Exception

Note
The message that will be printed by this exception reads:
"A call has been made to push_back_independent() when " "no independent values were requested."

◆ ExcDataLostSync()

template<int dim>
static ::ExceptionBase & PointValueHistory< dim >::ExcDataLostSync ( )
static

Exception

Note
The message that will be printed by this exception reads:
"This error is thrown to indicate that the data sets appear to be out of " "sync. The class requires that the number of dataset keys is the same as " "the number of independent values sets and mesh linked value sets. The " "number of each of these is allowed to differ by one to allow new values " "to be added with out restricting the order the user choses to do so. " "Special cases of no FHandler and no independent values should not " "trigger this error."

◆ ExcDoFHandlerRequired()

template<int dim>
static ::ExceptionBase & PointValueHistory< dim >::ExcDoFHandlerRequired ( )
static

Exception

Note
The message that will be printed by this exception reads:
"A method which requires access to a @p DoFHandler to be meaningful has " "been called when have_dof_handler is false (most likely due to default " "constructor being called). Only independent variables may be logged with " "no DoFHandler."

◆ ExcDoFHandlerChanged()

template<int dim>
static ::ExceptionBase & PointValueHistory< dim >::ExcDoFHandlerChanged ( )
static

Exception

Note
The message that will be printed by this exception reads:
"The triangulation has been refined or coarsened in some way. This " "suggests that the internal DoF indices stored by the current " "object are no longer meaningful."

◆ ExcNotPrepared()

template<int dim, typename VectorType = Vector<double>, int spacedim = dim>
static ::ExceptionBase & SolutionTransfer< dim, VectorType, spacedim >::ExcNotPrepared ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are attempting an operation for which this object is " "not prepared. This may be because you either did not call " "one of the prepare_*() functions at all, or because you " "called the wrong one for the operation you are currently " "attempting."

◆ ExcAlreadyPrepForRef()

template<int dim, typename VectorType = Vector<double>, int spacedim = dim>
static ::ExceptionBase & SolutionTransfer< dim, VectorType, spacedim >::ExcAlreadyPrepForRef ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are attempting to call one of the prepare_*() functions " "of this object to prepare it for an operation for which it " "is already prepared. Specifically, the object was " "previously prepared for pure refinement."

◆ ExcAlreadyPrepForCoarseAndRef()

template<int dim, typename VectorType = Vector<double>, int spacedim = dim>
static ::ExceptionBase & SolutionTransfer< dim, VectorType, spacedim >::ExcAlreadyPrepForCoarseAndRef ( )
static

Exception

Note
The message that will be printed by this exception reads:
"You are attempting to call one of the prepare_*() functions " "of this object to prepare it for an operation for which it " "is already prepared. Specifically, the object was " "previously prepared for both coarsening and refinement."

◆ ExcInvalidPosition()

static ::ExceptionBase & TimeDependent::ExcInvalidPosition ( )
static

Exception.

Note
The message that will be printed by this exception reads:
"You cannot insert a time step at the specified position."

◆ ExcInvalidValue() [1/2]

template<int dim>
static ::ExceptionBase & TimeStepBase_Tria_Flags::RefinementFlags< dim >::ExcInvalidValue ( double  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The value " << arg1 << " for the cell number corridor does not fulfill " "its natural requirements."

◆ ExcInvalidValue() [2/2]

template<int dim>
static ::ExceptionBase & TimeStepBase_Tria_Flags::RefinementData< dim >::ExcInvalidValue ( double  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The value " << arg1 << " for the cell refinement thresholds does not fulfill " "its natural requirements."

◆ ExcGridNotDeleted()

template<int dim>
static ::ExceptionBase & TimeStepBase_Tria< dim >::ExcGridNotDeleted ( )
static

Exception

Note
The message that will be printed by this exception reads:
"When calling restore_grid(), you must have previously " "deleted the triangulation."

◆ ExcPointNotAvailableHere()

static ::ExceptionBase & VectorTools::ExcPointNotAvailableHere ( )
static

Exception

Note
The message that will be printed by this exception reads:
"The given point is inside a cell of a " "parallel::distributed::Triangulation that is not " "locally owned by this processor."

◆ ExcPointNotOnManifold()

template<int dim>
static ::ExceptionBase & OpenCASCADE::ExcPointNotOnManifold ( Point< dim >  arg1)
static

Exception thrown when the point specified as argument does not lie between tolerance from the given TopoDS_Shape.

Note
The message that will be printed by this exception reads:
<< "The point [ " << arg1 << " ] is not on the manifold."

◆ ExcProjectionFailed()

template<int dim>
static ::ExceptionBase & OpenCASCADE::ExcProjectionFailed ( Point< dim >  arg1)
static

Exception thrown when the point specified as argument cannot be projected to the manifold.

Note
The message that will be printed by this exception reads:
<< "Projection of point [ " << arg1 << " ] failed."

◆ ExcOCCError()

static ::ExceptionBase & OpenCASCADE::ExcOCCError ( IFSelect_ReturnStatus  arg1)
static

Thrown when internal OpenCASCADE utilities fail to return the OK status.

Note
The message that will be printed by this exception reads:
<< "An OpenCASCADE routine failed with return status " << arg1

◆ ExcEdgeIsDegenerate()

static ::ExceptionBase & OpenCASCADE::ExcEdgeIsDegenerate ( )
static

Trying to make curve operations on a degenerate edge.

◆ ExcUnsupportedShape()

static ::ExceptionBase & OpenCASCADE::ExcUnsupportedShape ( )
static

Trying to make operations on the wrong type of shapes.

◆ ExcNotationExcFullMatrixToTensorRowSize2()

static ::ExceptionBase & Physics::Notation::Kelvin::ExcNotationExcFullMatrixToTensorRowSize2 ( int  arg1,
int  arg2,
int  arg3 
)
static

Input matrix has incorrect number of rows.

Note
The message that will be printed by this exception reads:
<< "The number of rows in the input matrix is " << arg1 << ", but needs to be either " << arg2 << " or " << arg3 << '.'

◆ ExcNotationExcFullMatrixToTensorRowSize3()

static ::ExceptionBase & Physics::Notation::Kelvin::ExcNotationExcFullMatrixToTensorRowSize3 ( int  arg1,
int  arg2,
int  arg3,
int  arg4 
)
static

Input matrix has incorrect number of rows.

Note
The message that will be printed by this exception reads:
<< "The number of rows in the input matrix is " << arg1 << ", but needs to be either " << arg2 << ',' << arg3 << ", or " << arg4 << '.'

◆ ExcNotationExcFullMatrixToTensorColSize2()

static ::ExceptionBase & Physics::Notation::Kelvin::ExcNotationExcFullMatrixToTensorColSize2 ( int  arg1,
int  arg2,
int  arg3 
)
static

Input matrix has incorrect number of columns.

Note
The message that will be printed by this exception reads:
<< "The number of columns in the input matrix is " << arg1 << ", but needs to be either " << arg2 << " or " << arg3 << '.'

◆ ExcNotationExcFullMatrixToTensorColSize3()

static ::ExceptionBase & Physics::Notation::Kelvin::ExcNotationExcFullMatrixToTensorColSize3 ( int  arg1,
int  arg2,
int  arg3,
int  arg4 
)
static

Input matrix has incorrect number of columns.

Note
The message that will be printed by this exception reads:
<< "The number of columns in the input matrix is " << arg1 << ", but needs to be either " << arg2 << ',' << arg3 << ", or " << arg4 << '.'

◆ ExcFunctionNotProvided() [2/4]

template<typename VectorType = Vector<double>>
static ::ExceptionBase & SUNDIALS::ARKode< VectorType >::ExcFunctionNotProvided ( std::string  arg1)
staticprivate

Throw an exception when a function with the given name is not implemented.

Note
The message that will be printed by this exception reads:
<< "Please provide an implementation for the function \"" << arg1 << "\""

◆ ExcARKodeError()

static ::ExceptionBase & SUNDIALS::ExcARKodeError ( int  arg1)
static

Handle ARKode exceptions.

Note
The message that will be printed by this exception reads:
<< "One of the SUNDIALS ARKode internal functions " << " returned a negative error code: " << arg1 << ". Please consult SUNDIALS manual."

◆ ExcIDAError()

template<typename VectorType = Vector<double>>
static ::ExceptionBase & SUNDIALS::IDA< VectorType >::ExcIDAError ( int  arg1)
static

Handle IDA exceptions.

Note
The message that will be printed by this exception reads:
<< "One of the SUNDIALS IDA internal functions " << " returned a negative error code: " << arg1 << ". Please consult SUNDIALS manual."

◆ ExcFunctionNotProvided() [3/4]

template<typename VectorType = Vector<double>>
static ::ExceptionBase & SUNDIALS::IDA< VectorType >::ExcFunctionNotProvided ( std::string  arg1)
staticprivate

Throw an exception when a function with the given name is not implemented.

Note
The message that will be printed by this exception reads:
<< "Please provide an implementation for the function \"" << arg1 << "\""

◆ ExcKINSOLError()

template<typename VectorType = Vector<double>>
static ::ExceptionBase & SUNDIALS::KINSOL< VectorType >::ExcKINSOLError ( int  arg1)
static

Handle KINSOL exceptions.

Note
The message that will be printed by this exception reads:
<< "One of the SUNDIALS KINSOL internal functions " << "returned a negative error code: " << arg1 << ". Please consult SUNDIALS manual."

◆ ExcFunctionNotProvided() [4/4]

template<typename VectorType = Vector<double>>
static ::ExceptionBase & SUNDIALS::KINSOL< VectorType >::ExcFunctionNotProvided ( std::string  arg1)
staticprivate

Throw an exception when a function with the given name is not implemented.

Note
The message that will be printed by this exception reads:
<< "Please provide an implementation for the function \"" << arg1 << "\""

◆ ExcNOXNoConvergence()

static ::ExceptionBase & TrilinosWrappers::ExcNOXNoConvergence ( )
static

◆ NegativeRadius()

static ::ExceptionBase & GeometricUtilities::Coordinates::NegativeRadius ( double  arg1)
static
Note
The message that will be printed by this exception reads:
<< "The radius <" << arg1 << "> can not be negative."

◆ SphericalAzimuth()

static ::ExceptionBase & GeometricUtilities::Coordinates::SphericalAzimuth ( double  arg1)
static
Note
The message that will be printed by this exception reads:
<< "The azimuth angle <" << arg1 << "> is not in [0,2Pi)."

◆ SphericalPolar()

static ::ExceptionBase & GeometricUtilities::Coordinates::SphericalPolar ( double  arg1)
static
Note
The message that will be printed by this exception reads:
<< "The polar angle <" << arg1 << "> is not in [0,Pi]."

◆ ExcInvalidNumber2StringConversersion()

static ::ExceptionBase & Utilities::ExcInvalidNumber2StringConversersion ( unsigned int  arg1,
unsigned int  arg2 
)
static
Note
The message that will be printed by this exception reads:
<< "When trying to convert " << arg1 << " to a string with " << arg2 << " digits"

◆ ExcInvalidNumber() [2/2]

static ::ExceptionBase & Utilities::ExcInvalidNumber ( unsigned int  arg1)
static
Note
The message that will be printed by this exception reads:
<< "Invalid number " << arg1

◆ ExcCantConvertString()

static ::ExceptionBase & Utilities::ExcCantConvertString ( std::string  arg1)
static
Note
The message that will be printed by this exception reads:
<< "Can't convert the string " << arg1 << " to the desired type"

◆ ExcNonMatchingElementsSetDofValuesByInterpolation()

template<typename Number >
static ::ExceptionBase & ExcNonMatchingElementsSetDofValuesByInterpolation ( Number  arg1,
Number  arg2 
)
static
Note
The message that will be printed by this exception reads:
<< "Called set_dof_values_by_interpolation(), but" << " the element to be set, value " << std::setprecision(16) << arg1 << ", does not match with the non-zero value " << std::setprecision(16) << arg2 << " already set before."

◆ ExcCellNotCartesian()

static ::ExceptionBase & ExcCellNotCartesian ( )
static
Note
The message that will be printed by this exception reads:
"You are using MappingCartesian, but the incoming cell is not Cartesian."

◆ ExcInternalErrorOnCell()

static ::ExceptionBase & internal::TriangulationImplementation::ExcInternalErrorOnCell ( int  arg1)
static

Exception

Note
The message that will be printed by this exception reads:
<< "Something went wrong upon construction of cell " << arg1

◆ ExcCellHasNegativeMeasure()

static ::ExceptionBase & internal::TriangulationImplementation::ExcCellHasNegativeMeasure ( int  arg1)
static

A cell was entered which has negative measure. In most cases, this is due to a wrong order of the vertices of the cell.

Note
The message that will be printed by this exception reads:
<< "Cell " << arg1 << " has negative measure. This typically " << "indicates some distortion in the cell, or a mistakenly " << "swapped pair of vertices in the input to " << "Triangulation::create_triangulation()."

◆ ExcInvalidVertexIndex() [2/2]

static ::ExceptionBase & internal::TriangulationImplementation::ExcInvalidVertexIndex ( int  arg1,
int  arg2,
int  arg3 
)
static

A cell is created with a vertex number exceeding the vertex array.

Note
The message that will be printed by this exception reads:
<< "Error while creating cell " << arg1 << ": the vertex index " << arg2 << " must be between 0 and " << arg3 << '.'

◆ ExcLineInexistant() [2/2]

static ::ExceptionBase & internal::TriangulationImplementation::ExcLineInexistant ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "While trying to assign a boundary indicator to a line: " << "the line with end vertices " << arg1 << " and " << arg2 << " does not exist."

◆ ExcQuadInexistant()

static ::ExceptionBase & internal::TriangulationImplementation::ExcQuadInexistant ( int  arg1,
int  arg2,
int  arg3,
int  arg4 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "While trying to assign a boundary indicator to a quad: " << "the quad with bounding lines " << arg1 << ", " << arg2 << ", " << arg3 << ", " << arg4 << " does not exist."

◆ ExcInteriorLineCantBeBoundary()

static ::ExceptionBase & internal::TriangulationImplementation::ExcInteriorLineCantBeBoundary ( int  arg1,
int  arg2,
types::boundary_id  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The input data for creating a triangulation contained " << "information about a line with indices " << arg1 << " and " << arg2 << " that is described to have boundary indicator " << static_cast<int>(arg3) << ". However, this is an internal line not located on the " << "boundary. You cannot assign a boundary indicator to it." << std::endl << std::endl << "If this happened at a place where you call " << "Triangulation::create_triangulation() yourself, you need " << "to check the SubCellData object you pass to this function." << std::endl << std::endl << "If this happened in a place where you are reading a mesh " << "from a file, then you need to investigate why such a line " << "ended up in the input file. A typical case is a geometry " << "that consisted of multiple parts and for which the mesh " << "generator program assumes that the interface between " << "two parts is a boundary when that isn't supposed to be " << "the case, or where the mesh generator simply assigns " << "'geometry indicators' to lines at the perimeter of " << "a part that are not supposed to be interpreted as " << "'boundary indicators'."

◆ ExcInteriorQuadCantBeBoundary()

static ::ExceptionBase & internal::TriangulationImplementation::ExcInteriorQuadCantBeBoundary ( int  arg1,
int  arg2,
int  arg3,
int  arg4,
types::boundary_id  arg5 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The input data for creating a triangulation contained " << "information about a quad with indices " << arg1 << ", " << arg2 << ", " << arg3 << ", and " << arg4 << " that is described to have boundary indicator " << static_cast<int>(arg5) << ". However, this is an internal quad not located on the " << "boundary. You cannot assign a boundary indicator to it." << std::endl << std::endl << "If this happened at a place where you call " << "Triangulation::create_triangulation() yourself, you need " << "to check the SubCellData object you pass to this function." << std::endl << std::endl << "If this happened in a place where you are reading a mesh " << "from a file, then you need to investigate why such a quad " << "ended up in the input file. A typical case is a geometry " << "that consisted of multiple parts and for which the mesh " << "generator program assumes that the interface between " << "two parts is a boundary when that isn't supposed to be " << "the case, or where the mesh generator simply assigns " << "'geometry indicators' to quads at the surface of " << "a part that are not supposed to be interpreted as " << "'boundary indicators'."

◆ ExcMultiplySetLineInfoOfLine()

static ::ExceptionBase & internal::TriangulationImplementation::ExcMultiplySetLineInfoOfLine ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "In SubCellData the line info of the line with vertex indices " << arg1 << " and " << arg2 << " appears more than once. " << "This is not allowed."

◆ ExcInconsistentLineInfoOfLine()

static ::ExceptionBase & internal::TriangulationImplementation::ExcInconsistentLineInfoOfLine ( int  arg1,
int  arg2,
std::string  arg3 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "In SubCellData the line info of the line with vertex indices " << arg1 << " and " << arg2 << " appears multiple times with different (valid) " << arg3 << ". This is not allowed."

◆ ExcInconsistentQuadInfoOfQuad()

static ::ExceptionBase & internal::TriangulationImplementation::ExcInconsistentQuadInfoOfQuad ( int  arg1,
int  arg2,
int  arg3,
int  arg4,
std::string  arg5 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "In SubCellData the quad info of the quad with line indices " << arg1 << ", " << arg2 << ", " << arg3 << " and " << arg4 << " appears multiple times with different (valid) " << arg5 << ". This is not allowed."

◆ ExcMemoryInexact()

static ::ExceptionBase & internal::TriangulationImplementation::ExcMemoryInexact ( int  arg1,
int  arg2 
)
static

Exception

Note
The message that will be printed by this exception reads:
<< "The containers have sizes " << arg1 << " and " << arg2 << ", which is not as expected."

◆ ExcReclassifyNotCalled()

static ::ExceptionBase & NonMatching::internal::MeshClassifierImplementation::ExcReclassifyNotCalled ( )
static
Note
The message that will be printed by this exception reads:
"The Triangulation has not been classified. You need to call the " "reclassify()-function before using this function."

◆ ExcTriangulationMismatch() [3/3]

static ::ExceptionBase & NonMatching::internal::MeshClassifierImplementation::ExcTriangulationMismatch ( )
static
Note
The message that will be printed by this exception reads:
"The incoming cell does not belong to the triangulation passed to " "the constructor."

◆ ExcCellNotSet()

static ::ExceptionBase & NonMatching::internal::DiscreteQuadratureGeneratorImplementation::ExcCellNotSet ( )
static
Note
The message that will be printed by this exception reads:
"The set_active_cell function has to be called before calling this function."

◆ ExcReferenceCellNotHypercube()

static ::ExceptionBase & NonMatching::internal::DiscreteQuadratureGeneratorImplementation::ExcReferenceCellNotHypercube ( )
static
Note
The message that will be printed by this exception reads:
"The reference cell of the incoming cell must be a hypercube."

◆ ExcSundialsSolverError()

static ::ExceptionBase & SUNDIALS::ExcSundialsSolverError ( int  arg1)
static
Note
The message that will be printed by this exception reads:
<< "One of the SUNDIALS linear solver internal" << " functions returned a negative error code: " << arg1 << ". Please consult SUNDIALS manual."