dune-fem  2.4.1-rc
Namespaces | Classes | Typedefs | Enumerations | Functions
Dune::Fem Namespace Reference

Namespaces

 __IdIndexSet
 
 __IndexSetDofMapper
 
 __NonBlockMapper
 
 Capabilities
 
 CombinedSpaceHelper
 
 FieldMatrixHelper
 
 GridPartCapabilities
 
 Solver
 

Classes

class  AbstractColumnWriter
 Class representing column writer in general. More...
 
class  AbstractShapeFunction
 
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...
 
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...
 
class  AdaptationManagerInterface
 AdaptationManagerInterface class. More...
 
struct  AdaptationManagerReferenceFactory
 factory class to create adaptation manager reference counter More...
 
class  AdaptationMethod
 AdaptationMethod is a simple adaptation method reader class. More...
 
class  AdaptiveDiscreteFunction
 
class  AdaptiveDofMapper
 Extended interface for adaptive DoF mappers. More...
 
class  AdaptiveGridPartBase
 A grid part with an index set specially designed for adaptive calculations. More...
 
class  AdaptiveIndexSet
 extended interface for adaptive, consecutive index sets More...
 
class  AdaptiveIndexSetBase
 consecutive, persistent index set for the leaf level based on the grid's hierarchy index set More...
 
class  AdaptiveIndexSetBaseTraits
 
class  AdaptiveLeafGridPart
 
class  AdaptiveLeafGridPartTraits
 Type definitions for the LeafGridPart class. More...
 
class  AdaptiveLeafIndexSet
 consecutive, persistent index set for the leaf level based on the grid's hierarchy index set More...
 
struct  AdaptiveLeafIndexSetTraits
 
class  AllGeomTypes
 default implementation uses method geomTypes of given index set. Used in DiscreteFunctionSpaces. More...
 
class  ALUGridWriter
 
class  ArrayAllocatorDefault
 
class  ArrayAllocatorInterface
 
struct  ArrayDataSource
 
class  ArrayDefault
 default implementation of the ArrayInterface More...
 
class  ArrayDefaultIterator
 
struct  ArrayDefaultTraits
 
class  ArrayInterface
 abstract array interface More...
 
class  ArrayWrapper
 implementation of the ArrayInterface wrapping a pointer to an array of elements More...
 
class  ArrayWrapperVector
 An implementation of VectorInterface wrapping a standard C++ array. More...
 
class  ASCIIInStream
 input stream reading from an STL input stream using ASCII decoding More...
 
struct  ASCIIInStreamTraits
 
class  ASCIIOutStream
 output stream writing into an STL output stream using ASCII encoding More...
 
struct  ASCIIOutStreamTraits
 
class  AssembledOperator
 abstract matrix operator More...
 
struct  AssignFunctor
 
struct  AssignFunctor< T *, Assign >
 
struct  AssignSingleFunctor
 
struct  AssignVectorReference
 
class  AutomaticDifferenceLinearOperator
 
class  AutomaticDifferenceOperator
 operator providing a Jacobian through automatic differentiation More...
 
class  AutoPersistentObject
 base class for auto persistent objects More...
 
struct  AxpyFunctor
 
class  BartonNackmanInterface
 
class  BaseFunctionSetSingletonFactory
 BasisFunctionSetSingletonFactory provides method createObject and deleteObject for the SingletonList. More...
 
class  BaseSetLocalKeyStorage
 storage class for base function set pointer and compiled local key pointers More...
 
class  BasicConstLocalFunction
 
class  BasicFilterWrapper
 
struct  BasicFilterWrapperTraits
 
class  BasicInstationaryFunction
 basic wrapper class (still a CRTP) for instationary functions More...
 
class  BasicMakeVectorialExpression
 
struct  BasicParameterReader
 
class  BasicTemporaryLocalFunction
 A temporary function carrying values for one entity. More...
 
class  BasisFunctionSet
 
class  BasisFunctionSetProxy
 
class  BasisFunctionSets
 interface class representing a family of basis function sets More...
 
class  BinaryFileInStream
 constructor More...
 
class  BinaryFileOutStream
 constructor More...
 
class  BlockDiagonalLinearOperator
 
class  BlockVectorDiscreteFunction
 
class  BlockVectorInterface
 
struct  BoundaryIdProvider
 
struct  BoundaryIdProvider< GeometryGrid< HostGrid, CoordFunction, Allocator > >
 
struct  BoundaryIdProvider< OneDGrid >
 
struct  BoundaryIdProvider< SGrid< dim, dimw, ctype > >
 
struct  BoundaryIdProvider< UGGrid< dim > >
 
struct  BoundaryIdProvider< YaspGrid< dim, CoordCont > >
 
struct  ByteOrder
 
class  CachedShapeFunctionSets
 
class  CacheProvider
 
class  CacheProvider< GridPart, 0 >
 
class  CacheProvider< GridPart, 1 >
 
class  CacheStorage
 Storage class for mappers. More...
 
class  CacheStorage< ct, dim, false >
 Specialisation for grids without any twists (i.e. Cartesian ones). More...
 
class  CacheStorage< ct, dim, true >
 Specialisation for grids with twist (i.e. unstructured ones). More...
 
class  CachingInterface
 interface a cachable quadrature has to implement More...
 
class  CachingLumpingQuadrature
 
class  CachingLumpingQuadrature< GridPart, 0 >
 
class  CachingLumpingQuadrature< GridPart, 1 >
 
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 >
 constructor More...
 
class  CachingQuadrature< GridPartImp, 1 >
 constructor More...
 
class  CachingShapeFunctionSet
 
class  CachingStorage
 
struct  CachingTraits
 
class  CArrayAllocator
 
struct  CArrayAllocatorTraits
 
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...
 
struct  CheckCartesian
 Helper class to check whether grid is structured or not. More...
 
class  CheckPointer
 Implementation of the IOInterface. This class manages checkpointing. More...
 
class  CheckPointerParameters
 local parameter collection for CheckPointer More...
 
class  CodegenInfo
 
class  CodegenInfoFinished
 
class  CodimensionMapper
 mapper allocating one DoF per subentity of a given codimension More...
 
class  CodimensionMapperSingletonFactory
 
class  CodimIndexSet
 
struct  ColumnObject
 
class  CombinedDataHandle
 combine multiple data handles into one More...
 
struct  CombinedDataType
 
struct  CombinedDataType< DataHandle >
 
struct  CombinedDataType< DataHandle, Tail... >
 
class  CombinedDiscreteFunction
 
class  CombinedDiscreteFunctionDofIterator
 Iterator over an array of dofs. More...
 
class  CombinedDiscreteFunctionSpace
 Combined discrete function space. More...
 
class  CombinedDofConversionUtility
 
class  CombinedDofConversionUtility< ContainedMapper, N, PointBased >
 
class  CombinedDofConversionUtility< ContainedMapper, N, VariableBased >
 Specialisation for VariableBased approach. More...
 
class  CombinedLocalDataCollect
 
class  CombinedLocalOperator
 
class  CombinedSpace
 
class  CombinedSpace< DiscreteFunctionSpace, N, PointBased >
 Combined Space Function Space. More...
 
class  CombinedSpace< DiscreteFunctionSpace, N, VariableBased >
 
class  CombinedSubMapper
 
class  CombinedVector
 
class  CommunicationIndexMap
 
class  CommunicationManager
 use Default CommunicationManager as Communication Manager More...
 
class  CommunicationManagerList
 Proxy class to DependencyCache which is singleton per space. More...
 
class  CompiledLocalKeyContainer
 class for storage local keys for a given range of polynomial order and available geometry type More...
 
class  ConjugateGradientSolver
 linear solver using the CG algorithm More...
 
class  ConsecutiveIndexSet
 extended interface for consecutive index sets More...
 
class  ConstantLocalRestrictProlong
 
class  ConstDofIteratorDefault
 
class  ConstLocalFunction
 A constant local function carrying values for one entity. More...
 
class  ConvertToGridFunction
 
class  CornerPointList
 
class  CornerPointSet
 
class  CornerPointSetTraits
 
class  CreateFeaturedPass
 CreateFeaturedPass takes a discrete model and a PassType (like LocalDGEllliptPass) and creates with the parameter PreviousPass in the method create the desired pass. The advantage here is, that no typedefs have to be done. More...
 
class  CreatePass
 CreatePass takes a discrete model and a PassType (like LocalDGPass) and creates with the parameter PreviousPass in the method create the desired pass. The advantage here is, that no typedefs have to be done. More...
 
class  CreatePassTree
 create pass tree from given list of discrete models the passId is deliviered to the start pass and stands for the global variable calculated by this pass More...
 
class  CreateSelectedPass
 create pass with previous unknown selector More...
 
class  CubeQuadrature
 
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...
 
class  DataCollectorInterface
 
struct  DataCollectorTraits
 
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 I/O for discrete functions. More...
 
struct  DataOutputParameters
 Parameter class for Dune::Fem::DataOutput. More...
 
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 I/O for discrete functions. More...
 
struct  DataWriterParameters
 
class  DeadIntersection
 
class  DeadIntersectionIterator
 
struct  DeadIterator
 
class  DebugCounter
 A counter only present if NDEBUG is not defined. More...
 
class  DebugLock
 
class  DefaultArrayAllocator
 
struct  DefaultAssign
 
class  DefaultBasisFunctionSet
 implementation of a basis function set for given entity More...
 
class  DefaultBasisFunctionSets
 generate a set of default basis function sets from given set of shape function sets More...
 
struct  DefaultCodeGenerator
 default code generator methods More...
 
class  DefaultCommunicationHandler
 Default communication handler for discrete functions. More...
 
class  DefaultCommunicationManager
 default communication manager using just the grids communicate method More...
 
struct  DefaultDiscreteFunctionTraits
 
class  DefaultDofAllocator
 oriented to the STL Allocator funtionality More...
 
struct  DefaultDofAllocator< bool >
 
struct  DefaultDofAllocator< char >
 
struct  DefaultDofAllocator< double >
 
struct  DefaultDofAllocator< float >
 
struct  DefaultDofAllocator< int >
 
struct  DefaultDofAllocator< size_t >
 
class  DefaultEntitySearch
 
class  DefaultEocCalculator
 Write a self contained tex table for eoc runs with timing information. More...
 
struct  DefaultFilterTraits
 type definitions More...
 
class  DefaultGridPartEntity
 
class  DefaultGridPartEntity< 0, dim, GridFamily >
 
class  DefaultLocalL2Projection
 
class  DefaultLocalRestrictProlong
 
class  DefaultLocalRestrictProlong< CombinedDiscreteFunctionSpace< SP1, SP2 > >
 
class  DefaultLocalRestrictProlong< CombinedSpace< DiscreteFunctionSpace, N, PointBased > >
 
class  DefaultLocalRestrictProlong< CombinedSpace< DiscreteFunctionSpace, N, VariableBased > >
 
class  DefaultLocalRestrictProlong< DiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, 0, StorageImp > >
 
class  DefaultLocalRestrictProlong< DiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, StorageImp > >
 
class  DefaultLocalRestrictProlong< Fem::PAdaptiveDGSpace< FunctionSpaceImp, GridPartImp, 0, StorageImp > >
 
class  DefaultLocalRestrictProlong< Fem::PAdaptiveDGSpace< FunctionSpaceImp, GridPartImp, polOrd, StorageImp > >
 
class  DefaultLocalRestrictProlong< Fem::PAdaptiveLagrangeSpace< FS, GP, ord, S > >
 
class  DefaultLocalRestrictProlong< FiniteVolumeSpace< FunctionSpace, GridPart, codim, Storage > >
 
class  DefaultLocalRestrictProlong< HierarchicLegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, 0, StorageImp > >
 
class  DefaultLocalRestrictProlong< HierarchicLegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, StorageImp > >
 
class  DefaultLocalRestrictProlong< LagrangeDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, 0, StorageImp > >
 
class  DefaultLocalRestrictProlong< LagrangeDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, StorageImp > >
 
class  DefaultLocalRestrictProlong< LagrangeDiscreteFunctionSpace< FunctionSpaceType, GridPartType, order, StorageType > >
 
class  DefaultLocalRestrictProlong< LegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, 0, StorageImp > >
 
class  DefaultLocalRestrictProlong< LegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, StorageImp > >
 
class  DefaultLocalRestrictProlong< PowerDiscreteFunctionSpace< DiscreteFunctionSpace, N > >
 
class  DefaultLocalRestrictProlong< TupleDiscreteFunctionSpace< DiscreteFunctionSpaces... > >
 
struct  DefaultLumpingQuadratureTraits
 
struct  DefaultOrderCalculator
 default Quadrature Order Calculator More...
 
struct  DefaultQuadratureTraits
 
struct  DefaultQuadratureTraits< FieldType, 0 >
 
struct  DefaultQuadratureTraits< FieldType, 1 >
 
struct  DefaultQuadratureTraits< FieldType, 2 >
 
struct  DefaultQuadratureTraits< FieldType, 3 >
 
struct  DefaultSingletonFactory
 
class  DenseLocalRieszProjection
 
class  DenseMatrix
 DenseMatrix based on std::vector< std::vector< T > > More...
 
class  DenseRowMatrix
 
class  DenseRowMatrixObject
 
class  DenseSubVector
 
struct  DFCommunicationOperation
 Mathematical operation apply during communication to data that is communicated enum of all avialable operations. More...
 
class  DGAdaptiveDiscreteModel
 
class  DGAdaptiveLeafGridPart
 A grid part with an index set specially designed for adaptive calculations. More...
 
class  DGAdaptiveLeafIndexSet
 consecutive, persistent index set for the leaf level based on the grid's hierarchy index set More...
 
struct  DGAdaptiveLeafIndexSetTraits
 
class  DGDiscreteModelCaller
 model caller for local DG pass More...
 
class  DGDiscreteModelDefault
 Default implementation of the DGDiscreteModelInterface where methods for the fluxes and the source term do nothing, so that the user needn't implement them if not needed. More...
 
class  DGDiscreteModelDefaultWithInsideOutside
 
struct  DGDiscreteModelInterface
 Interface class for problem definition in the LDG context. More...
 
class  DGHelmholtzJacobianOperator
 
class  DGHelmholtzOperator
 
class  DGInverseMassPass
 Pass applying the local inverse mass matrix on each element. More...
 
struct  DGInverseMassPassDiscreteModel
 
class  DGL2ProjectionImpl
 
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  DiagonalPreconditioner
 Precondtioner, multiplies with inverse of the diagonal works with. More...
 
class  DiagonalPreconditionerBase
 
class  DiagonalPreconditionerBase< DFImp, OperatorImp, true >
 
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...
 
struct  DifferentDiscreteFunctionSpace
 
struct  DifferentDiscreteFunctionSpace< CombinedDiscreteFunctionSpace< DFunctionSpaceImp1, DFunctionSpaceImp2 >, NewFunctionSpace >
 specialization of DifferentDiscreteFunctionSpace for CombinedDiscreteFunctionSpace More...
 
struct  DifferentDiscreteFunctionSpace< CombinedSpace< ContainedSpace, N, policy >, NewFunctionSpace >
 
struct  DifferentDiscreteFunctionSpace< DiscreteFunctionSpaceImp< FunctionSpaceImp, GridPartImp, polOrd, StorageImp >, NewFunctionSpace >
 
struct  DifferentDiscreteFunctionSpace< PowerDiscreteFunctionSpace< DiscreteFunctionSpace, N >, NewFunctionSpace >
 specialization of DifferentDiscreteFunctionSpace for PowerDiscreteFunctionSpace More...
 
class  DifferentiableOperator
 abstract differentiable operator More...
 
class  DiscontinuousGalerkinLocalInterpolation
 
class  DiscontinuousGalerkinLocalL2Projection
 
class  DiscontinuousGalerkinLocalRestrictProlong
 
class  DiscontinuousGalerkinSpace
 
struct  DiscontinuousGalerkinSpaceTraits
 
class  DiscreteFunctionDefault
 
class  DiscreteFunctionInterface
 
class  DiscreteFunctionSpaceAdapter
 Create Obejct that behaves like a discrete function space without to provide functions with the iterator facilities. 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  DiscreteFunctionSpaceInterface
 This is the interface for discrete function spaces. All methods declared here have to be implemented by the implementation class. More...
 
class  DiscreteFunctionTraits
 Traits class for a DiscreteFunction. More...
 
struct  DiscreteFunctionTraits< AdaptiveDiscreteFunction< DiscreteFunctionSpace > >
 
struct  DiscreteFunctionTraits< BlockVectorDiscreteFunction< DiscreteFunctionSpace, BlockVector > >
 
struct  DiscreteFunctionTraits< CombinedDiscreteFunction< ContainedDiscreteFunction, N > >
 
struct  DiscreteFunctionTraits< ISTLBlockVectorDiscreteFunction< DiscreteFunctionSpace, Block > >
 
struct  DiscreteFunctionTraits< VectorDiscreteFunction< DiscreteFunctionSpace, Vector > >
 
class  DiscreteModelWrapper
 DiscreteModelWrapper to combine DiscreteModel and Selector. More...
 
class  DofAlignment
 Interface documentation for Dof alignment classes used in VectorialBasisFunctionSet. More...
 
struct  DofBlockFunctor
 
class  DofBlockProxy
 DoF block proxy for discrete functions with random access to DoFs. More...
 
struct  DofBlockTraits
 
struct  DofBlockTraits< const DiscreteFunction >
 
class  DofConversionUtility
 
class  DofConversionUtility< PointBased >
 Specialisation for PointBased approach. More...
 
class  DofConversionUtility< VariableBased >
 Specialisation for VariableBased approach. More...
 
class  DofIteratorDefault
 default implementation of DofManagerInterface More...
 
class  DofIteratorInterface
 interface for DoF iterators of discrete functions More...
 
class  DofManager
 
class  DofManagerFactory
 Singleton provider for the DofManager. More...
 
class  DofManError
 
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  DofMapperCode
 
class  DofMapperCodeWriter
 
class  DofMapperError
 
class  DofStorageInterface
 Interface class for a dof storage object to be stored in discrete functions. More...
 
class  DomainDecomposedIterator
 Thread iterators using domain decomposition. More...
 
class  DomainDecomposedIteratorStorage
 Storage of thread iterators using domain decomposition. More...
 
class  Double
 
class  DummyDataCollector
 empty data collector More...
 
struct  DummyObjectStream
 
struct  DuneQuadratureTraits
 
struct  DuneQuadratureTraits< FieldType, 0 >
 
struct  DuneQuadratureTraits< FieldType, 1 >
 
struct  DuneQuadratureTraits< FieldType, 3 >
 
class  DynamicArray
 
class  DynamicReferenceVector
 Construct a vector with a dynamic size. More...
 
class  DynamicVector
 A vector using a DynamicArray as storage. More...
 
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...
 
class  ElementQuadrature< GridPartImp, 0 >
 constructor More...
 
class  ElementQuadrature< GridPartImp, 1 >
 constructor More...
 
struct  ElementQuadratureTraits
 
class  ElementTuple
 
class  ElementTuple< -1,-1,-1,-1,-1,-1,-1,-1,-1, Seed >
 
class  EmptyGeometry
 
class  EmptyIndexSetRestrictProlong
 
class  EmptyLocalRestrictProlong
 
struct  EmptyNonBlockingComm
 
struct  EntityGridTypeGetter
 
struct  EntityGridTypeGetter< const Entity >
 
struct  EntityGridTypeGetter< Dune::Entity< codim, dim, Grid, Impl > >
 
class  EntitySearch
 
class  EntitySearch< GeoGridPart< CoordFunction >, codim, partition >
 
class  EntitySearch< IdGridPart< HostGridPart >, codim, partition >
 
class  Envelope
 
struct  EOCDataSource
 
class  EvaluateCaller
 
class  EvaluateCaller< Traits, MIN_NUMBER_OF_QUAD_POINTS, MIN_NUMBER_OF_BASE_FCT >
 
class  EvaluateCaller< Traits, MIN_NUMBER_OF_QUAD_POINTS, numBaseFct >
 
class  EvaluateCaller< Traits, quadNop, MIN_NUMBER_OF_BASE_FCT >
 
class  EvaluateCallerInterface
 
struct  EvaluateCallerInterfaceTraits
 
struct  EvaluateCallerTraits
 
class  EvaluateImplementation
 
class  EvaluateRealImplementation
 
class  ExportsDiscreteFunctionSpaceType
 
struct  ExtractCommonFieldType
 
class  FemEoc
 Write a self contained tex table for eoc runs with timing information. More...
 
class  FemEocTable
 The Fem Eoc Table writer. More...
 
class  FieldMatrixConverter
 
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...
 
class  FieldMatrixConverterRow
 
class  FieldVectorAdapter
 
class  FieldVectorAdapter< FieldVector< Field, sz > >
 
class  FileIOCheckError
 check if lock file exists and aborts if true More...
 
class  FileIOLock
 creates and removes lock file during backup process More...
 
class  FilterDefaultImplementation
 
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
 
struct  FilteredGridPartIndexSetSelector
 
struct  FilteredGridPartIndexSetSelector< FilteredGP, HostGP, false >
 
class  FilteredGridPartIntersectionIterator
 
class  FilteredGridPartIterator
 
struct  FilteredGridPartTraits
 
class  FilterInterface
 Interface class for filter to use with a Dune::FilteredGridPart. More...
 
struct  FiniteVolumeBasisFunctionSet
 
class  FiniteVolumeBasisFunctionSets
 
class  FiniteVolumeLocalInterpolation
 
class  FiniteVolumeSpace
 
struct  FiniteVolumeSpaceTraits
 
class  FixedSizeArray
 standard array with fixed size More...
 
class  FixedStepTimeProvider
 
class  FlOpCounter
 
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  FourierDiscreteFunctionSpace
 
struct  FourierDiscreteFunctionSpaceTraits
 
class  FourierDofMapper
 
struct  FourierDofMapperTraits
 
struct  FourierFunctionSet
 
class  FourierFunctionSet< FunctionSpace< DomainFieldType, RangeFieldType, 1, 1 >, Order >
 
class  FourierFunctionSet< FunctionSpace< DomainFieldType, RangeFieldType, dimDomain, 1 >, Order >
 
struct  FourierFunctionSetSize
 
class  Function
 Abstract class representing a function. More...
 
struct  FunctionalAxpyFunctor
 
class  FunctionSet
 Global basis functions. More...
 
class  FunctionSetProxy
 Proxy for a FunctionSet. More...
 
class  FunctionSpace
 A vector valued function space. More...
 
class  FunctionSpaceInterface
 interface for an arbitrary function spaceBase class for specific function spaces. More...
 
class  GaussPts
 one-dimensional Gauss points and their weights More...
 
class  GenericAdaptiveDofMapper
 
class  GenericCombinedDiscreteFunctionSpace
 
class  GenericDiscontinuousGalerkinSpace
 generic implementation of a Discontinuous Galerkin space based on a fixed family of basis function sets More...
 
class  GenericDiscreteFunctionSpace
 Please doc me. More...
 
class  GenericLagrangeBaseFunction
 
class  GenericLagrangeBaseFunction< FunctionSpace, PointGeometry, order >
 
class  GenericLagrangeBaseFunction< FunctionSpace, ProductGeometry< FirstGeometryType, SecondGeometryType >, order >
 
class  GenericLagrangeBaseFunction< FunctionSpace, PyramidGeometry< BaseGeometryType >, 0 >
 
class  GenericLagrangeBaseFunction< FunctionSpace, PyramidGeometry< BaseGeometryType >, order >
 
class  GenericLagrangePoint
 
class  GenericLagrangePoint< PointGeometry, order, bottom >
 
class  GenericLagrangePoint< ProductGeometry< FirstGeometry, SecondGeometry >, order, bottom >
 
class  GenericLagrangePoint< PyramidGeometry< BaseGeometry >, 0, bottom >
 
class  GenericLagrangePoint< PyramidGeometry< BaseGeometry >, order, bottom >
 
class  GeoCoordFunctionCaller
 
class  GeoCoordFunctionCaller< codim, CoordFunction, false >
 
class  GeoCoordFunctionCaller< codim, CoordFunction, true >
 
class  GeoCoordVector
 
class  GeoCornerStorage
 
class  GeoDataHandle
 
class  GeoDiscreteCoordFunctionCaller
 
class  GeoDiscreteCoordFunctionCaller< codim, CoordFunction, LagrangeDiscreteFunctionSpace< FunctionSpace, GridPart, 1, Storage > >
 
class  GeoEntity
 
class  GeoEntity< 0, dim, GridFamily >
 
class  GeoGeometry
 
class  GeoGeometryTraits
 
class  GeoGridPart
 
struct  GeoGridPartFamily
 
struct  GeoGridPartTraits
 
class  GeoIntersection
 
class  GeoIntersectionCoordVector
 
class  GeoIntersectionIterator
 
class  GeoIterator
 
class  GeoLocalCoordVector
 
struct  GeometryAffinityCheck
 Helper class to check affinity of the grid's geometries. More...
 
class  GeometryInformation
 ReferenceVolume and local bary center keeper class. More...
 
class  GeometryWrapper
 
class  GeometryWrapper< id, 0 >
 
class  GeometryWrapper< id, 1 >
 
class  GlobalConsecutiveIndexSet
 
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  GridEntityAccess
 
struct  GridEntityAccess< Dune::Entity< codim, dim, Grid, EntityImpl > >
 
struct  GridEntityAccess< Dune::Entity< codim, dim, GridFamily, GeoEntity > >
 
struct  GridEntityAccess< Dune::Entity< codim, dim, GridFamily, IdEntity > >
 
class  GridEntitySearch
 
class  GridEntitySearch< GridPart, 0, partition >
 
class  GridFunctionAdapter
 GridFunctionAdapter provides local functions for a Function. More...
 
struct  GridFunctionAdapterTraits
 traits of GridFunctionAdapter More...
 
struct  GridName
 
struct  GridObjectStreamTraits
 
struct  GridObjectStreamTraits< const Grid >
 
struct  GridObjectStreamTraits< GeometryGrid< HostGrid, CoordFunction, Allocator > >
 
class  GridPart2GridView
 
class  GridPart2GridViewImpl
 
struct  GridPart2GridViewTraits
 
class  GridPartDefault
 Default implementation for the GridPart classes. More...
 
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  GridPartPolicies
 
class  GridSolution
 creates a function with evaluate method from a check point More...
 
class  GridSolutionVector
 
class  GridTimeProvider
 the same functionality as the Dune::TimeProvider. More...
 
class  GridView2GridPart
 
class  GridWidth
 utility functions for calculating the maximum grid width More...
 
class  GridWidthProvider
 utility functions for calculating the maximum grid width More...
 
class  H1Norm
 
class  HasLocalFunction
 
class  HdivProjection
 H-div Projection for discontinuous discrete functions. The projection is described in detail in: More...
 
struct  HessianRangeTypeEvaluator
 
struct  HessianTransformation
 
class  HexaQuadrature
 
class  HierarchicLegendreDiscontinuousGalerkinSpace
 
struct  HierarchicLegendreDiscontinuousGalerkinSpaceTraits
 
class  HierarchicLegendreShapeFunctionSet
 please doc me More...
 
class  HorizontalDofAlignment
 Implementation of DofAlignment. More...
 
struct  IdBasicGeometry
 
class  IdEntity
 
class  IdEntity< 0, dim, GridFamily >
 
class  IdEntityBasic
 
class  IdGeometry
 
struct  IdGeometryTraits
 
class  IdGridPart
 
struct  IdGridPartTraits
 
class  IdIndexSet
 
class  IdIntersection
 
class  IdIntersectionIterator
 
class  IdIterator
 
class  IdLocalGeometry
 
struct  IdLocalGeometryTraits
 
class  IdProvider
 Singleton that manages a globally unique identifier. More...
 
class  IdShapeFunctionSet
 
struct  IndexFunctor
 
class  IndexMapperInterface
 Abstract index mapper interface. More...
 
class  IndexSet
 interface documentation for (grid part) index sets More...
 
class  IndexSetDofMapper
 
class  IndexSetRestrictProlong
 
class  InsertFunctionPass
 Base class for specific pass implementations. InsertFunctionPass simply inserts a discrete function from outside of the pass tree into the current pass tree, for example when calculating the species transport the velocity function comes from a different pass but has to be inserted into the species pass. More...
 
struct  InsertFunctionPassDiscreteModel
 
struct  InsertFunctionPassDiscreteModelTraits
 Traits for InsertFunctionPass to create dummy discrete model. More...
 
class  InsertIndicesToSet
 
class  InsertOperatorPass
 include a Dune::Fem::Operator into a pass More...
 
class  InstationaryFunction
 implementation of a Dune::Fem::Function taking an instationary function More...
 
class  InStreamInterface
 abstract interface for an input stream More...
 
class  IntegrationPointList
 actual interface class for integration point lists More...
 
class  IntegrationPointListImp
 Generic implementation of an IntegrationPointList. More...
 
class  Integrator
 integrator for arbitrary functions providing evaluate More...
 
class  Interpolation
 native interpolation of a discrete function space More...
 
class  IntersectionAdaptiveLeafGridPart
 A grid part with an index set specially designed for adaptive calculations. More...
 
class  IntersectionAdaptiveLeafGridPartTraits
 Type definitions for the LeafGridPart class. More...
 
class  IntersectionAdaptiveLeafIndexSet
 
struct  IntersectionAdaptiveLeafIndexSetTraits
 
class  IntersectionQuadrature
 IntersectionQuadrature is a helper class for creating the appropriate face quadratures for integrating over intersections. More...
 
class  InverseFilter
 
class  IOInterface
 IOInterface to write data to hard disk. More...
 
class  IOTuple
 
class  IOTuple< tuple<> >
 
struct  IOTupleBase
 
struct  IsBlockVector
 
class  IsBlockVectorDiscreteFunction
 Tag for discrete functions using block vectors. More...
 
class  IsDiscreteFunction
 
struct  isGenericDiscreteFunctionSpace
 
struct  IsPersistent
 
class  ISTLBlockVector
 
class  ISTLBlockVectorDiscreteFunction
 
struct  IteratorProvider
 
struct  IteratorToInterface
 
struct  IteratorToInterface< InteriorBorder_Partition >
 
struct  JacobianRangeTypeEvaluator
 
struct  JacobianTransformation
 
class  L1Norm
 
class  L2Norm
 
class  L2Projection
 The L2Projection class provides methods for projecting a function unto a given discrete function space. Note that this implementation assumes orthogonal base functions! More...
 
class  LagrangeDiscontinuousGalerkinSpace
 
struct  LagrangeDiscontinuousGalerkinSpaceTraits
 
class  LagrangeDiscreteFunctionSpace
 Lagrange discrete function space. More...
 
struct  LagrangeDiscreteFunctionSpaceTraits
 
struct  LagrangeDofMapperCodeFactory
 
class  LagrangeInterpolation
 Generates the Lagrange Interpolation of an analytic function. More...
 
class  LagrangeLocalInterpolation
 
struct  LagrangeLocalRestrictProlong
 
struct  LagrangeMapperSingletonFactory
 
class  LagrangeMapperSingletonKey
 
class  LagrangePoint
 A single lagrange point. More...
 
class  LagrangePointImplementation
 
class  LagrangePointInterface
 
class  LagrangePointListImplementation
 
class  LagrangePointListInterface
 Set of lagrange points. More...
 
class  LagrangePointSet
 
struct  LagrangePointSetTraits
 
class  LagrangeShapeFunction
 implementation of Lagrange shape function using generic Lagrange shape functions More...
 
class  LagrangeShapeFunctionFactory
 factory class More...
 
class  LagrangeShapeFunctionInterface
 abstract base class for Lagrange shape functions More...
 
class  LagrangeShapeFunctionSet
 Lagrange shape function set. More...
 
class  LatexTableWriter
 writes latex tables based on user-defined row structure More...
 
class  LeafGridPart
 
struct  LeftAdd
 
struct  LeftAddScaled
 
struct  LeftAssign
 
class  LegendreDiscontinuousGalerkinSpace
 
struct  LegendreDiscontinuousGalerkinSpaceTraits
 
class  LegendrePolynomials
 
class  LegendreShapeFunction
 implementation of a single scalar-valued Legendre shape function More...
 
class  LegendreShapeFunctionSet
 a Dune::Fem::ShapeFunctionSet of Legendre ansatz polynomials More...
 
class  LevelGridPart
 
class  LinearOperator
 abstract affine-linear operator More...
 
class  LineQuadrature
 
class  LineSegmentSampler
 samples values of a discrete function along a given line segment More...
 
class  LineTwistMapperStrategy
 
class  LoadBalanceLeafData
 check for sets of entities for the load balance procedure 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  LoadBalancerInterface
 Interface class for load balancing. 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 to the local analytical function. More...
 
class  LocalAverage
 
struct  LocalAverageHelper
 
struct  LocalAverageImpl
 
class  LocalAverageImpl< LocalFunction, GridPart, DiscontinuousGalerkinSpace< FunctionSpace, GridPart, order, Storage > >
 
class  LocalAverageImpl< LocalFunction, GridPart, FiniteVolumeSpace< FunctionSpace, GridPart, codim, Storage > >
 
class  LocalCoordinate
 
class  LocalCoordinate< PointGeometry, Field, offset >
 
class  LocalCoordinate< ProductGeometry< FirstGeometry, SecondGeometry >, Field, offset >
 
class  LocalCoordinate< PyramidGeometry< BaseGeometry >, Field, offset >
 
class  LocalDataInliner
 Inline DiscreteFunction data during load balancing. More...
 
struct  LocalDataInlinerTraits
 
class  LocalDataXtractor
 Inline DiscreteFunction data during load balancing. More...
 
struct  LocalDataXtractorTraits
 
class  LocalDGMassPass
 Implementation of operator to calculate gradient of a given discrete function using the pass concept. More...
 
class  LocalDGPass
 
class  LocalFunction
 interface for local functions More...
 
class  LocalFunctionAdapter
 LocalFunctionAdapter wrapped a class with a local evaluate method into a grid function. More...
 
struct  LocalFunctionAdapterHasInitialize
 identifier to local function has initialize feature More...
 
class  LocalFunctionAdapterLocalFunction
 
struct  LocalFunctionAdapterTraits
 traits of DiscreteFunctionAdapter More...
 
class  LocalFunctionConverter
 implementation of a Dune::Fem::LocalFunction on a FunctionSpace V restircted/prolongated from an other function space W. More...
 
struct  LocalFunctionEvaluator
 
struct  LocalFunctionSelector
 
struct  LocalFunctionSelector< LocalFunctionAdapter< Evaluate > >
 
class  LocalFunctionSet
 Local basis functions. More...
 
class  LocalFunctionSetAdapter
 convert (global) function set to local function set More...
 
class  LocalFunctionSetProxy
 Proxy for a LocalBasisFunctionSet. More...
 
class  LocalFunctionsShapeFunctionSet
 
class  LocalFunctionsShapeFunctionSetTraits
 
class  LocalFunctionTuple
 
class  LocalFunctionTuple< DiscreteFunctionTuple, Entity, 0 >
 
class  LocalInlinePlus
 
class  LocalInterface
 
struct  LocalKey
 
class  LocalL2Projection
 please doc me More...
 
class  LocalMassMatrix
 Local Mass Matrix for arbitrary spaces. More...
 
class  LocalMassMatrix< DiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, BaseFunctionStorageImp >, VolumeQuadratureImp >
 Local Mass Matrix for DG space. More...
 
class  LocalMassMatrix< HierarchicLegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, BaseFunctionStorageImp >, VolumeQuadratureImp >
 Local Mass Matrix for hierarchic Legendre space. More...
 
class  LocalMassMatrix< LegendreDiscontinuousGalerkinSpace< FunctionSpaceImp, GridPartImp, polOrd, BaseFunctionStorageImp >, VolumeQuadratureImp >
 Local Mass Matrix for Legendre space. More...
 
class  LocalMassMatrixImplementation
 Local Mass Matrix inversion implementation, select the correct method in your implementation. More...
 
class  LocalMassMatrixImplementationDgOrthoNormal
 DG Local Mass Matrix for arbitrary spaces. More...
 
class  LocalMatrixDefault
 Default implementation for local matrix classes. More...
 
class  LocalMatrixInterface
 Interface for local matrix classes. More...
 
class  LocalMatrixWrapper
 
struct  LocalMatrixWrapperTraits
 
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  LocalOperatorInterface
 
struct  LocalParameter
 
struct  LocalParameter< ParamDefault, ParamDefault >
 
class  LocalPass
 Specialisation of Pass which provides a grid walk-through, but leaves open what needs to be done on each elements. 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  LocalRieszProjection
 interface documentation of a local Riesz projection More...
 
class  LPNorm
 
class  LPNormBase
 
class  LumpingQuadrature
 
struct  LumpingQuadratureTraits
 
class  MakeVectorialExpression
 
class  MakeVectorialExpression< FieldMatrix< K, 1, dimD >, FieldMatrix< K, dimR, dimD > >
 
class  MakeVectorialExpression< FieldVector< K, 1 >, FieldVector< K, dimR > >
 
struct  MakeVectorialTraits
 
struct  MakeVectorialTraits< FieldMatrix< K, 1, dimD >, FieldMatrix< K, dimR, dimD > >
 
struct  MakeVectorialTraits< FieldVector< K, 1 >, FieldVector< K, dimR > >
 
class  ManagedDiscreteFunction
 
class  ManagedDiscreteFunction< VectorDiscreteFunction< DiscreteFunctionSpace, Vector > >
 
class  ManagedDofStorage
 
class  ManagedDofStorageImplementation
 
class  ManagedDofStorageInterface
 Interface class for a dof storage object that can be managed (resized and compressed) by the DofManager. More...
 
class  ManagedIndexSet
 
class  ManagedIndexSetInterface
 
struct  MapGeometryType
 
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...
 
class  MatrixColumnObject
 
class  MatrixFunctionSpace
 A matrix valued function space. More...
 
struct  MatrixFunctor
 
class  MatrixMapping
 JacobianRangeType class for matrix valued functions - derived from FieldMatrix. More...
 
struct  MatrixParameter
 MatrixParameter. More...
 
struct  MatrixSpaceTraits
 Traits class for matrix valued spaces. More...
 
struct  MetaTwistUtility
 MetaTwistUtility forwards the twist calls to the TwistUtility of the underlying HostTwistUtility. More...
 
struct  MPIManager
 
class  MutableArray
 
class  MutableBlockVector
 
class  MutableBlockVector< MutableArray< F >, BlockSize >
 
class  MutableLocalFunction
 
class  NewtonInverseOperator
 inverse operator based on a newton scheme More...
 
struct  NewtonParameter
 
struct  NoDataException
 
class  NonAdaptiveIndexSet
 wrapper for (adaptive) index sets that disables all support for adaptivity More...
 
struct  NonAdaptiveIndexSetTraits
 
class  NonBlockMapper
 
class  NonBlockMapper< NonBlockMapper< BlockMapper, innerBlockSize >, outerBlockSize >
 
class  NoWhiteSpaceValidator
 
class  NumberColumnWriter
 gets the N th element of a provided tuple assuming its a number More...
 
class  ObjectPointer
 models a pointer to a reference countable object More...
 
class  ObjectStack
 
class  ObjectStackEntry
 
struct  ObjectStackEntryTraits
 
struct  ObjPointer
 
class  ObjPointerStorage
 
class  OEMBICGSQOp
 BiCG-SQ method. More...
 
class  OEMBICGSTABOp
 BiCG-stab solver. More...
 
class  OEMCGOp
 OEM-CG scheme after Hestenes and Stiefel. More...
 
class  OEMGMRESOp
 GMRES solver. More...
 
class  OEMMatrix
 interface for matrices to be used with OEM sovlers More...
 
class  OffsetSubMapper
 Index mapper which simply adds an offset to the index. More...
 
class  Operator
 abstract operator More...
 
struct  OrderCalculatorInterface
 Quadrature Order Interface. More...
 
class  OrthonormalBase_1D
 
class  OrthonormalBase_2D
 
class  OrthonormalBase_3D
 
class  OrthonormalLocalRieszProjection
 
struct  OrthonormalShapeFunctionHelper
 
class  OrthonormalShapeFunctionSet
 
class  OrthonormalShapeFunctionSetSize
 
class  OutStreamInterface
 abstract interface for an output stream More...
 
class  PAdaptiveDGMapper
 
struct  PAdaptiveDGMapperTraits
 
class  PAdaptiveDGSpace
 adaptive DG discrete function space More...
 
struct  PAdaptiveDGSpaceTraits
 
class  PAdaptiveLagrangeMapper
 
struct  PAdaptiveLagrangeMapperTraits
 
class  PAdaptiveLagrangeSpace
 Lagrange discrete function space. More...
 
struct  PAdaptiveLagrangeSpaceTraits
 
struct  PairFunctor
 
class  ParallelScalarProduct
 
class  Parameter
 Container for User Specified Parameters. More...
 
class  ParameterContainer
 
struct  ParameterContainerData
 
class  ParameterInvalid
 
class  ParameterNotFound
 
struct  ParameterParser
 
struct  ParameterParser< bool >
 
struct  ParameterParser< FieldMatrix< F, m, n > >
 
class  PARDGSpaceOperatorInterface
 ODESpaceOperatorInterface for Operators that work with PARDG ODE solvers of the type $L: X \longrightarrow X$ where $X$ is a discrete function space. More...
 
struct  PartitionIteratorProvider
 
class  Pass
 Base class for specific pass implementations. More...
 
class  PersistenceManager
 class with singleton instance managing all persistent objects More...
 
class  PersistentAdaptiveIndexSet
 
class  PersistentConsecutiveIndexSet
 
class  PersistentIndexSet
 please doc me More...
 
struct  PersistentIndexSetInterface
 virtual base class for persistent index sets More...
 
class  PersistentObject
 base class for persistent objects More...
 
class  PetscDiscreteFunction
 
struct  PLagrangeLocalRestrictProlong
 
class  PointBasedDofConversionUtility
 Specialisation for PointBased approach. More...
 
class  PointGeometry
 generic geometry modelling a single point More...
 
class  PointProvider
 
class  PointProvider< ct, dim, 0 >
 
class  PointProvider< ct, dim, 1 >
 
class  PointTwistMapperStrategy
 
class  PowerDiscreteFunctionSpace
 
struct  PowerDiscreteFunctionSpaceTraits
 
class  PowerLocalRestrictProlong
 
class  PowerMapper
 mapper allocating one DoF per subentity of a given codimension More...
 
class  PreconditionedInverseOperator
 
class  PrismQuadrature
 
class  ProductGeometry
 generic geometry modelling the product of two base geometries More...
 
class  ProlongFunction
 prolong discrete functions between grid levels More...
 
class  PyramidGeometry
 generic geometry modelling a pyramid over a base geometry More...
 
class  PyramidPoints
 
class  PyramidQuadrature
 
class  QuadCreator
 the actual quadrature storage More...
 
class  Quadrature
 actual interface class for quadratures More...
 
class  QuadratureImp
 Generic implementation of a Dune quadrature. More...
 
struct  QuadratureKey
 
class  QuadraturePointWrapper
 wrapper for a (Quadrature,int) pair 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  QuadratureRulesFactory
 quadrature implementation based on the standard DUNE quadratures More...
 
class  QuadratureStorageRegistry
 
class  QuadrilateralQuadrature
 
class  QuadrilateralTwistMapperStrategy
 
class  RadialFilter
 example implementation; given center x and radius r, filter is characteristic function of clos B_r( x ) More...
 
class  RangeMatrix
 RangeType class for matrix valued functions - derived from FieldMatrix but has representation as vector. More...
 
struct  RangeTypeEvaluator
 
struct  RannacherTurekBlockMapperFactory
 
class  RannacherTurekBlockMapperSingletonKey
 
struct  RannacherTurekDiscreteFunctionSpace
 
struct  RannacherTurekDofMapperCodeFactory
 
class  RannacherTurekLocalInterpolation
 
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  ReferenceBlockVectorBlock
 
class  ReferenceCounterDefault
 default implementation of ReferenceCounterInterface More...
 
class  ReferenceCounterInterface
 interface for objects capable of reference counting More...
 
class  RemoveIndicesFromSet
 
class  ReserveMemoryObjects
 
class  ResizeMemoryObjects
 
class  RestrictFunction
 restrict discrete functions between grid levels More...
 
class  RestrictProlongDefault
 This is a wrapper for the default implemented restriction/prolongation operator, which only takes a discrete function template. More...
 
struct  RestrictProlongDefaultTraits
 
struct  RestrictProlongDefaultTraits< std::tuple< DiscreteFunctions &... > >
 
class  RestrictProlongDefaultTuple
 conveniently set up a tuple of Dune::Fem::RestrictProlongDefault restriction/prolongation objects created from a variadic list of discrete functions More...
 
class  RestrictProlongInterface
 Interface class defining the local behaviour of the restrict/prolong operation (using BN) More...
 
class  RestrictProlongInterfaceDefault
 Interface default implementation for derived classes. More...
 
struct  RestrictProlongTraits
 Traits class for derivation from RestrictProlongInterface. More...
 
class  RestrictProlongTuple
 combine a variadic number of Dune::Fem::RestrictProlongInterface instances into a single object again derived from Dune::Fem::RestrictProlongInterface More...
 
class  RestrictProlongTuple< Head, Tail... >
 
class  RestrictProlongWrapper
 
struct  RowType
 
struct  RowType< const T >
 
struct  RowType< FieldMatrix< K, ROWS, COLS > >
 
struct  RowType< FieldVector< K, SIZE > >
 
class  ScaledLocalOperator
 
class  SelectCachingShapeFunctionSet
 
class  SelectCachingShapeFunctionSet< ShapeFunctionSet, CachingStorage >
 
class  SelectCachingShapeFunctionSet< ShapeFunctionSet, SimpleStorage >
 
class  SelectCachingShapeFunctionSets
 
struct  Selector
 A helper class that creates a selector tuple from given pass ids. More...
 
struct  SelectorBase
 A helper class that creates a selector tuple from given pass ids. More...
 
struct  SelectUnsignedLongInteger
 
struct  SelectUnsignedLongInteger< ulongint, ulongint >
 
class  ShapeFunctionSet
 
class  ShapeFunctionSetProxy
 
class  ShapeFunctionSets
 interface class representing a family of shape function sets More...
 
class  SimpleBasisFunctionSet
 Please doc me. More...
 
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  SimpleBlockVectorBlock
 This is the implementation of a block of SimpleBlockVector. More...
 
struct  SimpleDofAllocator
 
class  SimpleShapeFunctionSet
 
class  SimpleStencil
 a watered down stencil providing only the upper bound for the non-zero entries per row. More...
 
class  SimpleStorage
 
struct  SimplexMaxOrder
 
class  SimplexQuadrature
 
class  SingletonList
 Singleton list for key/object pairs. More...
 
class  SIONlibInStream
 input stream reading from a file in binary form More...
 
class  SIONlibOutStream
 output stream writing into a single file with the SIONlib (http://www2.fz-juelich.de/jsc/sionlib/) More...
 
class  SlaveDofs
 
class  SlaveDofsProvider
 
struct  SolverParameter
 
class  SpaceOperatorInterface
 interface for time evolution operators More...
 
class  SpaceOperatorPtr
 only for keeping the pointer More...
 
class  SpaceOperatorStorage
 only for keeping the pointer More...
 
class  SpaceOperatorWrapper
 apply wrapper More...
 
class  SparseRowLinearOperator
 
class  SparseRowMatrix
 SparseRowMatrix. More...
 
class  SparseRowMatrixObject
 
struct  SparseRowMatrixParameter
 
struct  SparseRowMatrixTraits
 
struct  SpecialArrayFeatures
 SpecialArrayFeatures is a wrapper class to extend some array classes with some special features needed for the MemObject. There exsist a specialization for MutableArray and PetscVector. More...
 
struct  SpecialArrayFeatures< MutableArray< ValueType > >
 Specialization of SpecialArrayFeatures for MutableArray. More...
 
struct  StackAllocator
 
struct  StackAllocator< void, S >
 
class  StandardArrayAllocator
 
struct  StandardArrayAllocatorTraits
 
class  StandardInStream
 input stream reading from a given std::istream More...
 
struct  StandardInStreamTraits
 
class  StandardOutStream
 output stream writing into a given std::ostream More...
 
struct  StandardOutStreamTraits
 
class  StartPass
 End marker for a compile-time list of passes. More...
 
class  StaticArray
 Static Array Wrapper for simple C Vectors like double* and int*. This also works as base class for the MutableArray which is used to store the degrees of freedom. More...
 
class  StaticOffsetSubMapper
 Index mapper with static size which simply adds an offset to the index. More...
 
class  StaticVector
 implementation of VectorInterface using a C++ array embedded info the class to provide the fields More...
 
class  Stencil
 default implementation for a general operator stencil More...
 
class  STLArray
 
class  STLArrayIterator
 
struct  STLArrayTraits
 
class  StreamError
 
struct  StreamFactory
 Factory class for Fem Streams to deal with different constructor parameters. More...
 
struct  StreamFactory< SIONlibInStream >
 Factory class for Fem Streams to deal with different constructor parameters. More...
 
class  SubArray
 
class  SubDofVector
 Extract Sub dof vector for single coordinate. More...
 
class  SubDofVector< DofVector, HorizontalDofAlignment< ScalarBasisFunctionSet, Range > >
 
class  SubDofVector< DofVector, VerticalDofAlignment< ScalarBasisFunctionSet, Range > >
 
class  SubEntityLagrangePointIterator
 
class  SubEntityLagrangePointIterator< GridPart, 0, polOrder >
 
class  SubFunctionStorage
 
class  SubObject
 
class  SubVector
 
struct  SupportsArrayInterface
 
struct  SupportsIndexMapperInterface
 
struct  SupportsReferenceCounterInterface
 
struct  SupportsVectorInterface
 
class  TemporaryLocalFunction
 A temporary function carrying values for one entity. More...
 
class  TemporaryLocalMatrix
 A local matrix with a small array as storage. More...
 
struct  TemporaryLocalMatrixTraits
 
class  TensorProductShapeFunctionSet
 
class  TestQuadrature
 
class  TetraQuadrature
 
class  ThreadFilter
 
struct  ThreadFilterTraits
 
class  ThreadIterator
 Thread iterators. More...
 
class  ThreadIteratorStorage
 Storage of thread iterators. More...
 
class  ThreadIteratorStorageBase
 Storage of thread iterators using domain decomposition. More...
 
class  ThreadManager
 The ThreadManager wrapps basic shared memory functionality provided by OpenMP or pthreads such as thread id, number of threads, etc. More...
 
class  ThreadSafeValue
 ThreadSafeValue realizes thread safety for a given variable by creating an instance of this variable for each thread. More...
 
class  TimeDependentFunction
 
class  TimeProvider
 manager for global simulation time of time-dependent solutions More...
 
class  TimeProviderBase
 general base for time providers More...
 
struct  Timer
 
struct  Timer< false >
 
struct  Timer< true >
 
struct  ToNewDimDomainFunctionSpace
 convert functions space to space with new dim domain 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
 convert functions space to space with new dim range More...
 
struct  ToNewDimRangeFunctionSpace< FunctionSpace< DomainFieldImp, RangeFieldImp, dimDomain, dimRange >, newDimRange >
 specialization for parameter list <domainfile,rangefield,dimDomain,dimRange,dimLocal> More...
 
struct  ToNewRange
 
struct  ToNewRange< FunctionSpace< DomainField, RangeField, dimD, 1 >, FieldVector< RangeField, dimR > >
 
class  TriangleQuadrature
 
class  TriangleTwistMapperStrategy
 
class  TupleBasisFunctionSet
 
struct  TupleDataSource
 
class  TupleDiscreteFunctionSpace
 
struct  TupleDiscreteFunctionSpaceTraits
 
class  TupleLocalRestrictProlong
 
class  TupleMapper
 mapper allocating one DoF per subentity of a given codimension More...
 
class  TupleShapeFunctionSet
 
struct  TwistFreeTwistUtility
 TwistFreeTwistUtility provides the default implementation for twistfree grid such as Cartesian grids. More...
 
class  TwistMapperCreator
 Helper class for TwistProvider which takes care of the creation process. More...
 
class  TwistMapperStrategy
 This class factors out all geometry dependent stuff in a strategy class. More...
 
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  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  TwistUtility
 Utility to get twist from IntersectionIterator, if provided by grid (i.e. AlbertaGrid, ALUGrid) otherwise return default values (correct for YASP/SGRID). More...
 
struct  TwistUtility< GeometryGrid< HostGrid, CoordFunction, Allocator > >
 
struct  TwistUtility< OneDGrid >
 
struct  TwistUtility< SGrid< dim, dimworld, ctype > >
 
struct  TwistUtility< YaspGrid< dimw, CoordCont > >
 
struct  UninitializedObjectStack
 
class  UnknownGridException
 
class  ValidateGreater
 
class  ValidateInterval
 
class  ValidateLess
 
class  ValidateNotGreater
 
class  ValidateNotLess
 
class  ValidatorDefault
 
class  ValidatorInterface
 
class  VectorDefault
 default implementation of VectorInterface More...
 
struct  VectorDefaultTraits
 
class  VectorDiscreteFunction
 
class  VectorialBasisFunctionSet
 Builds a vectorial basis function set from given scalar basis function set. More...
 
class  VectorialShapeFunctionSet
 
class  VectorialShapeFunctionSets
 
class  VectorInterface
 An abstract vector interface. More...
 
struct  VectorInterfaceArrayTraits
 
struct  VectorSpaceTraits
 Traits class for vector function spaces. More...
 
class  VerticalDofAlignment
 Implementation of DofAlignment. More...
 
class  VirtualInStream
 
class  VirtualInStreamObject
 
struct  VirtualInStreamTraits
 
class  VirtualInStreamWrapper
 
class  VirtualOutStream
 
class  VirtualOutStreamObject
 
struct  VirtualOutStreamTraits
 
class  VirtualOutStreamWrapper
 
class  VoidFilter
 
class  VTKFunctionWrapper
 
class  VTKIO
 
class  VTKIO< GridPart, false >
 
class  VTKIO< GridPart, true >
 
class  VTKIOBase
 /brief Output using VTK More...
 
class  VtxProjection
 The Projection class which average discontinuous function in the Lagrangepoints. More...
 
struct  VtxProjectionImpl
 
struct  WeightDefault
 
class  WeightedL2Norm
 
class  WeightedLPNorm
 
class  XDRBasicInStream
 base implementation for XDR input streams More...
 
class  XDRBasicOutStream
 base implementation for XDR output streams More...
 
class  XDRFileInStream
 XDR output stream reading from a file. More...
 
class  XDRFileOutStream
 XDR output stream writing into a file. More...
 
struct  XDRInStreamTraits
 
struct  XDROutStreamTraits
 

Typedefs

template<class GridPart >
using SubsamplingVTKIO = VTKIO< GridPart, true >
 
typedef BasicParameterReader< std::function< const std::string *(const std::string &, const std::string *) > > ParameterReader
 
typedef TimeProvider DefaultTimeProvider
 
typedef DefaultCodeGenerator CodeGeneratorType
 

Enumerations

enum  DFSpaceIdentifier {
  CombinedSpace_id, DFAdapter_id, DGSpace_id, FiniteVolumeSpace_id,
  FourierSpace_id, GenericSpace_id, LagrangeSpace_id, RannacherTurekSpace_id,
  LegendreDGSpace_id, HierarchicLegendreDGSpace_id, LagrangeDGSpace_id
}
 enumerator for identification of spaces More...
 
enum  DofStoragePolicy { PointBased, VariableBased }
 

Functions

template<class Point >
static const Point & coordinate (const Point &x)
 
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 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<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)
 
std::string generateFilename (const std::string &fn, int ntime, int precision=6)
 
template<class ObjectType >
PersistenceManageroperator<< (PersistenceManager &pm, ObjectType &object)
 
template<class ObjectType >
PersistenceManageroperator>> (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 &parameterTree)
 
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 Implementation >
Dune::EntityPointer< Grid, Implementation >::Entity make_entity (const Dune::EntityPointer< Grid, Implementation > &entityPointer)
 
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)
 
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 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 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>
scalarProduct (const FieldMatrix< K, ROWS, COLS > &a, const FieldMatrix< K, ROWS, COLS > &b)
 
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 FieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::cols, GeometryJacobianInverseTransposed::cols >, SIZE > &a, FieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::rows, GeometryJacobianInverseTransposed::rows >, SIZE > &b)
 
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 std::string &name, 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 GridFunction , class DiscreteFunction , unsigned int partitions>
static void interpolate (const GridFunction &u, DiscreteFunction &v, PartitionSet< partitions > ps)
 
template<class Function , class DiscreteFunction , unsigned int partitions>
static void interpolate (const Function &u, DiscreteFunction &v, PartitionSet< partitions > ps, std::integral_constant< bool, false >)
 
template<class GridFunction , class DiscreteFunction , unsigned int partitions>
static void interpolate (const GridFunction &u, DiscreteFunction &v, PartitionSet< partitions > ps, std::integral_constant< bool, true >)
 
template<class... DiscreteFunctions>
static RestrictProlongDefaultTuple< DiscreteFunctions... > makeRestrictProlongDefault (DiscreteFunctions &...discreteFunctions)
 
template<class... DiscreteFunctions>
static RestrictProlongDefaultTuple< DiscreteFunctions... > makeRestrictProlongDefault (std::tuple< DiscreteFunctions &... > tuple)
 
template<class Field , int dim>
DofMapperCode generateCodimensionCode (const Dune::ReferenceElement< Field, dim > &refElement, int codim)
 
template<class Field , int dim, class LocalCoefficients >
DofMapperCode compile (const Dune::ReferenceElement< Field, dim > &refElement, const LocalCoefficients &localCoefficients)
 
template<class DF , class Vector , class DFS >
void pAdaptation (DF &df, const Vector &polynomialOrders, const DFS &space, const int)
 
template<class DF , class Vector , class FS , class GP , int p, template< class > class Storage>
void pAdaptation (DF &df, const Vector &polynomialOrders, const Fem::PAdaptiveLagrangeSpace< FS, GP, p, Storage > &space, const int polOrderShift=0)
 pAdaptation More...
 
template<class DF , class Vector >
void pAdaptation (DF &df, const Vector &polynomialOrders, const int polOrderShift=0)
 pAdaptation More...
 
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< FieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::cols, GeometryJacobianInverseTransposed::cols >, 1 >, FieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::cols, GeometryJacobianInverseTransposed::cols >, SIZE > > &a, FieldVector< 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)
 
template<class T >
void moveBackward (ArrayInterface< T > &array, const unsigned int oldOffset, const unsigned int newOffset, const unsigned int length)
 
template<class T >
void moveForward (ArrayInterface< T > &array, const unsigned int oldOffset, const unsigned int newOffset, const unsigned int length)
 
template<class T >
void move (ArrayInterface< T > &array, const unsigned int oldOffset, const unsigned int newOffset, const unsigned int length)
 
template<class Traits1 , class Traits2 >
ExtractCommonFieldType< Traits1, Traits2 >::FieldType operator* (const VectorInterface< Traits1 > &u, const VectorInterface< Traits2 > &v)
 Scalar product of two vectors. More...
 
template<class StreamTraits , class VectorTraits >
OutStreamInterface< StreamTraits > & operator<< (OutStreamInterface< StreamTraits > &out, const VectorInterface< VectorTraits > &v)
 write a vector into an output stream More...
 
template<class StreamTraits , class VectorTraits >
InStreamInterface< StreamTraits > & operator>> (InStreamInterface< StreamTraits > &in, VectorInterface< VectorTraits > &v)
 read a vector from an input stream More...
 
void match (std::istream &in, char excepted)
 

Typedef Documentation

typedef BasicParameterReader< std::function< const std::string *( const std::string &, const std::string * ) > > Dune::Fem::ParameterReader
template<class GridPart >
using Dune::Fem::SubsamplingVTKIO = typedef VTKIO< GridPart, true >

Enumeration Type Documentation

Indicates how the dofs shall be stored in the discrete functions Point based means that all dofs belonging to one local degree in a contained spaced are stored consecutively, whereas in the variable based approach all dofs belonging to one subspace are stored consecutively

Enumerator
PointBased 
VariableBased 

Function Documentation

Double Dune::Fem::abs ( const Double a)
inline
template<class T >
void Dune::Fem::axpy ( const T &  a,
const T &  x,
T &  y 
)
inline
template<class K , int SIZE>
void Dune::Fem::axpy ( const typename FieldTraits< K >::field_type &  a,
const FieldVector< K, SIZE > &  x,
FieldVector< K, SIZE > &  y 
)
inline

References axpy().

template<class K , int ROWS, int COLS>
void Dune::Fem::axpy ( const typename FieldTraits< K >::field_type &  a,
const FieldMatrix< K, ROWS, COLS > &  x,
FieldMatrix< K, ROWS, COLS > &  y 
)
inline
template<class Scalar , class Vectorial >
void Dune::Fem::axpy ( const typename MakeVectorialTraits< Scalar, Vectorial >::field_type &  a,
const MakeVectorialExpression< Scalar, Vectorial > &  x,
typename MakeVectorialTraits< Scalar, Vectorial >::VectorialType &  y 
)
inline
template<class Field , int dim, class LocalCoefficients >
DofMapperCode Dune::Fem::compile ( const Dune::ReferenceElement< Field, dim > &  refElement,
const LocalCoefficients &  localCoefficients 
)
inline
template<class Point >
static const Point& Dune::Fem::coordinate ( const Point &  x)
inlinestatic

Referenced by Dune::Fem::DefaultBasisFunctionSet< Entity, ShapeFunctionSet >::axpy(), Dune::Fem::GridFunctionAdapter< FunctionImp, GridPartImp >::LocalFunction::evaluate(), Dune::Fem::LocalAnalyticalFunctionBinder< DiscreteFunctionSpaceImpl, AnalyticalFunctionImpl >::evaluate(), Dune::Fem::LocalFunctionSetAdapter< Entity, FunctionSet >::evaluateEach(), Dune::Fem::TensorProductShapeFunctionSet< FunctionSpace, ShapeFunctionSetTuple >::evaluateEach(), Dune::Fem::LocalFunctionsShapeFunctionSet< LocalBasis >::evaluateEach(), Dune::Fem::SimpleShapeFunctionSet< ShapeFunction >::evaluateEach(), Dune::Fem::LegendreShapeFunctionSet< ScalarShapeFunctionSpaceType >::evaluateEach(), Dune::Fem::OrthonormalShapeFunctionSet< FunctionSpace, polOrder >::evaluateEach(), Dune::Fem::LocalAnalyticalFunctionBinder< DiscreteFunctionSpaceImpl, AnalyticalFunctionImpl >::hessian(), Dune::Fem::DefaultBasisFunctionSet< Entity, ShapeFunctionSet >::hessianAll(), Dune::Fem::TensorProductShapeFunctionSet< FunctionSpace, ShapeFunctionSetTuple >::hessianEach(), Dune::Fem::LocalFunctionSetAdapter< Entity, FunctionSet >::hessianEach(), Dune::Fem::SimpleShapeFunctionSet< ShapeFunction >::hessianEach(), Dune::Fem::LegendreShapeFunctionSet< ScalarShapeFunctionSpaceType >::hessianEach(), Dune::Fem::OrthonormalShapeFunctionSet< FunctionSpace, polOrder >::hessianEach(), Dune::Fem::GridFunctionAdapter< FunctionImp, GridPartImp >::LocalFunction::jacobian(), Dune::Fem::LocalAnalyticalFunctionBinder< DiscreteFunctionSpaceImpl, AnalyticalFunctionImpl >::jacobian(), Dune::Fem::DefaultBasisFunctionSet< Entity, ShapeFunctionSet >::jacobianAll(), Dune::Fem::LocalFunctionSetAdapter< Entity, FunctionSet >::jacobianEach(), Dune::Fem::TensorProductShapeFunctionSet< FunctionSpace, ShapeFunctionSetTuple >::jacobianEach(), Dune::Fem::SimpleShapeFunctionSet< ShapeFunction >::jacobianEach(), Dune::Fem::LocalFunctionsShapeFunctionSet< LocalBasis >::jacobianEach(), Dune::Fem::LegendreShapeFunctionSet< ScalarShapeFunctionSpaceType >::jacobianEach(), Dune::Fem::OrthonormalShapeFunctionSet< FunctionSpace, polOrder >::jacobianEach(), Dune::Fem::PLagrangeLocalRestrictProlong< GP::GridType, Fem::PAdaptiveLagrangeSpace< FS, GP, ord, S > >::localInterpolation(), Dune::Fem::VtxProjectionImpl::project(), Dune::Fem::PLagrangeLocalRestrictProlong< GP::GridType, Fem::PAdaptiveLagrangeSpace< FS, GP, ord, S > >::prolongLocal(), Dune::Fem::LagrangeLocalRestrictProlong< GridPartType::GridType, order >::prolongLocal(), Dune::Fem::PLagrangeLocalRestrictProlong< GP::GridType, Fem::PAdaptiveLagrangeSpace< FS, GP, ord, S > >::restrictLocal(), and Dune::Fem::LagrangeLocalRestrictProlong< GridPartType::GridType, order >::restrictLocal().

static double Dune::Fem::cos ( const Double v)
inlinestatic
bool Dune::Fem::createDirectory ( const std::string &  name)

create a directory

Parameters
[in]namename of the directory to create
Returns
whether the directory has been successfully created

Referenced by Dune::Fem::CodegenInfo::addEntry(), Dune::Fem::IOInterface::createGlobalPath(), Dune::Fem::IOInterface::createPath(), Dune::Fem::PersistenceManager::restoreValue(), and Dune::Fem::Parameter::write().

bool Dune::Fem::directoryExists ( const std::string &  name)

check whether a directory exists

Parameters
[in]namename of the directory to check
Returns
true if the directory exists, false otherwise

Referenced by scanProcsPaths(), and Dune::Fem::Parameter::write().

std::string Dune::Fem::executeCommand ( const std::string &  command)

executes a command and return the output

Parameters
[in]commandcommand to execute
Returns
the output of the executed command
Note
This command throws an exception if the command returns unsuccsessfully.

Referenced by Dune::Fem::ParameterContainerData::resolveEscape().

void Dune::Fem::field_cast ( const Double f1,
double &  f2 
)
inline
bool Dune::Fem::fileExists ( const std::string &  name)

check whether a file exists

Parameters
[in]namename of the file to check
Returns
true if the file exists, false otherwise

Referenced by scanProcsFiles().

template<class Field , int dim>
DofMapperCode Dune::Fem::generateCodimensionCode ( const Dune::ReferenceElement< Field, dim > &  refElement,
int  codim 
)
inline
std::string Dune::Fem::generateFilename ( const std::string &  fn,
int  ntime,
int  precision = 6 
)
inline
template<class Entity >
const GridEntityAccess< Entity >::GridEntityType& Dune::Fem::gridEntity ( const Entity &  entity)
template<class GridImp >
static const std::string& Dune::Fem::gridName ( )
static
template<class GridImp >
static const std::string& Dune::Fem::gridName ( const GridImp &  grid)
static
template<class GeometryJacobianInverseTransposed , class K , int SIZE>
void Dune::Fem::hessianTransformation ( const GeometryJacobianInverseTransposed &  gjit,
const FieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::cols, GeometryJacobianInverseTransposed::cols >, SIZE > &  a,
FieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::rows, GeometryJacobianInverseTransposed::rows >, SIZE > &  b 
)
template<class GeometryJacobianInverseTransposed , class K , int SIZE>
void Dune::Fem::hessianTransformation ( const GeometryJacobianInverseTransposed &  gjit,
const MakeVectorialExpression< FieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::cols, GeometryJacobianInverseTransposed::cols >, 1 >, FieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::cols, GeometryJacobianInverseTransposed::cols >, SIZE > > &  a,
FieldVector< FieldMatrix< K, GeometryJacobianInverseTransposed::rows, GeometryJacobianInverseTransposed::rows >, SIZE > &  b 
)

References axpy().

double Dune::Fem::imag ( const std::complex< Double > &  x)
inline
double Dune::Fem::imag ( const Double x)
inline
template<class Function >
InstationaryFunction< Function, __InstationaryFunction::HoldCopy > Dune::Fem::instationaryFunction ( Function  function,
double  time 
)

References move().

template<class Function >
InstationaryFunction< typename std::remove_const< Function >::type, __InstationaryFunction::HoldReference > Dune::Fem::instationaryFunction ( std::reference_wrapper< Function function,
double  time 
)
template<class GridFunction , class DiscreteFunction , unsigned int partitions>
static void Dune::Fem::interpolate ( const GridFunction &  u,
DiscreteFunction &  v,
PartitionSet< partitions >  ps 
)
inlinestatic

References interpolate().

template<class Function , class DiscreteFunction , unsigned int partitions>
static void Dune::Fem::interpolate ( const Function u,
DiscreteFunction &  v,
PartitionSet< partitions >  ps,
std::integral_constant< bool, false >   
)
inlinestatic

References interpolate().

template<class GridFunction , class DiscreteFunction , unsigned int partitions>
static void Dune::Fem::interpolate ( const GridFunction &  u,
DiscreteFunction &  v,
PartitionSet< partitions >  ps,
std::integral_constant< bool, true >   
)
inlinestatic
template<class GeometryJacobianInverseTransposed , class K , int ROWS>
void Dune::Fem::jacobianTransformation ( const GeometryJacobianInverseTransposed &  gjit,
const FieldMatrix< K, ROWS, GeometryJacobianInverseTransposed::cols > &  a,
FieldMatrix< K, ROWS, GeometryJacobianInverseTransposed::rows > &  b 
)
template<class GeometryJacobianInverseTransposed , class K , int ROWS>
void Dune::Fem::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 HostLocalFunction , class Converter >
LocalFunctionConverter< HostLocalFunction, Converter, __InstationaryFunction::HoldCopy > Dune::Fem::localFunctionConverter ( HostLocalFunction  hostLocalFunction,
const Converter &  converter = Converter() 
)

References move().

template<class HostLocalFunction , class Converter >
LocalFunctionConverter< typename std::remove_const< HostLocalFunction >::type, Converter, __InstationaryFunction::HoldReference > Dune::Fem::localFunctionConverter ( std::reference_wrapper< HostLocalFunction >  hostLocalFunction,
const Converter &  converter = Converter() 
)
static double Dune::Fem::log ( const Double v)
inlinestatic
template<class Grid , class Implementation >
Dune::EntityPointer< Grid, Implementation >::Entity Dune::Fem::make_entity ( const Dune::EntityPointer< Grid, Implementation > &  entityPointer)

Referenced by Dune::Fem::LocalDGPass< DiscreteModelImp, PreviousPassImp >::applyLocal(), Dune::Fem::PAdaptiveLagrangeSpace< FS, GP, ord, S >::continuous(), Dune::Fem::DiagonalAndNeighborStencil< DomainSpace, RangeSpace >::DiagonalAndNeighborStencil(), Dune::Fem::CheckCartesian< GridPartType >::doCheck(), Dune::Fem::TwistFreeTwistUtility< YaspGrid< dimw, CoordCont > >::elementGeometry(), Dune::Fem::HdivProjection< DiscreteFunctionType >::estimator(), Dune::Fem::AdaptationManagerBase< GridType, RestProlOperatorImp >::getDofManager(), Dune::Fem::AdaptiveIndexSetBase< IntersectionAdaptiveLeafIndexSetTraits< GridPartImp > >::getIntersectionFace(), Dune::Fem::GlobalConsecutiveIndexSet< GridPartType >::GlobalConsecutiveIndexSet(), Dune::Fem::GenericAdaptiveDofMapper< PAdaptiveLagrangeMapperTraits< GridPart, polOrder > >::insertFather(), Dune::Fem::IdIntersection< GridFamily >::inside(), Dune::Fem::GeoIntersection< GridFamily >::inside(), Dune::Fem::FilteredGridPartIntersectionIterator< FilterType, GridPartType, HostIteratorType >::inside(), makeNonConformity(), Dune::Fem::HdivProjection< DiscreteFunctionType >::normalJump(), Dune::Fem::GridEntitySearch< GridPart, 0, partition >::operator()(), Dune::Fem::IdIntersection< GridFamily >::outside(), Dune::Fem::GeoIntersection< GridFamily >::outside(), Dune::Fem::FilteredGridPartIntersectionIterator< FilterType, GridPartType, HostIteratorType >::outside(), Dune::Fem::VtxProjectionImpl::project(), Dune::Fem::GeoEntity< 0, dim, GridFamily >::subEntity(), Dune::Fem::IdEntity< 0, dim, GridFamily >::subEntity(), and Dune::Fem::ALUGridWriter< GridPartType, IndexSetType >::writeBoundaries().

template<int codim, int dim, class Grid , template< int, int, class > class Implementation>
Dune::Entity< codim, dim, Grid, Implementation > Dune::Fem::make_entity ( Dune::Entity< codim, dim, Grid, Implementation >  entity)

References move().

template<class GridPartType >
static void Dune::Fem::makeNonConformity ( GridPartType &  gridPart,
const int  levelDifference,
const bool  verbose = false 
)
inlinestatic

mark entities such that non-conformity is a given number

Parameters
gridPartgiven grid part, i.e. grid to mark for
[in]levelDifferencemaximum allowed level difference
[in]verboseif true some output is given (default is false)

References abs(), make_entity(), and Dune::Std::max().

template<class Mapper , class Entity , class Functor >
PairFunctor< Mapper, Entity, Functor > Dune::Fem::makePairFunctor ( const Mapper &  mapper,
const Entity &  entity,
Functor  functor 
)
void Dune::Fem::match ( std::istream &  in,
char  excepted 
)
inline
static double Dune::Fem::max ( const Double v,
const double  p 
)
inlinestatic
static double Dune::Fem::max ( const double  v,
const Double p 
)
inlinestatic
static double Dune::Fem::min ( const Double v,
const double  p 
)
inlinestatic
static double Dune::Fem::min ( const double  v,
const Double p 
)
inlinestatic
template<class T >
void Dune::Fem::move ( ArrayInterface< T > &  array,
const unsigned int  oldOffset,
const unsigned int  newOffset,
const unsigned int  length 
)
inline
template<class T >
void Dune::Fem::moveBackward ( ArrayInterface< T > &  array,
const unsigned int  oldOffset,
const unsigned int  newOffset,
const unsigned int  length 
)
inline

References Dune::Fem::ArrayInterface< AT >::size().

Referenced by move().

template<class T >
void Dune::Fem::moveForward ( ArrayInterface< T > &  array,
const unsigned int  oldOffset,
const unsigned int  newOffset,
const unsigned int  length 
)
inline

References Dune::Fem::ArrayInterface< AT >::size().

Referenced by move().

template<class Scalar , class Vectorial >
bool Dune::Fem::operator!= ( const MakeVectorialExpression< Scalar, Vectorial > &  a,
const MakeVectorialExpression< Scalar, Vectorial > &  b 
)
inline
template<class Scalar , class Vectorial >
bool Dune::Fem::operator!= ( const Vectorial &  a,
const MakeVectorialExpression< Scalar, Vectorial > &  b 
)
inline
template<class Scalar , class Vectorial >
bool Dune::Fem::operator!= ( const MakeVectorialExpression< Scalar, Vectorial > &  a,
const Vectorial &  b 
)
inline
bool Dune::Fem::operator!= ( const Double a,
const Double b 
)
inline
bool Dune::Fem::operator!= ( const double  a,
const Double b 
)
inline
bool Dune::Fem::operator!= ( const Double a,
const double  b 
)
inline
bool Dune::Fem::operator!= ( const int  a,
const Double b 
)
inline
bool Dune::Fem::operator!= ( const Double a,
const int  b 
)
inline
bool Dune::Fem::operator!= ( const unsigned int  a,
const Double b 
)
inline
bool Dune::Fem::operator!= ( const Double a,
const unsigned int  b 
)
inline
template<class Traits1 , class Traits2 >
ExtractCommonFieldType< Traits1, Traits2 >:: FieldType Dune::Fem::operator* ( const VectorInterface< Traits1 > &  u,
const VectorInterface< Traits2 > &  v 
)
inline

Scalar product of two vectors.

References Dune::Fem::VectorInterface< VT >::size().

Double Dune::Fem::operator* ( const Double a,
const Double b 
)
inline
Double Dune::Fem::operator* ( const double  a,
const Double b 
)
inline
Double Dune::Fem::operator* ( const Double a,
const double  b 
)
inline
Double Dune::Fem::operator* ( const int  a,
const Double b 
)
inline
Double Dune::Fem::operator* ( const Double a,
const int  b 
)
inline
Double Dune::Fem::operator* ( const unsigned int  a,
const Double b 
)
inline
Double Dune::Fem::operator* ( const Double a,
const unsigned int  b 
)
inline
Double Dune::Fem::operator+ ( const Double a,
const Double b 
)
inline
Double Dune::Fem::operator+ ( const double  a,
const Double b 
)
inline
Double Dune::Fem::operator+ ( const Double a,
const double  b 
)
inline
Double Dune::Fem::operator+ ( const int  a,
const Double b 
)
inline
Double Dune::Fem::operator+ ( const Double a,
const int  b 
)
inline
Double Dune::Fem::operator+ ( const unsigned int  a,
const Double b 
)
inline
Double Dune::Fem::operator+ ( const Double a,
const unsigned int  b 
)
inline
Double Dune::Fem::operator- ( const Double a,
const Double b 
)
inline
Double Dune::Fem::operator- ( const double  a,
const Double b 
)
inline
Double Dune::Fem::operator- ( const Double a,
const double  b 
)
inline
Double Dune::Fem::operator- ( const int  a,
const Double b 
)
inline
Double Dune::Fem::operator- ( const Double a,
const int  b 
)
inline
Double Dune::Fem::operator- ( const unsigned int  a,
const Double b 
)
inline
Double Dune::Fem::operator- ( const Double a,
const unsigned int  b 
)
inline
Double Dune::Fem::operator/ ( const Double a,
const Double b 
)
inline
Double Dune::Fem::operator/ ( const double  a,
const Double b 
)
inline
Double Dune::Fem::operator/ ( const Double a,
const double  b 
)
inline
Double Dune::Fem::operator/ ( const int  a,
const Double b 
)
inline
Double Dune::Fem::operator/ ( const Double a,
const int  b 
)
inline
Double Dune::Fem::operator/ ( const unsigned int  a,
const Double b 
)
inline
Double Dune::Fem::operator/ ( const Double a,
const unsigned int  b 
)
inline
bool Dune::Fem::operator< ( const Double a,
const Double b 
)
inline
bool Dune::Fem::operator< ( const double  a,
const Double b 
)
inline
bool Dune::Fem::operator< ( const Double a,
const double  b 
)
inline
bool Dune::Fem::operator< ( const int  a,
const Double b 
)
inline
bool Dune::Fem::operator< ( const Double a,
const int  b 
)
inline
bool Dune::Fem::operator< ( const unsigned int  a,
const Double b 
)
inline
bool Dune::Fem::operator< ( const Double a,
const unsigned int  b 
)
inline
template<class StreamTraits , class... Args>
OutStreamInterface< StreamTraits >& Dune::Fem::operator<< ( OutStreamInterface< StreamTraits > &  out,
const std::tuple< Args... > &  tuple 
)
inline
template<class StreamTraits >
OutStreamInterface< StreamTraits >& Dune::Fem::operator<< ( OutStreamInterface< StreamTraits > &  out,
const std::tuple<> &  tuple 
)
inline
template<class StreamTraits , class VectorTraits >
OutStreamInterface< StreamTraits > & operator<< ( OutStreamInterface< StreamTraits > &  out,
const VectorInterface< VectorTraits > &  v 
)
inline

write a vector into an output stream

Parameters
[in]outstream to write to
[in]vvector to write
Returns
the ouput stream (for concatenation)

References Dune::Fem::VectorInterface< VT >::end().

template<typename K >
std::ostream& Dune::Fem::operator<< ( std::ostream &  s,
const DenseMatrix< K > &  matrix 
)

Send vector to output stream.

template<class StreamTraits , class Impl >
OutStreamInterface< StreamTraits > & operator<< ( OutStreamInterface< StreamTraits > &  out,
const DiscreteFunctionInterface< Impl > &  df 
)
inline

write a discrete function into an output stream

Parameters
[in]outstream to write to
[in]dfdiscrete function to write
Returns
the output stream (for concatenation)

References Dune::Fem::DiscreteFunctionInterface< Impl >::write().

template<class Traits , class T , class A >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const std::vector< T, A > &  value 
)
inline
template<class Traits , class T >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const std::complex< T >  value 
)
inline
template<class Traits >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const float  value 
)
inline
template<class Traits >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const double  value 
)
inline
template<class Traits >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const unsigned int  value 
)
inline
template<class Traits >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const int  value 
)
inline
template<class Traits >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const char  value 
)
inline
template<class Traits >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const bool  value 
)
inline
template<class Traits >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const std::string &  s 
)
inline
template<class Traits >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const uint64_t  value 
)
inline
template<class Traits >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const typename SelectUnsignedLongInteger< unsigned long, uint64_t >::UnsignedLongIntType &  value 
)
inline
template<class Traits , class T , std::size_t N>
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const std::array< T, N > &  value 
)
inline
template<class Traits , class T , int N>
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const Dune::FieldVector< T, N > &  value 
)
inline
template<class ObjectType >
PersistenceManager& Dune::Fem::operator<< ( PersistenceManager pm,
ObjectType &  object 
)
inline
std :: ostream& Dune::Fem::operator<< ( std::ostream &  out,
const Double a 
)
inline
template<class Traits >
OutStreamInterface< Traits >& Dune::Fem::operator<< ( OutStreamInterface< Traits > &  out,
const Double  a 
)
inline
bool Dune::Fem::operator<= ( const Double a,
const Double b 
)
inline
bool Dune::Fem::operator<= ( const double  a,
const Double b 
)
inline
bool Dune::Fem::operator<= ( const Double a,
const double  b 
)
inline
bool Dune::Fem::operator<= ( const int  a,
const Double b 
)
inline
bool Dune::Fem::operator<= ( const Double a,
const int  b 
)
inline
bool Dune::Fem::operator<= ( const unsigned int  a,
const Double b 
)
inline
bool Dune::Fem::operator<= ( const Double a,
const unsigned int  b 
)
inline
template<class Scalar , class Vectorial >
bool Dune::Fem::operator== ( const MakeVectorialExpression< Scalar, Vectorial > &  a,
const MakeVectorialExpression< Scalar, Vectorial > &  b 
)
inline
template<class Scalar , class Vectorial >
bool Dune::Fem::operator== ( const Vectorial &  a,
const MakeVectorialExpression< Scalar, Vectorial > &  b 
)
inline
template<class Scalar , class Vectorial >
bool Dune::Fem::operator== ( const MakeVectorialExpression< Scalar, Vectorial > &  a,
const Vectorial &  b 
)
inline
bool Dune::Fem::operator== ( const Double a,
const Double b 
)
inline
bool Dune::Fem::operator== ( const double  a,
const Double b 
)
inline
bool Dune::Fem::operator== ( const Double a,
const double  b 
)
inline
bool Dune::Fem::operator== ( const int  a,
const Double b 
)
inline
bool Dune::Fem::operator== ( const Double a,
const int  b 
)
inline
bool Dune::Fem::operator== ( const unsigned int  a,
const Double b 
)
inline
bool Dune::Fem::operator== ( const Double a,
const unsigned int  b 
)
inline
bool Dune::Fem::operator> ( const Double a,
const Double b 
)
inline
bool Dune::Fem::operator> ( const double  a,
const Double b 
)
inline
bool Dune::Fem::operator> ( const Double a,
const double  b 
)
inline
bool Dune::Fem::operator> ( const int  a,
const Double b 
)
inline
bool Dune::Fem::operator> ( const Double a,
const int  b 
)
inline
bool Dune::Fem::operator> ( const unsigned int  a,
const Double b 
)
inline
bool Dune::Fem::operator> ( const Double a,
const unsigned int  b 
)
inline
bool Dune::Fem::operator>= ( const Double a,
const Double b 
)
inline
bool Dune::Fem::operator>= ( const double  a,
const Double b 
)
inline
bool Dune::Fem::operator>= ( const Double a,
const double  b 
)
inline
bool Dune::Fem::operator>= ( const int  a,
const Double b 
)
inline
bool Dune::Fem::operator>= ( const Double a,
const int  b 
)
inline
bool Dune::Fem::operator>= ( const unsigned int  a,
const Double b 
)
inline
bool Dune::Fem::operator>= ( const Double a,
const unsigned int  b 
)
inline
template<class StreamTraits >
InStreamInterface< StreamTraits >& Dune::Fem::operator>> ( InStreamInterface< StreamTraits > &  in,
std::tuple<> &  tuple 
)
inline
template<class StreamTraits , class... Args>
InStreamInterface< StreamTraits >& Dune::Fem::operator>> ( InStreamInterface< StreamTraits > &  in,
std::tuple< Args... > &  tuple 
)
inline
template<class Traits >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
double &  value 
)
inline
template<class Traits >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
float &  value 
)
inline
template<class Traits >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
int &  value 
)
inline
template<class StreamTraits , class VectorTraits >
InStreamInterface< StreamTraits > & operator>> ( InStreamInterface< StreamTraits > &  in,
VectorInterface< VectorTraits > &  v 
)
inline

read a vector from an input stream

Parameters
[in]instream to read from
[out]vvector to read
Returns
the input stream (for concatenation)

References Dune::Fem::VectorInterface< VT >::begin(), and Dune::Fem::VectorInterface< VT >::end().

template<class Traits >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
char &  value 
)
inline
template<class Traits >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
bool &  value 
)
inline
template<class Traits >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
std::string &  s 
)
inline
template<class Traits >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
unsigned int &  value 
)
inline
template<class Traits >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
uint64_t &  value 
)
inline
template<class Traits >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
typename SelectUnsignedLongInteger< unsigned long, uint64_t >::UnsignedLongIntType &  value 
)
inline
template<class Traits , class T , std::size_t N>
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
std::array< T, N > &  value 
)
inline
template<class Traits , class T , int N>
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
Dune::FieldVector< T, N > &  value 
)
inline
template<class Traits , class T >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
std::complex< T > &  value 
)
inline
template<class Traits , class T , class A >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
std::vector< T, A > &  value 
)
inline
template<class StreamTraits , class Impl >
InStreamInterface< StreamTraits > & operator>> ( InStreamInterface< StreamTraits > &  in,
DiscreteFunctionInterface< Impl > &  df 
)
inline

read a discrete function from an input stream

Parameters
[in]instream to read from
[out]dfdiscrete function to read
Returns
the input stream (for concatenation)

References Dune::Fem::DiscreteFunctionInterface< Impl >::read().

template<class ObjectType >
PersistenceManager& Dune::Fem::operator>> ( PersistenceManager pm,
ObjectType &  object 
)
inline
std :: istream& Dune::Fem::operator>> ( std::istream &  in,
Double a 
)
inline
template<class Traits >
InStreamInterface< Traits >& Dune::Fem::operator>> ( InStreamInterface< Traits > &  in,
Double a 
)
inline
template<class DF , class Vector , class DFS >
void Dune::Fem::pAdaptation ( DF &  df,
const Vector &  polynomialOrders,
const DFS &  space,
const int   
)

Referenced by pAdaptation().

template<class DF , class Vector , class FS , class GP , int p, template< class > class Storage>
void Dune::Fem::pAdaptation ( DF &  df,
const Vector &  polynomialOrders,
const Fem::PAdaptiveLagrangeSpace< FS, GP, p, Storage > &  space,
const int  polOrderShift = 0 
)

pAdaptation

Parameters
dfdiscrete function to adapt
polynomialOrdersvector containing polynomial orders for each cell
spacetype of space tp be adapted
polOrderShiftpossible shift of polynomial order (i.e. in case of Taylor-Hood put -1 for the pressure) (default = 0)
template<class DF , class Vector >
void Dune::Fem::pAdaptation ( DF &  df,
const Vector &  polynomialOrders,
const int  polOrderShift = 0 
)

pAdaptation

Parameters
dfdiscrete function to adapt
polynomialOrdersvector containing polynomial orders for each cell
polOrderShiftpossible shift of polynomial order (i.e. in case of Taylor-Hood put -1 for the pressure) (default = 0)

References pAdaptation().

static ParameterReader Dune::Fem::parameterReader ( const ParameterTree &  parameterTree)
inlinestatic
template<class T >
static bool Dune::Fem::readParameter ( std::istream &  file,
const std::string  keyword,
T &  data,
bool  verbose = true,
bool  warn = true 
)
inlinestatic
template<class T >
static bool Dune::Fem::readParameter ( const std::string  filename,
const std::string  keyword,
T &  data,
bool  verbose = true,
bool  warn = true 
)
inlinestatic

reads data folowing the given keyword if verbose is true then an output of what was read is given the token '' or '#' stands for comment

References readParameter().

double Dune::Fem::real ( const std::complex< Double > &  x)
inline
double Dune::Fem::real ( const Double x)
inline
double Dune::Fem::scalarProduct ( const double &  a,
const double &  b 
)
inline
template<class T >
T::field_type Dune::Fem::scalarProduct ( const T &  a,
const T &  b 
)
inline
template<class K , int ROWS, int COLS>
K Dune::Fem::scalarProduct ( const FieldMatrix< K, ROWS, COLS > &  a,
const FieldMatrix< K, ROWS, COLS > &  b 
)
inline
template<class Scalar , class Vectorial >
MakeVectorialTraits< Scalar, Vectorial >::field_type Dune::Fem::scalarProduct ( const MakeVectorialExpression< Scalar, Vectorial > &  a,
const Vectorial &  b 
)
inline
template<class Scalar , class Vectorial >
MakeVectorialTraits< Scalar, Vectorial >::field_type Dune::Fem::scalarProduct ( const Vectorial &  a,
const MakeVectorialExpression< Scalar, Vectorial > &  b 
)
inline
template<class Scalar , class Vectorial >
MakeVectorialTraits< Scalar, Vectorial >::field_type Dune::Fem::scalarProduct ( const MakeVectorialExpression< Scalar, Vectorial > &  a,
const MakeVectorialExpression< Scalar, Vectorial > &  b 
)
inline
static double Dune::Fem::sin ( const Double v)
inlinestatic
static double Dune::Fem::sqrt ( const Double v)
inlinestatic
template<class Traits >
VirtualOutStream Dune::Fem::virtualize ( OutStreamInterface< Traits > &  stream)
template<class Traits >
VirtualInStream Dune::Fem::virtualize ( InStreamInterface< Traits > &  stream)