LehrFEM++ 1.0.0
A simple Finite Element Library for teaching
Loading...
Searching...
No Matches
Class Hierarchy
This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 123]
 Clf::base::AutoTimerMeasures execution time between construction and destruction. AutoTimer can output either to a std::ostream or to a spdlog::logger
 Clf::refinement::CellChildInfoInformation about the refinement status of a cell
 Clf::assemble::COOMatrix< SCALAR >A temporary data structure for matrix in COO format
 Clf::base::Timer::cpu_timesPackages the elapsed wall clock time, user process CPU time, and system process CPU time
 Clf::fe::DiffusionElementMatrixProvider< SCALAR, DIFF_COEFF >Class for computing element matrices for general scalar-valued finite elements and homogeneous 2nd-order elliptic bilinear forms
 Clf::assemble::DofHandlerA general (interface) class for DOF handling, see Lecture Document Paragraph 2.7.4.13
 Clf::refinement::EdgeChildInfoInformation about the refinement status of an edge
 Clf::io::GMshFileV2::ElementRepresents a mesh volume/surface/line/point
 Clf::io::GMshFileV4::ElementBlockRepresents number of mesh elements (such as triangles/quadrilaterals/points/lines) that share the same properties
 Clf::io::GMshFileV4::Elements
 Clf::io::GMshFileV4::EntityA higher-dimensional entity (which is not a point) such as a curve, surface or volume. It usually corresponds to an entity as it is created in a *.geo file. Every such entity consists of nodes and elements and is bounded by lower-dimensional entities
 Clf::mesh::EntityInterface class representing a topological entity in a cellular complex
 Clf::refinement::EntityCenterPositionSelector< POSPRED >Utility class: selection of entities according to the position of their midpoint
 Clf::assemble::EntityMatrixProviderAT< SCALAR >Archetype for the EntityMatrixProvider concept
 Clf::assemble::EntityVectorProviderAT< SCALAR >Archetype for the EntityVectorProvider concept
 Cstd::exception
 Clf::io::VtkFile::FieldDataArray< T >
 Cspdlog::formatter
 Clf::geometry::GeometryInterface class for shape information on a mesh cell in the spirit of parametric finite element methods
 Clf::io::GMshFileV4::GhostElement
 Clf::io::GMshFileV4::GhostEntity
 Clf::io::GMshFileV2A representation of a .msh file (V2) in a c++ data structure
 Clf::io::GMshFileV4A representation of a .msh file (V4) in a c++ data structure
 Clf::io::GmshReaderReads a Gmsh *.msh file into a mesh::MeshFactory and provides a link between mesh::Entity objects and the gmsh's physical entities
 Clf::base::IsScalar< T, typename >Base Traits class which can be used to determine if a type T is a scalar value
 Clf::base::IsScalar< std::complex< T >, std::enable_if_t< std::is_arithmetic_v< T > > >Also std::complex is a "scalar" type if the underlying type is a std::is_arithmetic type
 Clf::base::IsScalar< T, std::enable_if_t< std::is_arithmetic_v< T > > >Any type that is a std::is_arithmetic is also a scalar type
 Clf::base::LehrFemInfoProvides extra information about this version of LehrFEM++, in particular licensing information
 Clf::uscalfe::LinearFELaplaceElementMatrixComputing the element matrix for the (negative) Laplacian and linear finite elements
 Clf::uscalfe::LinearFELocalLoadVector< SCALAR, FUNCTOR >Class for computation of local load vector for linear finite elements
 Clf::fe::MassEdgeMatrixProvider< SCALAR, COEFF, EDGESELECTOR >Quadrature-based computation of local mass matrix for an edge
 Clf::uscalfe::MassEdgeMatrixProvider< SCALAR, COEFF, EDGESELECTOR >Quadrature-based computation of local mass matrix for an edge
 Clf::fe::MassElementMatrixProvider< SCALAR, REACTION_COEFF >Class for local quadrature based computation of element matrix for Lagrangian finite elements and a weighted \(L^2\) inner product
 Clf::mesh::MeshAbstract interface for objects representing a single mesh
 Clf::mesh::utils::MeshDataSet< T >Interface that specifies how data is stored with an entity
 Clf::mesh::utils::MeshDataSet< std::variant< std::monostate, lf::fe::FePoint< SCALAR >, lf::fe::FeHierarchicSegment< SCALAR >, lf::fe::FeHierarchicTria< SCALAR >, lf::fe::FeHierarchicQuad< SCALAR > > >
 Clf::mesh::MeshFactoryInterface class for initialization of a mesh object
 Clf::mesh::utils::MeshFunctionAT< R >Archetype for the MeshFunction concept
 Clf::mesh::utils::MeshFunctionBinary< OP, A, B >A MeshFunction which combines two other mesh functions using a binary operator (advanced use)
 Clf::mesh::utils::MeshFunctionConstant< R >A MeshFunction which takes the same constant value on the whole mesh
 Clf::fe::MeshFunctionFE< SCALAR_FE, SCALAR_COEFF >A MeshFunction representing an element from a ScalarFESpace (e.g. solution of BVP)
 Clf::mesh::utils::MeshFunctionGlobal< F >MeshFunction wrapper for a simple function of physical coordinates
 Clf::fe::MeshFunctionGradFE< SCALAR_FE, SCALAR_COEFF >A MeshFunction representing the gradient of a function from a scalar finite element space (e.g. gradient of a solution of BVP)
 Clf::refinement::MeshFunctionTransfer< MF >A MeshFunction representing interpolation on a lf::refinement::MeshHierarchy
 Clf::mesh::utils::MeshFunctionUnary< OP, MF >A mesh function representing another mesh function under a pointwise, unary operation
 Clf::refinement::MeshHierarchyA hierarchy of nested 2D hybrid meshes created by refinement
 Clf::io::GMshFileV4::NodeBlock
 Clf::io::GMshFileV4::Nodes
 Clf::refinement::ParentInfoInformation about possible parent entities
 Clf::io::GMshFileV4::PartitionedEntities
 Clf::io::GMshFileV4::PartitionedEntityA higher dimensional partitioned entity
 Clf::io::GMshFileV4::PartitionedPointEntityWhen a mesh is partitioned, the entities are also partitioned. This is a node entity which is typically used to describe other partitioned entities (as bounding entities)
 Clf::io::GMshFileV2::PeriodicEntityDescribes how 2 elementary entities are identified with each to represent periodic boundaries
 Clf::io::GMshFileV4::PeriodicLinkDescribes how 2 elementary entities are identified with each other to represent periodic boundaries
 Clf::io::GMshFileV2::PhysicalEntityRepresents a physical entity as defined in gmsh. In GMSH a Physical entity is created through one of the commands Physical Point, Physical Line, Physical Surface or Physical Volume and represents a collection of points, lines, surfaces or volumes
 Clf::io::GMshFileV4::PhysicalNameRepresents a physical name as defined in gmsh. In GMSH a Physical name is created through one of the commands Physical Point, Physical Line, Physical Surface or Physical Volume and represents a collection of points, lines, surfaces or volumes
 Clf::refinement::PointChildInfoInformation about the refinement status of a point
 Clf::io::GMshFileV4::PointEntityAn entity of dimension 0. Usually an entity corresponds to a geometric construct as it is defined in the original *.geo file. Every entity consists of one or more elements and nodes. And every entity can belong to some physical tags
 Clf::base::PredicateTrueA Function Object that can be invoked with any arguments and that always returns the value true
 Clf::quad::QuadRuleRepresents a Quadrature Rule over one of the Reference Elements
 Clf::quad::QuadRuleCacheA cache for make_QuadRule()
 Clf::uscalfe::ReactionDiffusionElementMatrixProvider< SCALAR, DIFF_COEFF, REACTION_COEFF >Class for local quadrature based computations for Lagrangian finite elements and second-order scalar elliptic BVPs
 Clf::base::RefElRepresents a reference element with all its properties
 Clf::geometry::RefinementPatternAbstract interface class for encoding topological local refinement
 Clf::io::VtkFile::ScalarData< T >Represents one set of attribute data (can be attached to points or cells)
 Clf::fe::ScalarFESpace< SCALAR >Space of scalar valued finite element functions on a Mesh
 Clf::fe::ScalarLoadEdgeVectorProvider< SCALAR, FUNCTOR, EDGESELECTOR >Local edge contributions to element vector
 Clf::uscalfe::ScalarLoadEdgeVectorProvider< SCALAR, FUNCTOR, EDGESELECTOR >Local edge contributions to element vector
 Clf::fe::ScalarLoadElementVectorProvider< SCALAR, MESH_FUNCTION >Local computation of general element (load) vector for scalar finite elements; volume contributions only
 Clf::uscalfe::ScalarLoadElementVectorProvider< SCALAR, MESH_FUNCTION >Local computation of general element (load) vector for scalar finite elements; volume contributions only
 Clf::fe::ScalarReferenceFiniteElement< SCALAR >Interface class for parametric scalar valued finite elements
 Clf::fe::ScalarReferenceFiniteElement< std::complex< SCALAR > >
 Clf::mesh::utils::StructuredMeshBuilderBuilder interface for creating structured meshes on rectangular domains
 Clf::base::TimerTimer class to measure time
 Clf::io::VtkFile::UnstructuredGrid
 CVariantVisitor< RESULT_TYPE, LAMBDA >
 Clf::io::VtkFile::VectorData< T >
 Clf::io::VtkFileRepresentation of a VTK file (only relevant) features (advanced usage)
 Clf::io::VtkWriterWrite a mesh along with mesh data into a vtk file