▼Ndftefe | Dealii includes |
►Natoms | |
►NAtomSphericalDataXMLLocal | |
CXPathInfo | |
►NAtomSphericalElectronicDataXMLLocal | |
CXPathInfo | |
CAtomSevereFunction | |
COverlappingAtomIds | Class to get the Ids of the Atoms overlapping a particular Processor for a particular field. Each Processor stores info of all the atoms |
CSphericalData | |
CSphericalDataDefaults | |
CSphericalDataNumerical | |
►Nbasis | |
►NCFEOverlapInverseOpContextGLLInternal | |
COverlapMatrixInverseLinearSolverFunctionFE | |
►NOrthoEFEOverlapInverseOpContextGLLInternal | |
COverlapMatrixInverseLinearSolverFunctionFE | |
CAtomIdsPartition | Class to get the renumbered Ids of the locally owned Atom ids returns the vector of no of atoms in each processor and the vector of old atom ids. so oldatomid(0) = 2 and so on. So also newatomid(2) = 0; but you do not need to store as oldatomid vector is same as newatomid i.e. memory layout should be 'locally owned enriched ids' should be consecutive integers |
CBasisDataStorage | An abstract class to store and access data for a given basis, such as the basis function values on a quadrature grid, the overlap matrix of the basis, etc |
CBasisDofHandler | |
CBasisManager | An abstract class to encapsulate the partitioning of a basis across multiple processors |
CBasisOperations | |
CCellMappingBase | An abstract class to map a real point to parametric point and vice-versa |
CCFEBasisDataStorageDealii | An abstract class to store and access data for a given basis, such as the basis function values on a quadrature grid, the overlap matrix of the basis, etc |
CCFEBasisDofHandlerDealii | |
CCFEConstraintsLocalDealii | |
CCFEOverlapInverseOpContextGLL | |
CCFEOverlapOperatorContext | A derived class of linearAlgebra::OperatorContext to encapsulate the action of a discrete operator on vectors, matrices, etc |
CConstraintsInternal | |
CConstraintsLocal | |
CEFEBasisDataStorage | An abstract class to store and access data for a given basis, such as the basis function values on a quadrature grid, the overlap matrix of the basis, etc |
CEFEBasisDataStorageDealii | An abstract class to store and access data for enriched fe basis, such as the basis function values on a quadrature grid, the overlap matrix of the basis, etc |
CEFEBasisDofHandler | |
CEFEBasisDofHandlerDealii | |
CEFEConstraintsLocalDealii | |
CEnrichmentClassicalInterfaceSpherical | Class to get the interface between Classical and Enrichment basis. It takes as the classical basis as input. The main functionalities of the class are: |
CEnrichmentFunctionManagerAtomCenteredNumerical | A class which provides access to spherical atom-centered enrichment functions, with the radial part given numerically on a grid. This specifically assumes the dimensionality of the problem to be 3. Thus, an enrichment function \(
N^{\boldsymbol{\textbf{R}}}(\boldsymbol{\textbf{r}})\), centered on a point \(\boldsymbol{\textbf{R}}\) can be written as |
CEnrichmentIdAttribute | |
CEnrichmentIdsPartition | Class to get the gost and locally owned enrichment ids from the renumbered atom ids in Atom Partition i.e. memory layout should be 'locally owned enrichment ids which would be contiguous' -> 'ghost enrichment ids' The class gives us the vector of cell enrichment Ids, locallyowned enrichment ids range, ghost enrichment ids |
CEnrichmentManager | Base class which provides access to the enrichment functions |
CFEBasisDataStorage | An abstract class to store and access data for a given basis, such as the basis function values on a quadrature grid, the overlap matrix of the basis, etc |
CFEBasisDofHandler | |
CFEBasisManager | An abstract class to encapsulate the partitioning of a finite element basis across multiple processors |
CFEBasisOperations | |
CFECellBase | An abstract class for a finite element cell (can be of any dimension) This is created primarily to be a wrapper around deal.ii cells, so as to avoid the cascading of template parameters |
CFECellDealii | |
CFECellWiseDataOperations | |
CField | |
CGenerateMesh | |
CGenerateMeshDefaults | |
CL2ProjectionDefaults | |
CL2ProjectionLinearSolverFunction | A derived class of linearAlgebra::LinearSolverFunction to encapsulate the L2 Projecton partial differential equation (PDE) discretized in a finite element (FE) basis |
CLinearCellMappingDealii | |
COrthoEFEOverlapInverseOpContextGLL | |
COrthoEFEOverlapOperatorContext | A derived class of linearAlgebra::OperatorContext to encapsulate the action of a discrete operator on vectors, matrices, etc. for enriched basis |
CParentToChildCellsManagerBase | |
CParentToChildCellsManagerDealii | |
CPristineEFEOverlapOperatorContext | A derived class of linearAlgebra::OperatorContext to encapsulate the action of a discrete operator on vectors, matrices, etc. for enriched basis |
CTriangulationBase | An abstract class for the triangulation class. The derived class specialises this class to dealii and otehr specialisations if required |
CTriangulationCellBase | An abstract class for an geometric cell. This is done to prevent the template (as required by deal.ii objects) to propagate all across the code, |
CTriangulationCellDealii | An interface to deal.ii geometric cell |
CTriangulationDealiiParallel | |
CTriangulationDealiiSerial | |
►Nelectrostatics | |
CLaplaceOperatorContextFE | A derived class of linearAlgebra::OperatorContext to encapsulate the action of a discrete operator on vectors, matrices, etc |
CPoissonLinearSolverFunctionFE | A derived class of linearAlgebra::LinearSolverFunction to encapsulate the Poisson partial differential equation (PDE) discretized in a finite element (FE) basis. The Possion PDE is given as: \(\nabla^2 v(\textbf{r}) = -4 \pi \rho(\textbf{r})$\f
with the boundary condition on
\)@_fakenlv(\textbf{r})|_{\partial \Omega}=g(\textbf{r})$\f ( \(\\partial Omega$\f denoting the boundary of a domain \)\Omega$\f). Here \(v$\f has the physical notion of a potential (e.g.,
Hartree potential, nuclear potential, etc.) arising due to a charge
distributin \)\rho$\f |
►Nksdft | |
CConstants | |
CDensityCalculator | |
CElectrostaticFE | A derived class of linearAlgebra::OperatorContext to encapsulate the action of a discrete operator on vectors, matrices, etc |
CElectrostaticLocalFE | |
CEnergy | |
CExchangeCorrelationFE | |
CFractionalOccupancyFunction | |
CHamiltonian | |
CKineticFE | |
CKohnShamDFT | |
CKohnShamEigenSolver | |
CKohnShamOperatorContextFE | A derived class of linearAlgebra::OperatorContext to encapsulate the action of a discrete Kohn-Sham operator on vectors |
CKSDFTDefaults | |
CLibxcDefaults | |
CLinearEigenSolverDefaults | |
CMixingScheme | This class performs the anderson mixing in a variable agnostic way This class takes can take different input variables as input in a std::vector format and computes the mixing coefficients These coefficients can then be used to compute the new variable at the start of the SCF |
CNewtonRaphsonSolverDefaults | |
CPoissonProblemDefaults | |
►NlinearAlgebra | |
►NblasLapack | |
►NblasLapackKernelsInternal | |
CScalarProduct | |
CScalarProduct< T1, T2, ScalarOp::Conj, ScalarOp::Conj > | |
CScalarProduct< T1, T2, ScalarOp::Conj, ScalarOp::Identity > | |
CScalarProduct< T1, T2, ScalarOp::Identity, ScalarOp::Conj > | |
CBlasQueueTypedef | |
CBlasQueueTypedef< dftefe::utils::MemorySpace::DEVICE > | |
CBlasQueueTypedef< dftefe::utils::MemorySpace::HOST > | |
CBlasQueueTypedef< dftefe::utils::MemorySpace::HOST_PINNED > | |
CKernelsOneValueType | |
CKernelsTwoValueTypes | Namespace class for BlasLapack kernels not present in blaspp |
CLapackQueueTypedef | |
CLapackQueueTypedef< dftefe::utils::MemorySpace::DEVICE > | |
CLapackQueueTypedef< dftefe::utils::MemorySpace::HOST > | |
CLapackQueueTypedef< dftefe::utils::MemorySpace::HOST_PINNED > | |
►NLanczosExtremeEigenSolverInternal | |
Cgenerate | |
Cgenerate< std::complex< double > > | |
Cgenerate< std::complex< float > > | |
►NOperatorContextFE | |
COperatorContext< ValueTypeOperator, ValueTypeOperand, memorySpace > | Abstract class to encapsulate the action of a discrete operator on vectors, matrices, etc. in a basis |
CChebyshevFilteredEigenSolver | A derived class of OperatorContext to encapsulate the action of a discrete operator on vectors, matrices, etc |
CEigenSolverError | |
CEigenSolverErrorMsg | |
CIdentityOperatorContext | Abstract class to encapsulate the action of a discrete operator on vectors, matrices, etc |
CJacobiPreconditioner | A class to encapsulate the Jacobi preconditioner in a linear or non-linear solve |
CLanczosExtremeEigenSolver | A derived class of OperatorContext to encapsulate the action of a discrete operator on vectors, matrices, etc |
CLapackError | |
CLapackErrorMsg | A class to map Error to a message |
CLinAlgOpContext | |
CLinearAlgebraProfiler | |
CLinearSolverDefaults | |
CLinearSolverError | |
CLinearSolverErrorMsg | A class to map Error to a message |
CLinearSolverImpl | Abstract class that implements the LinearSolver algorithm. For example, the derived classes of it, such as CGLinearSolver, GMRESLinearSolver implement the Conjugate-Gradient (CG) and Generalized Minimum Residual (GMRES) Krylov subspace based approches, respectively, to solve a linear system of equations |
CMultiPassLowdinDefaults | |
CMultiVector | An class template to encapsulate a MultiVector. A MultiVector is a collection of \(N\) vectors belonging to the same finite-dimensional vector space, where usual notion of vector size denotes the dimension of the vector space. Note that this in the mathematical sense and not in the sense of an multi-dimensional array.The MultiVector is stored contiguously with the vector index being the fastest index, or in other words a matrix of size \(M \times N\) in row major format with \(M \) denoting the dimension of the vector space (size of individual vector) |
CNewtonRaphsonError | |
CNewtonRaphsonErrorMsg | |
CNewtonRaphsonSolver | A class that implements the Newton-Raphson solver to find root of a function |
CNewtonRaphsonSolverFunction | |
COperatorContext | Abstract class to encapsulate the action of a discrete operator on vectors, matrices, etc |
COrthonormalizationError | |
COrthonormalizationErrorMsg | |
COrthonormalizationFunctions | |
CPreconditioner | Abstract class to encapsulate a preconditioner |
CPreconditionerJacobi | Class to encapsulate the Jacobi preconditioner |
CPreconditionerNone | Class to encapsulate the NONE preconditioner. Just takes in a vector and returns it |
CPrintControlDefaults | |
CRayleighRitzEigenSolver | A derived class of OperatorContext to encapsulate the action of a discrete operator on vectors, matrices, etc |
CVector | A class that encapsulates a vector. This is a vector in the mathematical sense and not in the sense of an array or STL container. This class handles both serial and distributed vector in a unfied way. There are different constructors provided for the serial and distributed case |
CVectorAttributes | |
►Nquadrature | |
CQuadraturePointAttributes | Class to store the attributes of a quad point, such as the cell Id it belongs, the quadPointId within the cell it belongs to, and the quadrature rule (defined by quadratureRuleId) it is part of |
CQuadratureRule | |
CQuadratureRuleAdaptive | |
CQuadratureRuleAdaptiveDefaults | |
CQuadratureRuleAttributes | |
CQuadratureRuleAttributesDefaults | |
CQuadratureRuleContainer | |
CQuadratureRuleGauss | |
CQuadratureRuleGaussIterated | |
CQuadratureRuleGaussSubdividedDefaults | |
CQuadratureRuleGLL | |
CQuadratureValuesContainer | |
►Nutils | |
►Nmpi | |
CMPICommunicatorP2P | |
CMPIErrorCodeHandler | |
CMPIPatternP2P | A class template to store the communication pattern (i.e., which entries/nodes to receive from which processor and which entries/nodes to send to which processor) |
CMPIRequestersBase | |
CMPIRequestersNBX | |
CTypes | A simple struct to return the MPIDatatype based on the user provided primitive data type (e.g., int, double, char, etc) |
CTypes< char > | |
CTypes< double > | |
CTypes< float > | |
CTypes< int > | |
CTypes< long > | |
CTypes< long double > | |
CTypes< long long int > | |
CTypes< short > | |
CTypes< signed char > | |
CTypes< std::complex< double > > | |
CTypes< std::complex< float > > | |
CTypes< unsigned char > | |
CTypes< unsigned int > | |
CTypes< unsigned long > | |
CTypes< unsigned long long int > | |
CTypes< unsigned short > | |
CTypes< wchar_t > | |
►NsplineInternal | |
Cband_matrix | |
CConditionalOStream | Provides an interface to print based on whether a certain condition is met or not. Typical use cases include: (a) printing based on different verbosity level (b) printing only from a certain processor while running in parallel |
CDiscontiguousDataOperations | |
CExpModX | |
CFunction | |
CLogModX | |
CMemoryManager | |
CMemoryManager< ValueType, MemorySpace::HOST > | |
CMemoryStorage | |
CMemoryTransfer | |
CMemoryTransfer< MemorySpace::HOST, MemorySpace::HOST > | |
CMPICommunicatorP2PKernels | |
COptimizedIndexSet | |
CPeriodicTableManager | Provides a map from Atomic Number to Atomic Symbol |
CPointChargePotentialFunction | |
CPointImpl | |
CRandNumGen | |
CRandNumGen< double > | |
CRandNumGen< float > | |
CRandNumGen< int > | |
CRandNumGen< long > | |
CRandNumGen< long double > | |
CRandNumGen< long long > | |
CRandNumGen< short > | |
CRandNumGen< std::complex< double > > | |
CRandNumGen< std::complex< float > > | |
CRandNumGen< std::complex< long double > > | |
CRandNumGen< unsigned int > | |
CRandNumGen< unsigned long > | |
CRandNumGen< unsigned long long > | |
CRandNumGen< unsigned short > | |
CScalarZeroFunctionReal | |
CSmearChargeDensityFunction | |
CSmearChargePotentialFunction | |
CSpline | |
CTypes | |
CTypes< char > | |
CTypes< double > | |
CTypes< float > | |
CTypes< int > | |
CTypes< long int > | |
CTypes< short int > | |
CTypes< std::complex< double > > | |
CTypes< std::complex< float > > | |
CTypes< std::string > | |
CTypes< unsigned int > | |
CTypes< unsigned long int > | |
CTypes< unsigned short int > | |
CRealType | |
CRealType< double > | |
CRealType< float > | |
CRealType< int > | |
CRealType< std::complex< double > > | |
CRealType< std::complex< float > > | |