|
struct | LeafOffsetCache |
|
class | L2Projection |
|
struct | backup_visitor |
|
struct | replay_visitor |
|
class | GridAdaptor |
| Class for automatic adaptation of the grid. More...
|
|
class | TimeAdaptationStrategy |
|
class | ConstAliasedMatrixView |
|
class | AliasedMatrixView |
|
struct | ConstAliasedVectorView |
|
struct | AliasedVectorView |
|
class | ConstUncachedMatrixView |
|
class | UncachedMatrixView |
|
struct | ConstUncachedVectorView |
|
struct | UncachedVectorView |
|
class | CG2DGProlongation |
|
class | LocalOperatorOvlpRegion |
| 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. More...
|
|
class | MultiCommGatherScatter |
| Gather/scatter communication that passes a single function from each subdomain to all its neighbors. More...
|
|
class | MultiCommDataHandle |
| 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. More...
|
|
class | SubdomainBasis |
| This represents a general per-subdomain basis. More...
|
|
class | SubdomainProjectedCoarseSpace |
| This constructs a coarse space from a per-subdomain local basis. More...
|
|
class | NonoverlappingOperator |
| Operator for the non-overlapping parallel case. More...
|
|
class | NonoverlappingScalarProduct |
|
class | NonoverlappingRichardson |
|
class | NonoverlappingJacobi |
| parallel non-overlapping Jacobi preconditioner More...
|
|
class | ISTLBackend_NOVLP_CG_NOPREC |
| Nonoverlapping parallel CG solver without preconditioner. More...
|
|
class | ISTLBackend_NOVLP_CG_Jacobi |
| Nonoverlapping parallel CG solver with Jacobi preconditioner. More...
|
|
class | ISTLBackend_NOVLP_BCGS_NOPREC |
| Nonoverlapping parallel BiCGStab solver without preconditioner. More...
|
|
class | ISTLBackend_NOVLP_BCGS_Jacobi |
| Nonoverlapping parallel BiCGStab solver with Jacobi preconditioner. More...
|
|
class | ISTLBackend_NOVLP_ExplicitDiagonal |
| Solver to be used for explicit time-steppers with (block-)diagonal mass matrix. More...
|
|
class | ISTLBackend_NOVLP_BASE_PREC |
| Utility base class for preconditioned novlp backends. More...
|
|
class | ISTLBackend_NOVLP_BCGS_SSORk |
| Nonoverlapping parallel BiCGSTAB solver preconditioned by block SSOR. More...
|
|
class | ISTLBackend_NOVLP_CG_SSORk |
| Nonoverlapping parallel CG solver preconditioned by block SSOR. More...
|
|
class | ISTLBackend_AMG_NOVLP |
|
class | ISTLBackend_NOVLP_CG_AMG_SSOR |
| Nonoverlapping parallel CG solver preconditioned with AMG smoothed by SSOR. More...
|
|
class | ISTLBackend_NOVLP_BCGS_AMG_SSOR |
| Nonoverlapping parallel BiCGStab solver preconditioned with AMG smoothed by SSOR. More...
|
|
class | ISTLBackend_NOVLP_LS_AMG_SSOR |
| Nonoverlapping parallel LoopSolver preconditioned with AMG smoothed by SSOR. More...
|
|
class | LocalGlobalMapDataHandle |
|
class | MatrixExchangeDataHandle |
|
class | OvlpDGAMGPrec |
|
class | ISTLBackend_OVLP_AMG_4_DG |
|
class | OverlappingOperator |
|
class | OverlappingScalarProduct |
|
class | OverlappingWrappedPreconditioner |
|
class | UMFPackSubdomainSolver |
|
class | OVLPScalarProductImplementation |
|
class | OVLPScalarProduct |
|
class | ISTLBackend_OVLP_Base |
|
class | ISTLBackend_OVLP_ILU0_Base |
|
class | ISTLBackend_OVLP_ILUn_Base |
|
class | ISTLBackend_OVLP_BCGS_SSORk |
| Overlapping parallel BiCGStab solver with SSOR preconditioner. More...
|
|
class | ISTLBackend_OVLP_BCGS_ILU0 |
| Overlapping parallel BiCGStab solver with ILU0 preconditioner. More...
|
|
class | ISTLBackend_OVLP_BCGS_ILUn |
| Overlapping parallel BiCGStab solver with ILU0 preconditioner. More...
|
|
class | ISTLBackend_OVLP_CG_SSORk |
| Overlapping parallel CGS solver with SSOR preconditioner. More...
|
|
class | ISTLBackend_OVLP_GMRES_ILU0 |
| Overlapping parallel restarted GMRes solver with ILU0 preconditioner. More...
|
|
class | ISTLBackend_OVLP_SuperLU_Base |
|
class | ISTLBackend_OVLP_UMFPack_Base |
|
class | ISTLBackend_OVLP_BCGS_SuperLU |
| Overlapping parallel BiCGStab solver with SuperLU preconditioner. More...
|
|
class | ISTLBackend_OVLP_CG_SuperLU |
| Overlapping parallel CG solver with SuperLU preconditioner. More...
|
|
class | ISTLBackend_OVLP_CG_UMFPack |
| Overlapping parallel CG solver with UMFPack preconditioner. More...
|
|
class | ISTLBackend_OVLP_ExplicitDiagonal |
| Solver to be used for explicit time-steppers with (block-)diagonal mass matrix. More...
|
|
class | ISTLBackend_AMG |
|
class | ISTLBackend_CG_AMG_SSOR |
| Overlapping parallel conjugate gradient solver preconditioned with AMG smoothed by SSOR. More...
|
|
class | ISTLBackend_BCGS_AMG_SSOR |
| Overlapping parallel BiCGStab solver preconditioned with AMG smoothed by SSOR. More...
|
|
class | ISTLBackend_BCGS_AMG_ILU0 |
| Overlapping parallel BiCGStab solver preconditioned with AMG smoothed by ILU0. More...
|
|
class | SeqDGAMGPrec |
|
class | ISTLBackend_SEQ_AMG_4_DG |
|
class | OnTheFlyOperator |
|
class | ISTLBackend_SEQ_Richardson |
|
class | ISTLBackend_SEQ_MatrixFree_Richardson |
|
class | ISTLBackend_SEQ_Base |
|
class | ISTLBackend_SEQ_ILU0 |
|
class | ISTLBackend_SEQ_ILUn |
|
class | ISTLBackend_SEQ_LOOP_Jac |
| Backend for sequential loop solver with Jacobi preconditioner. More...
|
|
class | ISTLBackend_SEQ_BCGS_Richardson |
| Backend for sequential BiCGSTAB solver with Richardson precondition (equivalent to no preconditioner for Richards with parameter=1.0). More...
|
|
class | ISTLBackend_SEQ_BCGS_Jac |
| Backend for sequential BiCGSTAB solver with Jacobi preconditioner. More...
|
|
class | ISTLBackend_SEQ_BCGS_SSOR |
| Backend for sequential BiCGSTAB solver with SSOR preconditioner. More...
|
|
class | ISTLBackend_SEQ_BCGS_ILU0 |
| Backend for sequential BiCGSTAB solver with ILU0 preconditioner. More...
|
|
class | ISTLBackend_SEQ_CG_ILU0 |
| Backend for sequential conjugate gradient solver with ILU0 preconditioner. More...
|
|
class | ISTLBackend_SEQ_BCGS_ILUn |
| Sequential BiCGStab solver with ILU0 preconditioner. More...
|
|
class | ISTLBackend_SEQ_CG_ILUn |
| Sequential congute gradient solver with ILU0 preconditioner. More...
|
|
class | ISTLBackend_SEQ_CG_SSOR |
| Backend for sequential conjugate gradient solver with SSOR preconditioner. More...
|
|
class | ISTLBackend_SEQ_MINRES_SSOR |
| Backend using a MINRes solver preconditioned by SSOR. More...
|
|
class | ISTLBackend_SEQ_CG_Jac |
| Backend for conjugate gradient solver with Jacobi preconditioner. More...
|
|
class | ISTLBackend_SEQ_SuperLU |
| Solver backend using SuperLU as a direct solver. More...
|
|
class | ISTLBackend_SEQ_UMFPack |
| Solver backend using UMFPack as a direct solver. More...
|
|
class | ISTLBackend_SEQ_ExplicitDiagonal |
| Solver to be used for explicit time-steppers with (block-)diagonal mass matrix. More...
|
|
struct | ISTLAMGStatistics |
| Class providing some statistics of the AMG solver. More...
|
|
class | ISTLBackend_SEQ_AMG |
|
class | ISTLBackend_SEQ_CG_AMG_SSOR |
| Sequential conjugate gradient solver preconditioned with AMG smoothed by SSOR. More...
|
|
class | ISTLBackend_SEQ_BCGS_AMG_SSOR |
| Sequential BiCGStab solver preconditioned with AMG smoothed by SSOR. More...
|
|
class | ISTLBackend_SEQ_BCGS_AMG_SOR |
| Sequential BiCGSTAB solver preconditioned with AMG smoothed by SOR. More...
|
|
class | ISTLBackend_SEQ_LS_AMG_SSOR |
| Sequential Loop solver preconditioned with AMG smoothed by SSOR. More...
|
|
class | ISTLBackend_SEQ_LS_AMG_SOR |
| Sequential Loop solver preconditioned with AMG smoothed by SOR. More...
|
|
class | ISTLBackend_SEQ_GMRES_ILU0 |
| Linear solver backend for Restarted GMRes preconditioned with ILU(0) More...
|
|
class | ISTLBackend_SEQ_MatrixFree_BCGS_Richardson |
|
struct | SequentialNorm |
|
struct | LinearSolverResult |
|
class | LinearResultStorage |
|
class | StructuredGrid |
|
class | StructuredGrid< YaspGrid< dim > > |
|
class | UnstructuredGrid |
|
class | CGFEMBase |
|
class | CGFEMBase< GV, C, R, degree, dim, Dune::GeometryType::simplex > |
|
class | CGFEMBase< GV, C, R, degree, dim, Dune::GeometryType::cube > |
|
class | CGCONBase |
|
class | CGCONBase< Grid, 1, Dune::GeometryType::simplex, MeshType::nonconforming, SolverCategory::sequential, BCType, GV > |
|
class | CGCONBase< Grid, 1, Dune::GeometryType::cube, MeshType::nonconforming, SolverCategory::sequential, BCType, GV > |
|
class | CGCONBase< Grid, degree, gt, MeshType::conforming, SolverCategory::sequential, BCType, GV > |
|
class | CGCONBase< Grid, degree, gt, MeshType::conforming, SolverCategory::overlapping, BCType, GV > |
|
class | CGCONBase< Grid, degree, gt, MeshType::conforming, SolverCategory::nonoverlapping, BCType, GV > |
|
class | CGSpace |
|
class | CGSpace< T, N, degree, BCType, gt, mt, SolverCategory::nonoverlapping, VBET > |
|
class | DGCONBase |
|
class | DGCONBase< SolverCategory::sequential > |
|
class | DGCONBase< SolverCategory::nonoverlapping > |
|
class | DGCONBase< SolverCategory::overlapping > |
|
class | DGPkSpace |
|
class | DGQkOPBSpace |
|
class | DGQkSpace |
|
class | DGQkGLSpace |
|
class | DGLegendreSpace |
|
class | P0Space |
|
class | UserFunction |
|
class | GalerkinGlobalAssembler |
|
class | GalerkinGlobalAssemblerNewBackend |
|
class | GlobalAssembler |
|
class | OneStepGlobalAssembler |
|
class | ISTLSolverBackend_CG_AMG_SSOR |
|
class | ISTLSolverBackend_CG_AMG_SSOR< FS, ASS, SolverCategory::nonoverlapping > |
|
class | ISTLSolverBackend_CG_AMG_SSOR< FS, ASS, SolverCategory::overlapping > |
|
class | ISTLSolverBackend_CG_SSOR |
|
class | ISTLSolverBackend_CG_SSOR< FS, ASS, SolverCategory::nonoverlapping > |
|
class | ISTLSolverBackend_CG_SSOR< FS, ASS, SolverCategory::overlapping > |
|
class | ISTLSolverBackend_IterativeDefault |
|
class | ISTLSolverBackend_IterativeDefault< FS, ASS, SolverCategory::nonoverlapping > |
|
class | ISTLSolverBackend_IterativeDefault< FS, ASS, SolverCategory::overlapping > |
|
class | ISTLSolverBackend_ExplicitDiagonal |
|
class | ISTLSolverBackend_ExplicitDiagonal< FS, ASS, SolverCategory::overlapping > |
|
class | ISTLSolverBackend_ExplicitDiagonal< FS, ASS, SolverCategory::nonoverlapping > |
|
struct | CppClockWallTimeSource |
|
struct | MPIWallTimeSource |
|
struct | Timing |
|
struct | BenchmarkEntry |
|
struct | BenchmarkHelper |
|
struct | BorderIndexIdCache |
|
struct | WallTimeClock |
|
struct | ProcessTimeClock |
|
struct | TimeSpec |
| struct to store temporal values More...
|
|
struct | ClockError |
| exception thrown by clock functions More...
|
|
class | CrossProduct |
| Calculate cross product. More...
|
|
struct | CrossProduct< 3, 3 > |
|
struct | CrossProduct< 2, 2 > |
|
struct | CrossProduct< 2, 1 > |
|
struct | CrossProduct< 1, 2 > |
|
class | DOFIndex |
| A multi-index representing a degree of freedom in a GridFunctionSpace. More...
|
|
class | ElementMapper |
| Class providing a consecutive index for codim 0 entities of a GridView. More...
|
|
class | Exception |
| Base class for all PDELab exceptions. More...
|
|
class | GridFunctionSpaceError |
| GridFunctionSpace-related error. More...
|
|
class | UninitializedGridFunctionSpaceError |
| Called a GridFunctionSpace method that requires initialization of the space. More...
|
|
class | GridFunctionSpaceHierarchyError |
|
class | OrderingError |
| Ordering-related error. More...
|
|
class | OrderingStructureError |
| Error related to the logical structure of an Ordering. More...
|
|
class | PermutedOrderingSizeError |
| A PermutedOrdering got a permutation vector of the wrong size. More...
|
|
class | ChunkedBlockOrderingSizeError |
| The block size of a ChunkedBlockOrdering does not divide the block count of the underlying ordering. More...
|
|
struct | FunctionTraits |
|
class | FunctionInterface |
| a Function that maps x in DomainType to y in RangeType More...
|
|
class | InstationaryFunctionDefaults |
| Default class for additional methods in instationary functions. More...
|
|
struct | PowerCompositeGridFunctionTraits |
| GV The type of the grid view the function lives on. More...
|
|
class | GridFunctionOutputParameters |
| Mixin base class for specifying output hints to I/O routines like VTK. More...
|
|
struct | GridFunctionTraits |
| traits class holding the function signature, same as in local function More...
|
|
class | GridFunctionInterface |
| a GridFunction maps x in DomainType to y in RangeType More...
|
|
struct | BoundaryGridFunctionTraits |
| traits class holding function signature, same as in local function More...
|
|
class | BoundaryGridFunctionInterface |
| A BoundaryGridFunction allows evaluation on boundary intersections. More...
|
|
struct | GridFunctionTag |
|
class | GridFunctionBase |
| leaf of a function tree More...
|
|
class | BoundaryGridFunctionBase |
| leaf of a function tree More...
|
|
struct | PowerCompositeSetTimeVisitor |
| Visitor for Power- and CompositeGridFunctions calling the setTime() method on the leafs of the corresponding function trees. More...
|
|
struct | PowerGridFunctionTag |
|
class | PowerGridFunction |
| product of identical functions More...
|
|
struct | CompositeGridFunctionTag |
|
class | CompositeGridFunction |
| composite functions More...
|
|
class | GridFunctionBaseAdapter |
| Turn an ordinary GridFunction into a GridFunctionTree leaf. More...
|
|
struct | AnalyticGridFunctionTraits |
| function signature for analytic functions on a grid More...
|
|
class | AnalyticGridFunctionBase |
| an analytic grid function More...
|
|
class | NormalFluxGridFunctionAdapter |
|
class | PiolaBackwardAdapter |
|
class | FunctionToGridFunctionAdapter |
| make a GridFunction from a Function More...
|
|
class | GridFunctionToFunctionAdapter |
| make a Function from a GridFunction More...
|
|
class | GlobalFunctionToLocalFunctionAdapter |
| make a Function in local coordinates from a Function in global coordinates More...
|
|
class | GridFunctionToLocalFunctionAdapter |
| make a LocalFunction from a GridFunction using local coordinates More...
|
|
class | SelectComponentAdapter |
| a Function maps x in DomainType to y in RangeType More...
|
|
class | BoundaryGridFunctionSelectComponentAdapter |
| Takes a BoundaryGridFunction and acts as a single component. More...
|
|
class | GridFunctionProbe |
| Evaluate a GridFunction at a certain global coordinate. More...
|
|
class | PointwiseGridFunctionAdapter |
|
class | PointwiseAdapterEngine |
| Interface of a pointwise adapter engine. More...
|
|
class | PointwiseScaleAdapterEngine |
| Scale the output value. More...
|
|
class | PointwiseSumAdapterEngine |
| Sum all terms. More...
|
|
class | ElementGeometry |
| Wrap element. More...
|
|
class | IntersectionGeometry |
| Wrap intersection. More...
|
|
class | GlobalDOFIndex |
|
class | FilenameHelper |
|
class | JacobianToCurl |
| extract the curl of a function from the jacobian of that function More...
|
|
class | JacobianToCurl< Jacobian, 1, 2 > |
| extract the curl of a 1D-valued function in 2D from the jacobian of that function More...
|
|
class | JacobianToCurl< Jacobian, 2, 2 > |
| extract the curl of a 2D-valued function in 2D from the jacobian of that function More...
|
|
class | JacobianToCurl< Jacobian, 3, 3 > |
| extract the curl of a 3D-valued function in 3D from the jacobian of that function More...
|
|
struct | LogtagFormatterBase |
| virtual base class for logger formatters More...
|
|
class | GeneralLogtagFormatter |
| A log tag formatter that wraps a unary formatting function or functor. More...
|
|
class | WithLogtag |
| temporarily use a different log tag format function More...
|
|
class | LocalTag |
| Insert standard boilerplate into log messages. More...
|
|
class | MultiIndex |
| A class for representing multi-indices. More...
|
|
class | PartitionViewEntitySet |
|
class | PartitionViewEntitySetIndexSet |
|
struct | PartitionViewEntitySetTraits |
|
class | PartitionViewEntitySetIndexSetBase |
|
class | PartitionViewEntitySetIndexSet< GV, Partitions::All > |
|
class | PolymorphicBufferWrapper |
| Wrapper for message buffers of grid DataHandles that allows for sending different types of data. More...
|
|
class | QuadratureRuleWrapper |
| Wrapper for Dune::QuadratureRule with value semantics. More...
|
|
struct | SimpleDOFIndex |
|
struct | SimpleContainerIndex |
|
struct | BasicTypeFromDimensionAndTopologyId |
| Utility TMP for determining the BasicType of a geometry from its dimension and topology id. More...
|
|
class | VTKGridFunctionAdapter |
| wrap a GridFunction so it can be used with the VTKWriter from dune-grid. More...
|
|
class | VTKFiniteElementMapAdapter |
|
struct | CompositeConstraintsOperator |
|
struct | CompositeConstraintsParameters |
|
struct | PowerConstraintsParameters |
|
struct | DirichletConstraintsParameters |
|
struct | NoDirichletConstraintsParameters |
|
struct | FluxConstraintsParameters |
|
struct | NoFluxConstraintsParameters |
|
struct | FluxFromDirichletConstraintsAdapter |
|
struct | DirichletFromFluxConstraintsAdapter |
|
class | NoConstraintsParameters |
|
class | ConstraintsTransformation |
| a class holding transformation for constrained spaces More...
|
|
class | EmptyTransformation |
|
class | ConformingDirichletConstraints |
| Dirichlet Constraints construction. More...
|
|
class | OverlappingConformingDirichletConstraints |
| extend conforming constraints class by processor boundary More...
|
|
class | NonoverlappingConformingDirichletConstraints |
| extend conforming constraints class by processor boundary More...
|
|
class | HangingNodesConstraintsAssemblers |
|
class | HangingNodesDirichletConstraints |
| Hanging Node constraints construction. More...
|
|
class | HangingNodeManager |
|
class | InteriorNodeConstraints |
| constraints all DOFs associated with interior vertices This allows to implement surface FEM using standard first order FEM More...
|
|
class | NoConstraints |
|
class | P0ParallelConstraints |
| Parallel P0 constraints for overlapping grids. More...
|
|
class | P0ParallelGhostConstraints |
| Parallel P0 constraints for nonoverlapping grids with ghosts. More...
|
|
class | RT0Constraints |
| Neumann Constraints construction, as needed for RT0. More...
|
|
class | LocalBasisCache |
| store values of basis functions and gradients in a cache More...
|
|
class | BDM1Cube2DLocalFiniteElementMap |
|
class | BDM1Simplex2DLocalFiniteElementMap |
|
class | BrezziDouglasMariniLocalFiniteElementMap |
|
class | EdgeS0_5FiniteElementMap |
| Global-valued finite element map for EdgeS0_5 elements. More...
|
|
class | FiniteElementMapError |
| general FiniteElementMap exception More...
|
|
class | VariableElementSize |
| FiniteElementMap exception concerning the computation of the FiniteElementMap size. More...
|
|
class | InvalidGeometryType |
| FiniteElementMap exception raised when trying to obtain a finite element for an unsupported GeometryType. More...
|
|
struct | FiniteElementMapTraits |
| collect types exported by a finite element map More...
|
|
struct | LocalFiniteElementMapTraits |
| collect types exported by a finite element map More...
|
|
class | LocalFiniteElementMapInterface |
| interface for a finite element map More...
|
|
class | SimpleLocalFiniteElementMap |
| simple implementation where all entities have the same finite element More...
|
|
class | EdgeS0LocalFiniteElementMap |
| implementation for finite elements requiring oriented edges More...
|
|
class | RTLocalFiniteElementMap |
|
class | GeometryFiniteElementMap |
| Generic finite element map for global finite elements created with a geometry. More...
|
|
class | GeometryVertexOrderFiniteElementMap |
| Generic finite element map for global finite elements created with a geometry and a vertex ordering. More...
|
|
class | MimeticLocalFiniteElementMap |
|
class | MonomLocalFiniteElementMap |
|
class | MonomFiniteElementMap |
| Global-valued finite element map for Monom elements. More...
|
|
class | OPBLocalFiniteElementMap |
|
class | P0LocalFiniteElementMap |
|
class | Pk1dLocalFiniteElementMap |
| FiniteElementMap for the Pk basis in 1d. More...
|
|
class | PkLocalFiniteElementMap |
|
class | PkQkLocalFiniteElementMap |
| FiniteElementMap which provides PkQkLocalFiniteElement instances, depending on the geometry type. More...
|
|
class | PowerFiniteElementMap |
| FiniteElementMap for PowerFiniteElements. More...
|
|
class | QkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::lagrange > |
| Qk discontinuous Galerkin FiniteElementMap based on Lagrange polynomials. More...
|
|
class | QkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::legendre > |
| Qk discontinuous Galerkin FiniteElementMap based on Legendre polynomials. More...
|
|
class | QkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::lobatto > |
| Qk discontinuous Galerkin FiniteElementMap based on Legendre polynomials at Gauss-Lobatto points. More...
|
|
class | QkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::l2orthonormal > |
| Qk discontinuous Galerkin FiniteElementMap based on an L2 orthonormal polynomials. More...
|
|
class | QkLocalFiniteElementMap |
|
class | RannacherTurekLocalFiniteElementMap |
|
class | RaviartThomasLocalFiniteElementMap |
| Raviart-Thomas elements of order k. More...
|
|
class | RT0Cube2DLocalFiniteElementMap |
|
class | RT0Cube3DLocalFiniteElementMap |
|
class | RT0Simplex2DLocalFiniteElementMap |
|
class | RT1Cube2DLocalFiniteElementMap |
|
class | RT1Cube3DLocalFiniteElementMap |
|
class | RT1Simplex2DLocalFiniteElementMap |
|
class | RT2Cube2DLocalFiniteElementMap |
|
class | VariableMonomLocalFiniteElementMap |
|
class | VariableOPBLocalFiniteElementMap |
|
class | VariableQkDGLocalFiniteElementMap |
|
class | SetTimeWrapper |
|
class | GlobalCallableToGridFunctionAdapter |
| Adapter for callables f(x) expecting a global coordinate x. More...
|
|
struct | CallableAdapterGetDim |
|
struct | CallableAdapterGetDim< FieldVector< T, n > > |
|
struct | CallableAdapterGetRangeFieldType |
|
struct | CallableAdapterGetRangeFieldType< FieldVector< T, n > > |
|
class | LocalCallableToGridFunctionAdapter |
| Adapter for callables f(e,x) expecting an entity e and a global coordinate x. More...
|
|
class | GlobalCallableToInstationaryGridFunctionAdapter |
| return a PDELab GridFunction (with setTime method) defined by a parameter class and a callable f(x) global coordinates x More...
|
|
class | LocalCallableToInstationaryGridFunctionAdapter |
| 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 More...
|
|
class | GlobalCallableToBoundaryConditionAdapter |
| Adapter for boundary cond from a callable taking global coordinates. More...
|
|
class | LocalCallableToBoundaryConditionAdapter |
| Adapter for boundary cond from a callable taking an entity and local coordinates. More...
|
|
class | ConstGridFunction |
| GridFunction returning a constant value everywhere. More...
|
|
class | ConstBoundaryGridFunction |
| BoundaryGridFunction returning a constant value everywhere. More...
|
|
struct | DiscreteGridViewFunctionTraits |
|
struct | DiscreteGridViewFunctionTraits< Signature, E, D, B, 0 > |
|
class | DiscreteGridViewFunction |
| A discrete function defined over a GridFunctionSpace. More...
|
|
class | DivisionGridFunctionAdapter |
| Substract two GridFunctions. More...
|
|
class | InverseGridFunctionAdapter |
| Take inverse of a GridFunction. More...
|
|
class | PowerLocalFunction |
|
class | CompositeLocalFunction |
|
struct | GridFunctionToLocalViewTransformation |
|
class | MemberFunctionToGridFunctionAdaptor |
| GridFunction implemented by a member function of some class. More...
|
|
class | TwoArgsMemberFunctionToGridFunctionAdaptor |
| GridFunction implemented by a member function of some class. More...
|
|
class | TwoArgsMemberFunctionToBoundaryGridFunctionAdaptor |
| BoundaryGridFunction implemented by a member function of some class. More...
|
|
class | MinusGridFunctionAdapter |
| Substract two GridFunctions. More...
|
|
class | ProductGridFunctionAdapter |
| Product of two GridFunctions. More...
|
|
class | ProductGridFunctionAdapter< GF1, GF2, typename std::enable_if< GF1::Traits::dimRange==1 &&GF2::Traits::dimRange !=1 >::type > |
| Product of two GridFunctions. More...
|
|
class | ProductGridFunctionAdapter< GF1, GF2, typename std::enable_if< GF1::Traits::dimRange !=1 &&GF2::Traits::dimRange==1 >::type > |
| Product of two GridFunctions. More...
|
|
class | ScalarScaledGridFunctionAdapter |
| Scale a GridFunction by a constant. More...
|
|
class | SelectComponentGridFunctionAdapter |
| Select certain component(s) of a gridfunction. More...
|
|
class | SqrGridFunctionAdapter |
| Take square of a GridFunction. More...
|
|
class | SqrtGridFunctionAdapter |
| Take sqrt of a GridFunction. More...
|
|
struct | DifferentiableFunctionBaseTag |
|
struct | DifferentiableFunctionLocalViewBaseTag |
|
struct | DifferentiableFunctionTag |
|
struct | DifferentiableFunctionLocalViewTag |
|
struct | PowerDifferentiableFunctionTag |
|
struct | PowerDifferentiableFunctionLocalViewTag |
|
struct | CompositeDifferentiableFunctionTag |
|
struct | CompositeDifferentiableFunctionLocalViewTag |
|
class | CompositeGridFunctionSpace |
| base class for tuples of grid function spaces base class that holds implementation of the methods this is the default version with lexicographic ordering More...
|
|
class | DataHandleProvider |
|
class | LFSIndexCacheBase< LFS, C, Experimental::DuneFunctionsCacheTag, false > |
|
class | LFSIndexCacheBase< LFS, EmptyTransformation, Experimental::DuneFunctionsCacheTag, false > |
|
class | LocalFunctionSpace< Experimental::GridFunctionSpace< DFBasis, V, CE >, TAG > |
|
class | LocalFunctionSpace< Experimental::GridFunctionSpace< DFBasis, V, CE >, AnySpaceTag > |
|
class | EntityIndexCache |
|
struct | DOFDataCommunicationDescriptor |
| Communication descriptor for sending one item of type E per DOF. More...
|
|
struct | EntityDataCommunicationDescriptor |
| Communication descriptor for sending count items of type E per entity with attached DOFs. More...
|
|
class | GFSDataHandle |
| Implement a data handle with a grid function space. More...
|
|
class | DataGatherScatter |
|
class | DataEntityGatherScatter |
|
class | DataContainerIndexGatherScatter |
|
class | AddGatherScatter |
|
class | AddDataHandle |
|
class | AddClearGatherScatter |
|
class | AddClearDataHandle |
|
class | CopyGatherScatter |
|
class | CopyDataHandle |
|
class | MinGatherScatter |
|
class | MinDataHandle |
|
class | MaxGatherScatter |
|
class | MaxDataHandle |
|
class | GhostGatherScatter |
| GatherScatter functor for marking ghost DOFs. More...
|
|
class | GhostDataHandle |
| Data handle for marking ghost DOFs. More...
|
|
class | DisjointPartitioningGatherScatter |
| GatherScatter functor for creating a disjoint DOF partitioning. More...
|
|
class | DisjointPartitioningDataHandle |
| GatherScatter data handle for creating a disjoint DOF partitioning. More...
|
|
struct | SharedDOFGatherScatter |
| GatherScatter functor for marking shared DOFs. More...
|
|
class | SharedDOFDataHandle |
| Data handle for marking shared DOFs. More...
|
|
class | GFSNeighborDataHandle |
| Data handle for collecting set of neighboring MPI ranks. More...
|
|
class | DifferenceAdapter |
| Adapter returning f1(x)-f2(x) for two given grid functions. More...
|
|
class | DifferenceSquaredAdapter |
| Adapter returning ||f1(x)-f2(x)||^2 for two given grid functions. More...
|
|
struct | GridFunctionSpaceTraits |
| collect types exported by a leaf grid function space More...
|
|
class | GridFunctionSpace |
| A grid function space. More...
|
|
class | GridFunctionSpaceBase |
|
class | DiscreteGridFunction |
| convert a grid function space and a coefficient vector into a grid function More...
|
|
class | DiscreteGridFunctionCurl |
| convert a grid function space and a coefficient vector into a grid function of the curl More...
|
|
struct | DiscreteGridFunctionCurlTraits |
| Helper class to calculate the Traits of DiscreteGridFunctionCurl. More...
|
|
struct | DiscreteGridFunctionCurlTraits< GV, RangeFieldType, 1 > |
| Helper class to calculate the Traits of DiscreteGridFunctionCurl (1D) More...
|
|
struct | DiscreteGridFunctionCurlTraits< GV, RangeFieldType, 2 > |
| Helper class to calculate the Traits of DiscreteGridFunctionCurl (2D) More...
|
|
struct | DiscreteGridFunctionCurlTraits< GV, RangeFieldType, 3 > |
| Helper class to calculate the Traits of DiscreteGridFunctionCurl (3D) More...
|
|
class | DiscreteGridFunctionGlobalCurl |
| convert a single component function space with experimental global finite elements into a grid function representing the curl More...
|
|
class | DiscreteGridFunctionGradient |
| convert a single component function space with a grid function representing the gradient More...
|
|
class | DiscreteGridFunctionPiola |
| DiscreteGridFunction with Piola transformation. More...
|
|
class | VectorDiscreteGridFunction |
| DiscreteGridFunction for vector-valued functions. More...
|
|
class | VectorDiscreteGridFunctionGradient |
| Equivalent of DiscreteGridFunctionGradient for vector-valued functions. More...
|
|
struct | SingleDerivativeComputationHelper |
| Helper class to compute a single derivative of scalar basis functions. More...
|
|
struct | SingleDerivativeComputationHelper< Dune::FieldMatrix< RF, size, size >, RF, size > |
| Template specialization for Dune::FieldMatrix. More...
|
|
struct | SingleDerivativeComputationHelper< Dune::DiagonalMatrix< RF, size >, RF, size > |
| Template specialization for Dune::DiagonalMatrix. More...
|
|
class | VectorDiscreteGridFunctionDiv |
| Compute divergence of vector-valued functions. More...
|
|
class | VectorDiscreteGridFunctionCurl |
| Compute curl of vector-valued functions. More...
|
|
class | VectorDiscreteGridFunctionCurl< T, X, 3 > |
| Compute curl of vector-valued functions (3D). More...
|
|
class | VectorDiscreteGridFunctionCurl< T, X, 2 > |
| Compute curl of vector-valued functions (2D). More...
|
|
class | DOFIndexViewIterator |
|
struct | extract_lfs_leaf_size_visitor |
|
struct | map_dof_indices_to_container_indices |
|
class | LFSIndexCacheBase |
|
class | LFSIndexCacheBase< LFS, EmptyTransformation, CacheTag, fast > |
|
class | LFSIndexCacheBase< LFS, C, SimpleLFSCacheTag, fast > |
|
class | LFSIndexCacheBase< LFS, EmptyTransformation, SimpleLFSCacheTag, fast > |
|
class | LFSIndexCache |
|
struct | LocalFunctionSpaceBaseTraits |
| traits mapping global function space information to local function space More...
|
|
class | LocalFunctionSpaceBaseNode |
|
struct | GridViewLocalFunctionSpaceBaseTraits |
| traits for local function space on a gridview More...
|
|
class | GridViewLocalFunctionSpaceBaseNode |
|
struct | PowerCompositeLocalFunctionSpaceTraits |
| traits for multi component local function space More...
|
|
class | PowerLocalFunctionSpaceNode |
|
struct | power_gfs_to_lfs_template |
|
class | CompositeLocalFunctionSpaceNode |
|
struct | composite_gfs_to_lfs_template |
|
struct | LeafLocalFunctionSpaceTraits |
| traits for single component local function space More...
|
|
class | LeafLocalFunctionSpaceNode |
| single component local function space More...
|
|
class | LocalFunctionSpace |
| Create a local function space from a global function space. More...
|
|
class | LocalFunctionSpace< GFS, AnySpaceTag > |
|
struct | AnySpaceTag |
|
struct | TrialSpaceTag |
|
struct | TestSpaceTag |
|
class | WeightedVectorAccumulationView |
| An accumulate-only view on a local vector that automatically takes into account an accumulation weight. More...
|
|
class | LocalVector |
| A container for storing data associated with the degrees of freedom of a LocalFunctionSpace. More...
|
|
struct | PowerCompositeGridFunctionSpaceTraits |
| Trait class for the multi component grid function spaces. More...
|
|
class | PowerCompositeGridFunctionSpaceBase |
| Mixin class providing common functionality of PowerGridFunctionSpace and CompositeGridFunctionSpace. More...
|
|
class | PowerGridFunctionSpace |
| base class for tuples of grid function spaces product of identical grid function spaces base class that holds implementation of the methods More...
|
|
struct | FunctionSpaceTag |
|
struct | GridFunctionSpaceTag |
|
struct | PowerGridFunctionSpaceTag |
|
struct | VectorGridFunctionSpaceTag |
|
struct | CompositeGridFunctionSpaceTag |
|
struct | LeafGridFunctionSpaceTag |
|
struct | GridFunctionSubSpaceTag |
|
struct | CompositeGridFunctionSpaceBaseTag |
| Tag for the intermediate base class of the CompositeGridFunctionSpace. More...
|
|
struct | EntityBlockedOrderingTag |
| Indicate blocking of the unknowns by grid entity. More...
|
|
struct | LexicographicOrderingTag |
| Indicate lexicographic ordering of the unknowns of non-leaf grid function spaces. More...
|
|
struct | InterleavedOrderingTag |
| Indicate interleaved ordering of the unknowns of non-leaf grid function spaces according to a given blocking pattern. More...
|
|
struct | NoConstOrderingSize |
| Mixin indicating whether a leaf GridFunctionSpace should never assume a const ordering size. More...
|
|
struct | PartitionSelector |
| Helper for building the bitmask describing the grid partitions contained in a GFS. More...
|
|
struct | EmptyParams |
|
struct | LeafOrderingTag |
| Tag indicating a standard ordering for a leaf GridfunctionSpace. More...
|
|
struct | SingleCodimMapper |
|
struct | PowerLocalFunctionSpaceTag |
| Tag denoting a PowerLocalFunctionSpace. More...
|
|
struct | CompositeLocalFunctionSpaceTag |
| Tag denoting a CompositeLocalFunctionSpace. More...
|
|
struct | LeafLocalFunctionSpaceTag |
| Tag denoting a LeafLocalFunctionSpace. More...
|
|
struct | HierarchicContainerAllocationTag |
|
struct | FlatContainerAllocationTag |
|
struct | DefaultLFSCacheTag |
|
struct | SimpleLFSCacheTag |
|
struct | _build_dof_index_type |
|
struct | _build_dof_index_type< GFS, SingleCodimMapper > |
|
struct | build_dof_index_type |
|
class | VectorGridFunctionSpace |
| tensorproduct space representing a vector valued function space More...
|
|
class | AssemblerInterface |
| The global assembler which performs the traversing of the integration parts. More...
|
|
class | LocalAssemblerEngine |
| The local assembler engine which handles the integration parts as provided by the global assemblers. More...
|
|
class | LocalAssemblerInterface |
| The local assembler which provides the engines that drive the global assembler. More...
|
|
class | GridOperatorInterface |
| The grid operator represents an operator mapping which corresponds to the (possibly nonlinear) algebraic problem resulting from the discretization of a PDE. More...
|
|
struct | LocalAssemblerTraits |
|
class | SparsityLink |
| Entry in sparsity pattern. More...
|
|
class | LocalSparsityPattern |
| Layout description for a sparse linear operator. More...
|
|
class | LocalAssemblerBase |
| Base class for local assembler. More...
|
|
class | NonOverlappingBorderDOFExchanger |
| Helper class for adding up matrix entries on border. More...
|
|
class | NoDataBorderDOFExchanger |
|
class | OverlappingBorderDOFExchanger |
|
class | DiagonalLocalMatrix |
| A dense matrix for storing data associated with the degrees of freedom of a pair of LocalFunctionSpaces. More...
|
|
struct | GridOperatorTraits |
| Traits class for the grid operator. More...
|
|
class | LocalAssemblerEngineBase |
| Base class for LocalAssemblerEngine implementations to avoid boilerplate code. More...
|
|
class | WeightedMatrixAccumulationView |
| An accumulate-only view on a local matrix that automatically takes into account an accumulation weight. More...
|
|
class | LocalMatrix |
| A dense matrix for storing data associated with the degrees of freedom of a pair of LocalFunctionSpaces. More...
|
|
class | DefaultAssembler |
| The assembler for standard DUNE grid. More...
|
|
class | DefaultLocalJacobianApplyAssemblerEngine |
| The local assembler engine for DUNE grids which assembles the local application of the Jacobian. More...
|
|
class | DefaultLocalJacobianAssemblerEngine |
| The local assembler engine for DUNE grids which assembles the jacobian matrix. More...
|
|
class | DefaultLocalAssembler |
| The local assembler for DUNE grids. More...
|
|
class | DefaultLocalPatternAssemblerEngine |
| The local assembler engine for DUNE grids which creates the matrix pattern. More...
|
|
class | DefaultLocalResidualAssemblerEngine |
| The local assembler engine for DUNE grids which assembles the residual vector. More...
|
|
class | FastDGAssembler |
| The fast DG assembler for standard DUNE grid. More...
|
|
class | FastDGLocalJacobianApplyAssemblerEngine |
| The fast DG local assembler engine for DUNE grids which assembles the local application of the Jacobian. More...
|
|
class | FastDGLocalJacobianAssemblerEngine |
| The fast DG local assembler engine for DUNE grids which assembles the jacobian matrix. More...
|
|
class | FastDGLocalAssembler |
| The local assembler for DUNE grids. More...
|
|
class | FastDGLocalPatternAssemblerEngine |
| The fast DG local assembler engine for DUNE grids which creates the matrix pattern. More...
|
|
class | FastDGLocalResidualAssemblerEngine |
| The fast DG local assembler engine for DUNE grids which assembles the residual vector. More...
|
|
class | FastDGGridOperator |
|
class | GridOperator |
| Standard grid operator implementation. More...
|
|
class | OneStepLocalAssemblerEngineBase |
| The local assembler engine for UDG sub triangulations which assembles the residual vector. More...
|
|
class | OneStepLocalJacobianApplyAssemblerEngine |
| The local assembler engine for one-step methods which applies the jacobian without explicitly assembling it. More...
|
|
class | OneStepLocalJacobianAssemblerEngine |
| The local assembler engine for one step methods which assembles the residual vector. More...
|
|
class | OneStepExplicitLocalJacobianResidualAssemblerEngine |
| The local assembler engine for DUNE grids which assembles the residual vector. More...
|
|
class | OneStepLocalAssembler |
| The local assembler for one step methods. More...
|
|
class | OneStepLocalPatternAssemblerEngine |
| The local assembler engine for OneStep sub triangulations which creates the matrix pattern. More...
|
|
class | OneStepLocalPreStageAssemblerEngine |
| The local assembler engine for one step methods which assembles the constant part of the residual vector. More...
|
|
class | OneStepLocalResidualAssemblerEngine |
| The local assembler engine for one step methods which assembles the residual vector. More...
|
|
class | OneStepGridOperator |
|
class | TimeControllerInterface |
| Controller interface for adaptive time stepping. More...
|
|
class | SimpleTimeController |
| Default time controller; just returns given dt. More...
|
|
class | CFLTimeController |
| limit time step to maximum dt * CFL number More...
|
|
class | ExplicitOneStepMethod |
| Do one step of an explicit time-stepping scheme. More...
|
|
struct | OneStepMethodPartialResult |
|
struct | OneStepMethodResult |
|
class | OneStepMethod |
| Do one step of a time-stepping scheme. More...
|
|
class | TimeSteppingParameterInterface |
| Base parameter class for time stepping scheme parameters. More...
|
|
class | OneStepThetaParameter |
| Parameters to turn the OneStepMethod into an one step theta method. More...
|
|
class | ExplicitEulerParameter |
| Parameters to turn the ExplicitOneStepMethod into an explicit Euler method. More...
|
|
class | ImplicitEulerParameter |
| Parameters to turn the OneStepMethod into an implicit Euler method. More...
|
|
class | HeunParameter |
| Parameters to turn the ExplicitOneStepMethod into a Heun scheme. More...
|
|
class | Shu3Parameter |
| Parameters to turn the ExplicitOneStepMethod into a third order strong stability preserving (SSP) scheme. More...
|
|
class | RK4Parameter |
| Parameters to turn the ExplicitOneStepMethod into a classical fourth order Runge-Kutta method. More...
|
|
class | Alexander2Parameter |
| Parameters to turn the OneStepMethod into an Alexander scheme. More...
|
|
class | FractionalStepParameter |
| Parameters to turn the OneStepMethod into a fractional step theta scheme. More...
|
|
class | Alexander3Parameter |
| Parameters to turn the OneStepMethod into an Alexander3 scheme. More...
|
|
class | BlockDiagonalLocalOperatorFullCoupling |
| Block diagonal extension of scalar local operator. More...
|
|
class | CombinedOperator |
| A local operator to take combine different local operators. More...
|
|
class | ConvectionDiffusionCCFV |
|
class | ConvectionDiffusionCCFVTemporalOperator |
|
struct | ConvectionDiffusionDGMethod |
|
struct | ConvectionDiffusionDGWeights |
|
class | ConvectionDiffusionDG |
|
class | ConvectionDiffusionFEM |
|
class | ConvectionDiffusionFEMResidualEstimator |
|
class | ConvectionDiffusionTemporalResidualEstimator1 |
|
class | CD_RHS_LocalAdapter |
|
class | ConvectionDiffusionTemporalResidualEstimator |
|
struct | ConvectionDiffusionParameterTraits |
| Traits class for convection diffusion parameters. More...
|
|
struct | ConvectionDiffusionBoundaryConditions |
| Class to define the boundary condition types. More...
|
|
class | ConvectionDiffusionModelProblem |
| Parameter class for solving the linear convection-diffusion equation. More...
|
|
class | ConvectionDiffusionBoundaryConditionAdapter |
|
class | ConvectionDiffusionVelocityExtensionAdapter |
|
class | ConvectionDiffusionDirichletExtensionAdapter |
|
class | ConvectionDiffusionExactGradientAdapter |
|
class | DefaultInteriorPenalty |
| Default implementation of the interior penalty factor. More...
|
|
class | OverPenalizedInteriorPenalty |
| Implementation of overpenalized interior penalty. More...
|
|
class | DGNavierStokes |
| A local operator for solving the Navier-Stokes equations using a DG discretization. More...
|
|
class | DGNavierStokesParameters |
| Parameter class for local operator DGNavierStokes. More...
|
|
struct | VectorBasisInterfaceSwitch |
|
struct | VectorBasisInterfaceSwitch< Basis, typename std::enable_if< Std::to_true_type< std::integral_constant< std::size_t, Basis::Traits::dimDomain > >::value >::type > |
| Switch for uniform treatment of local and global basis classes. More...
|
|
class | DGNavierStokesVelVecFEM |
| 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. More...
|
|
class | DiffusionMixed |
|
class | Electrodynamic_T |
| Construct matrix T for the Electrodynamic operator. More...
|
|
class | Electrodynamic_S |
| Contruct matrix S for the Electrodynamic operator. More...
|
|
class | ConvectionDiffusionDG_ErrorIndicator |
| a local operator for residual-based error estimation More...
|
|
class | LocalOperatorDefaultFlags |
| Default flags for all local operators. More...
|
|
class | InstationaryLocalOperatorDefaultMethods |
| Default class for additional methods in instationary local operators. More...
|
|
class | LocalOperatorInterface |
| Class to document the stationary local operator interface. More...
|
|
class | L2 |
|
class | L2VolumeFunctional |
| A local operator that tests a function against a test function space defined on the entire grid. More...
|
|
class | LinearAcousticsEigenvectors |
|
class | LinearAcousticsEigenvectors< 1 > |
| provide matrix which contains rowwise the eigenvectors of linear acoustics problem More...
|
|
class | LinearAcousticsEigenvectors< 2 > |
| provide matrix which contains rowwise the eigenvectors of linear acoustics problem More...
|
|
class | LinearAcousticsEigenvectors< 3 > |
| provide matrix which contains rowwise the eigenvectors of linear acoustics problem More...
|
|
class | DGLinearAcousticsSpatialOperator |
|
class | DGLinearAcousticsTemporalOperator |
|
struct | LinearAcousticsParameterTraits |
| Traits class for linear acoustics parameters. More...
|
|
class | LinearAcousticsInitialValueAdapter |
|
class | LinearAcousticsModelProblem |
|
class | LinearElasticity |
|
struct | LinearElasticityParameterTraits |
| Traits class for linear elasticity parameters. More...
|
|
class | LinearElasticityParameterInterface |
| base class for linear elasticity parameter class More...
|
|
class | LinearElasticityDirichletExtensionAdapter |
|
class | MaxwellEigenvectors |
|
class | MaxwellEigenvectors< 3 > |
| provide matrix which contains column-wise the eigenvectors of maxwell problem More...
|
|
class | DGMaxwellSpatialOperator |
| Spatial local operator for discontinuous Galerkin method for Maxwells Equations. More...
|
|
class | DGMaxwellTemporalOperator |
|
struct | MaxwellParameterTraits |
| Traits class for convection diffusion parameters. More...
|
|
class | MaxwellInitialValueAdapter |
|
class | MaxwellModelProblem |
|
class | NavierStokesMass |
| A local operator for the mass term corresponding to the instationary part in the Navier-Stokes equations. More...
|
|
class | NavierStokesVelVecMass |
| 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. More...
|
|
struct | NonLinearConvectionDiffusionParameterTraits |
| traits class for two phase parameter class More...
|
|
class | NonLinearConvectionDiffusionParameterInterface |
| base class for parameter class More...
|
|
class | BCTypeParam_CD |
|
class | DirichletBoundaryCondition_CD |
|
class | NonLinearConvectionDiffusionFEM |
|
class | NumericalJacobianVolume |
| Implement jacobian_volume() based on alpha_volume() More...
|
|
class | NumericalJacobianVolumePostSkeleton |
|
class | NumericalJacobianSkeleton |
| Implement jacobian_skeleton() based on alpha_skeleton() More...
|
|
class | NumericalJacobianBoundary |
| Implement jacobian_boundary() based on alpha_boundary() More...
|
|
class | NumericalJacobianApplyVolume |
| Implements linear and nonlinear versions of jacobian_apply_volume() based on alpha_volume() More...
|
|
class | NumericalJacobianApplyVolumePostSkeleton |
|
class | NumericalJacobianApplySkeleton |
| Implements linear and nonlinear versions of jacobian_apply_skeleton() based on alpha_skeleton() More...
|
|
class | NumericalJacobianApplyBoundary |
| Implements linear and nonlinear versions of jacobian_apply_boundary() based on alpha_boundary() More...
|
|
class | NumericalNonlinearJacobianApplyVolume |
| Implements nonlinear version of jacobian_apply_volume() based on alpha_volume() More...
|
|
class | NumericalNonlinearJacobianApplyVolumePostSkeleton |
|
class | NumericalNonlinearJacobianApplySkeleton |
| Implements nonlinear version of jacobian_apply_skeleton() based on alpha_skeleton() More...
|
|
class | NumericalNonlinearJacobianApplyBoundary |
| Implements nonlinear version of jacobian_apply_boundary() based on alpha_boundary() More...
|
|
class | JacobianBasedAlphaVolume |
| Implement alpha_volume() based on jacobian_volume() More...
|
|
class | JacobianBasedAlphaSkeleton |
| Implement alpha_skeleton() based on jacobian_skeleton() More...
|
|
class | JacobianBasedAlphaBoundary |
| Implement alpha_boundary() based on jacobian_boundary() More...
|
|
class | FullVolumePattern |
| sparsity pattern generator More...
|
|
class | FullSkeletonPattern |
| sparsity pattern generator More...
|
|
class | FullBoundaryPattern |
| sparsity pattern generator More...
|
|
class | ScaledLocalOperator |
| A local operator that scales the result of another local operator. More...
|
|
struct | StokesBoundaryCondition |
|
struct | NavierStokesParameterTraits |
|
class | NavierStokesDefaultParameters |
|
class | StokesVelocityDirichletConstraints |
|
class | StokesPressureDirichletConstraints |
|
class | NavierStokesVelocityFunctionAdapter |
|
class | InstationarySumLocalOperator |
| A local operator to take the sum of other local operators. More...
|
|
class | InstationarySumLocalOperator< std::tuple< Args... > > |
| deprecated specialization of More...
|
|
class | TaylorHoodNavierStokes |
| A local operator for the Navier-Stokes equations. More...
|
|
struct | TwoPhaseParameterTraits |
| traits class for two phase parameter class More...
|
|
struct | TwoPhaseFullTensorParameterTraits |
|
class | TwoPhaseParameterInterface |
| base class for parameter class More...
|
|
class | TwoPhaseTwoPointFluxOperator |
|
class | TwoPhaseOnePointTemporalOperator |
|
class | V_l |
| Provide velocity field for liquid phase. More...
|
|
class | V_g |
| Provide velocity field for gas phase. More...
|
|
class | WeightedSumLocalOperator |
| A local operator to take the weighted sum of other local operators. More...
|
|
class | WeightedSumLocalOperator< K, std::tuple< Args... > > |
| deprecated specialization of More...
|
|
class | ZeroLocalOperator |
| Do-nothing local operator. More...
|
|
class | ChunkedBlockOrdering |
| Ordering that permutes top-level ContainerIndex entries. More...
|
|
struct | power_gfs_to_local_ordering_descriptor< GFS, Transformation, ordering::Chunked< U > > |
|
struct | composite_gfs_to_local_ordering_descriptor< GFS, Transformation, ordering::Chunked< U > > |
|
class | DirectLeafLocalOrdering |
|
class | PowerEntityBlockedLocalOrdering |
|
struct | power_gfs_to_local_ordering_descriptor< GFS, Transformation, EntityBlockedOrderingTag > |
|
struct | power_gfs_to_entityblocked_ordering_descriptor |
|
class | CompositeEntityBlockedLocalOrdering |
|
struct | composite_gfs_to_local_ordering_descriptor< GFS, Transformation, EntityBlockedOrderingTag > |
|
struct | composite_gfs_to_entityblocked_ordering_descriptor |
|
struct | collect_used_codims |
|
struct | collect_a_priori_fixed_size |
|
struct | update_fixed_size |
|
struct | pre_collect_used_geometry_types |
|
struct | collect_used_geometry_types_from_cell_visitor |
|
struct | post_collect_used_geometry_types |
|
struct | extract_per_entity_sizes_from_cell_visitor |
|
struct | post_extract_per_entity_sizes |
|
class | GridViewOrdering |
|
class | PowerInterleavedOrdering |
|
struct | power_gfs_to_interleaved_ordering_descriptor |
|
class | CompositeInterleavedOrdering |
|
struct | composite_gfs_to_interleaved_ordering_descriptor |
|
class | LeafGridViewOrdering |
| Gridview ordering for leaf spaces. More...
|
|
struct | direct_leaf_gfs_to_gridview_ordering_descriptor |
|
class | LeafLocalOrdering |
|
struct | leaf_gfs_to_local_ordering_descriptor< GFS, Transformation, LeafOrderingTag< Params > > |
|
class | LeafOrderingBase |
| Generic infrastructure for orderings for leaf spaces. More...
|
|
class | PowerLexicographicOrdering |
|
struct | power_gfs_to_lexicographic_ordering_descriptor |
|
class | CompositeLexicographicOrdering |
| Interface for merging index spaces. More...
|
|
struct | composite_gfs_to_lexicographic_ordering_descriptor |
|
class | LocalOrderingBase |
|
class | OrderingBase |
|
class | PermutedOrdering |
| Ordering that permutes top-level ContainerIndex entries. More...
|
|
struct | power_gfs_to_local_ordering_descriptor< GFS, Transformation, ordering::Permuted< U > > |
|
struct | composite_gfs_to_local_ordering_descriptor< GFS, Transformation, ordering::Permuted< U > > |
|
class | SingleCodimLeafOrdering |
|
struct | leaf_gfs_to_ordering_descriptor< GFS, Transformation, SingleCodimMapper > |
|
class | SubOrdering |
| A view on a subtree of a multi-component ordering. More...
|
|
struct | MergeMode |
| Index merging algorithm for global orderings. More...
|
|
struct | DefaultDOFIndexAccessor |
|
struct | SimpleDOFIndexAccessor |
|
struct | SimpleOrderingTraits |
|
struct | SimpleOrderingTraits< SimpleDOFIndex< SizeType_ >, CI > |
|
struct | OrderingTraits |
|
struct | LocalOrderingTraits |
|
struct | GridViewOrderingTraits |
|
class | VirtualOrderingBase |
|
struct | extract_child_bases |
|
struct | DummyDOFIndexIterator |
| Dummy iterator type over DOF indices. More...
|
|
class | NewtonMethod |
| Newton solver for solving non-linear problems. More...
|
|
class | LineSearchInterface |
| Abstract base class describing the line search interface. More...
|
|
class | LineSearchNone |
| Class for simply updating the solution without line search. More...
|
|
class | LineSearchHackbuschReusken |
| Hackbusch-Reusken line search. More...
|
|
class | TerminateInterface |
|
class | DefaultTerminate |
|
struct | PDESolverResult |
|
struct | StationaryLinearProblemSolverResult |
|
class | StationaryLinearProblemSolver |
|
|
template<class Grid , class GFS , class X > |
void | adapt_grid (Grid &grid, GFS &gfs, X &x1, int int_order) |
| adapt a grid, corresponding function space and solution vectors More...
|
|
template<class Grid , class GFS , class X > |
void | adapt_grid (Grid &grid, GFS &gfs, X &x1, X &x2, int int_order) |
| adapt a grid, corresponding function space and solution vectors More...
|
|
template<typename GFS , typename... X> |
impl::GFSWithVectors< GFS, X... > | transferSolutions (GFS &gfs, int integrationOrder, X &... x) |
| Pack function space and vectors for grid adaption. More...
|
|
template<typename Grid , typename... X> |
void | adaptGrid (Grid &grid, X &... x) |
| Adapt grid and multiple function spaces with corresponding vectors. More...
|
|
template<typename T > |
void | error_fraction (const T &x, typename T::ElementType alpha, typename T::ElementType beta, typename T::ElementType &eta_alpha, typename T::ElementType &eta_beta, int verbose=0) |
|
template<typename T > |
void | element_fraction (const T &x, typename T::ElementType alpha, typename T::ElementType beta, typename T::ElementType &eta_alpha, typename T::ElementType &eta_beta, int verbose=0) |
|
template<typename T > |
void | error_distribution (const T &x, unsigned int bins) |
|
template<typename Grid , typename X > |
void | mark_grid (Grid &grid, const X &x, typename X::ElementType refine_threshold, typename X::ElementType coarsen_threshold, int min_level=0, int max_level=std::numeric_limits< int >::max(), int verbose=0) |
|
template<typename Grid , typename X > |
void | mark_grid_for_coarsening (Grid &grid, const X &x, typename X::ElementType refine_threshold, typename X::ElementType coarsen_threshold, int verbose=0) |
|
template<class GFS , class T , class A , int n, int m> |
void | restore_overlap_entries (const GFS &gfs, Dune::BCRSMatrix< Dune::FieldMatrix< T, n, m >, A > &matrix, Dune::BCRSMatrix< Dune::FieldMatrix< T, n, m >, A > &matrix2) |
|
std::ostream & | operator<< (std::ostream &s, const TimeSpec &t) |
| insert a timespec into an output stream More...
|
|
TimeSpec | gettimeofdayWallTime () |
|
const TimeSpec & | gettimeofdayWallTimeResolution () |
|
TimeSpec | getWallTime () |
| get the wall time in seconds since the epoch More...
|
|
TimeSpec | getWallTimeResolution () |
| get resolution of the wall time in seconds More...
|
|
const std::string & | getWallTimeImp () |
| return a string describing which implementation is used to get the wall time More...
|
|
TimeSpec | getrusageProcessTime () |
|
const TimeSpec & | getrusageProcessTimeResolution () |
|
TimeSpec | getProcessTime () |
| get the process time in seconds used by the current process More...
|
|
TimeSpec | getProcessTimeResolution () |
| get resolution of the process time in seconds More...
|
|
const std::string & | getProcessTimeImp () |
| return a string describing which implementation is used to get the process time More...
|
|
template<typename T , int dimB, int dimC> |
void | crossproduct (const FieldVector< T, dimB > &b, const FieldVector< T, dimC > &c, FieldVector< T,(CrossProduct< dimB, dimC >::dimA)> &a) |
| calculate crossproduct More...
|
|
template<typename T , int dimB, int dimC> |
FieldVector< T, CrossProduct< dimB, dimC >::dimA > | crossproduct (const FieldVector< T, dimB > &b, const FieldVector< T, dimC > &c) |
| calculate crossproduct More...
|
|
template<typename T , std::size_t n1, std::size_t n2> |
std::size_t | hash_value (const DOFIndex< T, n1, n2 > &di) |
|
template<typename GV , typename T > |
void | vtkwriter_tree_addvertexdata (Dune::VTKWriter< GV > &w, const T &t, std::string s="data") |
| add vertex data from a GridFunctionTree to a VTKWriter More...
|
|
template<typename GF > |
GF::Traits::RangeType | integrateGridFunction (const GF &gf, unsigned qorder=1) |
| Integrate a GridFunction. More...
|
|
template<typename GF > |
void | integrateGridFunction (const GF &gf, typename GF::Traits::RangeType &sum, unsigned qorder=1) |
| Integrate a GridFunction. More...
|
|
template<typename T , std::size_t n, typename ID > |
std::size_t | hash_value (const GlobalDOFIndex< T, n, ID > &di) |
|
std::string | getHostName () |
| C++ friendly wrapper around POSIX' gethostname() or GetComputerName() when compiling for Windows applications. More...
|
|
template<typename EntitySet , typename Intersection > |
std::tuple< IntersectionType, typename EntitySet::Element > | classifyIntersection (const EntitySet &entity_set, const Intersection &is) |
| Classifies the type of an intersection wrt to the passed EntitySet. More...
|
|
std::shared_ptr< LogtagFormatterBase > | makeGeneralLogtagFormatter (std::ostream &(&formatFunc)(std::ostream &)) |
| Convenience function to create a GeneralLogtagFormatter. More...
|
|
const std::shared_ptr< LogtagFormatterBase > & | getLogtagFormatter () |
| get the log tag formatter currently used by logtag() More...
|
|
void | setLogtagFormatter (const std::shared_ptr< LogtagFormatterBase > &formatter=std::shared_ptr< LogtagFormatterBase >()) |
| set a new log tag formatter to be used by logtag() More...
|
|
std::ostream & | logtag (std::ostream &s) |
| function that writes a log tag to some stream More...
|
|
void | logtagSetupMPI (bool syncWidthes=true) |
| collect MPI information for the logtag formatters More...
|
|
std::ostream & | hostRankWallUserLogtagFormatFunc (std::ostream &s) |
| logtag format function that includes hostname, rank (if available), wall time and CPU time More...
|
|
std::ostream & | hostPidWallUserLogtagFormatFunc (std::ostream &s) |
| logtag format function that includes host name, pid, wall time and CPU time More...
|
|
std::ostream & | nullFormatFunc (std::ostream &s) |
| logtag format function that does not write anything More...
|
|
template<class FormatFunc > |
std::shared_ptr< LogtagFormatterBase > | makeGeneralLogtagFormatter (const FormatFunc &formatFunc) |
| Convenience function to create a GeneralLogtagFormatter. More...
|
|
template<class FormatFunc > |
void | setLogtagFormatFunc (const FormatFunc &formatFunc) |
| set a new log tag format function to be used by logtag() More...
|
|
std::ostream & | operator<< (std::ostream &s, const LocalTag &tag) |
| insert a localtag into a std::ostream More...
|
|
template<typename T , std::size_t n> |
std::size_t | hash_value (const MultiIndex< T, n > &mi) |
|
template<typename Geometry > |
QuadratureRuleWrapper< QuadratureRule< typename Geometry::ctype, Geometry::mydimension > > | quadratureRule (const Geometry &geo, std::size_t order, QuadratureType::Enum quadrature_type=QuadratureType::GaussLegendre) |
| Returns a quadrature rule for the given geometry. More...
|
|
template<class T > |
std::vector< T > | rangeVector (T begin, T passed_the_end, T increment=1) |
| Generate a vector with a range of numbers. More...
|
|
template<class T > |
std::vector< T > | rangeVector (T passed_the_end) |
| Generate a vector with a range of numbers. More...
|
|
template<typename F > |
std::size_t | hash_value (const SimpleDOFIndex< F > &di) |
|
template<typename T > |
std::shared_ptr< T > | ensure_shared_ptr (T &t) |
| Ensures that t is wrapped in a shared_ptr<T> More...
|
|
template<class GF > |
std::shared_ptr< VTKGridFunctionAdapter< GF > > | makeVTKGridFunctionAdapter (const std::shared_ptr< GF > &gf, const std::string &name, const std::vector< std::size_t > &remap=rangeVector(std::size_t(GF::Traits::dimRange))) |
| construct a VTKGridFunctionAdapter More...
|
|
template<class GF > |
std::shared_ptr< VTKGridFunctionAdapter< GF > > | makeVTKGridFunctionAdapter (const GF &gf, const std::string &name, const std::vector< std::size_t > &remap=rangeVector(std::size_t(GF::Traits::dimRange))) |
| construct a VTKGridFunctionAdapter More...
|
|
template<class GF > |
std::shared_ptr< VTKGridFunctionAdapter< GF > > | makeVTKGridFunctionAdapter (const std::shared_ptr< const GF > &gf, const std::string &name, const std::vector< std::size_t > &remap=rangeVector(std::size_t(GF::Traits::dimRange))) |
| construct a VTKGridFunctionAdapter More...
|
|
template<typename GFS , typename CG > |
void | constraints (const GFS &gfs, CG &cg, const bool verbose=false) |
| construct constraints More...
|
|
template<typename P , typename GFS , typename CG > |
void | constraints (const P &p, const GFS &gfs, CG &cg, const bool verbose=false) |
| construct constraints from given constraints parameter tree More...
|
|
template<typename CG , typename XG > |
void | set_constrained_dofs (const CG &cg, typename XG::ElementType x, XG &xg) |
| construct constraints from given boundary condition function More...
|
|
template<typename CG , typename XG , typename Cmp > |
bool | check_constrained_dofs (const CG &cg, typename XG::ElementType x, XG &xg, const Cmp &cmp=Cmp()) |
| check that constrained dofs match a certain value More...
|
|
template<typename CG , typename XG > |
bool | check_constrained_dofs (const CG &cg, typename XG::ElementType x, XG &xg) |
| check that constrained dofs match a certain value More...
|
|
template<typename CG , typename XG > |
void | constrain_residual (const CG &cg, XG &xg) |
| transform residual into transformed basis: r -> r~ More...
|
|
template<typename FEM > |
constexpr std::size_t | finiteElementMapBlockSize () |
| Returns the block size for FEM if available, 0 otherwise. More...
|
|
template<typename F , typename Placeholder > |
SetTimeWrapper< F, Placeholder > | bindTime (F &&f, Placeholder p) |
|
template<typename GV , typename F > |
WrapperConformingToGridFunctionInterface | makeGridFunctionFromCallable (const GV &gv, const F &f) |
| Create a GridFunction adapter from a callable. More...
|
|
template<typename GV , typename F > |
WrapperConformingToGridFunctionInterface | makeInstationaryGridFunctionFromCallable (const GV &gv, const F &f) |
| Create a GridFunction from callable and parameter class with setTime method. More...
|
|
template<class F , class GV , typename std::enable_if< models< Dune::Functions::Imp::HasFreeLocalFunction, F >() and not(TypeTree::has_node_tag< typename std::decay< F >::type >::value), int >::type = 0> |
auto | makeLocalFunctionTree (const F &f, const GV &gv) -> Imp::LocalFunctionLeafNodeWrapper< decltype(localFunction(f)) > |
| turn a given function tree into a local function tree More...
|
|
template<class F , class GV , typename std::enable_if< models< Dune::Functions::Imp::HasFreeLocalFunction, F >() and TypeTree::has_node_tag< typename std::decay< F >::type >::value, int >::type = 0> |
auto | makeLocalFunctionTree (F &&f, const GV &gv) -> decltype(localView(f)) |
|
template<typename LeafNode > |
Dune::TypeTree::GenericLeafNodeTransformation< LeafNode, GridFunctionToLocalViewTransformation, Imp::LocalGridViewFunctionAdapter< LeafNode > > | registerNodeTransformation (LeafNode *l, GridFunctionToLocalViewTransformation *t, GridFunctionTag *tag) |
|
template<typename PowerNode > |
Dune::TypeTree::SimplePowerNodeTransformation< PowerNode, GridFunctionToLocalViewTransformation, PowerLocalFunction > | registerNodeTransformation (PowerNode *p, GridFunctionToLocalViewTransformation *t, PowerGridFunctionTag *tag) |
|
template<typename CompositeNode > |
Dune::TypeTree::SimpleCompositeNodeTransformation< CompositeNode, GridFunctionToLocalViewTransformation, CompositeLocalFunction > | registerNodeTransformation (CompositeNode *c, GridFunctionToLocalViewTransformation *t, CompositeGridFunctionTag *tag) |
|
template<class F , class GV , typename std::enable_if< not(IsGridFunction< F >::value) &&std::is_same< TypeTree::NodeTag< F >, TypeTree::LeafNodeTag >::value, int >::type = 0> |
auto | makeLocalFunctionTree (const GridFunctionInterface< typename F::Traits, F > &f, const GV &gv) -> Imp::LocalGridViewFunctionAdapter< F > |
|
template<class RF , std::size_t dimRange, class GV , class Class , class Member > |
MemberFunctionToGridFunctionAdaptor< Member, Class, GV, RF, dimRange > | makeMemberFunctionToGridFunctionAdaptor (const Class &obj, Member member, const GV &gv) |
| easy construction of a MemberFunctionToGridFunctionAdaptor More...
|
|
template<class RF , std::size_t dimRange, class GV , class Class , class Member > |
TwoArgsMemberFunctionToGridFunctionAdaptor< Member, Class, GV, RF, dimRange > | makeTwoArgsMemberFunctionToGridFunctionAdaptor (const Class &obj, Member member, const GV &gv) |
| easy construction of a TwoArgsMemberFunctionToGridFunctionAdaptor More...
|
|
template<class RF , std::size_t dimRange, class GV , class Class , class Member > |
TwoArgsMemberFunctionToBoundaryGridFunctionAdaptor< Member, Class, GV, RF, dimRange > | make2ArgsMemberFunctionToBoundaryGridFunctionAdaptor (const Class &obj, Member member, const GV &gv) |
| easy construction of a TwoArgsMemberFunctionToBoundaryGridFunctionAdaptor More...
|
|
template<typename F , typename GFS , typename XG > |
void | interpolate (const F &f, const GFS &gfs, XG &xg) |
| interpolation from a given grid function More...
|
|
template<typename LFS , typename Iterator > |
Iterator | extract_lfs_leaf_sizes (const LFS &lfs, Iterator it) |
|
template<typename Grid , typename... X> |
void | loadBalanceGrid (Grid &grid, X &... x) |
| Load balance grid and restore gridfunctionspace and gridfunctions given as packs. More...
|
|
template<typename PowerGridFunctionSpace , typename Params > |
TypeTree::TemplatizedGenericPowerNodeTransformation< PowerGridFunctionSpace, gfs_to_lfs< Params >, power_gfs_to_lfs_template< PowerGridFunctionSpace, gfs_to_lfs< Params > >::template result > | registerNodeTransformation (PowerGridFunctionSpace *pgfs, gfs_to_lfs< Params > *t, PowerGridFunctionSpaceTag *tag) |
|
template<typename CompositeGridFunctionSpace , typename Params > |
TypeTree::TemplatizedGenericCompositeNodeTransformation< CompositeGridFunctionSpace, gfs_to_lfs< Params >, composite_gfs_to_lfs_template< CompositeGridFunctionSpace, gfs_to_lfs< Params > >::template result > | registerNodeTransformation (CompositeGridFunctionSpace *cgfs, gfs_to_lfs< Params > *t, CompositeGridFunctionSpaceTag *tag) |
|
template<typename GridFunctionSpace , typename Params > |
TypeTree::GenericLeafNodeTransformation< GridFunctionSpace, gfs_to_lfs< Params >, LeafLocalFunctionSpaceNode< GridFunctionSpace, typename gfs_to_lfs< Params >::DOFIndex > > | registerNodeTransformation (GridFunctionSpace *gfs, gfs_to_lfs< Params > *t, LeafGridFunctionSpaceTag *tag) |
|
template<typename C > |
C & | accessBaseContainer (C &c) |
|
template<typename T , typename Tag , typename W > |
LocalVector< T, Tag, W >::BaseContainer & | accessBaseContainer (LocalVector< T, Tag, W > &c) |
|
template<typename C > |
WeightedVectorAccumulationView< C >::BaseContainer & | accessBaseContainer (WeightedVectorAccumulationView< C > &c) |
|
template<typename C > |
const C & | accessBaseContainer (const C &c) |
|
template<typename T , typename Tag , typename W > |
const LocalVector< T, Tag, W >::BaseContainer & | accessBaseContainer (const LocalVector< T, Tag, W > &c) |
|
template<typename C > |
const WeightedVectorAccumulationView< C >::BaseContainer & | accessBaseContainer (const WeightedVectorAccumulationView< C > &c) |
|
template<typename VTKWriter , typename GFS , typename X , typename NameGenerator = vtk::DefaultFunctionNameGenerator, typename Predicate = vtk::DefaultPredicate> |
vtk::OutputCollector< VTKWriter, vtk::DGFTreeCommonData< GFS, X, Predicate > > | addSolutionToVTKWriter (VTKWriter &vtk_writer, const GFS &gfs, const X &x, const NameGenerator &name_generator=vtk::defaultNameScheme(), const Predicate &predicate=Predicate()) |
|
template<typename VTKWriter , typename GFS , typename X , typename NameGenerator = vtk::DefaultFunctionNameGenerator, typename Predicate = vtk::DefaultPredicate> |
vtk::OutputCollector< VTKWriter, vtk::DGFTreeCommonData< GFS, X, Predicate > > | addSolutionToVTKWriter (VTKWriter &vtk_writer, std::shared_ptr< GFS > gfs, std::shared_ptr< X > x, const NameGenerator &name_generator=vtk::defaultNameScheme(), const Predicate &predicate=Predicate()) |
|
template<class Stream , class T , class W > |
Stream & | operator<< (Stream &stream, const LocalMatrix< T, W > &m) |
|
template<class Eps > |
Electrodynamic_T< std::decay_t< Eps > > | makeLocalOperatorEdynT (Eps &&eps, int qorder=2) |
| construct an Electrodynamic_T operator More...
|
|
template<class Mu > |
Electrodynamic_S< std::decay_t< Mu > > | makeLocalOperatorEdynS (Mu &&mu, int qorder=2) |
| construct an Electrodynamic_S operator More...
|
|
template<class DomainType , class LFS , class LV , class RangeFieldType > |
void | evalFunction (const DomainType &location, const LFS &lfs, const LV &xlocal, RangeFieldType &valU) |
|
template<class DomainType , class EG , class LFS , class LV , class RangeType > |
void | evalGradient (const DomainType &location, const EG &eg, const LFS &lfs, const LV &xlocal, RangeType &gradu) |
|
template<typename LFS > |
std::vector< typename LFS::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeType > | makeValueContainer (const LFS &lfs) |
| return a container for basis evaluations More...
|
|
template<typename LFS > |
std::vector< typename LFS::Traits::FiniteElementType::Traits::LocalBasisType::Traits::JacobianType > | makeJacobianContainer (const LFS &lfs) |
| return a container for Jacobian evaluations More...
|
|
template<typename LFS > |
LFS::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType | makeZeroBasisFieldValue (const LFS &lfs) |
| return a zero value of RangeFieldType of the basis More...
|
|
template<typename LFS > |
LFS::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeType | makeZeroBasisValue (const LFS &lfs) |
| return a zero value of RangeType of the basis More...
|
|
template<typename LFS > |
LFS::Traits::FiniteElementType::Traits::LocalBasisType::Traits::JacobianType | makeZeroJacobianValue (const LFS &lfs) |
| return a zero value of JacobianType of the basis More...
|
|
template<typename GFS , typename Transformation > |
power_gfs_to_entityblocked_ordering_descriptor< GFS, Transformation > | register_power_gfs_to_ordering_descriptor (GFS *, Transformation *, EntityBlockedOrderingTag *) |
|
template<typename GFS , typename Transformation > |
composite_gfs_to_entityblocked_ordering_descriptor< GFS, Transformation > | register_composite_gfs_to_ordering_descriptor (GFS *, Transformation *, EntityBlockedOrderingTag *) |
|
template<typename GFS , typename Transformation > |
power_gfs_to_interleaved_ordering_descriptor< GFS, Transformation > | register_power_gfs_to_ordering_descriptor (GFS *, Transformation *, InterleavedOrderingTag *) |
|
template<typename GFS , typename Transformation > |
composite_gfs_to_interleaved_ordering_descriptor< GFS, Transformation > | register_composite_gfs_to_ordering_descriptor (GFS *, Transformation *, InterleavedOrderingTag *) |
|
template<typename GFS , typename Transformation , typename Params > |
direct_leaf_gfs_to_gridview_ordering_descriptor< GFS, Transformation > | register_leaf_gfs_to_ordering_descriptor (GFS *, Transformation *, LeafOrderingTag< Params > *) |
|
template<typename GFS , typename Transformation > |
power_gfs_to_lexicographic_ordering_descriptor< GFS, Transformation > | register_power_gfs_to_ordering_descriptor (GFS *, Transformation *, LexicographicOrderingTag *) |
|
template<typename GFS , typename Transformation > |
composite_gfs_to_lexicographic_ordering_descriptor< GFS, Transformation > | register_composite_gfs_to_ordering_descriptor (GFS *, Transformation *, LexicographicOrderingTag *) |
|
LineSearchStrategy | lineSearchStrategyFromString (const std::string &name) |
| Get a LineSearchStrategy from a string identifier. More...
|
|
template<typename Newton > |
std::shared_ptr< LineSearchInterface< typename Newton::Domain > > | getLineSearch (Newton &newton, const std::string &name) |
| Get a pointer to a line search. More...
|
|
|
template<typename Engine , typename... Functions> |
PointwiseGridFunctionAdapter< Engine, Functions... > | makePointwiseGridFunctionAdapter (const Engine &engine, const Functions &... f) |
|
|
template<typename CG , typename XG > |
void | copy_constrained_dofs (const CG &cg, const XG &xgin, XG &xgout) |
|
template<typename CG , typename XG > |
void | set_nonconstrained_dofs (const CG &cg, typename XG::ElementType x, XG &xg) |
|
template<typename CG , typename XG > |
void | copy_nonconstrained_dofs (const CG &cg, const XG &xgin, XG &xgout) |
|
template<typename CG , typename XG > |
void | set_shifted_dofs (const CG &cg, typename XG::ElementType x, XG &xg) |
|