|
struct | BindGuard |
|
struct | isBindable |
|
class | ExplicitFieldVector |
|
struct | IsFieldType |
|
struct | AcceptElementImplicitConstruction |
|
struct | AcceptElementImplicitConstruction< C, T, std::enable_if_t<((IsFieldType< typename DenseMatVecTraits< C >::value_type >::value==IsFieldType< T >::value))> > |
|
struct | MakeExplicit |
|
struct | MakeExplicit< FieldVector< Field, Size > > |
|
struct | ForLoop |
|
class | LocalContribution |
|
struct | UninitializedObjectStack |
|
struct | StackAllocator |
|
struct | StackAllocator< void, S > |
|
class | AdaptiveDiscreteFunction |
|
struct | DiscreteFunctionTraits< AdaptiveDiscreteFunction< DiscreteFunctionSpace > > |
|
class | BlockVectorDiscreteFunction |
|
class | IsBlockVectorDiscreteFunction |
| Tag for discrete functions using block vectors. More...
|
|
struct | DiscreteFunctionTraits< BlockVectorDiscreteFunction< DiscreteFunctionSpace, BlockVector > > |
|
struct | DiscreteFunctionTraits< ISTLBlockVectorDiscreteFunction< DiscreteFunctionSpace, Block > > |
|
class | ISTLBlockVectorDiscreteFunction |
|
struct | IsBlockVector |
|
class | BlockVectorInterface |
|
class | SimpleBlockVector |
| This is the reference implementation of a block vector as it is expected as the second template parameter to Dune::Fem::BlockVectorDiscreteFunction. More...
|
|
class | MutableBlockVector |
|
class | MutableBlockVector< DynamicArray< Field >, BlockSize > |
|
class | ISTLBlockVector |
|
class | ReferenceBlockVector |
| This is the reference implementation of a block vector as it is expected as the second template parameter to Dune::Fem::BlockVectorDiscreteFunction. More...
|
|
class | CombinedDiscreteFunction |
|
class | CombinedDiscreteFunctionDofIterator |
| Iterator over an array of dofs. More...
|
|
struct | DiscreteFunctionTraits< CombinedDiscreteFunction< ContainedDiscreteFunction, N > > |
|
class | Identity |
|
class | Identity< FunctionSpace< ct, ct, dimworld, dimworld > > |
|
class | IsDiscreteFunction |
| base class for determing whether a class is a discrete function or not More...
|
|
class | HasLocalFunction |
| base class for determing whether a function has local functions or not More...
|
|
class | DiscreteFunctionTraits |
| Traits class for a DiscreteFunction. More...
|
|
class | DiscreteFunctionDefault |
|
class | DiscreteFunctionInterface |
|
class | ManagedDiscreteFunction |
|
struct | DiscreteFunctionTraits< ManagedDiscreteFunction< DiscreteFunction > > |
|
struct | DefaultDiscreteFunctionTraits |
|
class | DofBlockProxy |
| DoF block proxy for discrete functions with random access to DoFs. More...
|
|
class | DofIteratorInterface |
| interface for DoF iterators of discrete functions More...
|
|
class | DofIteratorDefault |
| default implementation of DofManagerInterface More...
|
|
class | ConstDofIteratorDefault |
|
class | Function |
| Abstract class representing a function. More...
|
|
class | FunctionSet |
| Global basis functions. More...
|
|
class | FunctionSetProxy |
| Proxy for a FunctionSet. More...
|
|
struct | LeftAdd |
|
struct | LeftAddScaled |
|
struct | LeftAssign |
|
struct | AssignVectorReference |
|
struct | DofBlockFunctor |
|
class | BasicGridFunctionAdapter |
| BasicGridFunctionAdapter provides local functions for a Function. More...
|
|
struct | BasicGridFunctionAdapterTraits |
| traits of GridFunctionAdapter More...
|
|
class | ConvertToGridFunction |
|
class | BasicInstationaryFunction |
| basic wrapper class (still a CRTP) for instationary functions More...
|
|
class | InstationaryFunction |
| implementation of a Dune::Fem::Function taking an instationary function More...
|
|
class | LocalContribution< DiscreteFunction, AssemblyOperation, std::enable_if_t< std::is_base_of< Fem::IsDiscreteFunction, DiscreteFunction >::value > > |
|
class | LocalFunctionAdapter |
| LocalFunctionAdapter wrapped a class with a local evaluate method into a grid function. More...
|
|
class | LocalFunctionAdapterLocalFunction |
|
struct | LocalFunctionAdapterTraits |
| traits of DiscreteFunctionAdapter More...
|
|
class | LocalAnalyticalFunctionBinder |
| LocalAnalyticalFunctionBinder binds a C++ local analytical function (and also its Jacobian and Hessian) to an object which provides all the methods and types needed by the LocalFunctionAdapter. It stores a copy as a std::function. More...
|
|
class | ParallelScalarProduct |
|
struct | HierarchicalDofBlock |
|
struct | SpecialArrayFeatures |
|
class | HierarchicalDofVector |
|
struct | SpecialArrayFeatures< HierarchicalDofVector< DC > > |
|
class | HierarchicalDiscreteFunction |
|
struct | DiscreteFunctionTraits< HierarchicalDiscreteFunction< DiscreteFunctionSpace > > |
|
class | LocalAverage |
|
struct | LocalAverageHelper |
|
struct | LocalAverageImpl |
|
class | LocalAverageImpl< LocalFunction, GridPart, DiscontinuousGalerkinSpace< FunctionSpace, GridPart, order, Storage > > |
|
class | LocalAverageImpl< LocalFunction, GridPart, FiniteVolumeSpace< FunctionSpace, GridPart, codim, Storage > > |
|
struct | BindableFunction |
|
struct | BindableGridFunction |
|
struct | BindableGridFunctionWithSpace |
|
class | BasicConstLocalFunction |
|
class | ConstLocalDiscreteFunction |
| A constant local function carrying values for one entity. More...
|
|
struct | IsConstLocalFunction |
|
struct | IsConstLocalFunction< T, std::enable_if_t<!std::is_same< T, std::decay_t< T > >{}> > |
|
struct | IsConstLocalFunction< T, std::enable_if_t<(std::is_same< T, std::decay_t< T > >{} &&std::is_same< T, Fem::ConstLocalFunction< typename T::GridFunctionType > >{})> > |
|
class | LocalFunctionConverter |
| implementation of a Dune::Fem::LocalFunction on a FunctionSpace V restircted/prolongated from an other function space W. More...
|
|
class | LocalFunction |
| interface for local functions More...
|
|
class | LocalFunctionSet |
| Local basis functions. More...
|
|
class | LocalFunctionSetProxy |
| Proxy for a LocalBasisFunctionSet. More...
|
|
class | LocalFunctionSetAdapter |
| convert (global) function set to local function set More...
|
|
class | MutableLocalFunction |
|
class | BasicTemporaryLocalFunction |
| A temporary function carrying values for one entity. More...
|
|
class | TemporaryLocalFunction |
| A temporary function carrying values for one entity. More...
|
|
class | SubFunctionStorage |
|
class | TupleDiscreteFunction |
| forward declaration More...
|
|
struct | DiscreteFunctionTraits< TupleDiscreteFunction< DiscreteFunctions ... > > |
|
class | TupleDofVector |
|
struct | DofBlockFunctor< TupleDofVector< DofVectors ... >, Functor > |
|
struct | DofBlockFunctor< const TupleDofVector< DofVectors ... >, Functor > |
|
class | ParallelScalarProduct< TupleDiscreteFunction< DiscreteFunctions ... > > |
|
struct | MemObject |
|
class | ManagedDiscreteFunction< VectorDiscreteFunction< DiscreteFunctionSpace, Vector > > |
|
class | VectorDiscreteFunction |
|
struct | DiscreteFunctionTraits< VectorDiscreteFunction< DiscreteFunctionSpace, Vector > > |
|
struct | IteratorToInterface |
|
struct | IteratorToInterface< InteriorBorder_Partition > |
|
class | AdaptiveGridPartBase |
| A grid part with an index set specially designed for adaptive calculations. More...
|
|
class | AdaptiveLeafGridPart |
|
class | AdaptiveLeafGridPartTraits |
| Type definitions for the LeafGridPart class. More...
|
|
class | IntersectionAdaptiveLeafGridPart |
| A grid part with an index set specially designed for adaptive calculations including indices for intersections. More...
|
|
class | IntersectionAdaptiveLeafGridPartTraits |
| A grid part with an index set specially designed for adaptive calculations including indices for intersections. More...
|
|
class | AdaptiveLeafIndexSet |
| consecutive, persistent index set for the leaf level based on the grid's hierarchy index set More...
|
|
class | IntersectionAdaptiveLeafIndexSet |
|
class | DGAdaptiveLeafIndexSet |
| consecutive, persistent index set for the leaf level based on the grid's hierarchy index set More...
|
|
class | AdaptiveIndexSetBaseTraits |
|
class | AdaptiveIndexSetBase |
| consecutive, persistent index set for the leaf level based on the grid's hierarchy index set More...
|
|
struct | AdaptiveLeafIndexSetTraits |
|
struct | IntersectionAdaptiveLeafIndexSetTraits |
|
struct | DGAdaptiveLeafIndexSetTraits |
|
class | CodimIndexSet |
|
struct | DeadIterator |
|
class | DeadIntersection |
|
class | DeadIntersectionIterator |
|
class | DefaultGridPartEntity |
|
class | DefaultGridPartEntity< 0, dim, GridFamily > |
|
class | DefaultEntitySearch |
|
class | GridEntitySearch |
|
class | GridEntitySearch< GridPart, 0, partition > |
|
class | EntitySearch |
|
class | GridPartInterface |
| Interface for the GridPart classes A GridPart class allows to access only a specific subset of a grid's entities. A GridPart implementation provides the corresponding index set and a begin/end iterator pair for accessing those entities, the corresponding intersection iterators and a appropriate communication method. GridParts are used to parametrize spaces (see DiscreteFunctionSpaceDefault [in dune-fem]). More...
|
|
class | GridPartDefault |
| Default implementation for the GridPart classes. More...
|
|
struct | GridEntityAccess |
|
struct | GridEntityAccess< Dune::Entity< codim, dim, Grid, EntityImpl > > |
|
struct | AddGridView |
|
class | GridPart2GridViewImpl |
|
struct | GridPart2GridViewTraits |
|
class | GridPart2GridView |
|
class | GridPartAdapter |
|
class | GridView2GridPart |
|
class | IndexSet |
| interface documentation for (grid part) index sets More...
|
|
class | ConsecutiveIndexSet |
| extended interface for consecutive index sets More...
|
|
class | AdaptiveIndexSet |
| extended interface for adaptive, consecutive index sets More...
|
|
struct | LocalFunctionBasicGeometry |
|
struct | MetaTwistUtility |
| MetaTwistUtility forwards the twist calls to the TwistUtility of the underlying HostTwistUtility. More...
|
|
class | NonAdaptiveIndexSet |
| wrapper for (adaptive) index sets that disables all support for adaptivity More...
|
|
struct | NonAdaptiveIndexSetTraits |
|
class | PersistentConsecutiveIndexSet |
|
class | PersistentAdaptiveIndexSet |
|
struct | PersistentIndexSetInterface |
| virtual base class for persistent index sets More...
|
|
class | PersistentIndexSet |
| please doc me More...
|
|
class | GridPartPolicies |
|
class | FilterDefaultImplementation |
|
class | BasicFilterWrapper |
|
struct | BasicFilterWrapperTraits |
|
class | DomainFilter |
|
struct | DomainFilterTraits |
|
struct | DefaultFilterTraits |
| type definitions More...
|
|
class | FilterInterface |
| Interface class for filter to use with a Dune::FilteredGridPart. More...
|
|
class | InverseFilter |
|
class | RadialFilter |
| given center x and radius r, filter is characteristic function of clos B_r( x ) More...
|
|
class | SimpleFilter |
|
struct | SimpleFilterTraits |
|
class | VoidFilter |
|
class | FilteredGridPart |
| A FilteredGridPart allows to extract a set of entities from a grid satisfying a given constrainted defined through a filter class. More...
|
|
class | FilteredGridPartDataHandle |
|
class | FilteredGridPartIntersection |
|
class | FilteredGridPartIntersectionIterator |
|
class | FilteredGridPartIterator |
|
struct | FilteredGridPartIndexSetSelector |
|
struct | FilteredGridPartIndexSetSelector< FilteredGP, HostGP, false > |
|
struct | EntityGridTypeGetter |
|
struct | EntityGridTypeGetter< Dune::Entity< codim, dim, Grid, Impl > > |
|
struct | EntityGridTypeGetter< const Entity > |
|
struct | FilteredGridPartTraits |
|
class | GeoGridPart |
|
class | LagrangeDiscreteFunctionSpace |
| Lagrange discrete function space. More...
|
|
class | GeoDiscreteCoordFunctionCaller |
|
class | GeoDiscreteCoordFunctionCaller< codim, CoordFunction, LagrangeDiscreteFunctionSpace< FunctionSpace, GridPart, 1, Storage > > |
|
class | GeoCoordFunctionCaller |
|
class | GeoCoordFunctionCaller< codim, CoordFunction, false > |
|
class | GeoCoordFunctionCaller< codim, CoordFunction, true > |
|
class | GeoCoordVector |
|
class | GeoLocalCoordVector |
|
class | GeoIntersectionCoordVector |
|
class | GeoCornerStorage |
|
class | GeoDataHandle |
|
class | GeoEntity |
|
class | GeoEntity< 0, dim, GridFamily > |
|
class | GeoGeometryTraits |
|
class | GeoGeometry |
|
class | GeoIntersection |
|
class | GeoIntersectionIterator |
|
struct | GeoGridPartFamily |
|
struct | GeoGridPartData |
|
struct | GeoGridPartTraits |
|
struct | GridEntityAccess< Dune::Entity< codim, dim, GridFamily, GeoEntity > > |
|
class | EntitySearch< GeoGridPart< CoordFunction >, codim, partition > |
|
class | GeometryGridPart |
|
class | GeometryGridPartDataHandle |
|
class | GeometryGridPartEntity |
|
class | GeometryGridPartEntity< 0, dim, GridFamily > |
|
class | GeometryGridPartIndexSet |
|
class | GeometryGridPartIntersection |
|
class | GeometryGridPartIntersectionIterator |
|
struct | GeometryGridPartData |
|
struct | GeometryGridPartFamily |
|
struct | GeometryGridPartTraits |
|
struct | GridEntityAccess< Dune::Entity< codim, dim, GridFamily, GeometryGridPartEntity > > |
|
class | EntitySearch< GeometryGridPart< GridFunction >, codim, partition > |
|
class | IdGridPart |
|
class | IdEntityBasic |
|
class | IdEntity |
|
class | IdEntity< 0, dim, GridFamily > |
|
class | IdGeometry |
|
class | IdLocalGeometry |
|
struct | IdBasicGeometry |
|
struct | IdGeometryTraits |
|
struct | IdLocalGeometryTraits |
|
class | IdIndexSet |
|
class | IdIntersection |
|
class | IdIntersectionIterator |
|
class | IdIterator |
|
struct | IdGridPartTraits |
|
struct | GridEntityAccess< Dune::Entity< codim, dim, GridFamily, IdEntity > > |
|
class | EntitySearch< IdGridPart< HostGridPart >, codim, partition > |
|
class | LeafGridPart |
|
class | LevelGridPart |
|
struct | DataOutputParameters |
| Parameter class for Dune::Fem::DataOutput. More...
|
|
class | DataOutput |
| Implementation of the Dune::Fem::IOInterface. This class manages data output. Available output formats are GRAPE, VTK and VTK Vertex projected using the VtxProjection operator. Details can be found in DiscFuncIO. More...
|
|
struct | DataWriterParameters |
|
class | DataWriter |
| Implementation of the Dune::IOInterface. This class manages data output. Available output formats are GRAPE, VTK and VTK Vertex projected using the VtxProjection operator. Details can be found in DiscFuncIO. More...
|
|
class | CheckPointerParameters |
| local parameter collection for CheckPointer More...
|
|
class | CheckPointer |
| Implementation of the IOInterface. This class manages checkpointing. More...
|
|
class | IOInterface |
| IOInterface to write data to hard disk. More...
|
|
class | FileIOLock |
| creates and removes lock file during backup process More...
|
|
class | FileIOCheckError |
| check if lock file exists and aborts if true More...
|
|
struct | IOTupleBase |
|
class | IOTuple |
|
class | IOTuple< std::tuple<> > |
|
struct | NoDataException |
|
class | AbstractColumnWriter |
| Class representing column writer in general. More...
|
|
struct | TupleDataSource |
|
struct | ArrayDataSource |
|
struct | EOCDataSource |
|
class | NumberColumnWriter |
| gets the N th element of a provided tuple assuming its a number More...
|
|
class | LatexTableWriter |
| writes latex tables based on user-defined row structure More...
|
|
class | PersistentObject |
| base class for persistent objects More...
|
|
struct | IsPersistent |
|
class | PersistenceManager |
| class with singleton instance managing all persistent objects More...
|
|
class | AutoPersistentObject |
| base class for auto persistent objects More...
|
|
class | VTKIO |
|
class | VTKFunctionWrapper |
|
class | VTKIOBase |
| Output using VTK. More...
|
|
class | VTKIO< GridPart, false > |
|
class | VTKIO< GridPart, true > |
|
struct | ParameterContainerData |
|
class | ParameterContainer |
|
class | ParameterNotFound |
|
class | ParameterInvalid |
|
struct | ParameterParser |
|
struct | ParameterParser< bool > |
|
struct | ParameterParser< FieldMatrix< F, m, n > > |
|
struct | BasicParameterReader |
|
class | Parameter |
| Container for User Specified Parameters. More...
|
|
struct | LocalParameter |
|
struct | LocalParameter< ParamDefault, ParamDefault > |
|
struct | ParameterDict |
|
struct | ASCIIOutStreamTraits |
|
class | ASCIIOutStream |
| output stream writing into an STL output stream using ASCII encoding More...
|
|
struct | ASCIIInStreamTraits |
|
class | ASCIIInStream |
| input stream reading from an STL input stream using ASCII decoding More...
|
|
class | BinaryFileOutStream |
| constructor More...
|
|
class | BinaryFileInStream |
| constructor More...
|
|
class | SIONlibOutStream |
| output stream writing into a single file with the SIONlib (http://www2.fz-juelich.de/jsc/sionlib/) More...
|
|
class | SIONlibInStream |
| input stream reading from a file in binary form More...
|
|
struct | StreamFactory< SIONlibInStream > |
| Factory class for Fem Streams to deal with different constructor parameters. More...
|
|
struct | ByteOrder |
|
struct | StandardOutStreamTraits |
|
class | StandardOutStream |
| output stream writing into a given std::ostream More...
|
|
struct | StandardInStreamTraits |
|
class | StandardInStream |
| input stream reading from a given std::istream More...
|
|
class | StreamError |
|
class | OutStreamInterface |
| abstract interface for an output stream More...
|
|
class | InStreamInterface |
| abstract interface for an input stream More...
|
|
struct | StreamFactory |
| Factory class for Fem Streams to deal with different constructor parameters. More...
|
|
struct | SelectUnsignedLongInteger |
|
struct | SelectUnsignedLongInteger< ulongint, ulongint > |
|
class | VirtualOutStreamObject |
|
struct | VirtualOutStreamTraits |
|
class | VirtualOutStream |
|
class | VirtualInStreamObject |
|
struct | VirtualInStreamTraits |
|
class | VirtualInStream |
|
class | VirtualOutStreamWrapper |
|
class | VirtualInStreamWrapper |
|
class | LocalFunctionalError |
|
class | BartonNackmanInterface |
|
struct | BoundaryIdProvider |
|
struct | BoundaryIdProvider< GeometryGrid< HostGrid, CoordFunction, Allocator > > |
|
struct | BoundaryIdProvider< OneDGrid > |
|
struct | BoundaryIdProvider< UGGrid< dim > > |
|
struct | BoundaryIdProvider< YaspGrid< dim, CoordCont > > |
|
struct | GeometryAffinityCheck |
| Helper class to check affinity of the grid's geometries. More...
|
|
struct | CheckCartesian |
| Helper class to check whether grid is structured or not. More...
|
|
class | DebugCounter |
| A counter only present if NDEBUG is not defined. More...
|
|
class | DebugLock |
|
class | IntegralBase |
|
class | Integral |
|
class | FlOpCounter |
|
class | Double |
|
class | FemEoc |
| Write a self contained tex table for eoc runs with timing information. More...
|
|
class | DefaultEocCalculator |
| Write a self contained tex table for eoc runs with timing information. More...
|
|
class | FemEocTable |
| The Fem Eoc Table writer. More...
|
|
struct | Timer |
|
struct | Timer< false > |
|
struct | Timer< true > |
|
class | FlopCounter |
| A class wrapper for the function PAPI_flops from the package PAPI. The results are CPU time, real and process local and the number of floating point operations in MFLOP/s. More...
|
|
class | FieldMatrixConverter |
|
class | FieldMatrixConverterRow |
|
class | FlatFieldMatrix |
|
class | FieldMatrixConverter< FieldVector< K, n *m >, FieldMatrix< K, n, m > > |
| convert a FieldVector with length n * m to a FieldMatrix with n rows and m cols More...
|
|
struct | DefaultAssign |
|
struct | AssignFunctor |
|
struct | AssignFunctor< T *, Assign > |
|
struct | AssignSingleFunctor |
|
struct | MatrixFunctor |
|
struct | IsGridFunctionView |
|
struct | GridFunctionView |
|
struct | GridFunctionView< GF, false > |
|
struct | GridFunctionView< GF, true > |
|
struct | GridName |
|
class | UnknownGridException |
|
struct | DummyObjectStream |
|
struct | GridObjectStreamTraits |
|
struct | GridObjectStreamTraits< const Grid > |
|
struct | GridObjectStreamTraits< GeometryGrid< HostGrid, CoordFunction, Allocator > > |
|
class | GridSolution |
| creates a function with evaluate method from a check point More...
|
|
class | GridSolutionVector |
|
class | GridWidthProvider |
| utility functions for calculating the maximum grid width More...
|
|
class | GridWidth |
| utility functions for calculating the maximum grid width More...
|
|
class | H1Norm |
|
class | L1Norm |
|
class | L2Norm |
|
class | WeightedL2Norm |
|
class | LineSegmentSampler |
| samples values of a discrete function along a given line segment More...
|
|
struct | OrderCalculatorInterface |
| Quadrature Order Interface. More...
|
|
struct | DefaultOrderCalculator |
| default Quadrature Order Calculator More...
|
|
class | LPNorm |
|
class | WeightedLPNorm |
|
struct | MapGeometryType |
|
struct | MPIManager |
|
class | DomainDecomposedIterator |
| Thread iterators using domain decomposition. More...
|
|
class | DomainDecomposedIteratorStorage |
| Storage of thread iterators using domain decomposition. More...
|
|
class | ThreadIterator |
| Thread iterators. More...
|
|
class | ThreadIteratorStorage |
| Storage of thread iterators. More...
|
|
class | ThreadIteratorStorageBase |
| Storage of thread iterators using domain decomposition. More...
|
|
struct | EmptyThreadManager |
|
class | ThreadSafeValue |
| ThreadSafeValue realizes thread safety for a given variable by creating an instance of this variable for each thread. More...
|
|
class | LocalMassMatrixImplementation |
| Local Mass Matrix inversion implementation, select the correct method in your implementation. More...
|
|
class | LocalMassMatrix |
| Local Mass Matrix for arbitrary spaces. More...
|
|
class | LocalMassMatrixImplementationDgOrthoNormal |
| DG Local Mass Matrix for arbitrary spaces. More...
|
|
class | AutomaticDifferenceOperator |
| operator providing a Jacobian through automatic differentiation More...
|
|
class | AutomaticDifferenceLinearOperator |
|
class | DifferentiableOperator |
| abstract differentiable operator More...
|
|
class | LocalContribution< AssembledOperator, AssemblyOperation, std::enable_if_t< Fem::IsAssembledOperator< AssembledOperator >::value > > |
|
class | MatrixColumnObject |
|
class | LocalMatrixInterface |
| Interface for local matrix classes. More...
|
|
class | LocalMatrixDefault |
| Default implementation for local matrix classes. More...
|
|
class | LocalMatrixEntry |
|
class | LocalMatrixColumn |
|
class | LocalMatrixColumn< TemporaryLocalMatrix< DomainSpace, RangeSpace > > |
|
class | LocalMatrixWrapper |
|
struct | LocalMatrixWrapperTraits |
|
class | LocalOperatorInterface |
|
class | LocalOperatorDefault |
| Default implementation of a local operator A local operator works on entities only and is used by a DiscreteOperator during a mesh traversal. This class implements the standard behaviour for prepareLocal(), finalizeLocal() and possibly other methods. More...
|
|
class | CombinedLocalOperator |
|
class | ScaledLocalOperator |
|
class | Mapping |
| A mapping from one vector space into another This class describes a general mapping from the domain vector space into the range vector space. It can also be used to construct linear combinations of mappings. More...
|
|
struct | MappingOperators |
| Implementation of Mapping +, -, *, / operations. More...
|
|
struct | ObjPointer |
|
class | ObjPointerStorage |
|
class | Operator |
| abstract operator More...
|
|
class | LinearOperator |
| abstract affine-linear operator More...
|
|
class | AssembledOperator |
| abstract matrix operator More...
|
|
class | SpaceOperatorInterface |
| interface for time evolution operators More...
|
|
class | SpaceOperatorStorage |
| only for keeping the pointer More...
|
|
class | SpaceOperatorPtr |
| only for keeping the pointer More...
|
|
class | SpaceOperatorWrapper |
| apply wrapper More...
|
|
class | Stencil |
| default implementation for a general operator stencil More...
|
|
class | SimpleStencil |
| a watered down stencil providing only the upper bound for the non-zero entries per row. More...
|
|
class | StencilWrapper |
| a simple wrapper class for sparsity patterns provide as vector< set< size_t > > More...
|
|
class | DiagonalStencil |
| Stencil contaning the entries (en,en) for all entities in the space. Defailt for an operator over a Lagrange space or a DG mass operator. More...
|
|
class | DiagonalAndNeighborStencil |
| Stencil contaning the entries (en,en) and (en,nb) for all entities en in the space and neighbors nb of en. Defailt for an operator over a DG space. More...
|
|
class | TemporaryLocalMatrix |
| A local matrix with a small array as storage. More...
|
|
struct | TemporaryLocalMatrixTraits |
|
class | TupleOperator |
|
class | RowTupleOperator |
|
class | DGHelmholtzJacobianOperator |
|
class | DGHelmholtzOperator |
|
class | BlockDiagonalLinearOperator |
| BlockDiagonalLinearOperator. More...
|
|
class | DenseRowLinearOperator |
|
class | HierarchicalLinearOperator |
|
struct | NumpyLinearOperator |
| NumpyLinearOperator. More...
|
|
struct | SparseRowLinearOperator |
| SparseRowLinearOperator. More...
|
|
class | DenseMatrix |
| DenseMatrix based on std::vector< std::vector< T > > More...
|
|
struct | ColumnObject |
|
class | DenseRowMatrix |
|
class | DenseRowMatrixObject |
|
struct | IndexFunctor |
|
struct | PairFunctor |
|
class | LagrangeParallelMatrixAdapter |
|
class | DGParallelMatrixAdapter |
|
struct | ISTLSolverParameter |
|
class | SparseRowMatrix |
| SparseRowMatrix. More...
|
|
class | SparseRowMatrixObject |
| SparseRowMatrixObject. More...
|
|
class | DGL2ProjectionImpl |
|
class | HdivProjection |
| H-div Projection for discontinuous discrete functions. The projection is described in detail in: More...
|
|
class | LocalL2Projection |
| please doc me More...
|
|
class | DefaultLocalL2Projection |
|
class | DenseLocalRieszProjection |
|
class | LocalRieszProjection |
| interface documentation of a local Riesz projection More...
|
|
class | OrthonormalLocalRieszProjection |
|
struct | WeightDefault |
|
struct | VtxProjectionImpl |
|
class | VtxProjection |
| The Projection class which average discontinuous function using the interpolation of the space (e.g. the Lagrangepoints) More...
|
|
class | Agglomeration |
| Agglomeration is a simple quadrature for polyhedral cells based on sub triangulation
More...
|
|
class | CacheStorage |
| Storage class for mappers. More...
|
|
class | CacheStorage< ct, dim, true > |
| Specialisation for grids with twist (i.e. unstructured ones). More...
|
|
class | CacheStorage< ct, dim, false > |
| Specialisation for grids without any twists (i.e. Cartesian ones). More...
|
|
class | CacheProvider |
|
class | CacheProvider< GridPart, 0 > |
|
class | CacheProvider< GridPart, 1 > |
|
struct | QuadratureKey |
|
struct | CachingTraits |
|
class | PointProvider |
|
class | PointProvider< ct, dim, 0 > |
|
class | PointProvider< ct, dim, 1 > |
|
class | QuadratureStorageRegistry |
|
class | TwistProvider |
| Access point for PointMapper objects with twist information PointMapper objects get created once and are reused as often as needed. The TwistProvider serves in this context as the single point of access which is responsible for the creation and management of these objects. TwistProvider follows the monostate pattern. More...
|
|
class | TwistMapperCreator |
| Helper class for TwistProvider which takes care of the creation process. More...
|
|
class | TwistStorage |
| Identifies quadrature points on faces with twists For a given quadrature type and a face with a given twist the TwistMapper provides a mapping from the quadrature point number on the twisted face to the quadrature point number on the (untwisted) reference face. (It removes the twist from the quadrature, so to say.) This is needed in unstructured grids when a quadrature point on a reference element's face needs to be transformed to a quadrature point in the reference element itself. More...
|
|
struct | TwistMapperStrategy |
| This class factors out all geometry dependent stuff in a strategy class. More...
|
|
class | PointTwistMapperStrategy |
|
class | LineTwistMapperStrategy |
|
class | TriangleTwistMapperStrategy |
|
class | QuadrilateralTwistMapperStrategy |
|
struct | TwistFreeTwistUtility |
| TwistFreeTwistUtility provides the default implementation for twistfree grid such as Cartesian grids. More...
|
|
struct | TwistUtility |
| Utility to get twist from IntersectionIterator, if provided by grid (i.e. AlbertaGrid, ALUGrid) otherwise return default values (correct for YASP). More...
|
|
struct | TwistUtility< GeometryGrid< HostGrid, CoordFunction, Allocator > > |
|
class | CachingInterface |
| interface a cachable quadrature has to implement More...
|
|
class | CachingPointList |
| integration point list supporting base function caching More...
|
|
class | CachingPointList< GridPartImp, 0, IntegrationTraits > |
| constructor More...
|
|
class | CachingPointList< GridPartImp, 1, IntegrationTraits > |
| constructor More...
|
|
class | CachingQuadrature |
| quadrature class supporting base function caching More...
|
|
class | CachingQuadrature< GridPart, 0, QuadratureTraits > |
| constructor More...
|
|
class | CachingQuadrature< GridPartImp, 1, QuadratureTraits > |
| constructor More...
|
|
class | CornerPointSet |
|
class | CornerPointList |
|
class | CornerPointSetTraits |
|
struct | DefaultQuadratureTraits |
|
struct | DefaultQuadratureTraits< FieldType, 0 > |
|
struct | DefaultQuadratureTraits< FieldType, 1 > |
|
struct | DefaultQuadratureTraits< FieldType, 2 > |
|
struct | DefaultQuadratureTraits< FieldType, 3 > |
|
class | QuadratureRulesFactory |
| quadrature implementation based on the standard DUNE quadratures More...
|
|
struct | DuneQuadratureTraits |
|
struct | DuneQuadratureTraits< FieldType, 0 > |
|
struct | DuneQuadratureTraits< FieldType, 1 > |
|
struct | DuneQuadratureTraits< FieldType, 3 > |
|
class | ElementIntegrationPointList |
| integration point list on the codim-0 reference element More...
|
|
class | ElementIntegrationPointList< GridPartImp, 0, IntegrationTraits > |
| constructor More...
|
|
class | ElementIntegrationPointList< GridPartImp, 1, IntegrationTraits > |
| constructor More...
|
|
class | ElementPointListBase |
| ElementPointListBase. More...
|
|
class | ElementPointListBase< GridPartImp, 0, IntegrationTraits > |
|
class | ElementQuadrature |
| quadrature on the codim-0 reference element More...
|
|
struct | ElementQuadratureTraits |
|
class | ElementQuadrature< GridPartImp, 0, QuadratureTraits > |
| constructor More...
|
|
class | ElementQuadrature< GridPartImp, 1, QuadratureTraits > |
| constructor More...
|
|
struct | SimplexMaxOrder |
|
class | SimplexQuadrature |
|
class | CubeQuadrature |
|
class | PrismQuadrature |
|
class | PyramidQuadrature |
|
class | PolyhedronQuadrature |
|
class | GaussPts |
| one-dimensional Gauss points and their weights More...
|
|
class | GaussLegendreQuadrature |
|
class | GeometryQuadrature |
|
class | GeometricQuadrature |
|
class | IdProvider |
| Singleton that manages a globally unique identifier. More...
|
|
class | Integrator |
| integrator for arbitrary functions providing evaluate More...
|
|
class | IntersectionQuadrature |
| IntersectionQuadrature is a helper class for creating the appropriate face quadratures for integrating over intersections. More...
|
|
class | LumpingQuadrature |
|
struct | DefaultLumpingQuadratureTraits |
|
class | PyramidPoints |
|
class | FemQuadratureKey |
| A simple quadrature key class for use FemPy. More...
|
|
class | QuadCreator |
| the actual quadrature storage More...
|
|
class | QuadratureProvider |
| provide a single instance pool of quadratures More...
|
|
class | QuadratureProvider< FieldImp, 0, QuadratureTraits > |
| provide a single instance pool of quadratures More...
|
|
class | QuadratureProvider< FieldImp, 1, QuadratureTraits > |
| provide a single instance pool of quadratures More...
|
|
class | QuadratureProvider< FieldImp, 2, QuadratureTraits > |
| provide a single instance pool of quadratures More...
|
|
class | QuadratureProvider< FieldImp, 3, QuadratureTraits > |
| provide a single instance pool of quadratures More...
|
|
class | QuadraturePointWrapper |
| wrapper for a (Quadrature,int) pair More...
|
|
class | QuadraturePointIterator |
| iterator over quadrature points More...
|
|
class | IntegrationPointList |
| actual interface class for integration point lists More...
|
|
class | Quadrature |
| actual interface class for quadratures More...
|
|
class | IntegrationPointListImp |
| Generic implementation of an IntegrationPointList. More...
|
|
class | QuadratureImp |
| Generic implementation of a Dune quadrature. More...
|
|
class | TestQuadrature |
|
struct | GalerkinOperator |
|
class | DifferentiableGalerkinOperator |
|
class | AutomaticDifferenceGalerkinOperator |
|
struct | ModelDifferentiableGalerkinOperator |
|
struct | IntegrandsTraits |
|
struct | FullIntegrands |
|
class | VirtualizedIntegrands |
|
struct | DiffusionModelIntegrands |
|
struct | DGDiffusionModelIntegrands |
|
struct | LinearizedScheme |
|
struct | MOLGalerkinOperator |
|
class | MOLDifferentiableGalerkinOperator |
|
class | MOLAutomaticDifferenceGalerkinOperator |
|
struct | MOLModelDifferentiableGalerkinOperator |
|
struct | AMGXSolverParameter |
|
class | AMGXInverseOperator |
| AMGX solver context for PETSc Mat and PETSc Vec. More...
|
|
struct | AMGXInverseOperatorTraits |
|
class | ConjugateGradientSolver |
| linear solver using the CG algorithm More...
|
|
class | CGInverseOperator |
| Inverse operator base on CG method. Uses a runtime parameter fem.preconditioning which enables diagonal preconditioning if diagonal matrix entries are available, i.e., Op :: assembled is true. More...
|
|
class | DiagonalPreconditionerBase |
|
class | DiagonalPreconditionerBase< DFImp, OperatorImp, true > |
|
class | DiagonalPreconditioner |
| Precondtioner, multiplies with inverse of the diagonal works with. More...
|
|
class | InverseOperatorInterface |
|
class | KrylovInverseOperator |
|
struct | KrylovInverseOperatorTraits |
|
struct | NewtonParameter |
|
class | NewtonInverseOperator |
| inverse operator based on a newton scheme More...
|
|
struct | SolverParameter |
|
class | PreconditionedInverseOperator |
|
class | TimeProviderBase |
| general base for time providers More...
|
|
class | FixedStepTimeProvider |
|
class | TimeProvider |
| manager for global simulation time of time-dependent solutions More...
|
|
class | GridTimeProvider |
| the same functionality as the Dune::TimeProvider. More...
|
|
class | BasisFunctionSet |
| Interface class for basis function sets. More...
|
|
class | DefaultBasisFunctionSet |
|
struct | AxpyFunctor |
|
struct | FunctionalAxpyFunctor |
|
class | InversePiolaTransformation |
|
class | PiolaTransformation |
|
class | SimpleBasisFunctionSet |
| This class is a simple basis function set which is needed for global basis functions sets (Fourier space etc.). More...
|
|
struct | JacobianTransformation |
|
struct | HessianTransformation |
|
class | TransformedBasisFunctionSet |
| implementation of a basis function set for given entity More...
|
|
struct | TupleSpaceProduct |
|
struct | TupleSpaceSummation |
|
class | TupleBasisFunctionSet |
|
class | DofAlignment |
| Interface documentation for Dof alignment classes used in VectorialBasisFunctionSet. More...
|
|
class | HorizontalDofAlignment |
| Implementation of DofAlignment. More...
|
|
class | VerticalDofAlignment |
| Implementation of DofAlignment. More...
|
|
class | SubDofVector |
| Extract Sub dof vector for single coordinate. More...
|
|
class | SubDofVector< DofVector, HorizontalDofAlignment< ScalarBasisFunctionSet, Range > > |
|
class | SubDofVector< DofVector, VerticalDofAlignment< ScalarBasisFunctionSet, Range > > |
|
class | VectorialBasisFunctionSet |
| Builds a vectorial basis function set from given scalar basis function set. More...
|
|
class | CombinedDofConversionUtility |
|
class | CombinedDofConversionUtility< ContainedMapper, N, PointBased > |
|
class | CombinedDofConversionUtility< ContainedMapper, N, VariableBased > |
| Specialisation for VariableBased approach. More...
|
|
class | CombinedSubMapper |
|
class | CombinedSpace |
|
class | CombinedSpace< DiscreteFunctionSpace, N, PointBased > |
| Combined Space Function Space. More...
|
|
class | CombinedSpace< DiscreteFunctionSpace, N, VariableBased > |
|
struct | DifferentDiscreteFunctionSpace< CombinedSpace< ContainedSpace, N, policy >, NewFunctionSpace > |
|
class | DefaultLocalRestrictProlong< CombinedSpace< DiscreteFunctionSpace, N, PointBased > > |
|
class | DefaultLocalRestrictProlong< CombinedSpace< DiscreteFunctionSpace, N, VariableBased > > |
|
class | GenericCombinedDiscreteFunctionSpace |
|
class | PowerSpaceInterpolation |
|
class | TupleSpaceInterpolation |
|
class | PowerLocalRestrictProlong |
|
class | PowerMapper |
| mapper allocating one DoF per subentity of a given codimension More...
|
|
class | PowerDiscreteFunctionSpace |
|
struct | PowerDiscreteFunctionSpaceTraits |
|
struct | DifferentDiscreteFunctionSpace< PowerDiscreteFunctionSpace< DiscreteFunctionSpace, N >, NewFunctionSpace > |
| specialization of DifferentDiscreteFunctionSpace for PowerDiscreteFunctionSpace More...
|
|
class | DefaultLocalRestrictProlong< PowerDiscreteFunctionSpace< DiscreteFunctionSpace, N > > |
|
struct | RowType |
|
struct | RowType< const T > |
|
struct | RowType< FieldVector< K, SIZE > > |
|
struct | RowType< ExplicitFieldVector< K, SIZE > > |
|
struct | RowType< FieldMatrix< K, ROWS, COLS > > |
|
class | SubObject |
|
class | TupleLocalRestrictProlong |
|
class | TupleMapper |
| mapper allocating one DoF per subentity of a given codimension More...
|
|
class | TupleDiscreteFunctionSpaceImpl |
|
struct | TupleDiscreteFunctionSpaceTraits |
|
struct | DifferentDiscreteFunctionSpace< TupleDiscreteFunctionSpaceImpl< CombineOp, DiscreteFunctionSpaces... >, NewFunctionSpace > |
| specialization of DifferentDiscreteFunctionSpace for TupleDiscreteFunctionSpace More...
|
|
class | DefaultLocalRestrictProlong< TupleDiscreteFunctionSpaceImpl< CombineOp, DiscreteFunctionSpaces ... > > |
|
class | AdaptationManagerInterface |
| AdaptationManagerInterface class. More...
|
|
class | AdaptationMethod |
| AdaptationMethod is a simple adaptation method reader class. More...
|
|
class | AdaptationManagerBase |
| This class manages the adaptation process. If the method adapt is called, then the grid is adapted and also all the data belonging to the given dof manager will be rearranged for data set where it is necessary to keep the data. More...
|
|
struct | AdaptationManagerReferenceFactory |
| factory class to create adaptation manager reference counter More...
|
|
class | AdaptationManager |
| This class manages the adaptation process including a load balancing after the adaptation step. This class is created by the AdaptationManager for each grid instance. See AdaptationManager for details. More...
|
|
struct | GlobalRefine |
| A class with one static method apply to globally refine a grid. All index sets are adapted to the new grid and the managed dof storage is expanded - but no prolongation or restriction of data is performed. More...
|
|
struct | LocalRefine |
| A class with one static method apply for invoking the local adaptation procedure on a given grid instance. All index sets are adapted to the new grid and the managed dof storage is expanded - but no prolongation or restriction of data is performed. More...
|
|
class | RestrictProlongWrapper |
|
class | GeometryInformation |
| ReferenceVolume and local bary center keeper class. More...
|
|
class | AllGeomTypes |
| default implementation uses method geomTypes of given index set. Used in DiscreteFunctionSpaces. More...
|
|
class | AuxiliaryDofs |
| In parallel computations the dofs of a discrete function are made up by all primary dofs. For technical reasons some dofs exists on multiply processes but are only primary on exactly one process. Dofs on processes that are not primary are called auxiliary. More...
|
|
struct | PrimaryDofs |
| In parallel computations the dofs of a discrete function are made up by all primary dofs. For technical reasons some dofs exists on multiply processes but are only primary on exactly one process. More...
|
|
struct | PrimaryDofs< AuxiliaryDofs< GridPart, Mapper > > |
|
class | BaseSetLocalKeyStorage |
| storage class for base function set pointer and compiled local key pointers More...
|
|
class | CompiledLocalKeyContainer |
| class for storage local keys for a given range of polynomial order and available geometry type More...
|
|
class | PetscDiscreteFunction |
|
class | CommunicationIndexMap |
|
struct | CombinedDataType |
|
struct | CombinedDataType< DataHandle > |
|
struct | CombinedDataType< DataHandle, Tail... > |
|
class | CombinedDataHandle |
| combine multiple data handles into one More...
|
|
struct | DFCommunicationOperation |
| Mathematical operation apply during communication to data that is communicated enum of all avialable operations. More...
|
|
class | LoadBalanceLeafData |
| check for sets of entities for the load balance procedure More...
|
|
class | DefaultCommunicationManager |
| default communication manager using just the grids communicate method More...
|
|
class | CommunicationManager |
| use Default CommunicationManager as Communication Manager More...
|
|
class | CommunicationManagerList |
| Proxy class to DependencyCache which is singleton per space. More...
|
|
class | DofManager |
|
class | LocalInlinePlus |
|
struct | DataCollectorTraits |
|
class | CombinedLocalDataCollect |
|
class | LocalInterface |
|
class | DataCollectorInterface |
|
class | DummyDataCollector |
| empty data collector More...
|
|
class | DataCollector |
| The DataCollector is an example for a grid walk done while load balancing moves entities from one processor to another. The Communicator or grid should call the inlineData (write Data to ObjectStream) and the xtractData (read Data from Stream) and provide the macro level Entity<codim =0> and the ObjectStream. This Operator then does the hierarhic walk and calls its local pack operators which know the discrete functions to pack to the stream. More...
|
|
struct | LocalDataInlinerTraits |
|
class | LocalDataInliner |
| Inline DiscreteFunction data during load balancing. More...
|
|
struct | LocalDataXtractorTraits |
|
class | LocalDataXtractor |
| Inline DiscreteFunction data during load balancing. More...
|
|
class | DefaultCommunicationHandler |
| Default communication handler for discrete functions. More...
|
|
class | ExportsDiscreteFunctionSpaceType |
|
struct | isGenericDiscreteFunctionSpace |
|
struct | DifferentDiscreteFunctionSpace |
|
struct | DifferentDiscreteFunctionSpace< DiscreteFunctionSpaceImp< FunctionSpaceImp, GridPartImp, polOrd, StorageImp >, NewFunctionSpace > |
|
struct | DifferentDiscreteFunctionSpace< DiscreteFunctionSpaceImp< FunctionSpaceImp, GridPartImp, polOrd, caching >, NewFunctionSpace > |
|
class | DiscreteFunctionSpaceInterface |
| This is the interface for discrete function spaces. All methods declared here have to be implemented by the implementation class. More...
|
|
class | DiscreteFunctionSpaceDefault |
| This is the class with default implementations for discrete function. The methods not marked with having a default in the interface class must be provided by the implementation; all other methods have a default implementation here. More...
|
|
class | DiscreteFunctionSpaceAdapter |
| Create Obejct that behaves like a discrete function space without to provide functions with the iterator facilities. More...
|
|
class | BaseFunctionSetSingletonFactory |
| BasisFunctionSetSingletonFactory provides method createObject and deleteObject for the SingletonList. More...
|
|
class | DofManagerFactory |
| Singleton provider for the DofManager. More...
|
|
class | ManagedIndexSetInterface |
|
class | RemoveIndicesFromSet |
|
class | InsertIndicesToSet |
|
class | ManagedIndexSet |
|
class | DofStorageInterface |
| Interface class for a dof storage object to be stored in discrete functions. More...
|
|
class | ManagedDofStorageInterface |
| Interface class for a dof storage object that can be managed (resized and compressed) by the DofManager. More...
|
|
class | ResizeMemoryObjects |
|
class | ReserveMemoryObjects |
|
class | ManagedDofStorageImplementation |
|
class | ManagedDofStorage |
|
class | IndexSetRestrictProlong |
|
class | EmptyIndexSetRestrictProlong |
|
class | DofManError |
|
class | DofConversionUtility |
|
class | DofConversionUtility< PointBased > |
| Specialisation for PointBased approach. More...
|
|
class | DofConversionUtility< VariableBased > |
| Specialisation for VariableBased approach. More...
|
|
class | PointBasedDofConversionUtility |
| Specialisation for PointBased approach. More...
|
|
class | FunctionSpace |
| A vector valued function space. More...
|
|
struct | VectorSpaceTraits |
| Traits class for vector function spaces. More...
|
|
class | MatrixFunctionSpace |
| A matrix valued function space. More...
|
|
class | RangeMatrix |
| RangeType class for matrix valued functions - derived from FieldMatrix but has representation as vector. More...
|
|
class | MatrixMapping |
| JacobianRangeType class for matrix valued functions - derived from FieldMatrix. More...
|
|
struct | MatrixSpaceTraits |
| Traits class for matrix valued spaces. More...
|
|
struct | ToNewDimDomainFunctionSpace |
| convert functions space to space with new dim domain More...
|
|
struct | ToNewDimRangeFunctionSpace |
| convert functions space to space with new dim range More...
|
|
struct | ToNewDimDomainFunctionSpace< FunctionSpace< DomainFieldImp, RangeFieldImp, dimDomain, dimRange >, newDimDomain > |
| specialization for parameter list <domainfile,rangefield,dimDomain,dimRange,newDimDomain> More...
|
|
struct | ToNewDimDomainFunctionSpace< MatrixFunctionSpace< DomainFieldImp, RangeFieldImp, n, m1, m2 >, newDimDomain > |
| specialization for parameter list <domainfile,rangefield,dimDomain,dimRange,dimLocal> More...
|
|
struct | ToNewDimRangeFunctionSpace< FunctionSpace< DomainFieldImp, RangeFieldImp, dimDomain, dimRange >, newDimRange > |
| specialization for parameter list <domainfile,rangefield,dimDomain,dimRange,dimLocal> More...
|
|
class | FunctionSpaceInterface |
| interface for an arbitrary function space More...
|
|
class | LoadBalancerInterface |
| Interface class for load balancing. More...
|
|
class | LoadBalancer |
| This class manages the adaptation process. If the method adapt is called, then the grid is adapted and also all the data belonging to the given dof manager will be rearranged for data set where it is necessary to keep the data. More...
|
|
class | LocalInterpolation |
|
class | LocalInterpolationWrapper |
|
class | DefaultLocalRestrictProlong |
|
class | ConstantLocalRestrictProlong |
|
class | EmptyLocalRestrictProlong |
|
class | ProlongFunction |
| prolong discrete functions between grid levels More...
|
|
class | RestrictFunction |
| restrict discrete functions between grid levels More...
|
|
class | RestrictProlongInterface |
| Interface class defining the local behaviour of the restrict/prolong operation (using BN) More...
|
|
struct | RestrictProlongTraits |
| Traits class for derivation from RestrictProlongInterface. More...
|
|
class | RestrictProlongInterfaceDefault |
| Interface default implementation for derived classes. More...
|
|
class | RestrictProlongDefault |
| This is a wrapper for the default implemented restriction/prolongation operator, which only takes a discrete function template. More...
|
|
class | RestrictProlongTuple |
| combine a variadic number of Dune::Fem::RestrictProlongInterface instances into a single object again derived from Dune::Fem::RestrictProlongInterface More...
|
|
class | RestrictProlongDefaultTuple |
| conveniently set up a tuple of Dune::Fem::RestrictProlongDefault restriction/prolongation objects created from a variadic list of discrete functions More...
|
|
class | RestrictProlongTuple< Head, Tail... > |
|
struct | RestrictProlongDefaultTraits |
|
struct | RestrictProlongDefaultTraits< std::tuple< DiscreteFunctions &... > > |
|
struct | DefaultUniqueFacetOrientation |
|
struct | CartesianUniqueFacetOrientation |
|
class | BasisFunctionSets |
| interface class representing a family of basis function sets More...
|
|
class | DefaultBasisFunctionSets |
| generate a set of default basis function sets from given set of shape function sets More...
|
|
class | DiscontinuousGalerkinSpace |
|
class | LagrangeDiscontinuousGalerkinSpace |
|
class | LegendreDiscontinuousGalerkinSpace |
|
class | HierarchicLegendreDiscontinuousGalerkinSpace |
|
class | GenericDiscontinuousGalerkinSpace |
| generic implementation of a Discontinuous Galerkin space based on a fixed family of basis function sets More...
|
|
class | DiscontinuousGalerkinLocalL2Projection |
|
class | LocalOrthonormalL2Projection |
| specialization of local L2 projection for orthonormal DG spaces More...
|
|
struct | LagrangeDiscontinuousGalerkinSpaceTraits |
|
struct | LegendreDiscontinuousGalerkinSpaceTraits |
|
class | LegendreDiscontinuousGalerkinSpaceBase |
|
class | LocalMassMatrix< DiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, BaseFunctionStorageImp >, VolumeQuadratureImp > |
| Local Mass Matrix for DG space. More...
|
|
class | LocalMassMatrix< LegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, BaseFunctionStorageImp >, VolumeQuadratureImp > |
| Local Mass Matrix for Legendre space. More...
|
|
class | LocalMassMatrix< HierarchicLegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, BaseFunctionStorageImp >, VolumeQuadratureImp > |
| Local Mass Matrix for hierarchic Legendre space. More...
|
|
class | DiscontinuousGalerkinLocalInterpolation |
|
class | DiscontinuousGalerkinLocalRestrictProlong |
|
class | DefaultLocalRestrictProlong< DiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, StorageImp > > |
|
class | DefaultLocalRestrictProlong< DiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, 0, StorageImp > > |
|
class | DefaultLocalRestrictProlong< LegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, StorageImp > > |
|
class | DefaultLocalRestrictProlong< LegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, 0, StorageImp > > |
|
class | DefaultLocalRestrictProlong< HierarchicLegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, StorageImp > > |
|
class | DefaultLocalRestrictProlong< HierarchicLegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, 0, StorageImp > > |
|
class | DefaultLocalRestrictProlong< LagrangeDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, StorageImp > > |
|
class | DefaultLocalRestrictProlong< LagrangeDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, 0, StorageImp > > |
|
class | ShapeFunctionSets |
| interface class representing a family of shape function sets More...
|
|
class | CachedShapeFunctionSets |
|
class | SelectCachingShapeFunctionSets |
|
class | VectorialShapeFunctionSets |
|
struct | DiscontinuousGalerkinSpaceTraits |
|
class | TupleDiscontinuousGalerkinSpace |
|
class | TupleLocalInterpolation |
|
class | TupleDiscontinuousGalerkinSpaceBasisFunctionSets |
|
struct | TupleDiscontinuousGalerkinSpaceTraits |
|
struct | DifferentDiscreteFunctionSpace< TupleDiscontinuousGalerkinSpace< DFS... >, NewFunctionSpace > |
|
class | DefaultLocalRestrictProlong< TupleDiscontinuousGalerkinSpace< DFS... > > |
|
struct | FiniteVolumeBasisFunctionSet |
|
class | FiniteVolumeBasisFunctionSets |
|
class | FiniteVolumeSpace |
|
class | FiniteVolumeLocalInterpolation |
|
struct | FiniteVolumeSpaceTraits |
|
class | LocalMassMatrix< FiniteVolumeSpace< FunctionSpaceImp, GridPartImp, polOrd, BaseFunctionStorageImp >, VolumeQuadratureImp > |
| Local Mass Matrix for FV space. More...
|
|
class | DefaultLocalRestrictProlong< FiniteVolumeSpace< FunctionSpace, GridPart, codim, Storage > > |
|
class | FourierDiscreteFunctionSpace |
|
struct | IsFourierDiscreteFunctionSpace |
|
struct | IsFourierDiscreteFunctionSpace< FourierDiscreteFunctionSpace< FunctionSpace, GridPart, order > > |
|
class | FourierDofMapper |
|
struct | FourierDofMapperTraits |
|
struct | FourierFunctionSetSize |
|
class | FourierFunctionSet |
|
class | FourierFunctionSet< FunctionSpace< DomainFieldType, RangeFieldType, 1, 1 >, Order > |
|
class | FourierFunctionSet< FunctionSpace< DomainFieldType, RangeFieldType, dimDomain, 1 >, Order > |
|
struct | FourierDiscreteFunctionSpaceTraits |
|
class | LocalMassMatrix< hpDG::OrthogonalDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, Storage >, VolumeQuadratureImp > |
| Local Mass Matrix for hierarchic Legendre space. More...
|
|
class | DefaultLocalRestrictProlong< LagrangeDiscreteFunctionSpace< FunctionSpaceType, GridPartType, maxPolOrder, StorageType > > |
|
struct | LagrangeDofMapperCodeFactory |
|
class | LagrangeLocalDofMapping |
|
class | GenericLagrangeBaseFunction |
|
class | GenericLagrangeBaseFunction< FunctionSpace, PointGeometry, order > |
|
class | GenericLagrangeBaseFunction< FunctionSpace, PyramidGeometry< BaseGeometryType >, 0 > |
|
class | GenericLagrangeBaseFunction< FunctionSpace, PyramidGeometry< BaseGeometryType >, order > |
|
class | GenericLagrangeBaseFunction< FunctionSpace, ProductGeometry< FirstGeometryType, SecondGeometryType >, order > |
|
class | PointGeometry |
| generic geometry modelling a single point More...
|
|
class | PyramidGeometry |
| generic geometry modelling a pyramid over a base geometry More...
|
|
class | ProductGeometry |
| generic geometry modelling the product of two base geometries More...
|
|
class | GeometryWrapper |
|
class | GeometryWrapper< id, 1 > |
|
class | GeometryWrapper< id, 0 > |
|
class | LocalCoordinate |
|
class | LocalCoordinate< PointGeometry, Field, offset > |
|
class | LocalCoordinate< PyramidGeometry< BaseGeometry >, Field, offset > |
|
class | LocalCoordinate< ProductGeometry< FirstGeometry, SecondGeometry >, Field, offset > |
|
class | GenericLagrangePoint |
|
class | GenericLagrangePoint< PointGeometry, order, bottom > |
|
class | GenericLagrangePoint< PyramidGeometry< BaseGeometry >, 0, bottom > |
|
class | GenericLagrangePoint< PyramidGeometry< BaseGeometry >, order, bottom > |
|
class | GenericLagrangePoint< ProductGeometry< FirstGeometry, SecondGeometry >, order, bottom > |
|
class | LagrangeLocalInterpolation |
|
class | LagrangePoint |
| A single lagrange point. More...
|
|
class | LagrangePointInterface |
|
class | LagrangePointImplementation |
|
class | LagrangePointListInterface |
| Set of lagrange points. More...
|
|
class | LagrangePointListImplementation |
|
struct | LagrangePointSetTraits |
|
class | LagrangePointSet |
|
class | SubEntityLagrangePointIterator |
|
class | SubEntityLagrangePointIterator< GridPart, 0, polOrder > |
|
struct | LagrangeLocalRestrictProlong |
|
class | LagrangeShapeFunctionInterface |
| abstract base class for Lagrange shape functions More...
|
|
class | LagrangeShapeFunction |
| implementation of Lagrange shape function using generic Lagrange shape functions More...
|
|
class | LagrangeShapeFunctionFactory |
| factory class More...
|
|
class | LagrangeShapeFunctionSet |
| Lagrange shape function set. More...
|
|
struct | LagrangeDiscreteFunctionSpaceTraits |
|
class | LagrangeMapperSingletonKey |
|
struct | LagrangeMapperSingletonFactory |
|
class | LocalFiniteElementSpace |
| Rannacher-Turek Space. More...
|
|
class | DiscontinuousLocalFiniteElementSpace |
| Rannacher-Turek Space. More...
|
|
struct | FixedOrderLagrangeFiniteElementMap |
|
struct | DiscontinuousLocalFiniteElementSpaceTraits |
|
struct | FixedPolyOrder_ |
|
struct | FixedPolyOrder_< LFEMap, std::enable_if_t< LFEMap::numBasisFunctions >=0, std::true_type > |
|
struct | ToNewDimRangeFunctionSpace< DiscontinuousLocalFiniteElementSpace< LFEMap, FunctionSpace, Storage >, newRange > |
|
struct | DifferentDiscreteFunctionSpace< DiscontinuousLocalFiniteElementSpace< LFEMap, FunctionSpace, Storage >, NewFunctionSpace > |
|
class | LocalFiniteElementInterpolation |
|
class | LocalFiniteElementInterpolation< Space, LocalInterpolation, false > |
|
class | LocalFiniteElementInterpolation< Space, LocalInterpolation, true > |
|
class | LocalFEInterpolationWrapper |
|
class | DefaultLocalRestrictProlong< LocalFiniteElementSpace< LFEMap, FunctionSpace, Storage > > |
|
class | DefaultLocalRestrictProlong< DiscontinuousLocalFiniteElementSpace< LFEMap, FunctionSpace, Storage > > |
|
class | LocalFunctionsShapeFunctionSetTraits |
|
class | LocalFunctionsShapeFunctionSet |
|
struct | LocalFiniteElementSpaceTraits |
|
struct | ToNewDimRangeFunctionSpace< LocalFiniteElementSpace< LFEMap, FunctionSpace, Storage >, newRange > |
|
struct | DifferentDiscreteFunctionSpace< LocalFiniteElementSpace< LFEMap, FunctionSpace, Storage >, NewFunctionSpace > |
|
class | DofMapperCode |
|
class | DofMapperCodeWriter |
|
class | CodimensionMapper |
| mapper allocating one DoF per subentity of a given codimension More...
|
|
class | DofMapper |
| Interface for calculating the size of a function space for a grid on a specified level. Furthermore the local to global mapping of dof number is done. Also during grid adaptation this mapper knows about old and new indices of entities. More...
|
|
class | AdaptiveDofMapper |
| Extended interface for adaptive DoF mappers. More...
|
|
class | DynamicNonBlockMapper |
|
class | DynamicNonBlockMapper< DynamicNonBlockMapper< BlockMapper > > |
|
class | DynamicNonBlockMapper< NonBlockMapper< BlockMapper, innerBlockSize > > |
|
class | NonBlockMapper< DynamicNonBlockMapper< BlockMapper >, outerBlockSize > |
|
class | DofMapperError |
|
class | GenericAdaptiveDofMapper |
|
struct | MasterDofs |
|
class | GhostDofMapper |
|
class | AuxiliaryDofs< GridPart, GhostDofMapper< GridPart, BaseMapper, GlobalKey > > |
|
struct | MasterDofs< AuxiliaryDofs< GridPart, GhostDofMapper< GridPart, BaseMapper, GlobalKey > > > |
|
class | DefaultLocalDofMapping |
|
class | IndexSetDofMapper |
|
struct | LocalKey |
|
class | NonBlockMapper |
|
class | NonBlockMapper< NonBlockMapper< BlockMapper, innerBlockSize >, outerBlockSize > |
|
class | ParallelDofMapper |
|
struct | LocalBubbleElementInterpolation |
|
struct | BubbleElementLocalKeyMap |
|
struct | BubbleElementDofMapperCodeFactory |
|
class | SimplexBubbleElementShapeFunctionSet |
|
class | Cube2DBubbleElementShapeFunctionSet |
|
class | BubbleElementSpace |
| [Class definition for new space] More...
|
|
struct | BubbleElementSpaceTraits |
|
struct | DifferentDiscreteFunctionSpace< BubbleElementSpace< FunctionSpace, GridPart, Storage >, NewFunctionSpace > |
|
class | DefaultLocalRestrictProlong< BubbleElementSpace< FunctionSpace, GridPart, Storage > > |
|
class | DefaultLocalRestrictProlong< Fem::PAdaptiveLagrangeSpace< FS, GP, ord, S > > |
|
class | DefaultLocalRestrictProlong< Fem::PAdaptiveDGSpace< FunctionSpaceImp, GridPartImp, polOrd, StorageImp > > |
|
class | DefaultLocalRestrictProlong< Fem::PAdaptiveDGSpace< FunctionSpaceImp, GridPartImp, 0, StorageImp > > |
|
class | PAdaptiveDGSpace |
| adaptive DG discrete function space More...
|
|
class | PAdaptiveLagrangeSpace |
| Lagrange discrete function space. More...
|
|
struct | PAdaptiveDGSpaceTraits |
|
class | GenericDiscreteFunctionSpace |
| Please doc me. More...
|
|
struct | PAdaptiveLagrangeSpaceTraits |
|
class | PAdaptiveLagrangeMapper |
|
struct | PAdaptiveLagrangeMapperTraits |
|
class | PAdaptiveDGMapper |
|
struct | PAdaptiveDGMapperTraits |
|
struct | PLagrangeLocalRestrictProlong |
|
class | RaviartThomasLocalInterpolation |
|
class | CachingShapeFunctionSet |
|
class | LegendreShapeFunction |
| implementation of a single scalar-valued Legendre shape function More...
|
|
class | LegendreShapeFunctionSet |
| a Dune::Fem::ShapeFunctionSet of Legendre ansatz polynomials More...
|
|
class | LegendrePolynomials |
|
class | OrthonormalBase_1D |
|
class | OrthonormalBase_2D |
|
class | OrthonormalBase_3D |
|
class | OrthonormalShapeFunctionSet |
|
class | ShapeFunctionSetProxy |
|
class | CachingStorage |
|
class | SimpleStorage |
|
class | CodegenStorage |
|
class | SelectCachingShapeFunctionSet |
|
class | SelectCachingShapeFunctionSet< ShapeFunctionSet, CachingStorage > |
|
class | SelectCachingShapeFunctionSet< ShapeFunctionSet, SimpleStorage > |
|
class | SelectCachingShapeFunctionSet< ShapeFunctionSet, CodegenStorage > |
|
class | ShapeFunctionSet |
| Interface class for shape function sets. More...
|
|
class | AbstractShapeFunction |
|
class | SimpleShapeFunctionSet |
|
class | TensorProductShapeFunctionSet |
|
class | TupleShapeFunctionSet |
|
struct | MakeVectorialTraits |
|
struct | MakeVectorialTraits< FieldVector< K, 1 >, FieldVector< K, dimR > > |
|
struct | MakeVectorialTraits< ExplicitFieldVector< K, 1 >, ExplicitFieldVector< K, dimR > > |
|
struct | MakeVectorialTraits< FieldMatrix< K, 1, dimD >, FieldMatrix< K, dimR, dimD > > |
|
class | BasicMakeVectorialExpression |
|
class | MakeVectorialExpression |
|
class | MakeVectorialExpression< FieldVector< K, 1 >, FieldVector< K, dimR > > |
|
class | MakeVectorialExpression< FieldMatrix< K, 1, dimD >, FieldMatrix< K, dimR, dimD > > |
|
struct | ToNewRange |
|
struct | ToNewRange< FunctionSpace< DomainField, RangeField, dimD, 1 >, FieldVector< RangeField, dimR > > |
|
class | VectorialShapeFunctionSet |
|
class | IdShapeFunctionSet |
|
class | StaticArray |
| An implementation of DenseVector which uses a C-array of fixed size as storage. More...
|
|
class | StandardArrayAllocator |
| oriented to the STL Allocator funtionality More...
|
|
class | PODArrayAllocator |
|
class | DynamicArray |
| An implementation of DenseVector which uses a C-array of dynamic size as storage. More...
|
|
class | Envelope |
|
class | ObjectStack |
|
class | ObjectStackEntry |
|
struct | ObjectStackEntryTraits |
|
class | ReferenceCounterInterface |
| interface for objects capable of reference counting More...
|
|
struct | SupportsReferenceCounterInterface |
|
class | ReferenceCounterDefault |
| default implementation of ReferenceCounterInterface More...
|
|
class | ObjectPointer |
| models a pointer to a reference countable object More...
|
|
class | DynamicReferenceVector |
| An implementation of DenseVector which uses a std::vector of references as storage. More...
|
|
class | RowReferenceVector |
|
class | Singleton |
| return singleton instance of given Object type. More...
|
|
struct | DefaultSingletonFactory |
|
class | SingletonList |
| Singleton list for key/object pairs. More...
|
|
class | SubVector |
| An implementation of DenseVector to extract a portion, not necessarly contiguos, of a vector. More...
|
|
class | IndexMapperInterface |
| Abstract index mapper interface. More...
|
|
class | OffsetSubMapper |
| Index mapper which simply adds an offset to the index. More...
|
|
class | StaticOffsetSubMapper |
| Index mapper with static size which simply adds an offset to the index. More...
|
|
|
template<class Object , class... Args> |
static auto | bindGuard (Object &object, Args &&... args) -> std::enable_if_t< isBindable< Object, Args... >::value, BindGuard< Object > > |
|
template<std::size_t... i, class Objects , class... Args> |
static auto | bindGuard (std::index_sequence< i... >, Objects objects, Args &&... args) -> std::tuple< decltype(bindGuard(std::declval< std::tuple_element_t< i, Objects > >(), std::declval< Args >()...))... > |
|
template<class... Object, class... Args> |
static auto | bindGuard (std::tuple< Object &... > objects, Args &&... args) -> decltype(bindGuard(std::index_sequence_for< Object... >(), objects, std::forward< Args >(args)...)) |
|
template<class Point > |
static const Point & | coordinate (const Point &x) |
|
template<class GF , class Intersection > |
constexpr auto | hasIntersectionBind (const MetaType< Intersection > &) -> decltype(std::declval< GF & >().bind(std::declval< const Intersection & >(), IntersectionSide::in), std::true_type{}) |
|
template<class GF > |
constexpr auto | hasIntersectionBind (...) -> std::false_type |
|
template<class GF , class Intersection > |
void | defaultIntersectionBind (GF &gf, const Intersection &intersection, IntersectionSide side) |
|
template<class T , std::enable_if_t< !std::is_base_of< std::enable_shared_from_this< std::decay_t< T > >, std::decay_t< T > >::value, int > = 0> |
static std::shared_ptr< T > | referenceToSharedPtr (T &t) |
|
template<class StreamTraits , class Impl > |
OutStreamInterface< StreamTraits > & | operator<< (OutStreamInterface< StreamTraits > &out, const DiscreteFunctionInterface< Impl > &df) |
| write a discrete function into an output stream More...
|
|
template<class StreamTraits , class Impl > |
InStreamInterface< StreamTraits > & | operator>> (InStreamInterface< StreamTraits > &in, DiscreteFunctionInterface< Impl > &df) |
| read a discrete function from an input stream More...
|
|
template<class DofVector , class Functor > |
static DofBlockFunctor< DofVector, Functor > | dofBlockFunctor (DofVector &dofVector, Functor functor) |
|
template<class Function , class GridPart > |
static GridFunctionAdapter< Function, GridPart > | gridFunctionAdapter (std::string name, const Function &function, const GridPart &gridPart, unsigned int order) |
| convert a function to a grid function More...
|
|
template<class Function , class GridPart > |
static GridFunctionAdapter< Function, GridPart > | gridFunctionAdapter (const Function &function, const GridPart &gridPart, unsigned int order) |
| convert a function to a grid function More...
|
|
template<class Function , class GridPart > |
static GridFunctionAdapter< Function, GridPart > | gridFunctionAdapter (std::string name, Function &function, const GridPart &gridPart, unsigned int order) |
| convert a function to a grid function More...
|
|
template<class Function , class GridPart > |
static GridFunctionAdapter< Function, GridPart > | gridFunctionAdapter (Function &function, const GridPart &gridPart, unsigned int order) |
| convert a function to a grid function More...
|
|
template<class Function , class GridPart > |
static BasicGridFunctionAdapter< Function, GridPart > | gridFunctionAdapter (std::string name, Function &&function, const GridPart &gridPart, unsigned int order) |
| convert a function to a grid function More...
|
|
template<class Function , class GridPart > |
static BasicGridFunctionAdapter< Function, GridPart > | gridFunctionAdapter (Function &&function, const GridPart &gridPart, unsigned int order) |
| convert a function to a grid function More...
|
|
template<class Function , class GridPart > |
ConvertToGridFunction< Function, GridPart > | convertToGridFunction (const std::string &name, const Function &function, const GridPart &gridPart) |
|
template<class Function > |
InstationaryFunction< Function, __InstationaryFunction::HoldCopy > | instationaryFunction (Function function, double time) |
|
template<class Function > |
InstationaryFunction< typename std::remove_const< Function >::type, __InstationaryFunction::HoldReference > | instationaryFunction (std::reference_wrapper< Function > function, double time) |
|
template<typename DF > |
IteratorRange< typename DF::DiscreteFunctionSpaceType::IteratorType > | entities (const DF &df) |
| Iterator ranges for entities and DOFs to support iteration with range-based for loops. More...
|
|
template<typename DF > |
IteratorRange< typename DF::DofIteratorType > | dofs (DF &df) |
| Iterates over all DOFs. More...
|
|
template<typename DF > |
IteratorRange< typename DF::ConstDofIteratorType > | dofs (const DF &df) |
| Iterates over all DOFs. More...
|
|
template<class GP , class LF > |
constexpr detail::canBind_t< GP, LF > | checkGridPartValid () |
|
template<class F , std::enable_if_t<!IsConstLocalFunction< F >::value, int > = 0> |
constexpr auto | constLocalFunction (F &&f) |
|
template<class F , std::enable_if_t< IsConstLocalFunction< F >::value, int > = 0> |
constexpr decltype(auto) | constLocalFunction (F &&f) |
|
template<class F , class Entity > |
constexpr auto | constLocalFunction (F &&f, const Entity &entity) |
|
template<class HostLocalFunction , class Converter > |
LocalFunctionConverter< HostLocalFunction, Converter, __InstationaryFunction::HoldCopy > | localFunctionConverter (HostLocalFunction hostLocalFunction, const Converter &converter=Converter()) |
|
template<class HostLocalFunction , class Converter > |
LocalFunctionConverter< typename std::remove_const< HostLocalFunction >::type, Converter, __InstationaryFunction::HoldReference > | localFunctionConverter (std::reference_wrapper< HostLocalFunction > hostLocalFunction, const Converter &converter=Converter()) |
|
template<class Entity > |
const GridEntityAccess< Entity >::GridEntityType & | gridEntity (const Entity &entity) |
|
template<class T > |
static bool | readParameter (std::istream &file, const std::string keyword, T &data, bool verbose=true, bool warn=true) |
|
template<class T > |
static bool | readParameter (const std::string filename, const std::string keyword, T &data, bool verbose=true, bool warn=true) |
|
template<class Grid , class... Args, std::enable_if_t< Std::And(Impl::ValidDataOutputArgument< Args >::value...), int > = 0> |
static auto | dataOutput (const Grid &grid, Args &&... args) |
|
template<class Grid , class... Args, std::enable_if_t< Std::And(Impl::ValidDataOutputArgument< Args >::value...), int > = 0> |
static auto | dataOutput (const Grid &grid, const TimeProviderBase &tp, Args &&... args) |
|
std::string | generateFilename (const std::string &fn, int ntime, int precision=6) |
|
template<class ObjectType > |
PersistenceManager & | operator<< (PersistenceManager &pm, ObjectType &object) |
|
template<class ObjectType > |
PersistenceManager & | operator>> (PersistenceManager &pm, ObjectType &object) |
|
bool | createDirectory (const std::string &name) |
| create a directory More...
|
|
bool | fileExists (const std::string &name) |
| check whether a file exists More...
|
|
bool | directoryExists (const std::string &name) |
| check whether a directory exists More...
|
|
std::string | executeCommand (const std::string &command) |
| executes a command and return the output More...
|
|
static ParameterReader | parameterReader (const ParameterTree ¶meterTree) |
|
static const std::string & | checkParameterExistsString () |
|
template<class... KeyValues> |
ParameterReader | parameterDict (const std::string &rmPrefix, KeyValues... keyValues) |
|
template<class Traits > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const double value) |
|
template<class Traits > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const float value) |
|
template<class Traits > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const int value) |
|
template<class Traits > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const char value) |
|
template<class Traits > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const bool value) |
|
template<class Traits > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const std ::string &s) |
|
template<class Traits > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const unsigned int value) |
|
template<class Traits , class T > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const std::complex< T > value) |
|
template<class Traits > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const uint64_t value) |
|
template<class Traits > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const typename SelectUnsignedLongInteger< unsigned long, uint64_t >::UnsignedLongIntType &value) |
|
template<class Traits , class T , std::size_t N> |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const std::array< T, N > &value) |
|
template<class Traits , class T , int N> |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const Dune::FieldVector< T, N > &value) |
|
template<class Traits , class T , class A > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const std::vector< T, A > &value) |
|
template<class Traits > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, double &value) |
|
template<class Traits > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, float &value) |
|
template<class Traits > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, int &value) |
|
template<class Traits > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, char &value) |
|
template<class Traits > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, bool &value) |
|
template<class Traits > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, std ::string &s) |
|
template<class Traits > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, unsigned int &value) |
|
template<class Traits > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, uint64_t &value) |
|
template<class Traits > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, typename SelectUnsignedLongInteger< unsigned long, uint64_t >::UnsignedLongIntType &value) |
|
template<class Traits , class T , std::size_t N> |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, std::array< T, N > &value) |
|
template<class Traits , class T , int N> |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, Dune::FieldVector< T, N > &value) |
|
template<class Traits , class T > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, std::complex< T > &value) |
|
template<class Traits , class T , class A > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, std::vector< T, A > &value) |
|
template<class StreamTraits > |
InStreamInterface< StreamTraits > & | operator>> (InStreamInterface< StreamTraits > &in, std::tuple<> &tuple) |
|
template<class StreamTraits , class... Args> |
InStreamInterface< StreamTraits > & | operator>> (InStreamInterface< StreamTraits > &in, std::tuple< Args... > &tuple) |
|
template<class StreamTraits > |
OutStreamInterface< StreamTraits > & | operator<< (OutStreamInterface< StreamTraits > &out, const std::tuple<> &tuple) |
|
template<class StreamTraits , class... Args> |
OutStreamInterface< StreamTraits > & | operator<< (OutStreamInterface< StreamTraits > &out, const std::tuple< Args... > &tuple) |
|
template<class Traits > |
VirtualOutStream | virtualize (OutStreamInterface< Traits > &stream) |
|
template<class Traits > |
VirtualInStream | virtualize (InStreamInterface< Traits > &stream) |
|
template<class Grid , class Indicator > |
static std::pair< int, int > | maximumMarking (Grid &grid, const Indicator &indicator, double theta, int maxLevel=-1) |
|
template<int codim, int dim, class Grid , template< int, int, class > class Implementation> |
Dune::Entity< codim, dim, Grid, Implementation > | make_entity (Dune::Entity< codim, dim, Grid, Implementation > entity) |
|
static double | log (const Double &v) |
|
static double | sqrt (const Double &v) |
|
static double | cos (const Double &v) |
|
static double | sin (const Double &v) |
|
static double | min (const Double &v, const double p) |
|
static double | min (const double v, const Double &p) |
|
static double | max (const Double &v, const double p) |
|
static double | max (const double v, const Double &p) |
|
Double | operator+ (const Double &a, const Double &b) |
|
Double | operator+ (const double a, const Double &b) |
|
Double | operator+ (const Double &a, const double b) |
|
Double | operator+ (const int a, const Double &b) |
|
Double | operator+ (const Double &a, const int b) |
|
Double | operator+ (const unsigned int a, const Double &b) |
|
Double | operator+ (const Double &a, const unsigned int b) |
|
Double | operator- (const Double &a, const Double &b) |
|
Double | operator- (const double a, const Double &b) |
|
Double | operator- (const Double &a, const double b) |
|
Double | operator- (const int a, const Double &b) |
|
Double | operator- (const Double &a, const int b) |
|
Double | operator- (const unsigned int a, const Double &b) |
|
Double | operator- (const Double &a, const unsigned int b) |
|
Double | operator* (const Double &a, const Double &b) |
|
Double | operator* (const double a, const Double &b) |
|
Double | operator* (const Double &a, const double b) |
|
Double | operator* (const int a, const Double &b) |
|
Double | operator* (const Double &a, const int b) |
|
Double | operator* (const unsigned int a, const Double &b) |
|
Double | operator* (const Double &a, const unsigned int b) |
|
Double | operator/ (const Double &a, const Double &b) |
|
Double | operator/ (const double a, const Double &b) |
|
Double | operator/ (const Double &a, const double b) |
|
Double | operator/ (const int a, const Double &b) |
|
Double | operator/ (const Double &a, const int b) |
|
Double | operator/ (const unsigned int a, const Double &b) |
|
Double | operator/ (const Double &a, const unsigned int b) |
|
bool | operator== (const Double &a, const Double &b) |
|
bool | operator== (const double a, const Double &b) |
|
bool | operator== (const Double &a, const double b) |
|
bool | operator== (const int a, const Double &b) |
|
bool | operator== (const Double &a, const int b) |
|
bool | operator== (const unsigned int a, const Double &b) |
|
bool | operator== (const Double &a, const unsigned int b) |
|
bool | operator!= (const Double &a, const Double &b) |
|
bool | operator!= (const double a, const Double &b) |
|
bool | operator!= (const Double &a, const double b) |
|
bool | operator!= (const int a, const Double &b) |
|
bool | operator!= (const Double &a, const int b) |
|
bool | operator!= (const unsigned int a, const Double &b) |
|
bool | operator!= (const Double &a, const unsigned int b) |
|
bool | operator< (const Double &a, const Double &b) |
|
bool | operator< (const double a, const Double &b) |
|
bool | operator< (const Double &a, const double b) |
|
bool | operator< (const int a, const Double &b) |
|
bool | operator< (const Double &a, const int b) |
|
bool | operator< (const unsigned int a, const Double &b) |
|
bool | operator< (const Double &a, const unsigned int b) |
|
bool | operator<= (const Double &a, const Double &b) |
|
bool | operator<= (const double a, const Double &b) |
|
bool | operator<= (const Double &a, const double b) |
|
bool | operator<= (const int a, const Double &b) |
|
bool | operator<= (const Double &a, const int b) |
|
bool | operator<= (const unsigned int a, const Double &b) |
|
bool | operator<= (const Double &a, const unsigned int b) |
|
bool | operator> (const Double &a, const Double &b) |
|
bool | operator> (const double a, const Double &b) |
|
bool | operator> (const Double &a, const double b) |
|
bool | operator> (const int a, const Double &b) |
|
bool | operator> (const Double &a, const int b) |
|
bool | operator> (const unsigned int a, const Double &b) |
|
bool | operator> (const Double &a, const unsigned int b) |
|
bool | operator>= (const Double &a, const Double &b) |
|
bool | operator>= (const double a, const Double &b) |
|
bool | operator>= (const Double &a, const double b) |
|
bool | operator>= (const int a, const Double &b) |
|
bool | operator>= (const Double &a, const int b) |
|
bool | operator>= (const unsigned int a, const Double &b) |
|
bool | operator>= (const Double &a, const unsigned int b) |
|
std ::ostream & | operator<< (std ::ostream &out, const Double &a) |
|
std ::istream & | operator>> (std ::istream &in, Double &a) |
|
template<class Traits > |
OutStreamInterface< Traits > & | operator<< (OutStreamInterface< Traits > &out, const Double a) |
|
template<class Traits > |
InStreamInterface< Traits > & | operator>> (InStreamInterface< Traits > &in, Double &a) |
|
Double | abs (const Double &a) |
|
double | pow (const Double &a, const double b) |
|
void | field_cast (const Double &f1, double &f2) |
|
double | real (const std::complex< Double > &x) |
|
double | real (const Double &x) |
|
double | imag (const std::complex< Double > &x) |
|
double | imag (const Double &x) |
|
template<class GF , std::enable_if_t< !std::is_base_of< Fem::IsGridFunctionView, GF >::value &&std::is_base_of< Fem::HasLocalFunction, GF >::value, int > = 0> |
static GridFunctionView< GF > | localFunction (const GF &gf) |
|
template<class GridImp > |
static const std::string & | gridName () |
|
template<class GridImp > |
static const std::string & | gridName (const GridImp &grid) |
|
template<class GridPartType > |
static void | makeNonConformity (GridPartType &gridPart, const int levelDifference, const bool verbose=false) |
| mark entities such that non-conformity is a given number More...
|
|
template<typename K > |
std::ostream & | operator<< (std::ostream &s, const DenseMatrix< K > &matrix) |
| Send vector to output stream. More...
|
|
template<class Mapper , class Entity , class Functor > |
PairFunctor< Mapper, Entity, Functor > | makePairFunctor (const Mapper &mapper, const Entity &entity, Functor functor) |
|
template<class GridPart , class Entity > |
static auto | cachingQuadrature (const GridPart &gridPart, const Entity &entity, unsigned quadOrder) |
|
template<class GridPart , class Entity > |
static auto | elementQuadrature (const GridPart &gridPart, const Entity &entity, unsigned quadOrder) |
|
template<class DiscreteFunctionSpace , class Vector > |
void | generateCode (const DiscreteFunctionSpace &space, const Vector &elemQuadOrders, const Vector &faceQuadOrders, const std::string &outpath="./", const std::string &filename="autogeneratedcode.hh") |
|
template<class T > |
void | axpy (const T &a, const T &x, T &y) |
|
template<class K , int SIZE> |
void | axpy (const typename FieldTraits< K >::field_type &a, const FieldVector< K, SIZE > &x, FieldVector< K, SIZE > &y) |
|
template<class K , int ROWS, int COLS> |
void | axpy (const typename FieldTraits< K >::field_type &a, const FieldMatrix< K, ROWS, COLS > &x, FieldMatrix< K, ROWS, COLS > &y) |
|
double | scalarProduct (const double &a, const double &b) |
|
template<class T > |
T::field_type | scalarProduct (const T &a, const T &b) |
|
template<class K , int ROWS, int COLS> |
K | scalarProduct (const FieldMatrix< K, ROWS, COLS > &a, const FieldMatrix< K, ROWS, COLS > &b) |
|
template<class K , int ROWS, int COLS, int R> |
K | scalarProduct (const FieldVector< FieldMatrix< K, ROWS, COLS >, R > &a, const FieldVector< FieldMatrix< K, ROWS, COLS >, R > &b) |
|
template<class K , int ROWS, int COLS, int R> |
K | scalarProduct (const ExplicitFieldVector< FieldMatrix< K, ROWS, COLS >, R > &a, const ExplicitFieldVector< FieldMatrix< K, ROWS, COLS >, R > &b) |
|
template<class Mat > |
double | determinante (const Mat &m) |
|
template<class F , int d, int l> |
double | determinante (const FieldMatrix< F, d, l > &m) |
|
template<class F , int d> |
double | determinante (const DiagonalMatrix< F, d > &m) |
|
template<class GeometryJacobianInverseTransposed , class K , int ROWS> |
void | jacobianTransformation (const GeometryJacobianInverseTransposed &gjit, const FieldMatrix< K, ROWS, GeometryJacobianInverseTransposed::cols > &a, FieldMatrix< K, ROWS, GeometryJacobianInverseTransposed::rows > &b) |
|
template<class GeometryJacobianInverseTransposed , class K , int SIZE> |
void | hessianTransformation (const GeometryJacobianInverseTransposed &gjit, const ExplicitFieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::cols, GeometryJacobianInverseTransposed::cols >, SIZE > &a, ExplicitFieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::rows, GeometryJacobianInverseTransposed::rows >, SIZE > &b) |
|
template<class AuxiliaryDofs > |
static PrimaryDofs< AuxiliaryDofs > | primaryDofs (const AuxiliaryDofs &auxiliaryDofs) |
|
template<class AuxiliaryDofs > |
static PrimaryDofs< AuxiliaryDofs > | masterDofs (const AuxiliaryDofs &auxiliaryDofs) |
|
std::string | spaceName (const DFSpaceIdentifier id) |
|
template<class DofStorageType , class GridType , class MapperType > |
static std::pair< DofStorageInterface *, DofStorageType * > | allocateManagedDofStorage (const GridType &grid, const MapperType &mapper, const DofStorageType *=0) |
| default implementation for creating a managed dof storage More...
|
|
template<class GridFunction , class DiscreteFunction > |
static void | interpolate (const GridFunction &u, DiscreteFunction &v) |
| perform native interpolation of a discrete function space More...
|
|
template<class Function , class DiscreteFunction , unsigned int partitions> |
static std::enable_if_t< !std::is_convertible< Function, HasLocalFunction >::value > | interpolate (const Function &u, DiscreteFunction &v, PartitionSet< partitions > ps) |
|
template<class GridFunction , class DiscreteFunction , unsigned int partitions> |
static std::enable_if_t< std::is_convertible< GridFunction, HasLocalFunction >::value &&Capabilities::hasInterpolation< typename DiscreteFunction::DiscreteFunctionSpaceType >::v > | interpolate (const GridFunction &u, DiscreteFunction &v, PartitionSet< partitions > ps) |
|
template<class GridFunction , class DiscreteFunction , class Weight > |
static auto | interpolate (const GridFunction &u, DiscreteFunction &v, Weight &&weight) -> std::enable_if_t< !std::is_const< std::remove_reference_t< Weight > >::value > |
|
template<class GridFunction , class DiscreteFunction , class Weight > |
static auto | interpolate (const GridFunction &u, DiscreteFunction &v, Weight &&weight, DiscreteFunction &w) -> std::enable_if_t< std::is_base_of< HasLocalFunction, GridFunction >::value &&Capabilities::hasInterpolation< typename DiscreteFunction::DiscreteFunctionSpaceType >::v, void_t< decltype(std::declval< Weight >().setEntity(std::declval< const typename DiscreteFunction::DiscreteFunctionSpaceType::EntityType & >())) > > |
|
template<class GridFunction , class DiscreteFunction , unsigned int partitions> |
static std::enable_if_t< std::is_convertible< GridFunction, HasLocalFunction >::value &&IsFourierDiscreteFunctionSpace< typename DiscreteFunction::DiscreteFunctionSpaceType >::value > | interpolate (const GridFunction &u, DiscreteFunction &v, PartitionSet< partitions > ps) |
|
template<class RefElement , std::enable_if_t< std::is_same< std::decay_t< decltype(std::declval< const RefElement & >().size(0)) >, int >::value , int , std::enable_if_t< std::is_same< std::decay_t< decltype(std::declval< const RefElement & >().type(0, 0)) >, GeometryType >::value , int > |
DofMapperCode | generateCodimensionCode (const RefElement &refElement, int codim, unsigned int blockSize=1) |
|
template<class RefElement , class LocalCoefficients , std::enable_if_t< std::is_same< std::decay_t< decltype(std::declval< const RefElement & >().size(0)) >, int >::value , int , std::enable_if_t< std::is_same< std::decay_t< decltype(std::declval< const RefElement & >().type(0, 0)) >, GeometryType >::value , int > |
DofMapperCode | compile (const RefElement &refElement, const LocalCoefficients &localCoefficients) |
|
template<class Scalar , class Vectorial > |
bool | operator== (const MakeVectorialExpression< Scalar, Vectorial > &a, const MakeVectorialExpression< Scalar, Vectorial > &b) |
|
template<class Scalar , class Vectorial > |
bool | operator!= (const MakeVectorialExpression< Scalar, Vectorial > &a, const MakeVectorialExpression< Scalar, Vectorial > &b) |
|
template<class Scalar , class Vectorial > |
bool | operator== (const Vectorial &a, const MakeVectorialExpression< Scalar, Vectorial > &b) |
|
template<class Scalar , class Vectorial > |
bool | operator!= (const Vectorial &a, const MakeVectorialExpression< Scalar, Vectorial > &b) |
|
template<class Scalar , class Vectorial > |
bool | operator== (const MakeVectorialExpression< Scalar, Vectorial > &a, const Vectorial &b) |
|
template<class Scalar , class Vectorial > |
bool | operator!= (const MakeVectorialExpression< Scalar, Vectorial > &a, const Vectorial &b) |
|
template<class Scalar , class Vectorial > |
void | axpy (const typename MakeVectorialTraits< Scalar, Vectorial >::field_type &a, const MakeVectorialExpression< Scalar, Vectorial > &x, typename MakeVectorialTraits< Scalar, Vectorial >::VectorialType &y) |
|
template<class GeometryJacobianInverseTransposed , class K , int ROWS> |
void | jacobianTransformation (const GeometryJacobianInverseTransposed &gjit, const MakeVectorialExpression< FieldMatrix< K, 1, GeometryJacobianInverseTransposed::cols >, FieldMatrix< K, ROWS, GeometryJacobianInverseTransposed::cols > > &a, FieldMatrix< K, ROWS, GeometryJacobianInverseTransposed::rows > &b) |
|
template<class GeometryJacobianInverseTransposed , class K , int SIZE> |
void | hessianTransformation (const GeometryJacobianInverseTransposed &gjit, const MakeVectorialExpression< ExplicitFieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::cols, GeometryJacobianInverseTransposed::cols >, 1 >, ExplicitFieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::cols, GeometryJacobianInverseTransposed::cols >, SIZE > > &a, ExplicitFieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::rows, GeometryJacobianInverseTransposed::rows >, SIZE > &b) |
|
template<class Scalar , class Vectorial > |
MakeVectorialTraits< Scalar, Vectorial >::field_type | scalarProduct (const MakeVectorialExpression< Scalar, Vectorial > &a, const Vectorial &b) |
|
template<class Scalar , class Vectorial > |
MakeVectorialTraits< Scalar, Vectorial >::field_type | scalarProduct (const Vectorial &a, const MakeVectorialExpression< Scalar, Vectorial > &b) |
|
template<class Scalar , class Vectorial > |
MakeVectorialTraits< Scalar, Vectorial >::field_type | scalarProduct (const MakeVectorialExpression< Scalar, Vectorial > &a, const MakeVectorialExpression< Scalar, Vectorial > &b) |
|