DOLFINx 0.7.3
DOLFINx C++ interface
|
▼Ndolfinx | Top-level namespace |
▼Ncommon | Miscellaneous classes, functions and types |
CIndexMap | This class represents the distribution index arrays across processes. An index array is a contiguous collection of N+1 indices [0, 1, . . ., N] that are distributed across 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 indices to a unique global index |
CScatterer | A Scatterer supports the MPI scattering and gathering of data that is associated with a common::IndexMap |
CTimeLogger | Timer logging |
CTimeLogManager | Logger initialisation |
CTimer | A timer can be used for timing tasks. The basic usage is |
▼Nfem | Finite element method functionality |
Npetsc | Helper functions for assembly into PETSc data structures |
Nsparsitybuild | Support for building sparsity patterns from degree-of-freedom maps |
CConstant | Constant value which can be attached to a Form |
CCoordinateElement | A CoordinateElement manages coordinate mappings for isoparametric cells |
CDirichletBC | Object for setting (strong) Dirichlet boundary conditions |
CDofMap | Degree-of-freedom map |
CElementDofLayout | The 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 |
CExpression | Represents a mathematical expression evaluated at a pre-defined set of points on the reference cell |
CFiniteElement | Finite Element, containing the dof layout on a reference element, and various methods for evaluating and transforming the basis |
CForm | A representation of finite element variational forms |
CFunction | This class represents a function \( u_h \) in a finite element function space \( V_h \), given by |
CFunctionSpace | This 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 |
RFEkernel | Finite element cell kernel concept |
▼Ngeometry | Geometry data structures and algorithms |
CBoundingBoxTree | Axis-Aligned bounding box binary tree. It is used to find entities in a collection (often a mesh::Mesh) |
▼Ngraph | Graph data structures and algorithms |
Nbuild | Tools for distributed graphs |
Nkahip | Interfaces to KaHIP parallel partitioner |
CAdjacencyList | 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 |
▼Nio | Support for file IO |
Ncells | Functions for the re-ordering of input mesh topology to the DOLFINx ordering, and transpose orderings for file output |
Nxdmf_function | Low-level methods for reading/writing XDMF files |
Nxdmf_mesh | Low-level methods for reading XDMF files |
CADIOS2Writer | Base class for ADIOS2-based writers |
CVTKFile | Output of meshes and functions in VTK/ParaView format |
CXDMFFile | Read and write mesh::Mesh, fem::Function and other objects in XDMF |
▼Nla | Linear algebra interface |
▼Npetsc | PETSc linear algebra functions |
Noptions | These 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 |
CKrylovSolver | This class implements Krylov methods for linear systems of the form Ax = b. It is a wrapper for the Krylov solvers of PETSc |
CMatrix | It is a simple wrapper for a PETSc matrix pointer (Mat). Its main purpose is to assist memory management of PETSc Mat objects |
COperator | This class is a base class for matrices that can be used in petsc::KrylovSolver |
CVector | A simple wrapper for a PETSc vector pointer (Vec). Its main purpose is to assist with memory/lifetime management of PETSc Vec objects |
CMatrixCSR | Distributed sparse matrix |
CSLEPcEigenSolver | This class provides an eigenvalue solver for PETSc matrices. It is a wrapper for the SLEPc eigenvalue solver |
CSparsityPattern | Sparsity pattern data structure that can be used to initialize sparse matrices. After assembly, column indices are always sorted in increasing order. Ghost entries are kept after assembly |
CVector | Distributed vector |
RMatSet | Matrix accumulate/set concept for functions that can be used in assemblers to accumulate or set values in a matrix |
▼Nmesh | Mesh data structures and algorithms on meshes |
CGeometry | Geometry stores the geometry imposed on a mesh |
CMesh | A Mesh consists of a set of connected and numbered mesh topological entities, and geometry data |
CMeshTags | MeshTags associate values with mesh topology entities |
CTopology | Topology stores the topology of a mesh, consisting of mesh entities and connectivity (incidence relations for the mesh entities) |
RMarkerFn | Requirements on function for geometry marking |
▼NMPI | MPI support functionality |
CComm | A duplicate MPI communicator and manage lifetime of the communicator |
Cdependent_false | |
▼Nnls | Nonlinear solvers |
▼Nrefinement | Mesh refinement algorithms |
Nplaza | Plaza mesh refinement |
CTable | This class provides storage and pretty-printing for tables. Example usage: |
Rscalar | This concept is used to constrain the a template type to floating point real or complex types. Note that this concept is different to std::floating_point which does not include std::complex |
NGeneric | Tools |