DOLFIN-X
DOLFIN-X C++ interface
Class Hierarchy

Go to the graphical class hierarchy

This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 12]
 Cdolfinx::graph::AdjacencyList< T >This class provides a static adjacency list data structure. It is commonly used to store directed graphs. For each node in the contiguous list of nodes [0, 1, 2, ..., n) it stores the connected nodes. The representation is strictly local, i.e. it is not parallel aware
 Cdolfinx::graph::BoostGraphColoringThis class colors a graph using the Boost Graph Library
 Cdolfinx::graph::BoostGraphOrderingThis class computes graph re-orderings. It uses Boost Graph
 Cdolfinx::geometry::BoundingBoxTreeAxis-Aligned bounding box binary tree. It is used to find entities in a collection (often a mesh::Mesh)
 Cdolfinx::generation::BoxMeshTetrahedral mesh of the 3D rectangular prism spanned by two points p0 and p1. Given the number of cells (nx, ny, nz) in each direction, the total number of tetrahedra will be 6*nx*ny*nz and the total number of vertices will be (nx + 1)*(ny + 1)*(nz + 1)
 Cdolfinx::geometry::CollisionPredicatesThis class implements algorithms for detecting pairwise collisions between mesh entities of varying dimensions
 Cdolfinx::MPI::CommA duplicate MPI communicator and manage lifetime of the communicator
 Cdolfinx::function::ConstantA constant value which can be attached to a Form. Constants may be scalar (rank 0), vector (rank 1), or tensor valued
 Cdolfinx::fem::CoordinateElementThis class manages coordinate mappings for isoparametric cells
 Cdolfinx::fem::DirichletBCInterface for setting (strong) Dirichlet boundary conditions
 Cdolfinx::fem::DiscreteOperatorsDiscrete gradient operators providing derivatives of functions
 Cdolfinx::fem::DofMapDegree-of-freedom map
 Cdolfinx::fem::DofMapBuilderBuilds a DofMap on a mesh::Mesh
 Cdolfinx::fem::ElementDofLayoutThe class represents the degree-of-freedom (dofs) for an element. Dofs are associated with a mesh entity. This class also handles sub-space dofs, which are views into the parent dofs
 Cfalse_type
 Cdolfinx::MPI::dependent_false< T >
 Cdolfinx::fem::FiniteElementFinite Element, containing the dof layout on a reference element, and various methods for evaluating and transforming the basis
 Cdolfinx::fem::FormBase class for variational forms
 Cdolfinx::fem::FormCoefficientsStorage for the coefficients of a Form consisting of Function and the Element objects they are defined on
 Cdolfinx::fem::FormIntegralsIntegrals of a Form, including those defined over cells, interior and exterior facets, and vertices
 Cdolfinx::function::FunctionThis class represents a function \( u_h \) in a finite element function space \( V_h \), given by
 Cdolfinx::function::FunctionSpaceThis class represents a finite element function space defined by a mesh, a finite element, and a local-to-global map of the degrees of freedom (dofmap)
 Cdolfinx::mesh::GeometryGeometry stores the geometry imposed on a mesh
 Cdolfinx::geometry::GeometryPredicatesThis class implements geometric predicates, i.e. function that return either true or false
 Cdolfinx::mesh::GraphBuilderThis class builds a Graph corresponding to various objects
 Cdolfinx::io::HDF5FileInterface to HDF5 files
 Cdolfinx::io::HDF5InterfaceThis class wraps HDF5 function calls. HDF5 function calls should only appear in a member function of this class and not elsewhere in the library
 Cdolfinx::common::IndexMapThis class represents the distribution index arrays across processes. An index array is a contiguous collection of N+1 block indices [0, 1, . . ., N] that are distributed across processes M processes. On a given process, the IndexMap stores a portion of the index set using local indices [0, 1, . . . , n], and a map from the local block indices to a unique global block index
 Cdolfinx::generation::IntervalMeshInterval mesh of the 1D line [a,b]. Given the number of cells (n) in the axial direction, the total number of intervals will be n and the total number of vertices will be (n + 1)
 Cdolfinx::graph::KaHIPThis class provides an interface to KaHIP parallel partitioner
 Cdolfinx::mesh::MeshA Mesh consists of a set of connected and numbered mesh topological entities, and geometry data
 Cdolfinx::mesh::MeshEntityA MeshEntity represents a mesh entity associated with a specific topological dimension of some Mesh. A MeshEntity object is left in an undefined state if the Mesh that it is constructed with is destroyed
 Cdolfinx::mesh::MeshQualityThe class provides functions to quantify mesh quality
 Cdolfinx::mesh::MeshTags< T >A MeshTags are used to associate mesh entities with values. The entity index (local to process) identifies the entity. MeshTags is a sparse data storage class; it allows tags to be associated with an arbitrary subset of mesh entities. An entity can have only one associated tag
 Cdolfinx::MPIThis class provides utility functions for easy communication with MPI and handles cases when DOLFINX is not configured with MPI
 Cdolfinx::nls::NewtonSolverThis class defines a Newton solver for nonlinear systems of equations of the form \(F(x) = 0\)
 Cdolfinx::nls::NonlinearProblemThis is a base class for nonlinear problems which can return the nonlinear function F(u) and its Jacobian J = dF(u)/du
 Cdolfinx::refinement::ParallelRefinementData structure and methods for refining meshes in parallel
 Cdolfinx::graph::ParMETISThis class provides an interface to ParMETIS
 Cdolfinx::graph::PartitioningTools for distributed graphs
 Cdolfinx::mesh::PartitioningTools for partitioning meshes
 Cdolfinx::mesh::PermutationComputationTools for computing mesh entity permutations
 Cdolfinx::la::PETScKrylovSolverThis class implements Krylov methods for linear systems of the form Ax = b. It is a wrapper for the Krylov solvers of PETSc
 Cdolfinx::la::PETScOperatorThis class is a base class for matrices that can be used in PETScKrylovSolver
 Cdolfinx::la::PETScMatrixIt is a simple wrapper for a PETSc matrix pointer (Mat). Its main purpose is to assist memory management of PETSc Mat objects
 Cdolfinx::la::PETScOptionsThese class provides static functions that permit users to set and retrieve PETSc options via the PETSc option/parameter system. The option must not be prefixed by '-', e.g
 Cdolfinx::la::PETScVectorIt is a simple wrapper for a PETSc vector pointer (Vec). Its main purpose is to assist memory management of PETSc Vec objects
 Cdolfinx::refinement::PlazaRefinementNDImplementation of the refinement method described in Plaza and Carey "Local refinement of simplicial grids based on the skeleton" (Applied Numerical Mathematics 32 (2000) 195-218)
 Cdolfinx::geometry::PredicateInitializationClass used for automatic initialization of tolerances at startup. A global instance is defined inside predicates.cpp to ensure that the constructor and thus exactinit() is called
 Cdolfinx::generation::RectangleMeshTriangular mesh of the 2D rectangle spanned by two points p0 and p1. Given the number of cells (nx, ny) in each direction, the total number of triangles will be 2*nx*ny and the total number of vertices will be (nx + 1)*(ny + 1)
 Cdolfinx::fem::ReferenceCellGeometryTabulates the vertex positions for the reference cell
 Cdolfinx::graph::SCOTCHThis class provides an interface to SCOTCH-PT (parallel version)
 Cdolfinx::la::SparsityPatternThis class provides a sparsity pattern data structure that can be used to initialize sparse matrices
 Cdolfinx::fem::SparsityPatternBuilderThis class provides functions to compute the sparsity pattern based on DOF maps
 Cdolfinx::common::SubSystemsManagerThis is a singleton class which manages the initialisation and finalisation of various sub systems, such as MPI and PETSc
 Cdolfinx::TableThis class provides storage and pretty-printing for tables. Example usage:
 Cdolfinx::common::TimeLoggerTimer logging
 Cdolfinx::common::TimeLogManagerLogger initialisation
 Cdolfinx::common::TimerA timer can be used for timing tasks. The basic usage is
 Cdolfinx::mesh::TopologyTopology stores the topology of a mesh, consisting of mesh entities and connectivity (incidence relations for the mesh entities). Note that the mesh entities don't need to be stored, only the number of entities and the connectivity
 Cdolfinx::mesh::TopologyComputationThis class implements a set of basic algorithms that automate the computation of mesh entities and connectivity
 Cdolfinx::common::UniqueIdGeneratorThis is a singleton class that return IDs that are unique in the lifetime of a program
 Cdolfinx::generation::UnitDiscMeshA mesh consisting of a circular domain with quadratic geometry. This class is useful for testing
 Cdolfinx::la::VecReadWrapperRead-only wrapper around a PETSc Vec object, to simplify direct access to data
 Cdolfinx::la::VectorSpaceBasisThis class defines a basis for vector spaces, typically used for expressing nullspaces of singular operators and 'near nullspaces' used in smoothed aggregation algebraic multigrid
 Cdolfinx::la::VecWrapperWrapper around a PETSc Vec object, to simplify direct access to data
 Cdolfinx::io::VTKFileOutput of meshes and functions in VTK format
 Cdolfinx::io::VTKWriterWrite VTK mesh::Mesh representation
 Cdolfinx::io::XDMFFileRead and write mesh::Mesh, function::Function and other objects in XDMF