Dune Core Modules (2.3.1)
•All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Modules Pages
File List
Here is a list of all documented files with brief descriptions:
[detail level 1234567]
▼ dune | |
► common | |
► parallel | |
collectivecommunication.hh | Implements an utility class that provides collective communication methods for sequential programs |
communicator.hh | Provides utility classes for syncing distributed data via MPI communication |
indexset.hh | Provides a map between global and local indices |
indicessyncer.hh | Class for adding missing indices of a distributed index set in a local communication |
interface.hh | Provides classes for building the communication interface between remote indices |
localindex.hh | Provides classes for use as the local index in ParallelIndexSet |
mpicollectivecommunication.hh | Implements an utility class that provides MPI's collective communication methods |
mpiguard.hh | Implements a MPIGuard which detects an error on a remote process |
mpihelper.hh | Helpers for dealing with MPI |
mpitraits.hh | Traits classes for mapping types onto MPI_Datatype |
plocalindex.hh | Provides classes for use as the local index in ParallelIndexSet for distributed computing |
remoteindices.hh | Classes describing a distributed indexset |
selection.hh | Provides classes for selecting indices based on attribute flags |
variablesizecommunicator.hh | A communicator that only needs to know the number of elements per index at the sender side |
► std | |
constexpr.hh | |
alignment.hh | This file implements a template class to determine alignment requirements of types at compile time |
array.hh | Fallback implementation of the std::array class (a static array) |
arraylist.hh | Implements a random-access container that can efficiently change size (similar to std::deque) |
bartonnackmanifcheck.hh | Provides check for implementation of interface methods when using static polymorphism, i.e. the Barton-Nackman trick |
bigunsignedint.hh | Portable very large unsigned integers |
binaryfunctions.hh | Various helper classes derived from from std::binary_function for stl-style functional programming |
bitsetvector.hh | Efficient implementation of a dynamic array of static arrays of booleans |
classname.hh | A free function to provide the demangled class name of a given object or type as a string |
collectivecommunication.hh | |
debugallocator.hh | |
debugstream.hh | Defines several output streams for messages of different importance |
densematrix.hh | Implements a matrix constructed from a given type representing a field and a compile-time given number of rows and columns |
densevector.hh | Implements the dense vector interface, with an exchangeable storage class |
deprecated.hh | Definition of the DUNE_DEPRECATED macro for the case that config.h is not available |
diagonalmatrix.hh | This file implements a quadratic diagonal matrix of fixed size |
documentation.hh | Documentation related stuff |
dotproduct.hh | Provides the functions dot(a,b) := a^H \cdot b and dotT(a,b) := a^T \cdot b |
dynmatrix.hh | This file implements a dense matrix with dynamic numbers of rows and columns |
dynmatrixev.hh | Utility functions to compute eigenvalues for dense matrices |
dynvector.hh | This file implements a dense vector with a dynamic size |
enumset.hh | Classes for building sets out of enumeration values |
exceptions.hh | A few common exception classes |
fassign.hh | Classes for implementing an assignment to FieldVector from a comma-separated list |
float_cmp.hh | Various ways to compare floating-point numbers |
fmatrix.hh | Implements a matrix constructed from a given type representing a field and compile-time given number of rows and columns |
fmatrixev.hh | Eigenvalue computations for the FieldMatrix class |
forloop.hh | A static for loop for template meta-programming |
ftraits.hh | Type traits to determine the type of reals (when working with complex numbers) |
function.hh | Simple base class templates for functions |
fvector.hh | Implements a vector constructed from a given type representing a field and a compile-time given size |
gcd.hh | Statically compute the greatest common divisor of two integers |
genericiterator.hh | Implements a generic iterator class for writing stl conformant iterators |
gmpfield.hh | Wrapper for the GNU multiprecision (GMP) library |
hash.hh | Support for calculating hash values of objects |
identitymatrix.hh | Implementation of an identity matrix that does not store any data |
indent.hh | Utility class for handling nested indentation in output |
interfaces.hh | Provides interfaces for detection of specific behavior |
ios_state.hh | Utility class for storing and resetting stream attributes |
iteratorfacades.hh | This file implements iterator facade classes for writing stl conformant iterators |
lcm.hh | Statically compute the least common multiple of two integers |
lru.hh | LRU Cache Container, using an STL like interface |
mallocallocator.hh | Allocators that use malloc/free |
math.hh | Some useful basic math stuff |
matvectraits.hh | Documentation of the traits classes you need to write for each implementation of DenseVector or DenseMatrix |
misc.hh | Miscellaneous helper stuff |
mpicollectivecommunication.hh | |
mpiguard.hh | |
mpihelper.hh | |
mpitraits.hh | |
nullptr.hh | Fallback implementation of the nullptr object in C++0x |
parametertree.hh | A hierarchical structure of string parameters |
parametertreeparser.hh | Various parser methods to get data into a ParameterTree object |
path.cc | Utilites for handling filesystem paths |
path.hh | Utilities for handling filesystem paths |
poolallocator.hh | An stl-compliant pool allocator |
power.hh | Various implementations of the power function for run-time and static arguments |
precision.hh | Various precision settings for calculations with FieldMatrix and FieldVector |
promotiontraits.hh | Provides some promotion traits |
propertymap.hh | |
reservedvector.hh | An stl-compliant random-access container which stores everything on the stack |
shared_ptr.hh | This file implements the class shared_ptr (a reference counting pointer), for those systems that don't have it in the standard library |
singleton.hh | Useful wrapper for creating singletons |
sllist.hh | Implements a singly linked list together with the necessary iterators |
static_assert.hh | Fallback implementation of the C++0x static_assert feature |
stdstreams.hh | Standard Dune debug streams |
stringutility.hh | Miscellaneous helper stuff |
timer.hh | A simple timing class |
tuples.hh | Fallback implementation of the std::tuple class |
tupleutility.hh | Contains utility classes which can be used with tuples |
typetraits.hh | Traits for type conversions and type information |
unused.hh | Definition of the DUNE_UNUSED macro for the case that config.h is not available |
version.hh | Various macros to work with Dune module version numbers |
visibility.hh | Definition of macros controlling symbol visibility at the ABI level |
▼ dune | |
► geometry | |
► genericgeometry | |
► test | |
testbasicgeometry.cc | A unit test for the BasicGeometry class |
cachedmapping.hh | |
codimtable.hh | |
conversion.hh | |
cornermapping.hh | |
geometry.hh | |
geometrytraits.hh | |
hybridmapping.hh | |
mapping.hh | |
mappingprovider.hh | |
matrixhelper.hh | |
maximum.hh | |
referencedomain.hh | |
referenceelements.hh | Implements some reference element functionality needed by the generic geometries |
subtopologies.hh | |
topologytypes.hh | |
traceprovider.hh | |
► refinement | |
base.cc | This file contains the parts independent of a particular Refinement implementation |
hcube.cc | This file contains the Refinement implementation for hypercubes (quadrilaterals, hexahedrons, etc.) |
hcubetriangulation.cc | This file contains the Refinement implementation for triangulating hypercubes (quadrilateral -> triangle, hexahedron -> tetrahedron) |
simplex.cc | This file contains the Refinement implementation for simplices (triangles, tetrahedrons...) |
► test | |
checkgeometry.hh | |
test-axisalignedcubegeometry.cc | A unit test for the AxisAlignedCubeGeometry class |
test-referenceelements.cc | A unit test for the ReferenceElements |
test-refinement.cc | Unit tests for the virtual refinement code |
affinegeometry.hh | An implementation of the Geometry interface for affine geometries |
axisalignedcubegeometry.hh | A geometry implementation for axis-aligned hypercubes |
generalvertexorder.hh | |
genericreferenceelements.hh | |
mockgeometry.hh | |
multilineargeometry.hh | |
quadraturerules.hh | |
referenceelements.hh | |
refinement.hh | This file simply includes all Refinement implementations so you don't have to do them separately |
topologyfactory.hh | |
type.hh | A unique label for each type of element that can occur in a grid |
typeindex.hh | Helper classes to provide indices for geometrytypes for use in a vector |
virtualrefinement.cc | This file contains the virtual wrapper around refinement |
virtualrefinement.hh | This file contains the virtual wrapper around refinement |
▼ dune | |
► grid | |
► albertagrid | |
agrid.hh | AlbertaGrid class |
albertaheader.hh | |
albertareader.hh | |
algebra.hh | |
backuprestore.hh | |
capabilities.hh | |
coordcache.hh | |
datahandle.hh | |
dgfparser.hh | |
dofadmin.hh | |
dofvector.hh | |
elementinfo.cc | Wrapper for ALBERTA's el_info structure |
elementinfo.hh | Wrapper for ALBERTA's el_info structure |
entity.hh | |
entitypointer.hh | |
entityseed.hh | |
geometry.hh | |
geometrycache.hh | |
gridfactory.hh | Specialization of the generic GridFactory for AlbertaGrid |
gridfamily.hh | GridFamily for AlbertaGrid |
gridview.hh | |
hierarchiciterator.hh | |
indexsets.hh | |
indexstack.hh | Provides an index stack that supplies indices for element numbering for a grid (i.e. AlbertaGrid and ALUGrid) |
intersection.hh | |
intersectioniterator.hh | Implementation of the IntersectionIterator for AlbertaGrid |
leafiterator.hh | |
level.hh | |
leveliterator.hh | |
macrodata.cc | Wrapper for ALBERTA's macro_data structure |
macrodata.hh | Wrapper for ALBERTA's macro_data structure |
macroelement.hh | |
meshpointer.hh | Wrapper for ALBERTA's mesh structure |
misc.hh | |
persistentcontainer.hh | |
projection.hh | |
refinement.hh | Wrapper for ALBERTA's refinement patches and the corners for geometryInFather |
transformation.hh | |
treeiterator.hh | |
undefine-2.0.hh | Contains #undef s for all preprocessor macros defined by alberta |
undefine-3.0.hh | Contains #undef s for all preprocessor macros defined by alberta |
► alugrid | |
► 2d | |
alu2dgridfactory.hh | |
alu2dinclude.hh | |
alugrid.hh | |
bndprojection.hh | |
capabilities.hh | |
datahandle.hh | |
entity.hh | |
entityseed.hh | |
geometry.hh | |
grid.hh | |
indexsets.hh | |
intersection.hh | |
iterator.hh | |
► 3d | |
alu3dgridfactory.hh | |
alu3dinclude.hh | |
alu3diterators.hh | |
alugrid.hh | Provides base classes for ALUGrid |
capabilities.hh | |
datahandle.hh | |
entity.hh | |
entity_inline.hh | |
entityseed.hh | |
faceutility.hh | |
geometry.hh | |
grid.hh | |
grid_inline.hh | |
indexsets.hh | |
iterator.hh | |
lbdatahandle.hh | |
mappings.hh | |
topology.hh | |
► common | |
backuprestore.hh | |
bndprojection.hh | |
capabilities.hh | |
checkparallel.hh | |
declaration.hh | |
defaultindexsets.hh | Provides default index set implementations for Level- and LeafIndexsets used by ALUGrid |
geostorage.hh | |
interfaces.hh | Provides a Interfaces for detection of specific behavior |
intersectioniteratorwrapper.hh | Provides proxy classes for IntersectionsIterators |
memory.hh | |
objectfactory.hh | |
persistentcontainer.hh | |
transformation.hh | |
► common | |
► test | |
mcmgmappertest.cc | A unit test for the MultipleCodimMultipleGeometryMapper |
scsgmappertest.cc | A unit test for the SingleCodimSingleGeomTypeMapper |
adaptcallback.hh | Interfaces and wrappers needed for the callback adaptation provided by AlbertaGrid and ALUGrid |
backuprestore.hh | |
boundaryprojection.hh | |
boundarysegment.hh | Base class for grid boundary segments of arbitrary geometry |
capabilities.hh | A set of traits classes to store static information about grid implementation |
datahandleif.hh | Describes the parallel communication interface class for MessageBuffers and DataHandles |
defaultgridview.hh | |
entity.hh | |
entityiterator.hh | |
entitypointer.hh | Wrapper and interface classe for a static iterator (EntityPointer) |
entityseed.hh | Interface class EntitySeed |
exceptions.hh | |
geometry.hh | Wrapper and interface classes for element geometries |
geometryreference.hh | Wrapper and interface classes for element geometries |
grid.hh | Different resources needed by all grid implementations |
gridenums.hh | |
gridfactory.hh | Provide a generic factory class for unstructured grids |
gridinfo.hh | Some functions to list information about a grid |
gridview.hh | |
hierarchiciterator.hh | |
indexidset.hh | Provides base classes for index and id sets |
intersection.hh | |
intersectioniterator.hh | |
leafiterator.hh | |
leveliterator.hh | |
mapper.hh | Provides classes with basic mappers which are used to attach data to a grid |
mcmgmapper.hh | Mapper for multiple codim and multiple geometry types |
refinement.hh | |
scsgmapper.hh | Mapper classes are used to attach data to a grid |
sizecache.hh | Provides size cache classes to implement the grids size method efficiently |
universalmapper.hh | Mapper for any set of entities |
virtualrefinement.hh | |
► geometrygrid | |
backuprestore.hh | |
cachedcoordfunction.hh | |
capabilities.hh | |
coordfunction.hh | |
coordfunctioncaller.hh | |
cornerstorage.hh | |
datahandle.hh | |
declaration.hh | |
entity.hh | |
entitypointer.hh | |
entityseed.hh | |
geometry.hh | |
grid.hh | |
gridfamily.hh | |
gridview.hh | |
hostcorners.hh | |
identity.hh | |
idset.hh | |
indexsets.hh | |
intersection.hh | |
intersectioniterator.hh | |
iterator.hh | |
persistentcontainer.hh | |
► io | |
► file | |
► amiramesh | |
psurfaceboundary.hh | A domain boundary implemented by the psurface library |
► dgfparser | |
► blocks | |
basic.hh | |
boundarydom.hh | |
boundaryseg.hh | |
cube.hh | |
dim.hh | |
general.hh | |
gridparameter.hh | |
interval.hh | |
periodicfacetrans.hh | |
projection.hh | |
simplex.hh | |
simplexgeneration.hh | |
vertex.hh | |
► utils | |
dgf2dgf.cc | Small program converting a DGF file into a DGF file |
gmsh2dgf.cc | Small program converting a gmsh file into a DGF file |
dgfalu.hh | |
dgfexception.hh | |
dgfgeogrid.hh | |
dgfgridfactory.hh | |
dgfoned.hh | |
dgfparser.hh | |
dgfs.hh | |
dgfug.hh | |
dgfwriter.hh | Write a GridView to a DGF file |
dgfyasp.hh | |
entitykey.hh | |
entitykey_inline.hh | |
gridptr.hh | |
macrogrid.hh | |
parser.hh | |
► gnuplot | |
gnuplot.cc | Implementation of gnuplot output for 1D and 2D grids |
► vtk | |
b64enc.hh | Simple base64 encode |
basicwriter.hh | |
boundaryiterators.hh | Functions for VTK output on the skeleton |
boundarywriter.hh | |
common.hh | Common stuff for the VTKWriter |
corner.hh | |
corneriterator.hh | |
dataarraywriter.hh | Data array writers for the VTKWriter |
function.hh | Functions for VTK output |
functionwriter.hh | |
pointiterator.hh | |
pvtuwriter.hh | |
skeletonfunction.hh | Functions for VTK output on the skeleton |
streams.hh | |
subsamplingvtkwriter.hh | Provides subsampled file i/o for the visualization toolkit |
volumeiterators.hh | |
volumewriter.hh | |
vtksequencewriter.hh | |
vtkwriter.hh | Provides file i/o for the visualization toolkit |
vtuwriter.hh | |
amirameshreader.hh | |
amirameshwriter.hh | |
dgfparser.hh | |
gmshreader.hh | |
gmshwriter.hh | |
gnuplot.hh | Provides gnuplot output for 1D Grids |
starcdreader.hh | |
vtk.hh | Convenience header which includes all available VTK writers |
► visual | |
► grape | |
geldesc.hh | |
ghmesh.hh | |
grape_undefs.hh | Contains #undef s for all preprocessor macros defined by grape |
grapecommon.hh | |
grapehmesh.hh | |
grapeinclude.hh | |
combinedgrapedisplay.hh | Combines several mesh scenes for visualisation of parallel data |
grapedatadisplay.hh | Provides a DataDisplay class using the GridDisplay and dune-fem module for class DiscreteFubctions support |
grapegriddisplay.hh | Provides a GridDisplay class using the GRAPE-HMesh Interface |
► uggrid | |
uggridfactory.hh | The specialization of the generic GridFactory for UGGrid |
► utility | |
► test | |
persistentcontainertest.cc | A unit test for the PersistentContainer |
structuredgridfactorytest.cc | A unit test for the StructuredGridFactory |
vertexordertest.cc | A unit test for the VertexOrder classes |
entitycommhelper.hh | |
grapedataioformattypes.hh | |
gridinfo-gmsh-main.hh | Generic main() function for printing information about a mesh read from a .msh-file |
gridinfo.hh | |
gridtype.hh | This file can be included directly following config.h to test if a grid type was correctly selected |
hierarchicsearch.hh | Utility class for hierarchically searching for an Entity containing a given point |
hostgridaccess.hh | |
persistentcontainer.hh | |
persistentcontainerinterface.hh | |
persistentcontainermap.hh | |
persistentcontainervector.hh | |
persistentcontainerwrapper.hh | |
structuredgridfactory.hh | A class to construct structured cube and simplex grids using the grid factory |
vertexorderfactory.hh | |
albertagrid.hh | |
alugrid.hh | Provides base classes for ALUGrid |
geometrygrid.hh | |
onedgrid.hh | The OneDGrid class |
sgrid.hh | |
uggrid.hh | The UGGrid class |
yaspgrid.hh | |
▼ dune | |
► istl | |
► paamg | |
aggregates.hh | Provides classes for the Coloring process of AMG |
amg.hh | The AMG preconditioner |
combinedfunctor.hh | |
construction.hh | Helper classes for the construction of classes without empty constructor |
dependency.hh | Provides classes for initializing the link attributes of a matrix graph |
fastamg.hh | A fast AMG method, that currently only allows only Gauss-Seidel smoothing and is currently purely sequential. It combines one Gauss-Seidel presmoothing sweep with the defect calculation to reduce memory transfers |
fastamgsmoother.hh | |
galerkin.hh | Provides a class for building the galerkin product based on a aggregation scheme |
globalaggregates.hh | Provdes class for identifying aggregates globally |
graph.hh | Provides classes for building the matrix graph |
graphcreator.hh | |
hierarchy.hh | Provides a classes representing the hierarchies in AMG |
indicescoarsener.hh | Provides a class for building the index set and remote indices on the coarse level |
kamg.hh | Provides an algebraic multigrid using a Krylov cycle |
parameters.hh | Parameter classes for customizing AMG |
pinfo.hh | |
properties.hh | Provides classes for handling internal properties in a graph |
renumberer.hh | |
smoother.hh | Classes for the generic construction and application of the smoothers |
transfer.hh | Prolongation and restriction for amg |
twolevelmethod.hh | Algebraic twolevel methods |
basearray.hh | Implements several basic array containers |
bcrsmatrix.hh | Implementation of the BCRSMatrix class |
bdmatrix.hh | Implementation of the BDMatrix class |
btdmatrix.hh | Implementation of the BTDMatrix class |
bvector.hh | This file implements a vector space as a tensor product of a given vector space. The number of components can be given at run-time |
colcompmatrix.hh | |
diagonalmatrix.hh | This file implements a quadratic diagonal matrix of fixed size |
gsetc.hh | Simple iterative methods like Jacobi, Gauss-Seidel, SOR, SSOR, etc. in a generic way |
ilu.hh | ??? |
ilusubdomainsolver.hh | Various local subdomain solvers based on ILU for SeqOverlappingSchwarz |
io.hh | Some generic functions for pretty printing vectors and matrices |
istlexception.hh | |
matrix.hh | A dynamic dense block matrix class |
matrixindexset.hh | |
matrixmarket.hh | Provides classes for reading and writing MatrixMarket Files with an extension for parallel matrices |
matrixmatrix.hh | Functions for sparse matrix matrix multiplication |
matrixredistribute.hh | Functionality for redistributing a sparse matrix |
matrixutils.hh | Some handy generic functions for ISTL matrices |
multitypeblockmatrix.hh | |
multitypeblockvector.hh | |
novlpschwarz.hh | |
operators.hh | Define general, extensible interface for operators. The available implementation wraps a matrix |
overlappingschwarz.hh | Contains one level overlapping Schwarz preconditioners |
owneroverlapcopy.hh | Classes providing communication interfaces for overlapping Schwarz methods |
pardiso.hh | |
preconditioner.hh | |
preconditioners.hh | Define general preconditioner interface |
repartition.hh | Functionality for redistributing a parallel index set using graph partitioning |
scalarproducts.hh | Define base class for scalar product and norm |
scaledidmatrix.hh | This file implements a quadratic matrix of fixed size which is a multiple of the identity |
schwarz.hh | |
solver.hh | Define general, extensible interface for inverse operators |
solvercategory.hh | |
solvers.hh | Implementations of the inverse operator interface |
solvertype.hh | Templates characterizing the type of a solver |
superlu.hh | Classes for using SuperLU with ISTL matrices |
supermatrix.hh | |
umfpack.hh | Classes for using UMFPack with ISTL matrices |
vbvector.hh | ??? |
