libMesh
Class Hierarchy

Go to the graphical class hierarchy

This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 123456789]
 CFParserAutodiffTest::ADTest
 Callocator
 ClibMesh::VariationalMeshSmoother::Array2D< T >2D array type for interfacing with C APIs
 ClibMesh::VariationalMeshSmoother::Array3D< T >3D array type for interfacing with C APIs
 ClibMesh::System::AssemblyAbstract base class to be used for system assembly
 Catomic
 CTIMPI::Attributes< libMesh::FEType >
 ClibMesh::DofMap::AugmentSendListAbstract base class to be used to add user-defined parallel degree of freedom couplings
 ClibMesh::SparsityPattern::AugmentSparsityPatternAbstract base class to be used to add user-defined implicit degree of freedom couplings
 ClibMesh::BasicOStreamProxy< charT, traits >This class is intended to be reseatable like a pointer-to-ostream for flexibility, but to look like a reference when used to produce less awkward user code
 ClibMesh::Threads::BlockedRange< T >Blocked range which can be subdivided and executed in parallel
 ClibMesh::Threads::BoolAcquireWe use a class to turn Threads::in_threads on and off, to be exception-safe
 ClibMesh::BoundaryProjectSolutionThis class implements projecting an arbitrary boundary function to the current mesh
 ClibMesh::BuildProjectionListThis class builds the send_list of old dof indices whose coefficients are needed to perform a projection
 ClibMesh::casting_compare< Comp >
 ClibMesh::CompareDofObjectsByIDComparison object to use with DofObject pointers
 ClibMesh::CompareDofObjectsByPIDAndThenID
 ClibMesh::CompareElemIdsByLevelSpecific weak ordering for Elem *'s to be used in a set
 ClibMesh::CompareTypes< S, T >
 ClibMesh::CompareTypes< MetaPhysicL::DualNumber< T, D, asd >, MetaPhysicL::DualNumber< T, D, asd > >
 ClibMesh::CompareTypes< MetaPhysicL::DualNumber< T, D, asd >, MetaPhysicL::DualNumber< T2, D2, asd > >
 ClibMesh::CompareTypes< MetaPhysicL::DualNumber< T, D, asd >, T2 >
 ClibMesh::CompareTypes< MetaPhysicL::DualNumber< T, T, asd >, MetaPhysicL::DualNumber< T2, T2, asd > >
 ClibMesh::CompareTypes< MetaPhysicL::DualNumber< T, T, asd >, T2 >
 ClibMesh::CompareTypes< MetaPhysicL::DynamicSparseNumberArray< T, IndexType >, T2 >
 ClibMesh::CompareTypes< std::complex< T >, T >
 ClibMesh::CompareTypes< T, MetaPhysicL::DualNumber< T2, D, asd > >
 ClibMesh::CompareTypes< T, MetaPhysicL::DualNumber< T2, T2, asd > >
 ClibMesh::CompareTypes< T, std::complex< T > >
 ClibMesh::CompareTypes< T, T >
 ClibMesh::CompareTypes< TypeVector< T >, TypeVector< T > >
 ClibMesh::CompareTypes< TypeVector< T >, TypeVector< T2 > >
 ClibMesh::CompareTypes< TypeVector< T >, VectorValue< T2 > >
 ClibMesh::CompareTypes< VectorValue< T >, TypeVector< T2 > >
 ClibMesh::CompareTypes< VectorValue< T >, VectorValue< T > >
 ClibMesh::CompareTypes< VectorValue< T >, VectorValue< T2 > >
 ClibMesh::Utility::CompareUnderlyingStruct which defines a custom comparison object that can be used with std::sets of std::unique_ptrs
 CComputeBounds
 ClibMesh::NonlinearImplicitSystem::ComputeBoundsAbstract base class to be used to calculate the bounds on the degrees of freedom of a nonlinear system
 ClibMesh::OptimizationSystem::ComputeEqualityConstraintsAbstract base class to be used to calculate the equality constraints
 ClibMesh::OptimizationSystem::ComputeEqualityConstraintsJacobianAbstract base class to be used to calculate the Jacobian of the equality constraints
 ClibMesh::OptimizationSystem::ComputeGradientAbstract base class to be used to calculate the gradient of an objective function
 ClibMesh::OptimizationSystem::ComputeHessianAbstract base class to be used to calculate the Hessian of an objective function
 ClibMesh::OptimizationSystem::ComputeInequalityConstraintsAbstract base class to be used to calculate the inequality constraints
 ClibMesh::OptimizationSystem::ComputeInequalityConstraintsJacobianAbstract base class to be used to calculate the Jacobian of the inequality constraints
 ClibMesh::NonlinearImplicitSystem::ComputeJacobianAbstract base class to be used to calculate the Jacobian of a nonlinear system
 ClibMesh::PetscNonlinearSolver< T >::ComputeLineSearchObjectAbstract base class to be used to implement a custom line-search algorithm
 ClibMesh::OptimizationSystem::ComputeLowerAndUpperBoundsAbstract base class to be used to calculate the lower and upper bounds for all dofs in the system
 ClibMesh::OptimizationSystem::ComputeObjectiveAbstract base class to be used to calculate the objective function for optimization
 ClibMesh::NonlinearImplicitSystem::ComputePostCheckAbstract base class to be used for applying user modifications to the solution vector and/or Newton update step after each nonlinear step
 ClibMesh::NonlinearImplicitSystem::ComputePreCheckAbstract base class to be used for applying user modifications to the Newton search direction before the solver's line search is called
 CComputeResidual
 ClibMesh::NonlinearImplicitSystem::ComputeResidualAbstract base class to be used to calculate the residual of a nonlinear system
 CComputeResidualandJacobian
 ClibMesh::NonlinearImplicitSystem::ComputeResidualandJacobianAbstract base class to be used to calculate the residual and Jacobian simultaneously of a nonlinear system
 ClibMesh::NonlinearImplicitSystem::ComputeVectorSubspaceCallable abstract base class to be used as a callback to provide the solver with a basis for the system's Jacobian's nullspace (the kernel or the "zero energy modes") or near-nullspace (the "low energy modes")
 ClibMesh::RBParameters::const_iteratorDefine a constant iterator for iterating over the map of parameters
 ClibMesh::chunked_mapvector< Val, index_t, N >::const_reverse_veclike_iterator
 ClibMesh::mapvector< Val, index_t >::const_reverse_veclike_iterator
 ClibMesh::mapvector< Val, index_t >::const_veclike_iterator
 ClibMesh::ConstCouplingAccessorThis accessor class allows simple access to CouplingMatrix values
 ClibMesh::ConstCouplingRowThis proxy class acts like a container of indices from a single coupling row
 ClibMesh::ConstCouplingRowConstIterator
 ClibMesh::ConstParameterProxy< T >
 ClibMesh::System::ConstraintAbstract base class to be used for system constraints
 ClibMesh::SensitivityData::ConstRow
 ClibMesh::ConstTypeTensorColumn< T >
 ClibMesh::ExodusII_IO_Helper::Conversion
 ClibMesh::Parallel::Utils::Convert< KeyType >A utility to convert a double to some sort of KeyType, for interpreting how histogram bounds relate to KeyType positions
 ClibMesh::Parallel::Utils::Convert< Hilbert::HilbertIndices >
 ClibMesh::Parallel::Utils::Convert< std::pair< FirstKeyType, SecondKeyType > >A pseudoinverse for converting bounds back to pairs of key types
 ClibMesh::CouplingMatrixThis class defines a coupling matrix
 CCurlCurlExactSolution
 C
 ClibMesh::TensorTools::DecrementRank< T >
 ClibMesh::TensorTools::DecrementRank< TensorValue< T > >
 ClibMesh::TensorTools::DecrementRank< TypeNTensor< N, T > >
 ClibMesh::TensorTools::DecrementRank< TypeTensor< T > >
 ClibMesh::TensorTools::DecrementRank< TypeVector< T > >
 ClibMesh::TensorTools::DecrementRank< VectorValue< T > >
 ClibMesh::DenseMatrixBase< T >Defines an abstract dense matrix base class for use in Finite Element-type computations
 ClibMesh::DenseVectorBase< T >Defines an abstract dense vector base class for use in Finite Element-type computations
 ClibMesh::DiffContextThis class provides all data required for a physics package (e.g
 ClibMesh::DifferentiablePhysicsThis class provides a specific system class
 ClibMesh::DifferentiableQoIThis class provides a specific system class
 ClibMesh::DirichletBoundaryThis class allows one to associate Dirichlet boundary values with a given set of mesh boundary ids and system variable ids
 ClibMesh::Threads::DisablePerfLogInScopeWe use a class to turn perf logging off and on within threads, to be exception-safe and to avoid forcing indirect inclusion of libmesh_logging.h everywhere
 CDivGradExactSolution
 CDM_libMesh
 CDMVec_libMesh
 ClibMesh::Utility::do_pow< N, T >An efficient template instantiation for raising to an arbitrary integer power
 ClibMesh::Utility::do_pow< 0, T >
 ClibMesh::Utility::do_pow< 1, T >
 ClibMesh::Utility::do_pow< 6, T >
 CDofObjectTest< DerivedClass >
 CDofObjectTest< Node >
 ClibMesh::DSNAOutput< Output >
 ClibMesh::DSNAOutput< VectorValue< InnerOutput > >
 ClibMesh::DTKAdapterThe DTKAdapter is used with the DTKSolutionTransfer object to adapt libmesh data to the DTK interface
 CEdgeType
 ClibMesh::EimPointDataThis struct is used to encapsulate the arguments required to specify an EIM point that we may add to our list of interpolation points
 ClibMesh::ElemCutterThis class implements cutting a single element into a collection of subelements
 ClibMesh::DynaIO::ElementDefinitionDefines mapping from libMesh element types to LS-DYNA element types or vice-versa
 ClibMesh::GmshIO::ElementDefinitionDefines mapping from libMesh element types to Gmsh element types or vice-versa
 ClibMesh::MeshRefinement::ElementFlaggingAbstract base class to be used for user-specified element flagging
 ClibMesh::VTKIO::ElementMapsHelper object that holds a map from VTK to libMesh element types and vice-versa
 ClibMesh::DynaIO::ElementMapsStruct which holds a map from LS-DYNA to libMesh element numberings and vice-versa
 ClibMesh::GmshIO::ElementMapsStruct which holds a map from Gmsh to libMesh element numberings and vice-versa
 ClibMesh::ElemHashUtilsThe ElemHashUtils struct defines functions used for the "Hash" and "Pred" template arguments of the various "unordered" containers, e.g
 ClibMesh::ElemSideBuilderHelper for building element sides that minimizes the construction of new elements
 ClibMesh::boostcopy::enable_if_c< B, T >
 ClibMesh::boostcopy::enable_if_c< false, T >
 CEpetra_Operator
 ClibMesh::ErrorEstimatorThis class holds functions that will estimate the error in a finite element solution on a given mesh
 ClibMesh::PatchRecoveryErrorEstimator::EstimateErrorClass to compute the error contribution for a range of elements
 ClibMesh::WeightedPatchRecoveryErrorEstimator::EstimateErrorClass to compute the error contribution for a range of elements
 CExactSoln
 ClibMesh::ExactSolutionThis class handles the computation of the L2 and/or H1 error for the Systems in the EquationSystems object which is passed to it
 Cexception
 ClibMesh::ExodusHeaderInfoThis class is used as both an external data structure for passing around Exodus file header information, and for storing information internally in ExodusII_IO_Helper
 ClibMesh::Factory< Base >Factory class definition
 Cfast_pool_allocator
 ClibMesh::FEComputeDataClass FEComputeData hides arbitrary data to be passed to and from children of FEBase through the FEInterface::compute_data() method
 ClibMesh::FEInterfaceThis class provides an encapsulated access to all static public member functions of finite element classes
 ClibMesh::FEMapClass contained in FE that encapsulates mapping (i.e
 ClibMesh::FEMFunctionBase< Output >FEMFunctionBase is a base class from which users can derive in order to define "function-like" objects that can be used within FEMSystem
 ClibMesh::FEMFunctionBase< Number >
 ClibMesh::FEMFunctionWrapper< Output >The FEMFunctionWrapper input functor class can be used with a GenericProjector to read values from an FEMFunction
 CFEMSystem
 ClibMesh::FEMContext::FENeeded< OutputType >Helper nested class for C++03-compatible "template typedef"
 ClibMesh::FEOutputType< T >Most finite element types in libMesh are scalar-valued
 ClibMesh::FEOutputType< HIERARCHIC_VEC >
 ClibMesh::FEOutputType< L2_HIERARCHIC_VEC >
 ClibMesh::FEOutputType< L2_LAGRANGE_VEC >
 ClibMesh::FEOutputType< L2_RAVIART_THOMAS >
 ClibMesh::FEOutputType< LAGRANGE_VEC >Specialize for non-scalar-valued elements
 ClibMesh::FEOutputType< MONOMIAL_VEC >
 ClibMesh::FEOutputType< NEDELEC_ONE >
 ClibMesh::FEOutputType< RAVIART_THOMAS >
 ClibMesh::FETransformationBase< OutputShape >This class handles the computation of the shape functions in the physical domain
 ClibMesh::FETypeClass FEType hides (possibly multiple) FEFamily and approximation orders, thereby enabling specialized finite element families
 CFieldEvaluator
 ClibMesh::vectormap< Key, Tp >::FirstCompareEquality comparison, based solely on first element in a pair
 ClibMesh::vectormap< Key, Tp >::FirstOrderStrict weak ordering, based solely on first element in a pair
 ClibMesh::FunctionBase< Output >Base class for functors that can be evaluated at a point and (optionally) time
 ClibMesh::FunctionBase< Gradient >
 ClibMesh::FunctionBase< Number >
 ClibMesh::FunctionBase< Real >
 ClibMesh::FunctionBase< T >
 ClibMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >The GenericProjector class implements the core of other projection operations, using two input functors to read values to be projected and an output functor to set degrees of freedom in the result
 CGETPOT_NAMESPACE::GetPotGetPot - A class for parsing command line arguments and configuration files
 ClibMesh::hash
 Cstd::hash< libMesh::FEType >
 Cstd::hash< libMesh::Point >
 ClibMesh::HistoryDataThe History Data classes are companion classes to SolutionHistory and MeshHistory classes
 ClibMesh::TriangulatorInterface::HoleAn abstract class for defining a 2-dimensional hole
 ClibMesh::HPSelectorSubclasses of this abstract base class choose between h refining and p elevation
 ClibMesh::HPSingularityThis class uses a user-provided list of singularity locations to choose between h refining and p elevation
 ClibMesh::TensorTools::IncrementRank< T >
 ClibMesh::TensorTools::IncrementRank< TensorValue< T > >
 ClibMesh::TensorTools::IncrementRank< TypeNTensor< N, T > >
 ClibMesh::TensorTools::IncrementRank< TypeTensor< T > >
 ClibMesh::TensorTools::IncrementRank< TypeVector< T > >
 ClibMesh::TensorTools::IncrementRank< VectorValue< T > >
 ClibMesh::InfElemBuilderThis class is used to build infinite elements on top of an existing mesh
 ClibMesh::InfFEBaseThis nested class contains most of the static methods related to the base part of an infinite element
 ClibMesh::InfFEMapClass that encapsulates mapping (i.e
 ClibMesh::InfFERadialInfinite elements are in some sense directional, compared to conventional finite elements
 CInitialization
 ClibMesh::System::InitializationAbstract base class to be used for system initialization
 CIntegrate
 ClibMesh::InterMeshProjectionThis class implements inter mesh projection, i.e
 ClibMesh::IntRange< T >The IntRange templated class is intended to make it easy to loop over integers which are indices of a container
 Cboost::multiprecision::detail::is_lossy_conversion< libMesh::NumericVector< T >, To >
 ClibMesh::Utility::is_streamable< T >Helper struct for enabling template metaprogramming/SFINAE
 ClibMesh::QoISet::iterator
 ClibMesh::IntRange< T >::iterator
 Cvariant_filter_iterator< Predicate, Type, ReferenceType, PointerType, ConstType, ConstReferenceType, ConstPointerType >::IterBaseAbstract base class for the iterator type
 CJacobian
 CLaplaceExactGradient
 CLaplaceExactSolution
 ClibMesh::LibMeshInitThe LibMeshInit class, when constructed, initializes the dependent libraries (e.g
 ClibMesh::LinearSolutionMonitorFunctor for use as callback in solve of nonlinear solver
 ClibMesh::LocationMap< T >Data structures that enable location-based lookups The key is a hash of the Point location
 Clogic_error
 CGETPOT_NAMESPACE::GetPot::ltstrHelper functor for creating sets of C-style strings
 ClibMesh::TensorTools::MakeBaseNumber< T, enable >
 ClibMesh::TensorTools::MakeBaseNumber< T, typename std::enable_if< ScalarTraits< T >::value >::type >
 ClibMesh::TensorTools::MakeBaseNumber< Wrapper< T >, typename std::enable_if< MathWrapperTraits< Wrapper< T > >::value >::type >
 ClibMesh::TensorTools::MakeNumber< T >
 ClibMesh::TensorTools::MakeNumber< std::complex< T > >
 ClibMesh::TensorTools::MakeNumber< TensorValue< T > >
 ClibMesh::TensorTools::MakeNumber< TypeNTensor< N, T > >
 ClibMesh::TensorTools::MakeNumber< TypeTensor< T > >
 ClibMesh::TensorTools::MakeNumber< TypeVector< T > >
 ClibMesh::TensorTools::MakeNumber< VectorValue< T > >
 ClibMesh::TensorTools::MakeReal< T >
 ClibMesh::TensorTools::MakeReal< std::complex< T > >
 ClibMesh::TensorTools::MakeReal< TensorValue< T > >
 ClibMesh::TensorTools::MakeReal< TypeNTensor< N, T > >
 ClibMesh::TensorTools::MakeReal< TypeTensor< T > >
 ClibMesh::TensorTools::MakeReal< TypeVector< T > >
 ClibMesh::TensorTools::MakeReal< VectorValue< T > >
 Cmap
 ClibMesh::ExodusII_IO_Helper::MappedInputVectorThis class facilitates reading in vectors from Exodus file that may be of a different floating point type than Real
 ClibMesh::ExodusII_IO_Helper::MappedOutputVectorThis class facilitates inline conversion of an input data vector to a different precision level, depending on the underlying type of Real and whether or not the single_precision flag is set
 ClibMesh::TensorTools::MathWrapperTraits< T >This helper structure is used to determine whether a template class is one of our mathematical structures, like TypeVector, TypeTensor and their descendents
 ClibMesh::TensorTools::MathWrapperTraits< TensorValue< T > >
 ClibMesh::TensorTools::MathWrapperTraits< TypeNTensor< N, T > >
 ClibMesh::TensorTools::MathWrapperTraits< TypeTensor< T > >
 ClibMesh::TensorTools::MathWrapperTraits< TypeVector< T > >
 ClibMesh::TensorTools::MathWrapperTraits< VectorValue< T > >
 ClibMesh::MatrixFillAction< ValIn, ValOut >The MatrixFillAction output functor class can be used with GenericProjector to write solution transfer coefficients into a sparse matrix
 ClibMesh::mesh_inserter_iterator< T >A class for templated methods that expect output iterator arguments, which adds objects to the Mesh
 ClibMesh::MeshCommunicationThis is the MeshCommunication class
 ClibMesh::MeshInput< MT >This class defines an abstract interface for Mesh input
 ClibMesh::MeshInput< MeshBase >
 ClibMesh::MeshOutput< MT >This class defines an abstract interface for Mesh output
 ClibMesh::MeshOutput< MeshBase >
 ClibMesh::MeshSerializerTemporarily serialize a DistributedMesh for non-distributed-mesh capable code paths
 ClibMesh::MeshSmootherThis class provides the necessary interface for mesh smoothing
 ClibMesh::METIS_CSR_Graph< IndexType >This utility class provides a convenient implementation for building the compressed-row-storage graph required for the METIS/ParMETIS graph partitioning schemes
 CMixedExactSolution
 ClibMesh::Predicates::movable_il< T >Helper object for creating a std::vector from a std::initializer_list https://stackoverflow.com/questions/46737054/vectorunique-ptra-using-initialization-list
 ClibMesh::Predicates::multi_predicate
 Cstd::multiplies< boost::multiprecision::float128 >
 ClibMesh::ExodusII_IO_Helper::NamesDataThis class is useful for managing anything that requires a char ** input/output in ExodusII file
 ClibMesh::Threads::NonConcurrentThreadSimple compatibility class for std::thread 'concurrent' execution
 CNonlinearNeoHookeCurrentConfigThis class implements a constitutive formulation for an Neo-Hookean elastic solid in terms of the current configuration
 ClibMesh::null_output_iterator< T >A do-nothing class for templated methods that expect output iterator arguments
 ClibMesh::OldSolutionBase< Output, point_output >The OldSolutionBase input functor abstract base class is the root of the OldSolutionValue and OldSolutionCoefs classes which allow a GenericProjector to read old solution values or solution interpolation coefficients for a just-refined-and-coarsened mesh
 CTIMPI::OpFunction< libMesh::FEType >
 ClibMesh::OrderWrapperThis provides a shim class that wraps the Order enum
 COverlappingTestBase
 ClibMesh::Parallel::Packing< const Elem * >
 ClibMesh::Parallel::Packing< const Elem *const >
 ClibMesh::Parallel::Packing< const Node * >
 ClibMesh::Parallel::Packing< const Node *const >
 ClibMesh::Parallel::Packing< Eigen::Matrix< Scalar, Rows, Cols, Options, MaxRows, MaxCols > >
 ClibMesh::Parallel::Packing< Elem * >
 ClibMesh::Parallel::Packing< Elem *const >
 ClibMesh::Parallel::Packing< Node * >
 ClibMesh::Parallel::Packing< Node *const >
 Cpair
 ClibMesh::ParallelObjectAn object whose state is distributed along a set of processors
 ClibMesh::ParameterAccessor< T >Accessor object allowing reading and modification of the independent variables in a parameter sensitivity calculation
 ClibMesh::ParameterProxy< T >
 ClibMesh::ParametersThis class provides the ability to map between arbitrary, user-defined strings and several data types
 ClibMesh::ParameterVectorData structure for specifying which Parameters should be independent variables in a parameter sensitivity calculation
 ClibMesh::ParmetisHelperThe ParmetisHelper class allows us to use a 'pimpl' strategy in the ParmetisPartitioner class
 ClibMesh::PartitionerThe Partitioner class provides a uniform interface for partitioning algorithms
 ClibMesh::PerfDataThe PerfData class simply contains the performance data that is recorded for individual events
 ClibMesh::PerfItemUsed for logging something that naturally lasts as long as some enclosing scope, such as the current function
 ClibMesh::PerfLogThe PerfLog class allows monitoring of specific events
 ClibMesh::PerfMonPAPI stands for Performance Application Programming Interface
 ClibMesh::PeriodicBoundaryBaseThe base class for defining periodic boundaries
 ClibMesh::PetscDMContextStruct to house data regarding where in the mesh hierarchy we are located
 ClibMesh::PetscDMWrapperThis class defines a wrapper around the PETSc DM infrastructure
 ClibMesh::PltLoaderThis class will read a binary .plt file
 Cstd::plus< boost::multiprecision::float128 >
 ClibMesh::PointerToPointerIter< T >The PointerToPointerIter templated class is intended to wrap pointer-to-pointer iterators in an interface which works more like a standard iterator, by returning a value rather than a pointer
 ClibMesh::PointerToPointerIter< const Elem >
 ClibMesh::PointerToPointerIter< const Node >
 ClibMesh::PointerToPointerIter< Elem >
 ClibMesh::PointerToPointerIter< Node >
 ClibMesh::InverseDistanceInterpolation< KDDim >::PointListAdaptor< PLDim >This class adapts list of libMesh Point types for use in a nanoflann KD-Tree
 ClibMesh::InverseDistanceInterpolation< KDDim >::PointListAdaptor< KDDim >
 Cpool_allocator
 CPreconditioner
 Cvariant_filter_iterator< Predicate, Type, ReferenceType, PointerType, ConstType, ConstReferenceType, ConstPointerType >::PredBaseAbstract base class for the predicate
 ClibMesh::Predicates::predicate< T >
 ClibMesh::System::QOIAbstract base class to be used for quantities of interest
 ClibMesh::System::QOIDerivativeAbstract base class to be used for derivatives of quantities of interest
 ClibMesh::QoISetData structure for specifying which Quantities of Interest should be calculated in an adjoint or a parameter sensitivity calculation
 CQSubCell
 ClibMesh::MeshTools::Generation::QueryElemSubdomainIDBaseClass for receiving the callback during extrusion generation and providing user-defined subdomains based on the old (existing) element id and the current layer
 ClibMesh::Threads::RangeBody< Range, Body >
 ClibMesh::RawAccessor< FieldType >This class provides single index access to FieldType (i.e
 ClibMesh::RawAccessor< TypeNTensor< N, ScalarType > >Stub implementations for stub TypeNTensor object
 ClibMesh::RawFieldType< FieldType >What underlying data type would we need to access in each field?
 ClibMesh::RawFieldType< Gradient >
 ClibMesh::RawFieldType< Number >
 ClibMesh::RawFieldType< Real >
 ClibMesh::RawFieldType< RealGradient >
 ClibMesh::RawFieldType< RealTensor >
 ClibMesh::RawFieldType< Tensor >
 ClibMesh::RawFieldType< TypeNTensor< 3, Number > >
 ClibMesh::RawFieldType< TypeNTensor< 3, Real > >
 CMetaPhysicL::RawType< libMesh::DenseMatrix< T > >
 CMetaPhysicL::RawType< libMesh::DenseVector< T > >
 CMetaPhysicL::RawType< libMesh::TensorValue< T > >
 CMetaPhysicL::RawType< libMesh::TypeTensor< T > >
 CMetaPhysicL::RawType< libMesh::TypeVector< T > >
 CMetaPhysicL::RawType< libMesh::VectorValue< T > >
 CRBAssemblyExpansion
 CRBEIMEvaluation
 ClibMesh::RBDataDeserialization::RBEIMEvaluationDeserializationThis class de-serializes a RBEIMEvaluation object using the Cap'n Proto library
 ClibMesh::RBDataSerialization::RBEIMEvaluationSerializationThis class serializes an RBEIMEvaluation object using the Cap'n Proto library
 ClibMesh::RBDataDeserialization::RBEvaluationDeserializationThis class de-serializes an RBEvaluation object using the Cap'n Proto library
 ClibMesh::RBDataSerialization::RBEvaluationSerializationThis class serializes an RBEvaluation object using the Cap'n Proto library
 ClibMesh::RBParametersThis class is part of the rbOOmit framework
 ClibMesh::RBParametrizedFunctionA simple functor class that provides a RBParameter-dependent function
 ClibMesh::RBDataDeserialization::RBSCMEvaluationDeserializationThis class de-serializes a RBSCMEvaluation object using the Cap'n Proto library
 ClibMesh::RBDataSerialization::RBSCMEvaluationSerializationThis class serializes an RBSCMEvaluation object using the Cap'n Proto library
 ClibMesh::RBTemporalDiscretizationDefine a class that encapsulates the details of a "generalized Euler" temporal discretization to be used in the rbOOmit framework
 CRBThetaExpansion
 ClibMesh::RealTraits< T >
 ClibMesh::VectorValue< T >::rebind< T2 >
 ClibMesh::FastPoolAllocator< T >::rebind< U >Methods required for copy construction of containers using this allocator
 ClibMesh::Threads::scalable_allocator< T >::rebind< U >
 ClibMesh::TensorValue< T >::rebind< T2 >
 ClibMesh::PoolAllocator< T >::rebind< U >Methods required for copy construction of containers using this allocator
 ClibMesh::Threads::recursive_mutexRecursive mutex
 ClibMesh::ReferenceCounterThis is the base class for enabling reference counting
 ClibMesh::RefinementSelectorThis abstract class provides an interface to methods for selecting the type of refinement to be used on each element in a given mesh
 ClibMesh::TriangulatorInterface::RegionA class for defining a 2-dimensional region for Triangle
 CMetaPhysicL::ReplaceAlgebraicType< libMesh::TensorValue< T >, U >
 CMetaPhysicL::ReplaceAlgebraicType< libMesh::TypeTensor< T >, U >
 CMetaPhysicL::ReplaceAlgebraicType< libMesh::TypeVector< T >, U >
 CMetaPhysicL::ReplaceAlgebraicType< libMesh::VectorValue< T >, U >
 CRequired
 ClibMesh::ResidualContext
 ClibMesh::Utility::ReverseBytesThis Functor simply takes an object and reverses its byte representation
 ClibMesh::SensitivityData::Row
 Cruntime_error
 Cscalable_allocator
 ClibMesh::EnsightIO::Scalars
 ClibMesh::ScalarTraits< T >
 ClibMesh::ScalarTraits< MetaPhysicL::DualNumber< T, D, asd > >
 ClibMesh::ScalarTraits< MetaPhysicL::DynamicSparseNumberArray< T, IndexType > >
 ClibMesh::ScalarTraits< std::complex< T > >
 ClibMesh::Threads::recursive_mutex::scoped_lock
 ClibMesh::Threads::spin_mutex::scoped_lock
 ClibMesh::SensitivityDataData structure for holding completed parameter sensitivity calculations
 Cset
 ClibMesh::Singleton::SetupAbstract base class for runtime singleton setup
 ClibMesh::Elem::SideIterThe definition of the protected nested SideIter class
 CSideType
 ClibMesh::SimpleRange< IndexType >The SimpleRange templated class is intended to make it easy to construct ranges from pairs of iterators
 ClibMesh::SingletonBase class for all library singleton objects
 ClibMesh::SolutionHistoryA SolutionHistory class that enables the storage and retrieval of timesteps and (in the future) adaptive steps
 ClibMesh::Threads::spin_mutexSpin mutex
 ClibMesh::Threads::splitDummy "splitting object" used to distinguish splitting constructors from copy constructors
 ClibMesh::StoredRange< iterator_type, object_type >The StoredRange class defines a contiguous, divisible set of objects
 CStreamRedirectorThis class uses RAII to control redirecting the libMesh::err stream to NULL and restoring it around some operation where we do not want to see output to the screen
 ClibMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::SubFunctor
 ClibMesh::SurfaceThe base class for all "surface" related geometric objects
 ClibMesh::SyncElementIntegers
 ClibMesh::Parallel::SyncEverything
 ClibMesh::SyncLocalIDs
 ClibMesh::SyncNodalPositions
 ClibMesh::SyncRefinementFlags
 ClibMesh::SyncSubdomainIds
 CSystemBase
 ClibMesh::SystemNormThis class defines a norm/seminorm to be applied to a NumericVector which contains coefficients in a finite element space
 ClibMesh::EnsightIO::SystemVars
 CInfFERadialTest::TabulatedGrad
 CInfFERadialTest::TabulatedVal
 ClibMesh::Threads::task_scheduler_initScheduler to manage threads
 ClibMesh::TensorTools::TensorTraits< T, Enable >
 ClibMesh::TensorTools::TensorTraits< T, typename std::enable_if< ScalarTraits< T >::value >::type >
 ClibMesh::TensorTools::TensorTraits< TensorValue< T > >
 ClibMesh::TensorTools::TensorTraits< TypeNTensor< N, T > >
 ClibMesh::TensorTools::TensorTraits< TypeTensor< T > >
 ClibMesh::TensorTools::TensorTraits< TypeVector< T > >
 ClibMesh::TensorTools::TensorTraits< VectorValue< T > >
 CTestCase
 ClibMesh::TestClass
 ClibMesh::TetGenMeshInterfaceClass TetGenMeshInterface provides an interface for tetrahedralization of meshes using the TetGen library
 ClibMesh::TetGenWrapperThe TetGenWrapper provides an interface for basic access to TetGen data structures and methods
 CTimeSolverTestImplementation< TimeSolverType >
 CTimeSolverTestImplementation< Euler2Solver >
 CTimeSolverTestImplementation< EulerSolver >
 CTimeSolverTestImplementation< NewmarkSolver >
 Ctimeval
 Ctoken
 ClibMesh::TopologyMapData structures that enable topology-based lookups of nodes created by mesh refinement
 CTransientNonlinearImplicitSystem
 CTransientRBConstruction
 CTransientRBEvaluation
 ClibMesh::RBDataDeserialization::TransientRBEvaluationDeserializationThis class de-serializes a TransientRBEvaluation object using the Cap'n Proto library
 ClibMesh::RBDataSerialization::TransientRBEvaluationSerializationThis class serializes a TransientRBEvaluation object using the Cap'n Proto library
 ClibMesh::TreeNode< N >This class defines a node on a tree
 ClibMesh::TriangulatorInterface
 ClibMesh::tuple_n< Index, T >
 ClibMesh::tuple_n< 0, T >
 ClibMesh::TypeNTensor< N, T >This class will eventually define a rank-N tensor in LIBMESH_DIM dimensional space of type T
 ClibMesh::TypesEqual< T1, T2 >
 ClibMesh::TypesEqual< T, T >
 ClibMesh::TypeTensor< T >This class defines a tensor in LIBMESH_DIM dimensional space of type T
 ClibMesh::TypeTensorColumn< T >
 ClibMesh::TypeToSend< T >For ease of communication, we allow users to translate their own value types to a more easily computable (typically a vector of some fixed-size type) output, by specializing these calls using different types
 ClibMesh::TypeToSend< MetaPhysicL::DynamicSparseNumberArray< T, IndexType > >
 ClibMesh::TypeVector< T >This class defines a vector in LIBMESH_DIM dimensional space of type T
 ClibMesh::TypeVector< Real >
 ClibMesh::TypeVectorAttributes< V >
 ClibMesh::TypeVectorAttributes< libMesh::Point >
 ClibMesh::TypeVectorAttributes< libMesh::TypeVector< T > >
 ClibMesh::TypeVectorAttributes< libMesh::VectorValue< T > >
 ClibMesh::TypeVectorOpFunction< V >
 ClibMesh::TypeVectorOpFunction< libMesh::Point >
 ClibMesh::TypeVectorOpFunction< libMesh::TypeVector< T > >
 ClibMesh::TypeVectorOpFunction< libMesh::VectorValue< T > >
 CUnitPerfItem
 ClibMesh::DenseMatrix< T >::UseBlasLapackHelper structure for determining whether to use blas_lapack
 CGETPOT_NAMESPACE::GetPot::variableVariable to be specified on the command line or in input files
 ClibMesh::VariableThis class defines the notion of a variable in the system
 Cvariant_filter_iterator< Predicate, Type, ReferenceType, PointerType, ConstType, ConstReferenceType, ConstPointerType >Original Authors: Corwin Joy * Michael Gradman cjoy@.nosp@m.hous.nosp@m.ton.r.nosp@m.r.co.nosp@m.m * Micha.nosp@m.el.G.nosp@m.radma.nosp@m.n@ca.nosp@m.minus.nosp@m..com Caminus, Suite 1150, Two Allen Center, 1200 Smith Street, Houston, TX 77002 This class is an extension of variant_bidirectional_iterator to a filter_iterator similar to boost's
 Cvariant_filter_iterator< Elem::Predicate, Elem *>
 ClibMesh::mapvector< Val, index_t >::veclike_iterator
 ClibMesh::chunked_mapvector< Val, index_t, N >::veclike_iterator_base< MapIter >
 ClibMesh::chunked_mapvector< Val, index_t, N >::veclike_iterator_base< maptype::const_iterator >
 ClibMesh::chunked_mapvector< Val, index_t, N >::veclike_iterator_base< maptype::iterator >
 Cvector
 ClibMesh::VectorizedEvalInputDefine a struct for the input to the "vectorized evaluate" functions below
 ClibMesh::VectorOfNodesAdaptor
 ClibMesh::EnsightIO::Vectors
 ClibMesh::VectorSetAction< Val >The VectorSetAction output functor class can be used with a GenericProjector to set projection values (which must be of type Val) as coefficients of the given NumericVector
 ClibMesh::WendlandRBF< SpaceDim, Continuity >Simple radial basis function
 ClibMesh::WrappedPetsc< T >
 ClibMesh::WrappedPetsc< IS >
 ClibMesh::WrappedPetsc< KSP >
 ClibMesh::WrappedPetsc< Mat >
 ClibMesh::WrappedPetsc< PC >
 ClibMesh::WrappedPetsc< SNES >
 ClibMesh::XdrThis class implements a C++ interface to the XDR (eXternal Data Representation) format
 CBase