|
DOLFIN
DOLFIN C++ interface
|
| ►Ndolfin | |
| CAdaptiveLinearVariationalSolver | |
| CAdaptiveNonlinearVariationalSolver | |
| CALE | |
| CAmesos2LUSolver | |
| CArray | |
| CArrayView | |
| CAssembler | |
| CAssemblerBase | Provide some common functions used in assembler classes |
| CBasisFunction | Represention of a finite element basis function |
| CBelosKrylovSolver | |
| CBisectionRefinement1D | This class implements mesh refinement in 1D |
| CBlockMatrix | Block Matrix |
| CBlockVector | Block vector |
| CBoostGraphColoring | This class colors a graph using the Boost Graph Library |
| CBoostGraphOrdering | This class computes graph re-orderings. It uses Boost Graph |
| CBoundaryComputation | Provide a set of basic algorithms for the computation of boundaries |
| CBoundaryMesh | |
| CBoundingBoxTree | |
| ►CBoundingBoxTree1D | Specialization of bounding box implementation to 1D |
| Cless_x | |
| ►CBoundingBoxTree2D | Specialization of bounding box implementation to 2D |
| Cless_x | |
| Cless_y | |
| ►CBoundingBoxTree3D | Specialization of bounding box implementation to 3D |
| Cless_x_bbox | Comparison operators for sorting of bounding boxes |
| Cless_y_bbox | Less than operator in y-direction |
| Cless_z_bbox | Less than operator in z-direction |
| CBoxMesh | |
| CCell | A Cell is a MeshEntity of topological codimension 0 |
| CCellType | |
| CCoefficientAssigner | |
| CCollisionPredicates | |
| CConstant | This class represents a constant-valued expression |
| CConvexTriangulation | |
| CCoordinateMatrix | Coordinate sparse matrix |
| ►CCSRGraph | Compressed Sparse Row graph |
| Cnode | |
| CCVode | Wrapper class to SUNDIALS CVODE |
| CDefaultFactory | Default linear algebra factory based on global parameter "linear_algebra_backend" |
| CDirichletBC | Interface for setting (strong) Dirichlet boundary conditions |
| CDiscreteOperators | Discrete gradient operators providing derivatives of functions |
| CDistributedMeshTools | |
| CDofMap | Degree-of-freedom map |
| CDofMapBuilder | Builds a DofMap on a Mesh |
| CDomainBoundary | |
| CDynamicMeshEditor | |
| CEdge | An Edge is a MeshEntity of topological dimension 1 |
| CEigenFactory | Eigen linear algebra factory |
| CEigenKrylovSolver | |
| ►CEigenLUSolver | |
| CEigenLUImplBase | |
| CEigenMatrix | |
| CEigenVector | |
| CEquation | |
| CErrorControl | (Goal-oriented) Error Control class |
| CEvent | |
| CExpression | |
| CExtrapolation | |
| CFace | A Face is a MeshEntity of topological dimension 2 |
| CFacet | A Facet is a MeshEntity of topological codimension 1 |
| CFacetArea | |
| CFacetCell | |
| CFile | |
| CFiniteElement | This is a wrapper for a UFC finite element (ufc::finite_element) |
| CForm | Base class for UFC code generated by FFC for DOLFIN with option -l |
| CFunction | |
| CFunctionAssigner | |
| CFunctionAXPY | |
| CFunctionSpace | |
| CGenericAdaptiveVariationalSolver | |
| ►CGenericBoundingBoxTree | |
| CBBox | |
| Cless_x_point | |
| Cless_y_point | |
| Cless_z_point | |
| CGenericDofMap | This class provides a generic interface for dof maps |
| CGenericFile | Base class for file I/O objects |
| CGenericFunction | |
| ►CGenericLinearAlgebraFactory | Base class for LinearAlgebra factories |
| CNotImplementedLinearOperator | |
| CGenericLinearOperator | |
| CGenericLinearSolver | This class provides a general solver for linear systems Ax = b |
| CGenericMatrix | This class defines a common interface for matrices |
| CGenericTensor | A common interface for arbitrary rank tensors |
| CGenericVector | This class defines a common interface for vectors |
| CGeometryDebugging | |
| CGeometryPredicates | |
| CGeometryTools | This class provides useful tools (functions) for computational geometry |
| CGlobalParameters | This class defines the global DOLFIN parameter database |
| CGoalFunctional | |
| CGraphBuilder | This class builds a Graph corresponding to various objects |
| CGraphColoring | This class provides a common interface to graph coloring libraries |
| CHarmonicSmoothing | |
| CHDF5Attribute | |
| CHDF5File | |
| CHDF5Interface | |
| CHDF5Utility | |
| CHexahedronCell | This class implements functionality for hexahedral cell meshes |
| CHierarchical | |
| CIfpack2Preconditioner | Implements preconditioners using Ifpack2 from Trilinos |
| CIndexMap | |
| CIndexSet | |
| CIntersectionConstruction | |
| CIntervalCell | This class implements functionality for interval cell meshes |
| CIntervalMesh | |
| CKrylovSolver | |
| CLagrange | |
| CLagrangeInterpolator | |
| CLegendre | Interface for computing Legendre polynomials via Boost |
| CLinearAlgebraObject | |
| CLinearOperator | |
| CLinearSolver | This class provides a general solver for linear systems Ax = b |
| CLinearTimeDependentProblem | |
| CLinearVariationalProblem | |
| CLinearVariationalSolver | This class implements a solver for linear variational problems |
| CLocalAssembler | |
| CLocalMeshCoarsening | This class implements local mesh coarsening for different mesh types |
| ►CLocalMeshData | This class stores mesh data on a local processor corresponding to a portion of a (larger) global mesh |
| CGeometry | Holder for geometry data |
| CTopology | Holder for topology data |
| CLocalMeshValueCollection | |
| CLocalSolver | Solve problems cell-wise |
| CLogger | Handling of error messages, logging and informational display |
| CLogManager | Logger initialisation |
| CLogStream | |
| CLUSolver | LU solver for the built-in LA backends |
| CMatrix | |
| CMesh | |
| CMeshColoring | |
| CMeshConnectivity | |
| CMeshCoordinates | This Function represents the mesh coordinates on a given mesh |
| CMeshData | |
| CMeshDisplacement | |
| CMeshDomains | |
| CMeshEditor | |
| CMeshEntity | |
| CMeshEntityIterator | |
| CMeshEntityIteratorBase | Base class for MeshEntityIterators |
| CMeshFunction | |
| CMeshGeometry | MeshGeometry stores the geometry imposed on a mesh |
| CMeshHierarchy | Experimental implementation of a list of Meshes as a hierarchy |
| CMeshOrdering | |
| CMeshPartitioning | |
| CMeshPointIntersection | |
| CMeshQuality | The class provides functions to quantify mesh quality |
| CMeshRelation | |
| CMeshRenumbering | This class implements renumbering algorithms for meshes |
| CMeshSmoothing | This class implements various mesh smoothing algorithms |
| CMeshTopology | |
| CMeshTransformation | |
| CMeshValueCollection | |
| ►CMPI | |
| CComm | |
| CMPIInfo | |
| CMueluPreconditioner | Implements Muelu preconditioner from Trilinos |
| CMultiMesh | |
| CMultiMeshAssembler | |
| CMultiMeshCoefficientAssigner | |
| CMultiMeshDirichletBC | |
| CMultiMeshDofMap | |
| CMultiMeshForm | |
| CMultiMeshFunction | |
| CMultiMeshFunctionSpace | |
| CMultiMeshSubSpace | |
| CMultiStageScheme | Place-holder for forms and solutions for a multi-stage Butcher tableau based method |
| CNewtonSolver | |
| CNoDeleter | NoDeleter is a customised deleter intended for use with smart pointers |
| CNonlinearProblem | |
| CNonlinearVariationalProblem | |
| CNonlinearVariationalSolver | |
| COptimisationProblem | |
| CParallelRefinement | Data structure and methods for refining meshes in parallel |
| CParameter | Base class for parameters |
| CParameters | |
| CParMETIS | This class provides an interface to ParMETIS |
| CPeriodicBoundaryComputation | This class computes map from slave entity to master entity |
| CPETScBaseMatrix | |
| CPETScDMCollection | |
| CPETScFactory | PETSc linear algebra factory |
| CPETScKrylovSolver | |
| CPETScLinearOperator | PETSc version of the GenericLinearOperator |
| CPETScLUSolver | |
| CPETScMatrix | |
| CPETScObject | |
| CPETScOptions | |
| CPETScPreconditioner | |
| CPETScSNESSolver | |
| CPETScTAOSolver | |
| CPETScVector | |
| CPlazaRefinementND | |
| CPoint | |
| CPointCell | This class implements functionality for point cell meshes |
| CPointIntegralSolver | This class is a time integrator for general Runge Kutta forms |
| CPointSource | |
| CPredicateInitialization | |
| CProgress | |
| CQuadrilateralCell | This class implements functionality for quadrilaterial cells |
| CRangedIndexSet | |
| CRAWFile | Output of data in raw binary format |
| CRectangleMesh | |
| CRegularCutRefinement | |
| CRKSolver | This class is a time integrator for general Runge Kutta problems |
| CScalar | |
| CSCOTCH | This class provides an interface to SCOTCH-PT (parallel version) |
| CSet | |
| CSimplexQuadrature | This class defines quadrature rules for simplices |
| CSLEPcEigenSolver | |
| CSparsityPattern | |
| CSparsityPatternBuilder | |
| CSpecialFacetFunction | |
| CSphericalShellMesh | |
| CSubDomain | |
| CSubMesh | |
| CSubsetIterator | |
| CSubSystemsManager | |
| CSUNDIALSNVector | |
| CSVGFile | |
| CSystemAssembler | |
| CTable | |
| CTableEntry | This class represents an entry in a Table |
| CTAOLinearBoundSolver | |
| CTensorLayout | |
| CTetrahedronCell | This class implements functionality for tetrahedral cell meshes |
| CTimer | |
| CTimeSeries | |
| CTopologyComputation | |
| CTpetraFactory | Tpetra linear algebra factory |
| CTpetraMatrix | |
| CTpetraVector | |
| CTriangleCell | This class implements functionality for triangular meshes |
| CTrilinosParameters | |
| CTrilinosPreconditioner | This class provides a common base for Trilinos preconditioners |
| CUFC | |
| CUniqueIdGenerator | |
| CUnitCubeMesh | |
| CUnitDiscMesh | A unit disc mesh in 2D or 3D geometry |
| CUnitIntervalMesh | |
| CUnitSquareMesh | |
| CUnitTetrahedronMesh | |
| CUnitTriangleMesh | |
| CVariable | Common base class for DOLFIN variables |
| CVector | |
| CVectorSpaceBasis | |
| CVertex | A Vertex is a MeshEntity of topological dimension 0 |
| CVTKFile | Output of meshes and functions in VTK format |
| CVTKWriter | Write VTK Mesh representation |
| CX3DFile | |
| CX3DOM | |
| CX3DOMParameters | Class data to store X3DOM view parameters |
| CXDMFFile | Read and write Mesh, Function, MeshFunction and other objects in XDMF |
| CXMLArray | I/O of array data in XML format |
| CXMLFile | I/O of DOLFIN objects in XML format |
| CXMLFunctionData | I/O for XML representation of Function |
| CXMLMesh | I/O of XML representation of a Mesh |
| CXMLMeshFunction | I/O of XML representation of MeshFunction |
| CXMLMeshValueCollection | I/O of XML representation of a MeshValueCollection |
| CXMLParameters | I/O of Parameters in XML format |
| CXMLTable | Output of XML representation of DOLFIN Table |
| CXMLVector | I/O of XML representation of GenericVector |
| CXYZFile | Simple and light file format for use with Xd3d |
| CZoltanInterface | |
| CEmptySubDomain |
1.8.11