▼NDune | For backward compatibility – Do not use this! |
►NLegendreStuff | |
CLegendreSize | |
CLegendreSize< 0, 1 > | |
CLegendreSize< k, 1 > | |
CLegendreSize< 0, n > | |
CLegendrePolynomials1d | The 1d Legendre Polynomials (k=0,1 are specialized below) |
CLegendrePolynomials1d< D, R, 0 > | |
CLegendrePolynomials1d< D, R, 1 > | |
CDGLegendreLocalBasis | Lagrange shape functions of order k on the reference cube |
CDGLegendreLocalInterpolation | Determine degrees of freedom |
CDGLegendreLocalCoefficients | Layout map for Q1 elements |
►NPB | |
CMultiIndex | |
CPkSize | |
CBasisTraits | |
►CBasisTraits< BasisType::Pk > | |
COrder | |
CSize | |
►CBasisTraits< BasisType::Qk > | |
COrder | |
CSize | |
CMonomialIntegrator | Integrate monomials over the reference element |
CMonomialIntegrator< ComputationFieldType, Dune::GeometryType::cube, d > | Integrate monomials over the cube in any d |
CMonomialIntegrator< ComputationFieldType, Dune::GeometryType::simplex, 1 > | Integrate monomials over the unit interval considered as a simplex |
CMonomialIntegrator< ComputationFieldType, Dune::GeometryType::simplex, 2 > | Integrate monomials over the triangle |
CMonomialIntegrator< ComputationFieldType, Dune::GeometryType::simplex, 3 > | Integrate monomials over the tetrahedron |
CMonomialEvaluate | Compute |
CMonomialEvaluate< F, 0 > | |
COrthonormalPolynomialBasis | Integrate monomials over the reference element |
►NPDELab | |
►NBackend | |
Cunattached_container | Tag for requesting a vector or matrix container without a pre-attached underlying object |
Cattached_container | Tag for requesting a vector or matrix container with a pre-attached underlying object |
►NCG2DGHelper | |
CWrappedLocalShapeFunctionTraits | |
CWrappedLocalShapeFunction | |
CComputeCG2DGVisitor | |
►NExperimental | |
►CGridFunctionSpace | A pdelab grid function space implemented by a dune-functions function space basis |
CConstraintsContainer | Extract type for storing constraints |
►CLeafOrdering | The actual Ordering object of the grid function space |
CTraits | |
COrdering | Root of the ordering tree |
►CTraits | Export Traits class |
►CFEM | Rudimentary internal implementation of a FiniteElementMap |
CTraits | |
►CLeafLFSMixin | |
CTraits | |
►CLocalFunctionSpace | |
CTraits | |
CDuneFunctionsCacheTag | |
►Nfem | |
CPkLocalFiniteElementMapBase | |
CPkLocalFiniteElementMapBase< GV, D, R, k, 1 > | |
CPkLocalFiniteElementMapBase< GV, D, R, k, 2 > | |
CPkLocalFiniteElementMapBase< GV, D, R, k, 3 > | |
►Ngfs | Implementation namespace for GridFunctionSpace-specific features |
CGridFunctionSubSpace | Non-nesting implementation of GridFunctionSubSpace |
CDefaultSubSpaceFeatures | Default features used by every subspace implementation |
CLeafSubSpaceFeatures | Additional features used by leaf subspaces |
CSubSpaceFeatureProvider | |
CGridFunctionSubSpaceOutputParameters | Mixin class which inherits from GridFunctionOutputParameters iff T inherits from GridFunctionOutputParameters |
►Nimpl | |
CisBlockSORPreconditionerLocalOperator | |
CisBlockSORPreconditionerLocalOperator< BlockSORPreconditionerLocalOperator< JacobianLOP, BlockOffDiagonalLOP, GridFunctionSpace > > | |
CisFastDGGridOperator | |
CisFastDGGridOperator< FastDGGridOperator< GFSU, GFSV, LOP, MB, DF, RF, JF, CU, CV > > | |
CResult | |
CLocalPointJacobiPreconditioner | |
CBlockDiagonalOperator | Create ISTL operator that applies a local block diagonal |
CWeightedPointDiagonalAccumulationView | |
CBlockDiagonalAccumulationViewWrapper | |
CZeroViewWrapper | |
CZeroViewWrapper< AliasedVectorView< Container, LocalFunctionSpaceCache > > | |
CScalarL2 | |
CPointDiagonalAccumulationViewWrapper | |
►Ninterleaved_ordering | |
CBase | Interface for merging index spaces |
►NISTL | |
►Nimpl | |
C_extract_iterators | |
C_extract_iterators< T, true, tags::block_vector, Iterators... > | |
C_extract_iterators< T, false, tags::block_vector, Iterators... > | |
C_extract_iterators< T, true, tags::field_vector, Iterators... > | |
C_extract_iterators< T, false, tags::field_vector, Iterators... > | |
C_extract_iterators< T, true, tags::dynamic_vector, Iterators... > | |
C_extract_iterators< T, false, tags::dynamic_vector, Iterators... > | |
Cextract_iterators | |
Cextract_iterators< const V > | |
Cvector_iterator_base | |
Cvector_iterator_base< const V > | |
►Ntags | |
Cblock_vector | Tag describing a BlockVector |
Cdynamic_vector | Tag describing a DynamicVector |
Cfield_vector | Tag describing an arbitrary FieldVector |
Cfield_vector_1 | Tag describing a field vector with block size 1 |
Cfield_vector_n | Tag describing a field vector with block size > 1 |
Cbcrs_matrix | Tag describing a BCRSMatrix |
Cdynamic_matrix | Tag describing a DynamicMatrix |
Cfield_matrix | Tag describing an arbitrary FieldMatrix |
Cfield_matrix_1_any | Tag describing a FieldMatrix with row block size 1 and arbitrary column block size |
Cfield_matrix_n_any | Tag describing a FieldMatrix with row block size > 1 and arbitrary column block size |
Cfield_matrix_any_1 | Tag describing a FieldMatrix with arbitrary row block size and column block size 1 |
Cfield_matrix_any_m | Tag describing a FieldMatrix with arbitrary row block size and column block size > 1 |
Cfield_matrix_1_1 | Tag describing a FieldMatrix with row block size 1 and column block size 1 |
Cfield_matrix_n_1 | Tag describing a FieldMatrix with row block size > 1 and column block size 1 |
Cfield_matrix_1_m | Tag describing a FieldMatrix with row block size 1 and column block size > 1 |
Cfield_matrix_n_m | Tag describing a FieldMatrix with row block size > 1 and column block size > 1 |
Ccontainer | Extracts the container tag from T |
CBCRSMatrix | |
►CBCRSMatrixBackend | Backend using (possibly nested) ISTL BCRSMatrices |
CMatrixHelper | |
►CBCRSPattern | Pattern builder for generic BCRS-like sparse matrices |
Citerator | Iterator over all column indices for a given row, unique but in arbitrary order |
CNestedPattern | Pattern builder for nested hierarchies of generic BCRS-like sparse matrices |
►CBlockMatrixDiagonal | |
CAddMatrixElementVectorDataHandle | |
CMatrixElementVector | |
Cvector_backend_tag | Tag describing an ISTL BlockVector backend |
►CVectorBackend | |
CTraits | |
CSimpleVectorBackend | |
CParallelHelper | |
CCommSelector | |
CCommSelector< s, false > | |
CPatternStatistics | Statistics about the pattern of a BCRSMatrix |
Cnesting_depth | TMP for figuring out the depth up to which ISTL containers are nested |
CBlockVector | |
Cvector_iterator | |
►Nlexicographic_ordering | |
CBase | |
►Nlop | Namespace with decorator classes that influence assembler behavior |
CDiagonalJacobian | Decorator base class for local operators that have a diagonal jacobian matrix |
►NNavierStokesDGImp | |
CVariableBoundarySlipSwitch | Compile-time switch for the boundary slip factor |
CVariableBoundarySlipSwitch< PRM, typename std::enable_if< PRM::enable_variable_slip >::type > | |
►Nordering | |
►Nchunked | |
Cgfs_to_chunked | |
►Npermuted | |
Cgfs_to_permuted | |
CChunked | |
Cdecorated_ordering_tag | |
Cgfs_to_decorator_descriptor | |
Cleaf_gfs_to_decorated | |
►Crecursive_power_gfs_to_decorated | |
Cresult | |
Cnonrecursive_power_gfs_to_decorated | |
Cpower_gfs_to_decorated | |
►Crecursive_composite_gfs_to_decorated | |
Cresult | |
Cnonrecursive_composite_gfs_to_decorated | |
Ccomposite_gfs_to_decorated | |
CPermuted | Permute the ordering created from the passed-in tag based on a simple lookup table |
►NSimple | |
►CVectorBackend | |
CTraits | |
►CMatrixBackend | |
CMatrixHelper | |
CPattern | |
►CSparseMatrixBackend | |
CMatrixHelper | |
CMatrixContainer | |
CSparseMatrixPattern | |
CSparseMatrixData | |
CSparseMatrixContainer | |
CVectorContainer | |
►Nvtk | |
CDGFTreeLeafFunction | |
CDGFTreeVectorFunction | |
COutputCollector | |
CDGFTreeCommonData | Helper class for common data of a DGFTree |
CDefaultFunctionNameGenerator | |
►Cadd_solution_to_vtk_writer_visitor | |
CVisitChild | |
CDefaultPredicate | |
CLeafOffsetCache | |
CL2Projection | |
Cbackup_visitor | |
►Creplay_visitor | |
►Ccoarse_function | |
CTraits | Traits class containing decayed types |
CGridAdaptor | Class for automatic adaptation of the grid |
CTimeAdaptationStrategy | |
CConstAliasedMatrixView | |
CAliasedMatrixView | |
CConstAliasedVectorView | |
CAliasedVectorView | |
CConstUncachedMatrixView | |
CUncachedMatrixView | |
CConstUncachedVectorView | |
CUncachedVectorView | |
CCG2DGProlongation | |
CLocalOperatorOvlpRegion | Wrapper for LocalOperators restricting their action to areas overlapping with other subdomains Any entity not covered by multiple subdomains will be ignored by not evaluating the underlying LocalOperator. This wrapper can be used to generate the overlap matrix needed for the GenEO coarse space |
CMultiCommGatherScatter | Gather/scatter communication that passes a single function from each subdomain to all its neighbors |
CMultiCommDataHandle | Gather/scatter communication that passes a single function from each subdomain to all its neighbors. The functions are received individually without applying any further operations |
CSubdomainBasis | This represents a general per-subdomain basis |
CSubdomainProjectedCoarseSpace | This constructs a coarse space from a per-subdomain local basis |
CISTLBackend_SEQ_MatrixFree_Base | Sequential matrix-free solver backend |
CISTLBackend_SEQ_BCGS_SOR | |
CBlockSORPreconditionerLocalOperator | Turn a matrix-free Jacobi-type local preconditioner to a SOR one |
CGridOperatorPreconditioner | Turn a grid operator that represents a preconditioner into an ISTL preconditioner |
CBlockSolverOptions | Options for IterativeBlockJacobiPreconditionerLocalOperator |
CIterativeBlockJacobiPreconditionerLocalOperator | Local operator that can be used to create a fully matrix-free Jacobi preconditioner |
CStatisticsResult | Statistics result structure |
CSolverStatistics | Class for collecting statistics over several invocations |
CNonoverlappingOperator | Operator for the non-overlapping parallel case |
CNonoverlappingScalarProduct | |
CNonoverlappingRichardson | |
CNonoverlappingJacobi | Parallel non-overlapping Jacobi preconditioner |
CISTLBackend_NOVLP_CG_NOPREC | Nonoverlapping parallel CG solver without preconditioner |
CISTLBackend_NOVLP_CG_Jacobi | Nonoverlapping parallel CG solver with Jacobi preconditioner |
CISTLBackend_NOVLP_BCGS_NOPREC | Nonoverlapping parallel BiCGStab solver without preconditioner |
CISTLBackend_NOVLP_BCGS_Jacobi | Nonoverlapping parallel BiCGStab solver with Jacobi preconditioner |
CISTLBackend_NOVLP_ExplicitDiagonal | Solver to be used for explicit time-steppers with (block-)diagonal mass matrix |
CISTLBackend_NOVLP_BASE_PREC | Utility base class for preconditioned novlp backends |
CISTLBackend_NOVLP_BCGS_SSORk | Nonoverlapping parallel BiCGSTAB solver preconditioned by block SSOR |
CISTLBackend_NOVLP_CG_SSORk | Nonoverlapping parallel CG solver preconditioned by block SSOR |
CISTLBackend_AMG_NOVLP | |
CISTLBackend_NOVLP_CG_AMG_SSOR | Nonoverlapping parallel CG solver preconditioned with AMG smoothed by SSOR |
CISTLBackend_NOVLP_BCGS_AMG_SSOR | Nonoverlapping parallel BiCGStab solver preconditioned with AMG smoothed by SSOR |
CISTLBackend_NOVLP_LS_AMG_SSOR | Nonoverlapping parallel LoopSolver preconditioned with AMG smoothed by SSOR |
CLocalGlobalMapDataHandle | |
CMatrixExchangeDataHandle | |
COvlpDGAMGPrec | |
CISTLBackend_OVLP_AMG_4_DG | |
COverlappingOperator | |
COverlappingScalarProduct | |
COverlappingWrappedPreconditioner | |
CUMFPackSubdomainSolver | |
COVLPScalarProductImplementation | |
COVLPScalarProduct | |
CISTLBackend_OVLP_Base | |
CISTLBackend_OVLP_ILU0_Base | |
CISTLBackend_OVLP_ILUn_Base | |
CISTLBackend_OVLP_BCGS_SSORk | Overlapping parallel BiCGStab solver with SSOR preconditioner |
CISTLBackend_OVLP_BCGS_ILU0 | Overlapping parallel BiCGStab solver with ILU0 preconditioner |
CISTLBackend_OVLP_BCGS_ILUn | Overlapping parallel BiCGStab solver with ILU0 preconditioner |
CISTLBackend_OVLP_CG_SSORk | Overlapping parallel CGS solver with SSOR preconditioner |
CISTLBackend_OVLP_GMRES_ILU0 | Overlapping parallel restarted GMRes solver with ILU0 preconditioner |
CISTLBackend_OVLP_SuperLU_Base | |
CISTLBackend_OVLP_UMFPack_Base | |
CISTLBackend_OVLP_BCGS_SuperLU | Overlapping parallel BiCGStab solver with SuperLU preconditioner |
CISTLBackend_OVLP_CG_SuperLU | Overlapping parallel CG solver with SuperLU preconditioner |
CISTLBackend_OVLP_CG_UMFPack | Overlapping parallel CG solver with UMFPack preconditioner |
CISTLBackend_OVLP_ExplicitDiagonal | Solver to be used for explicit time-steppers with (block-)diagonal mass matrix |
CISTLBackend_AMG | |
CISTLBackend_CG_AMG_SSOR | Overlapping parallel conjugate gradient solver preconditioned with AMG smoothed by SSOR |
CISTLBackend_BCGS_AMG_SSOR | Overlapping parallel BiCGStab solver preconditioned with AMG smoothed by SSOR |
CISTLBackend_BCGS_AMG_ILU0 | Overlapping parallel BiCGStab solver preconditioned with AMG smoothed by ILU0 |
CSeqDGAMGPrec | |
CISTLBackend_SEQ_AMG_4_DG | |
COnTheFlyOperator | |
CISTLBackend_SEQ_Richardson | |
CISTLBackend_SEQ_MatrixFree_Richardson | |
CISTLBackend_SEQ_Base | |
CISTLBackend_SEQ_ILU0 | |
CISTLBackend_SEQ_ILUn | |
CISTLBackend_SEQ_LOOP_Jac | Backend for sequential loop solver with Jacobi preconditioner |
CISTLBackend_SEQ_BCGS_Richardson | Backend for sequential BiCGSTAB solver with Richardson precondition (equivalent to no preconditioner for Richards with parameter=1.0) |
CISTLBackend_SEQ_BCGS_Jac | Backend for sequential BiCGSTAB solver with Jacobi preconditioner |
CISTLBackend_SEQ_BCGS_SSOR | Backend for sequential BiCGSTAB solver with SSOR preconditioner |
CISTLBackend_SEQ_BCGS_ILU0 | Backend for sequential BiCGSTAB solver with ILU0 preconditioner |
CISTLBackend_SEQ_CG_ILU0 | Backend for sequential conjugate gradient solver with ILU0 preconditioner |
CISTLBackend_SEQ_BCGS_ILUn | Sequential BiCGStab solver with ILU0 preconditioner |
CISTLBackend_SEQ_CG_ILUn | Sequential congute gradient solver with ILU0 preconditioner |
CISTLBackend_SEQ_CG_SSOR | Backend for sequential conjugate gradient solver with SSOR preconditioner |
CISTLBackend_SEQ_MINRES_SSOR | Backend using a MINRes solver preconditioned by SSOR |
CISTLBackend_SEQ_CG_Jac | Backend for conjugate gradient solver with Jacobi preconditioner |
CISTLBackend_SEQ_SuperLU | Solver backend using SuperLU as a direct solver |
CISTLBackend_SEQ_UMFPack | Solver backend using UMFPack as a direct solver |
CISTLBackend_SEQ_ExplicitDiagonal | Solver to be used for explicit time-steppers with (block-)diagonal mass matrix |
CISTLAMGStatistics | Class providing some statistics of the AMG solver |
CISTLBackend_SEQ_AMG | |
CISTLBackend_SEQ_CG_AMG_SSOR | Sequential conjugate gradient solver preconditioned with AMG smoothed by SSOR |
CISTLBackend_SEQ_BCGS_AMG_SSOR | Sequential BiCGStab solver preconditioned with AMG smoothed by SSOR |
CISTLBackend_SEQ_BCGS_AMG_SOR | Sequential BiCGSTAB solver preconditioned with AMG smoothed by SOR |
CISTLBackend_SEQ_LS_AMG_SSOR | Sequential Loop solver preconditioned with AMG smoothed by SSOR |
CISTLBackend_SEQ_LS_AMG_SOR | Sequential Loop solver preconditioned with AMG smoothed by SOR |
CISTLBackend_SEQ_GMRES_ILU0 | Linear solver backend for Restarted GMRes preconditioned with ILU(0) |
CISTLBackend_SEQ_MatrixFree_BCGS_Richardson | |
CSequentialNorm | |
CLinearSolverResult | |
CLinearResultStorage | |
CLinearSolverHasIsMatrixFree | |
CLinearSolverHasIsMatrixFree< LS, std::void_t< decltype(std::declval< LS >().isMatrixFree)> > | SFINAE check if a linear solver backend has a isMatrixFree method |
CStructuredGrid | |
CStructuredGrid< YaspGrid< dim > > | |
CUnstructuredGrid | |
CCGFEMBase | |
CCGFEMBase< GV, C, R, degree, dim, Dune::GeometryType::simplex > | |
CCGFEMBase< GV, C, R, degree, dim, Dune::GeometryType::cube > | |
CCGCONBase | |
CCGCONBase< Grid, 1, Dune::GeometryType::simplex, MeshType::nonconforming, SolverCategory::sequential, BCType, GV > | |
CCGCONBase< Grid, 1, Dune::GeometryType::cube, MeshType::nonconforming, SolverCategory::sequential, BCType, GV > | |
CCGCONBase< Grid, degree, gt, MeshType::conforming, SolverCategory::sequential, BCType, GV > | |
CCGCONBase< Grid, degree, gt, MeshType::conforming, SolverCategory::overlapping, BCType, GV > | |
CCGCONBase< Grid, degree, gt, MeshType::conforming, SolverCategory::nonoverlapping, BCType, GV > | |
CCGSpace | |
CCGSpace< T, N, degree, BCType, gt, mt, SolverCategory::nonoverlapping, VBET > | |
CDGCONBase | |
CDGCONBase< SolverCategory::sequential > | |
CDGCONBase< SolverCategory::nonoverlapping > | |
CDGCONBase< SolverCategory::overlapping > | |
CDGPkSpace | |
CDGQkOPBSpace | |
CDGQkSpace | |
CDGQkGLSpace | |
CDGLegendreSpace | |
CP0Space | |
CUserFunction | |
CGalerkinGlobalAssembler | |
CGalerkinGlobalAssemblerNewBackend | |
CGlobalAssembler | |
COneStepGlobalAssembler | |
CISTLSolverBackend_CG_AMG_SSOR | |
CISTLSolverBackend_CG_AMG_SSOR< FS, ASS, SolverCategory::nonoverlapping > | |
CISTLSolverBackend_CG_AMG_SSOR< FS, ASS, SolverCategory::overlapping > | |
CISTLSolverBackend_CG_SSOR | |
CISTLSolverBackend_CG_SSOR< FS, ASS, SolverCategory::nonoverlapping > | |
CISTLSolverBackend_CG_SSOR< FS, ASS, SolverCategory::overlapping > | |
CISTLSolverBackend_IterativeDefault | |
CISTLSolverBackend_IterativeDefault< FS, ASS, SolverCategory::nonoverlapping > | |
CISTLSolverBackend_IterativeDefault< FS, ASS, SolverCategory::overlapping > | |
CISTLSolverBackend_ExplicitDiagonal | |
CISTLSolverBackend_ExplicitDiagonal< FS, ASS, SolverCategory::overlapping > | |
CISTLSolverBackend_ExplicitDiagonal< FS, ASS, SolverCategory::nonoverlapping > | |
CCppClockWallTimeSource | |
CMPIWallTimeSource | |
CTiming | |
CBenchmarkEntry | |
CBenchmarkHelper | |
►CBorderIndexIdCache | |
CEntityIndex | |
CWallTimeClock | |
CProcessTimeClock | |
CTimeSpec | Struct to store temporal values |
CClockError | Exception thrown by clock functions |
CCrossProduct | Calculate cross product |
CCrossProduct< 3, 3 > | |
CCrossProduct< 2, 2 > | |
CCrossProduct< 2, 1 > | |
CCrossProduct< 1, 2 > | |
►CDOFIndex | A multi-index representing a degree of freedom in a GridFunctionSpace |
CView | |
CElementMapper | Class providing a consecutive index for codim 0 entities of a GridView |
CException | Base class for all PDELab exceptions |
CGridFunctionSpaceError | GridFunctionSpace-related error |
CUninitializedGridFunctionSpaceError | Called a GridFunctionSpace method that requires initialization of the space |
CGridFunctionSpaceHierarchyError | |
COrderingError | Ordering-related error |
COrderingStructureError | Error related to the logical structure of an Ordering |
CPermutedOrderingSizeError | A PermutedOrdering got a permutation vector of the wrong size |
CChunkedBlockOrderingSizeError | The block size of a ChunkedBlockOrdering does not divide the block count of the underlying ordering |
CFunctionTraits | |
CFunctionInterface | Function that maps x in DomainType to y in RangeType |
CInstationaryFunctionDefaults | Default class for additional methods in instationary functions |
CPowerCompositeGridFunctionTraits | GV The type of the grid view the function lives on |
►CGridFunctionOutputParameters | Mixin base class for specifying output hints to I/O routines like VTK |
COutput | Namespace for output-related data types and enums |
CGridFunctionTraits | Traits class holding the function signature, same as in local function |
CGridFunctionInterface | GridFunction maps x in DomainType to y in RangeType |
CBoundaryGridFunctionTraits | Traits class holding function signature, same as in local function |
CBoundaryGridFunctionInterface | A BoundaryGridFunction allows evaluation on boundary intersections |
CGridFunctionTag | |
CGridFunctionBase | Leaf of a function tree |
CBoundaryGridFunctionBase | Leaf of a function tree |
CPowerCompositeSetTimeVisitor | Visitor for Power- and CompositeGridFunctions calling the setTime() method on the leafs of the corresponding function trees |
CPowerGridFunctionTag | |
CPowerGridFunction | Product of identical functions |
CCompositeGridFunctionTag | |
CCompositeGridFunction | Composite functions |
CGridFunctionBaseAdapter | Turn an ordinary GridFunction into a GridFunctionTree leaf |
CAnalyticGridFunctionTraits | Function signature for analytic functions on a grid |
CAnalyticGridFunctionBase | Analytic grid function |
CNormalFluxGridFunctionAdapter | |
CPiolaBackwardAdapter | |
CFunctionToGridFunctionAdapter | Make a GridFunction from a Function |
CGridFunctionToFunctionAdapter | Make a Function from a GridFunction |
CGlobalFunctionToLocalFunctionAdapter | Make a Function in local coordinates from a Function in global coordinates |
CGridFunctionToLocalFunctionAdapter | Make a LocalFunction from a GridFunction using local coordinates |
CSelectComponentAdapter | Function maps x in DomainType to y in RangeType |
CBoundaryGridFunctionSelectComponentAdapter | Takes a BoundaryGridFunction and acts as a single component |
CGridFunctionProbe | Evaluate a GridFunction at a certain global coordinate |
CPointwiseGridFunctionAdapter | |
CPointwiseAdapterEngine | Interface of a pointwise adapter engine |
CPointwiseScaleAdapterEngine | Scale the output value |
CPointwiseSumAdapterEngine | Sum all terms |
CElementGeometry | Wrap element |
CIntersectionGeometry | Wrap intersection |
►CGlobalDOFIndex | |
CView | |
CFilenameHelper | |
CJacobianToCurl | Extract the curl of a function from the jacobian of that function |
CJacobianToCurl< Jacobian, 1, 2 > | Extract the curl of a 1D-valued function in 2D from the jacobian of that function |
CJacobianToCurl< Jacobian, 2, 2 > | Extract the curl of a 2D-valued function in 2D from the jacobian of that function |
CJacobianToCurl< Jacobian, 3, 3 > | Extract the curl of a 3D-valued function in 3D from the jacobian of that function |
CLogtagFormatterBase | Virtual base class for logger formatters |
CGeneralLogtagFormatter | A log tag formatter that wraps a unary formatting function or functor |
CWithLogtag | Temporarily use a different log tag format function |
CLocalTag | Insert standard boilerplate into log messages |
►CMultiIndex | A class for representing multi-indices |
CView | |
CPartitionViewEntitySet | Partition view (or entity set) of a grid view |
CPartitionViewEntitySetIndexSet | |
►CPartitionViewEntitySetTraits | |
►CCodim | |
CPartition | |
CPartitionViewEntitySetIndexSetBase | |
CPartitionViewEntitySetIndexSet< GV, Partitions::All > | |
CPolymorphicBufferWrapper | Wrapper for message buffers of grid DataHandles that allows for sending different types of data |
CQuadratureRuleWrapper | Wrapper for Dune::QuadratureRule with value semantics |
CSimpleDOFIndex | |
CSimpleContainerIndex | |
CBasicTypeFromDimensionAndTopologyId | Utility TMP for determining the BasicType of a geometry from its dimension and topology id |
CVTKGridFunctionAdapter | Wrap a GridFunction so it can be used with the VTKWriter from dune-grid |
CVTKFiniteElementMapAdapter | |
CCompositeConstraintsOperator | |
CCompositeConstraintsParameters | |
CPowerConstraintsParameters | |
CDirichletConstraintsParameters | |
CNoDirichletConstraintsParameters | |
CFluxConstraintsParameters | |
CNoFluxConstraintsParameters | |
CFluxFromDirichletConstraintsAdapter | |
CDirichletFromFluxConstraintsAdapter | |
CNoConstraintsParameters | |
►CConstraintsTransformation | Class holding transformation for constrained spaces |
CLocalTransformation | |
CEmptyTransformation | |
CConformingDirichletConstraints | Dirichlet Constraints construction |
COverlappingConformingDirichletConstraints | Extend conforming constraints class by processor boundary |
CNonoverlappingConformingDirichletConstraints | Extend conforming constraints class by processor boundary |
►CHangingNodesConstraintsAssemblers | |
CCubeGridQ1Assembler | |
CSimplexGridP1Assembler | |
CHangingNodesDirichletConstraints | Hanging Node constraints construction |
►CHangingNodeManager | |
CNodeState | |
CInteriorNodeConstraints | Constraints all DOFs associated with interior vertices This allows to implement surface FEM using standard first order FEM |
CNoConstraints | |
CP0ParallelConstraints | Parallel P0 constraints for overlapping grids |
CP0ParallelGhostConstraints | Parallel P0 constraints for nonoverlapping grids with ghosts |
CRT0Constraints | Neumann Constraints construction, as needed for RT0 |
CLocalBasisCache | Store values of basis functions and gradients in a cache |
CBDM1Cube2DLocalFiniteElementMap | |
CBDM1Simplex2DLocalFiniteElementMap | |
CBrezziDouglasMariniLocalFiniteElementMap | |
CEdgeS0_5FiniteElementMap | Global-valued finite element map for EdgeS0_5 elements |
CFiniteElementMapError | General FiniteElementMap exception |
CVariableElementSize | FiniteElementMap exception concerning the computation of the FiniteElementMap size |
CInvalidGeometryType | FiniteElementMap exception raised when trying to obtain a finite element for an unsupported GeometryType |
CFiniteElementMapTraits | Collect types exported by a finite element map |
CLocalFiniteElementMapTraits | Collect types exported by a finite element map |
CLocalFiniteElementMapInterface | Interface for a finite element map |
CSimpleLocalFiniteElementMap | Simple implementation where all entities have the same finite element |
CEdgeS0LocalFiniteElementMap | Implementation for finite elements requiring oriented edges |
CRTLocalFiniteElementMap | |
CGeometryFiniteElementMap | Generic finite element map for global finite elements created with a geometry |
CGeometryVertexOrderFiniteElementMap | Generic finite element map for global finite elements created with a geometry and a vertex ordering |
CMimeticLocalFiniteElementMap | |
CMonomLocalFiniteElementMap | |
CMonomFiniteElementMap | Global-valued finite element map for Monom elements |
COPBLocalFiniteElementMap | |
CP0LocalFiniteElementMap | |
CPk1dLocalFiniteElementMap | FiniteElementMap for the Pk basis in 1d |
CPkLocalFiniteElementMap | |
CPkQkLocalFiniteElementMap | FiniteElementMap which provides PkQkLocalFiniteElement instances, depending on the geometry type |
CPowerFiniteElementMap | FiniteElementMap for PowerFiniteElements |
CQkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::lagrange > | Qk discontinuous Galerkin FiniteElementMap based on Lagrange polynomials |
CQkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::legendre > | Qk discontinuous Galerkin FiniteElementMap based on Legendre polynomials |
CQkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::lobatto > | Qk discontinuous Galerkin FiniteElementMap based on Legendre polynomials at Gauss-Lobatto points |
CQkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::l2orthonormal > | Qk discontinuous Galerkin FiniteElementMap based on an L2 orthonormal polynomials |
CQkLocalFiniteElementMap | |
CRannacherTurekLocalFiniteElementMap | |
CRaviartThomasLocalFiniteElementMap | Raviart-Thomas elements of order k |
CRT0Cube2DLocalFiniteElementMap | |
CRT0Cube3DLocalFiniteElementMap | |
CRT0Simplex2DLocalFiniteElementMap | |
CRT1Cube2DLocalFiniteElementMap | |
CRT1Cube3DLocalFiniteElementMap | |
CRT1Simplex2DLocalFiniteElementMap | |
CRT2Cube2DLocalFiniteElementMap | |
CVariableMonomLocalFiniteElementMap | |
CVariableOPBLocalFiniteElementMap | |
CVariableQkDGLocalFiniteElementMap | |
CSetTimeWrapper | |
CGlobalCallableToGridFunctionAdapter | Adapter for callables f(x) expecting a global coordinate x |
CCallableAdapterGetDim | |
CCallableAdapterGetDim< FieldVector< T, n > > | |
CCallableAdapterGetRangeFieldType | |
CCallableAdapterGetRangeFieldType< FieldVector< T, n > > | |
CLocalCallableToGridFunctionAdapter | Adapter for callables f(e,x) expecting an entity e and a global coordinate x |
CGlobalCallableToInstationaryGridFunctionAdapter | Return a PDELab GridFunction (with setTime method) defined by a parameter class and a callable f(x) global coordinates x |
CLocalCallableToInstationaryGridFunctionAdapter | Return a PDELab GridFunction (with setTime method) defined by a parameter class and a callable f(e,x) that expects an entity e and local coordinates x |
CGlobalCallableToBoundaryConditionAdapter | Adapter for boundary cond from a callable taking global coordinates |
CLocalCallableToBoundaryConditionAdapter | Adapter for boundary cond from a callable taking an entity and local coordinates |
CConstGridFunction | GridFunction returning a constant value everywhere |
CConstBoundaryGridFunction | BoundaryGridFunction returning a constant value everywhere |
CDiscreteGridViewFunctionTraits | |
CDiscreteGridViewFunctionTraits< Signature, E, D, B, 0 > | |
►CDiscreteGridViewFunction | A discrete function defined over a GridFunctionSpace |
CLocalFunction | |
CDivisionGridFunctionAdapter | Substract two GridFunctions |
CInverseGridFunctionAdapter | Take inverse of a GridFunction |
CPowerLocalFunction | |
CCompositeLocalFunction | |
CGridFunctionToLocalViewTransformation | |
CMemberFunctionToGridFunctionAdaptor | GridFunction implemented by a member function of some class |
CTwoArgsMemberFunctionToGridFunctionAdaptor | GridFunction implemented by a member function of some class |
CTwoArgsMemberFunctionToBoundaryGridFunctionAdaptor | BoundaryGridFunction implemented by a member function of some class |
CMinusGridFunctionAdapter | Substract two GridFunctions |
CProductGridFunctionAdapter | Product of two GridFunctions |
CProductGridFunctionAdapter< GF1, GF2, typename std::enable_if< GF1::Traits::dimRange==1 &&GF2::Traits::dimRange !=1 >::type > | Product of two GridFunctions |
CProductGridFunctionAdapter< GF1, GF2, typename std::enable_if< GF1::Traits::dimRange !=1 &&GF2::Traits::dimRange==1 >::type > | Product of two GridFunctions |
CScalarScaledGridFunctionAdapter | Scale a GridFunction by a constant |
CSelectComponentGridFunctionAdapter | Select certain component(s) of a gridfunction |
CSqrGridFunctionAdapter | Take square of a GridFunction |
CSqrtGridFunctionAdapter | Take sqrt of a GridFunction |
CDifferentiableFunctionBaseTag | |
CDifferentiableFunctionLocalViewBaseTag | |
CDifferentiableFunctionTag | |
CDifferentiableFunctionLocalViewTag | |
CPowerDifferentiableFunctionTag | |
CPowerDifferentiableFunctionLocalViewTag | |
CCompositeDifferentiableFunctionTag | |
CCompositeDifferentiableFunctionLocalViewTag | |
►CCompositeGridFunctionSpace | Base class for tuples of grid function spaces base class that holds implementation of the methods this is the default version with lexicographic ordering |
CConstraintsContainer | Extract type for storing constraints |
CDataHandleProvider | |
►CLFSIndexCacheBase< LFS, C, Experimental::DuneFunctionsCacheTag, false > | |
CConstraintsEntry | |
►CLFSIndexCacheBase< LFS, EmptyTransformation, Experimental::DuneFunctionsCacheTag, false > | |
CConstraintsEntry | |
CLocalFunctionSpace< Experimental::GridFunctionSpace< DFBasis, V, CE >, TAG > | |
CLocalFunctionSpace< Experimental::GridFunctionSpace< DFBasis, V, CE >, AnySpaceTag > | |
CEntityIndexCache | |
CDOFDataCommunicationDescriptor | Communication descriptor for sending one item of type E per DOF |
CEntityDataCommunicationDescriptor | Communication descriptor for sending count items of type E per entity with attached DOFs |
CGFSDataHandle | Implement a data handle with a grid function space |
CDataGatherScatter | |
CDataEntityGatherScatter | |
CDataContainerIndexGatherScatter | |
CAddGatherScatter | |
CAddDataHandle | |
CAddClearGatherScatter | |
CAddClearDataHandle | |
CCopyGatherScatter | |
CCopyDataHandle | |
CMinGatherScatter | |
CMinDataHandle | |
CMaxGatherScatter | |
CMaxDataHandle | |
CGhostGatherScatter | GatherScatter functor for marking ghost DOFs |
CGhostDataHandle | Data handle for marking ghost DOFs |
CDisjointPartitioningGatherScatter | GatherScatter functor for creating a disjoint DOF partitioning |
CDisjointPartitioningDataHandle | GatherScatter data handle for creating a disjoint DOF partitioning |
CSharedDOFGatherScatter | GatherScatter functor for marking shared DOFs |
CSharedDOFDataHandle | Data handle for marking shared DOFs |
CGFSNeighborDataHandle | Data handle for collecting set of neighboring MPI ranks |
CDifferenceAdapter | Adapter returning f1(x)-f2(x) for two given grid functions |
CDifferenceSquaredAdapter | Adapter returning ||f1(x)-f2(x)||^2 for two given grid functions |
CGridFunctionSpaceTraits | Collect types exported by a leaf grid function space |
►CGridFunctionSpace | A grid function space |
CConstraintsContainer | Extract type for storing constraints |
CGridFunctionSpaceBase | |
CDiscreteGridFunction | Convert a grid function space and a coefficient vector into a grid function |
CDiscreteGridFunctionCurl | Convert a grid function space and a coefficient vector into a grid function of the curl |
CDiscreteGridFunctionCurlTraits | Helper class to calculate the Traits of DiscreteGridFunctionCurl |
CDiscreteGridFunctionCurlTraits< GV, RangeFieldType, 1 > | Helper class to calculate the Traits of DiscreteGridFunctionCurl (1D) |
CDiscreteGridFunctionCurlTraits< GV, RangeFieldType, 2 > | Helper class to calculate the Traits of DiscreteGridFunctionCurl (2D) |
CDiscreteGridFunctionCurlTraits< GV, RangeFieldType, 3 > | Helper class to calculate the Traits of DiscreteGridFunctionCurl (3D) |
CDiscreteGridFunctionGlobalCurl | Convert a single component function space with experimental global finite elements into a grid function representing the curl |
CDiscreteGridFunctionGradient | Convert a single component function space with a grid function representing the gradient |
CDiscreteGridFunctionPiola | DiscreteGridFunction with Piola transformation |
CVectorDiscreteGridFunction | DiscreteGridFunction for vector-valued functions |
CVectorDiscreteGridFunctionGradient | Equivalent of DiscreteGridFunctionGradient for vector-valued functions |
CSingleDerivativeComputationHelper | Helper class to compute a single derivative of scalar basis functions |
CSingleDerivativeComputationHelper< Dune::FieldMatrix< RF, size, size >, RF, size > | Template specialization for Dune::FieldMatrix |
CSingleDerivativeComputationHelper< Dune::DiagonalMatrix< RF, size >, RF, size > | Template specialization for Dune::DiagonalMatrix |
CVectorDiscreteGridFunctionDiv | Compute divergence of vector-valued functions |
CVectorDiscreteGridFunctionCurl | Compute curl of vector-valued functions |
CVectorDiscreteGridFunctionCurl< T, X, 3 > | Compute curl of vector-valued functions (3D) |
CVectorDiscreteGridFunctionCurl< T, X, 2 > | Compute curl of vector-valued functions (2D) |
►CDOFIndexViewIterator | |
Cproxy | |
Cextract_lfs_leaf_size_visitor | |
Cmap_dof_indices_to_container_indices | |
►CLFSIndexCacheBase | |
CConstraintsEntry | |
►CLFSIndexCacheBase< LFS, EmptyTransformation, CacheTag, fast > | |
CConstraintsEntry | |
►CLFSIndexCacheBase< LFS, C, SimpleLFSCacheTag, fast > | |
CConstraintsEntry | |
►CLFSIndexCacheBase< LFS, EmptyTransformation, SimpleLFSCacheTag, fast > | |
CConstraintsEntry | |
CLFSIndexCache | |
CLocalFunctionSpaceBaseTraits | Traits mapping global function space information to local function space |
CLocalFunctionSpaceBaseNode | |
CGridViewLocalFunctionSpaceBaseTraits | Traits for local function space on a gridview |
CGridViewLocalFunctionSpaceBaseNode | |
CPowerCompositeLocalFunctionSpaceTraits | Traits for multi component local function space |
CPowerLocalFunctionSpaceNode | |
►Cpower_gfs_to_lfs_template | |
Cresult | |
CCompositeLocalFunctionSpaceNode | |
►Ccomposite_gfs_to_lfs_template | |
Cresult | |
CLeafLocalFunctionSpaceTraits | Traits for single component local function space |
CLeafLocalFunctionSpaceNode | Single component local function space |
CLocalFunctionSpace | Create a local function space from a global function space |
CLocalFunctionSpace< GFS, AnySpaceTag > | |
CAnySpaceTag | |
CTrialSpaceTag | |
CTestSpaceTag | |
CWeightedVectorAccumulationView | An accumulate-only view on a local vector that automatically takes into account an accumulation weight |
CLocalVector | A container for storing data associated with the degrees of freedom of a LocalFunctionSpace |
CPowerCompositeGridFunctionSpaceTraits | Trait class for the multi component grid function spaces |
CPowerCompositeGridFunctionSpaceBase | Mixin class providing common functionality of PowerGridFunctionSpace and CompositeGridFunctionSpace |
►CPowerGridFunctionSpace | Base class for tuples of grid function spaces product of identical grid function spaces base class that holds implementation of the methods |
CConstraintsContainer | Extract type for storing constraints |
CFunctionSpaceTag | |
CGridFunctionSpaceTag | |
CPowerGridFunctionSpaceTag | |
CVectorGridFunctionSpaceTag | |
CCompositeGridFunctionSpaceTag | |
CLeafGridFunctionSpaceTag | |
CGridFunctionSubSpaceTag | |
CCompositeGridFunctionSpaceBaseTag | Tag for the intermediate base class of the CompositeGridFunctionSpace |
CEntityBlockedOrderingTag | Indicate blocking of the unknowns by grid entity |
CLexicographicOrderingTag | Indicate lexicographic ordering of the unknowns of non-leaf grid function spaces |
CInterleavedOrderingTag | Indicate interleaved ordering of the unknowns of non-leaf grid function spaces according to a given blocking pattern |
CNoConstOrderingSize | Mixin indicating whether a leaf GridFunctionSpace should never assume a const ordering size |
CPartitionSelector | Helper for building the bitmask describing the grid partitions contained in a GFS |
CEmptyParams | |
CLeafOrderingTag | Tag indicating a standard ordering for a leaf GridfunctionSpace |
CSingleCodimMapper | |
CPowerLocalFunctionSpaceTag | Tag denoting a PowerLocalFunctionSpace |
CCompositeLocalFunctionSpaceTag | Tag denoting a CompositeLocalFunctionSpace |
CLeafLocalFunctionSpaceTag | Tag denoting a LeafLocalFunctionSpace |
CHierarchicContainerAllocationTag | |
CFlatContainerAllocationTag | |
CDefaultLFSCacheTag | |
CSimpleLFSCacheTag | |
C_build_dof_index_type | |
C_build_dof_index_type< GFS, SingleCodimMapper > | |
Cbuild_dof_index_type | |
►CVectorGridFunctionSpace | Tensorproduct space representing a vector valued function space |
CConstraintsContainer | Extract type for storing constraints |
CAssemblerInterface | The global assembler which performs the traversing of the integration parts |
CLocalAssemblerEngine | The local assembler engine which handles the integration parts as provided by the global assemblers |
►CLocalAssemblerInterface | The local assembler which provides the engines that drive the global assembler |
CLocalJacobianAssemblerEngine | |
CLocalPatternAssemblerEngine | |
CLocalResidualAssemblerEngine | |
CLocalResidualJacobianAssemblerEngine | |
CGridOperatorInterface | The grid operator represents an operator mapping which corresponds to the (possibly nonlinear) algebraic problem resulting from the discretization of a PDE |
CLocalAssemblerTraits | |
CSparsityLink | Entry in sparsity pattern |
CLocalSparsityPattern | Layout description for a sparse linear operator |
CLocalAssemblerBase | Base class for local assembler |
►CNonOverlappingBorderDOFExchanger | Helper class for adding up matrix entries on border |
CCommunicationCache | |
CEntryAccumulator | A DataHandle class to exchange matrix entries |
CPatternExtender | A DataHandle class to exchange matrix sparsity patterns |
CNoDataBorderDOFExchanger | |
COverlappingBorderDOFExchanger | |
►CDiagonalLocalMatrix | A dense matrix for storing data associated with the degrees of freedom of a pair of LocalFunctionSpaces |
Citerator | |
CGridOperatorTraits | Traits class for the grid operator |
►CLocalAssemblerEngineBase | Base class for LocalAssemblerEngine implementations to avoid boilerplate code |
CTraits | |
CWeightedMatrixAccumulationView | An accumulate-only view on a local matrix that automatically takes into account an accumulation weight |
►CLocalMatrix | A dense matrix for storing data associated with the degrees of freedom of a pair of LocalFunctionSpaces |
Citerator | |
CDefaultAssembler | The assembler for standard DUNE grid |
CDefaultLocalJacobianApplyAssemblerEngine | The local assembler engine for DUNE grids which assembles the local application of the Jacobian |
CDefaultLocalJacobianAssemblerEngine | The local assembler engine for DUNE grids which assembles the jacobian matrix |
CDefaultLocalAssembler | The local assembler for DUNE grids |
CDefaultLocalPatternAssemblerEngine | The local assembler engine for DUNE grids which creates the matrix pattern |
CDefaultLocalResidualAssemblerEngine | The local assembler engine for DUNE grids which assembles the residual vector |
CFastDGAssembler | The fast DG assembler for standard DUNE grid |
CFastDGLocalJacobianApplyAssemblerEngine | The fast DG local assembler engine for DUNE grids which assembles the local application of the Jacobian |
CFastDGLocalJacobianAssemblerEngine | The fast DG local assembler engine for DUNE grids which assembles the jacobian matrix |
CFastDGLocalAssembler | The local assembler for DUNE grids |
CFastDGLocalPatternAssemblerEngine | The fast DG local assembler engine for DUNE grids which creates the matrix pattern |
CFastDGLocalResidualAssemblerEngine | The fast DG local assembler engine for DUNE grids which assembles the residual vector |
►CFastDGGridOperator | |
CMatrixContainer | |
CSetupGridOperator | |
►CGridOperator | Standard grid operator implementation |
CMatrixContainer | |
CSetupGridOperator | |
COneStepLocalAssemblerEngineBase | The local assembler engine for UDG sub triangulations which assembles the residual vector |
COneStepLocalJacobianApplyAssemblerEngine | The local assembler engine for one-step methods which applies the jacobian without explicitly assembling it |
COneStepLocalJacobianAssemblerEngine | The local assembler engine for one step methods which assembles the residual vector |
COneStepExplicitLocalJacobianResidualAssemblerEngine | The local assembler engine for DUNE grids which assembles the residual vector |
COneStepLocalAssembler | The local assembler for one step methods |
COneStepLocalPatternAssemblerEngine | The local assembler engine for OneStep sub triangulations which creates the matrix pattern |
COneStepLocalPreStageAssemblerEngine | The local assembler engine for one step methods which assembles the constant part of the residual vector |
COneStepLocalResidualAssemblerEngine | The local assembler engine for one step methods which assembles the residual vector |
►COneStepGridOperator | |
CMatrixContainer | |
CTimeControllerInterface | Controller interface for adaptive time stepping |
CSimpleTimeController | Default time controller; just returns given dt |
CCFLTimeController | Limit time step to maximum dt * CFL number |
CExplicitOneStepMethod | Do one step of an explicit time-stepping scheme |
COneStepMethodPartialResult | |
COneStepMethodResult | |
COneStepMethod | Do one step of a time-stepping scheme |
CTimeSteppingParameterInterface | Base parameter class for time stepping scheme parameters |
COneStepThetaParameter | Parameters to turn the OneStepMethod into an one step theta method |
CExplicitEulerParameter | Parameters to turn the ExplicitOneStepMethod into an explicit Euler method |
CImplicitEulerParameter | Parameters to turn the OneStepMethod into an implicit Euler method |
CHeunParameter | Parameters to turn the ExplicitOneStepMethod into a Heun scheme |
CShu3Parameter | Parameters to turn the ExplicitOneStepMethod into a third order strong stability preserving (SSP) scheme |
CRK4Parameter | Parameters to turn the ExplicitOneStepMethod into a classical fourth order Runge-Kutta method |
CAlexander2Parameter | Parameters to turn the OneStepMethod into an Alexander scheme |
CFractionalStepParameter | Parameters to turn the OneStepMethod into a fractional step theta scheme |
CAlexander3Parameter | Parameters to turn the OneStepMethod into an Alexander3 scheme |
CBlockDiagonalLocalOperatorFullCoupling | Block diagonal extension of scalar local operator |
CBlockDiagonalLocalOperatorWrapper | A local operator that accumulates the block diagonal |
CBlockOffDiagonalLocalOperatorWrapper | A local operator that accumulates the off block diagonal |
CCombinedOperator | A local operator to take combine different local operators |
CConvectionDiffusionCCFV | |
CConvectionDiffusionCCFVTemporalOperator | |
CConvectionDiffusionDGMethod | |
CConvectionDiffusionDGWeights | |
CConvectionDiffusionDG | |
CConvectionDiffusionFEM | |
CConvectionDiffusionFEMResidualEstimator | |
CConvectionDiffusionTemporalResidualEstimator1 | |
CCD_RHS_LocalAdapter | |
CConvectionDiffusionTemporalResidualEstimator | |
CConvectionDiffusionParameterTraits | Traits class for convection diffusion parameters |
CConvectionDiffusionBoundaryConditions | Class to define the boundary condition types |
CConvectionDiffusionModelProblem | Parameter class for solving the linear convection-diffusion equation |
CConvectionDiffusionBoundaryConditionAdapter | |
CConvectionDiffusionVelocityExtensionAdapter | |
CConvectionDiffusionDirichletExtensionAdapter | |
CConvectionDiffusionExactGradientAdapter | |
CDefaultInteriorPenalty | Default implementation of the interior penalty factor |
COverPenalizedInteriorPenalty | Implementation of overpenalized interior penalty |
CDGNavierStokes | A local operator for solving the Navier-Stokes equations using a DG discretization |
CDGNavierStokesParameters | Parameter class for local operator DGNavierStokes |
CVectorBasisInterfaceSwitch | |
CVectorBasisInterfaceSwitch< Basis, typename std::enable_if< Dune::AlwaysTrue< std::integral_constant< std::size_t, Basis::Traits::dimDomain > >::value >::type > | Switch for uniform treatment of local and global basis classes |
CDGNavierStokesVelVecFEM | A local operator for solving the Navier-Stokes equations using a DG discretization and a vector-valued finite element map for the velocity grid function space |
CDiffusionMixed | |
CElectrodynamic_T | Construct matrix T for the Electrodynamic operator |
CElectrodynamic_S | Contruct matrix S for the Electrodynamic operator |
CConvectionDiffusionDG_ErrorIndicator | Local operator for residual-based error estimation |
CLocalOperatorDefaultFlags | Default flags for all local operators |
CInstationaryLocalOperatorDefaultMethods | Default class for additional methods in instationary local operators |
CLocalOperatorInterface | Class to document the stationary local operator interface |
CL2 | |
CL2VolumeFunctional | A local operator that tests a function against a test function space defined on the entire grid |
CLinearAcousticsEigenvectors | |
CLinearAcousticsEigenvectors< 1 > | Provide matrix which contains rowwise the eigenvectors of linear acoustics problem |
CLinearAcousticsEigenvectors< 2 > | Provide matrix which contains rowwise the eigenvectors of linear acoustics problem |
CLinearAcousticsEigenvectors< 3 > | Provide matrix which contains rowwise the eigenvectors of linear acoustics problem |
CDGLinearAcousticsSpatialOperator | |
CDGLinearAcousticsTemporalOperator | |
CLinearAcousticsParameterTraits | Traits class for linear acoustics parameters |
CLinearAcousticsInitialValueAdapter | |
CLinearAcousticsModelProblem | |
CLinearElasticity | |
CLinearElasticityParameterTraits | Traits class for linear elasticity parameters |
CLinearElasticityParameterInterface | Base class for linear elasticity parameter class |
CLinearElasticityDirichletExtensionAdapter | |
CMaxwellEigenvectors | |
CMaxwellEigenvectors< 3 > | Provide matrix which contains column-wise the eigenvectors of maxwell problem |
CDGMaxwellSpatialOperator | Spatial local operator for discontinuous Galerkin method for Maxwells Equations |
CDGMaxwellTemporalOperator | |
CMaxwellParameterTraits | Traits class for convection diffusion parameters |
CMaxwellInitialValueAdapter | |
CMaxwellModelProblem | |
CNavierStokesMass | A local operator for the mass term corresponding to the instationary part in the Navier-Stokes equations |
CNavierStokesVelVecMass | A local operator for the mass term corresponding to the instationary part in the Navier-Stokes equations using a vector-valued Finite Element map for the velocity grid function space |
CNonLinearConvectionDiffusionParameterTraits | Traits class for two phase parameter class |
CNonLinearConvectionDiffusionParameterInterface | Base class for parameter class |
CBCTypeParam_CD | |
CDirichletBoundaryCondition_CD | |
CNonLinearConvectionDiffusionFEM | |
CNumericalJacobianVolume | Implement jacobian_volume() based on alpha_volume() |
CNumericalJacobianVolumePostSkeleton | |
CNumericalJacobianSkeleton | Implement jacobian_skeleton() based on alpha_skeleton() |
CNumericalJacobianBoundary | Implement jacobian_boundary() based on alpha_boundary() |
CNumericalJacobianApplyVolume | Implements linear and nonlinear versions of jacobian_apply_volume() based on alpha_volume() |
CNumericalJacobianApplyVolumePostSkeleton | |
CNumericalJacobianApplySkeleton | Implements linear and nonlinear versions of jacobian_apply_skeleton() based on alpha_skeleton() |
CNumericalJacobianApplyBoundary | Implements linear and nonlinear versions of jacobian_apply_boundary() based on alpha_boundary() |
CNumericalNonlinearJacobianApplyVolume | Implements nonlinear version of jacobian_apply_volume() based on alpha_volume() |
CNumericalNonlinearJacobianApplyVolumePostSkeleton | |
CNumericalNonlinearJacobianApplySkeleton | Implements nonlinear version of jacobian_apply_skeleton() based on alpha_skeleton() |
CNumericalNonlinearJacobianApplyBoundary | Implements nonlinear version of jacobian_apply_boundary() based on alpha_boundary() |
CJacobianBasedAlphaVolume | Implement alpha_volume() based on jacobian_volume() |
CJacobianBasedAlphaSkeleton | Implement alpha_skeleton() based on jacobian_skeleton() |
CJacobianBasedAlphaBoundary | Implement alpha_boundary() based on jacobian_boundary() |
CFullVolumePattern | Sparsity pattern generator |
CFullSkeletonPattern | Sparsity pattern generator |
CFullBoundaryPattern | Sparsity pattern generator |
CPointDiagonalLocalOperatorWrapper | A local operator that accumulates the point diagonal |
CScaledLocalOperator | A local operator that scales the result of another local operator |
CStokesBoundaryCondition | |
CNavierStokesParameterTraits | |
CNavierStokesDefaultParameters | |
CStokesVelocityDirichletConstraints | |
CStokesPressureDirichletConstraints | |
CNavierStokesVelocityFunctionAdapter | |
CInstationarySumLocalOperator | A local operator to take the sum of other local operators |
CInstationarySumLocalOperator< std::tuple< Args... > > | Deprecated specialization of |
CTaylorHoodNavierStokes | A local operator for the Navier-Stokes equations |
CTwoPhaseParameterTraits | Traits class for two phase parameter class |
CTwoPhaseFullTensorParameterTraits | |
CTwoPhaseParameterInterface | Base class for parameter class |
CTwoPhaseTwoPointFluxOperator | |
CTwoPhaseOnePointTemporalOperator | |
CV_l | Provide velocity field for liquid phase |
CV_g | Provide velocity field for gas phase |
►CWeightedSumLocalOperator | A local operator to take the weighted sum of other local operators |
CWeightedContainer | |
CWeightedSumLocalOperator< K, std::tuple< Args... > > | Deprecated specialization of |
CZeroLocalOperator | Do-nothing local operator |
CChunkedBlockOrdering | Ordering that permutes top-level ContainerIndex entries |
Cpower_gfs_to_local_ordering_descriptor< GFS, Transformation, ordering::Chunked< U > > | |
Ccomposite_gfs_to_local_ordering_descriptor< GFS, Transformation, ordering::Chunked< U > > | |
CDirectLeafLocalOrdering | |
CPowerEntityBlockedLocalOrdering | |
►Cpower_gfs_to_local_ordering_descriptor< GFS, Transformation, EntityBlockedOrderingTag > | |
Cresult | |
Cpower_gfs_to_entityblocked_ordering_descriptor | |
CCompositeEntityBlockedLocalOrdering | |
►Ccomposite_gfs_to_local_ordering_descriptor< GFS, Transformation, EntityBlockedOrderingTag > | |
Cresult | |
Ccomposite_gfs_to_entityblocked_ordering_descriptor | |
Ccollect_used_codims | |
Ccollect_a_priori_fixed_size | |
Cupdate_fixed_size | |
Cpre_collect_used_geometry_types | |
Ccollect_used_geometry_types_from_cell_visitor | |
Cpost_collect_used_geometry_types | |
Cextract_per_entity_sizes_from_cell_visitor | |
Cpost_extract_per_entity_sizes | |
CGridViewOrdering | Transforms a local ordering (entity-wise order) into a global ordering |
CPowerInterleavedOrdering | |
►Cpower_gfs_to_interleaved_ordering_descriptor | |
Cresult | |
CCompositeInterleavedOrdering | |
►Ccomposite_gfs_to_interleaved_ordering_descriptor | |
Cresult | |
CLeafGridViewOrdering | Gridview ordering for leaf spaces |
Cdirect_leaf_gfs_to_gridview_ordering_descriptor | |
CLeafLocalOrdering | |
Cleaf_gfs_to_local_ordering_descriptor< GFS, Transformation, LeafOrderingTag< Params > > | |
CLeafOrderingBase | Generic infrastructure for orderings for leaf spaces |
CPowerLexicographicOrdering | |
►Cpower_gfs_to_lexicographic_ordering_descriptor | |
Cresult | |
CCompositeLexicographicOrdering | Interface for merging index spaces |
►Ccomposite_gfs_to_lexicographic_ordering_descriptor | |
Cresult | |
CLocalOrderingBase | Entity-wise orderings |
COrderingBase | |
CPermutedOrdering | Ordering that permutes top-level ContainerIndex entries |
Cpower_gfs_to_local_ordering_descriptor< GFS, Transformation, ordering::Permuted< U > > | |
Ccomposite_gfs_to_local_ordering_descriptor< GFS, Transformation, ordering::Permuted< U > > | |
CSingleCodimLeafOrdering | |
Cleaf_gfs_to_ordering_descriptor< GFS, Transformation, SingleCodimMapper > | |
CSubOrdering | A view on a subtree of a multi-component ordering |
CMergeMode | Index merging algorithm for global orderings |
►CDefaultDOFIndexAccessor | |
CGeometryIndex | |
CSimpleDOFIndexAccessor | |
CSimpleOrderingTraits | |
CSimpleOrderingTraits< SimpleDOFIndex< SizeType_ >, CI, CIOrder > | |
COrderingTraits | |
CLocalOrderingTraits | |
CGridViewOrderingTraits | |
CVirtualOrderingBase | |
Cextract_child_bases | |
CDummyDOFIndexIterator | Dummy iterator type over DOF indices |
CSizeProviderAdapter | Adapter to create a size provider from an ordering |
CLineSearchError | |
CLineSearchInterface | Abstract base class describing the line search interface |
CLineSearchNone | Class for simply updating the solution without line search |
CLineSearchHackbuschReusken | Hackbusch-Reusken line search |
CNewtonMethod | Newton solver for solving non-linear problems |
CTerminateError | |
CTerminateInterface | |
CDefaultTerminate | |
CPDESolverResult | |
CStationaryLinearProblemSolverResult | |
CStationaryLinearProblemSolver | Solve linear problems using a residual formulation |
►NQkStuff | |
CQkSize | |
CQkSize< 0, 1 > | |
CQkSize< k, 1 > | |
CQkSize< 0, n > | |
CEquidistantLagrangePolynomials | Lagrange polynomials of degree k at equidistant points as a class |
CQkLocalBasis | Lagrange shape functions of order k on the reference cube |
CQkDGLocalCoefficients | Layout map for Q1 elements |
CQkLocalInterpolation | |
CQkLocalInterpolation< 0, d, LB > | |
CGaussLobattoLagrangePolynomials | Lagrange polynomials at Gauss-Lobatto points |
CQkGLLocalBasis | Lagrange shape functions of order k on the reference cube |
CQkGLLocalInterpolation | |
CQkGLLocalInterpolation< 0, d, LB > | |
COPBLocalBasis | |
COPBLocalCoefficients | |
COPBLocalInterpolation | |
COPBLocalFiniteElement | |
CPk1dLocalFiniteElement | Define the Pk Lagrange basis functions in 1d on the reference interval |
CQkDGLagrangeLocalFiniteElement | |
CQkDGFiniteElementFactory | Factory for global-valued QkDG elements |
CQkDGLegendreLocalFiniteElement | |
CQkDGLegendreFiniteElementFactory | Factory for global-valued DGLegendre elements |
CQkDGGLLocalFiniteElement | |
CQkDGGLFiniteElementFactory | Factory for global-valued QkDG elements |
CVTKWriter | |
CSubsamplingVTKWriter | |
CVTKSequenceWriter | |
▼Nstd | STL namespace |
Ccommon_type< Dune::FieldVector< T, N >, R2 > | Specialization of common_type for FieldVector and scalar |
Ccommon_type< Dune::FieldVector< T, N >, Dune::FieldVector< R2, N > > | Specialization of common_type for two FieldVectors |
CCoarseSpace | Representation of a coarse space intended for two-level Schwarz preconditioners |
CDarcyVelocityFromHeadCCFV | Provide velocity field for liquid phase |
CDarcyVelocityFromHeadFEM | Provide Darcy velocity as a vector-valued grid function |
CDiagonalPermeabilityAdapter | |
CGenericEllipticProblem | |
CGridTransformation | |
CLOP_spatial_contaminant | |
CLOP_spatial_flow | |
CLOP_time_contaminant | |
CLOP_time_flow | |
COpSplitException | |
CParameters | |
CPermeabilityAdapter | |
CVectorExchange | |
CYaspPartition | |