Note: this is documentation for an old release. View the latest documentation at docs.fenicsproject.org/dolfinx/v0.9.0/cpp/doxygen/namespaces.html
DOLFINx 0.7.3
DOLFINx C++ interface
Loading...
Searching...
No Matches
Namespace List
Here is a list of all documented namespaces with brief descriptions:
[detail level 1234]
 NdolfinxTop-level namespace
 NcommonMiscellaneous classes, functions and types
 CIndexMapThis 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
 CScattererA Scatterer supports the MPI scattering and gathering of data that is associated with a common::IndexMap
 CTimeLoggerTimer logging
 CTimeLogManagerLogger initialisation
 CTimerA timer can be used for timing tasks. The basic usage is
 NfemFinite element method functionality
 NpetscHelper functions for assembly into PETSc data structures
 NsparsitybuildSupport for building sparsity patterns from degree-of-freedom maps
 CConstantConstant value which can be attached to a Form
 CCoordinateElementA CoordinateElement manages coordinate mappings for isoparametric cells
 CDirichletBCObject for setting (strong) Dirichlet boundary conditions
 CDofMapDegree-of-freedom map
 CElementDofLayoutThe 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
 CExpressionRepresents a mathematical expression evaluated at a pre-defined set of points on the reference cell
 CFiniteElementFinite Element, containing the dof layout on a reference element, and various methods for evaluating and transforming the basis
 CFormA representation of finite element variational forms
 CFunctionThis class represents a function \( u_h \) in a finite element function space \( V_h \), given by
 CFunctionSpaceThis 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
 RFEkernelFinite element cell kernel concept
 NgeometryGeometry data structures and algorithms
 CBoundingBoxTreeAxis-Aligned bounding box binary tree. It is used to find entities in a collection (often a mesh::Mesh)
 NgraphGraph data structures and algorithms
 NbuildTools for distributed graphs
 NkahipInterfaces to KaHIP parallel partitioner
 CAdjacencyListThis 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
 NioSupport for file IO
 NcellsFunctions for the re-ordering of input mesh topology to the DOLFINx ordering, and transpose orderings for file output
 Nxdmf_functionLow-level methods for reading/writing XDMF files
 Nxdmf_meshLow-level methods for reading XDMF files
 CADIOS2WriterBase class for ADIOS2-based writers
 CVTKFileOutput of meshes and functions in VTK/ParaView format
 CXDMFFileRead and write mesh::Mesh, fem::Function and other objects in XDMF
 NlaLinear algebra interface
 NpetscPETSc linear algebra functions
 NoptionsThese 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
 CKrylovSolverThis class implements Krylov methods for linear systems of the form Ax = b. It is a wrapper for the Krylov solvers of PETSc
 CMatrixIt is a simple wrapper for a PETSc matrix pointer (Mat). Its main purpose is to assist memory management of PETSc Mat objects
 COperatorThis class is a base class for matrices that can be used in petsc::KrylovSolver
 CVectorA simple wrapper for a PETSc vector pointer (Vec). Its main purpose is to assist with memory/lifetime management of PETSc Vec objects
 CMatrixCSRDistributed sparse matrix
 CSLEPcEigenSolverThis class provides an eigenvalue solver for PETSc matrices. It is a wrapper for the SLEPc eigenvalue solver
 CSparsityPatternSparsity 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
 CVectorDistributed vector
 RMatSetMatrix accumulate/set concept for functions that can be used in assemblers to accumulate or set values in a matrix
 NmeshMesh data structures and algorithms on meshes
 CGeometryGeometry stores the geometry imposed on a mesh
 CMeshA Mesh consists of a set of connected and numbered mesh topological entities, and geometry data
 CMeshTagsMeshTags associate values with mesh topology entities
 CTopologyTopology stores the topology of a mesh, consisting of mesh entities and connectivity (incidence relations for the mesh entities)
 RMarkerFnRequirements on function for geometry marking
 NMPIMPI support functionality
 CCommA duplicate MPI communicator and manage lifetime of the communicator
 Cdependent_false
 NnlsNonlinear solvers
 NrefinementMesh refinement algorithms
 NplazaPlaza mesh refinement
 CTableThis class provides storage and pretty-printing for tables. Example usage:
 RscalarThis 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
 NGenericTools