 Ewoms | |
  detail | |
   is_alignment_constant | |
   min_size | |
   offset_object | |
   alignment_of | |
   max_align | |
   max_count_of | |
  Linear | |
   BiCGStabSolver | Implements a preconditioned stabilized BiCG linear solver |
   BlackList | Expresses which degrees of freedom are blacklisted for the parallel linear solvers and which domestic indices they correspond to |
    PeerBlackListedEntry | |
   CombinedCriterion | Convergence criterion which looks at the absolute value of the residual and fails if the linear solver stagnates |
   ConvergenceCriterion | Base class for all convergence criteria which only defines an virtual API |
   DomesticOverlapFromBCRSMatrix | This class creates and manages the foreign overlap given an initial list of border indices and a BCRS matrix |
   ElementBorderListFromGrid | Uses communication on the grid to find the initial seed list of indices for methods which use element-based degrees of freedom |
   FixPointCriterion | Provides a convergence criterion for the linear solvers which looks at the weighted maximum of the difference between two iterations |
   ForeignOverlapFromBCRSMatrix | This class creates and manages the foreign overlap given an initial list of border indices and a BCRS matrix |
   GlobalIndices | This class maps domestic row indices to and from "global" indices which is used to construct an algebraic overlap for the parallel linear solvers |
   SolverWrapperRestartedGMRes | Solver wrapper for the restarted GMRES solver of dune-istl |
   SolverReport | Collects summary information about the execution of the linear solver |
   NullBorderListCreator | This is a grid manager which does not create any border list |
   OverlappingBCRSMatrix | An overlap aware block-compressed row storage (BCRS) matrix |
   OverlappingBlockVector | An overlap aware block vector |
   OverlappingOperator | An overlap aware linear operator usable by ISTL |
   OverlappingPreconditioner | An overlap aware preconditioner for any ISTL linear solver |
   OverlappingScalarProduct | An overlap aware ISTL scalar product |
   IndexRank | This structure stores an index and a process rank |
   PeerIndexGlobalIndex | This structure stores a local index on a peer process and a global index |
   IndexRankDist | This structure stores an index, a process rank, and the distance of the degree of freedom to the process border |
   IndexDistanceNpeers | This structure stores an index, a process rank, and the number of processes which "see" the degree of freedom with the index |
   BorderIndex | A single index intersecting with the process boundary |
   SeedList | The list of indices which are on the process boundary |
   PeerSet | A set of process ranks |
   ParallelAmgBackend | Provides a linear solver backend using the parallel algebraic multi-grid (AMG) linear solver from DUNE-ISTL |
   ParallelBaseBackend | Provides the common code which is required by most linear solvers |
   ParallelBiCGStabSolverBackend | Implements a generic linear solver abstraction |
   ParallelIstlSolverBackend | Provides all unmodified linear solvers from dune-istl |
   ResidReductionCriterion | Provides a convergence criterion which looks at the reduction of the two-norm of the residual for the linear solvers |
   VertexBorderListFromGrid | Uses communication on the grid to find the initial seed list of indices |
   WeightedResidualReductionCriterion | Convergence criterion which looks at the weighted absolute value of the residual |
  BaseAuxiliaryModule | Base class for specifying auxiliary equations |
  aligned_allocator | |
   rebind | |
  aligned_allocator< void, Alignment > | |
   rebind | |
  ConditionalStorage | A simple class which only stores a given member attribute if a boolean condition is true |
  ConditionalStorage< false, T > | |
  GenericGuard | A simple class which makes sure that a cleanup function is called once the object is destroyed |
  PffGridVector | A random-access container which stores data attached to a grid's degrees of freedom in a prefetch friendly manner |
  QuadrialteralQuadratureGeometry | Quadrature geometry for quadrilaterals |
  Simulator | Manages the initializing and running of time dependent problems |
  Timer | Provides an encapsulation to measure the system time |
  TimerGuard | A simple class which makes sure that a timer gets stopped if an exception is thrown |
  FvBaseAdLocalLinearizer | Calculates the local residual and its Jacobian for a single element of the grid |
  FvBaseBoundaryContext | Represents all quantities which available on boundary segments |
  FvBaseConstraints | Class to specify constraints for a finite volume spatial discretization |
  FvBaseConstraintsContext | Represents all quantities which available for calculating constraints |
  FvBaseDiscretization | The base class for the finite volume discretization schemes |
  FvBaseElementContext | This class stores an array of IntensiveQuantities objects, one intensive quantities object for each of the element's vertices |
  FvBaseExtensiveQuantities | Provide the properties at a face which make sense indepentently of the conserved quantities |
  FvBaseFdLocalLinearizer | Calculates the Jacobian of the local residual for finite volume spatial discretizations using a finite difference method |
  EcfvDiscretization | The base class for the element-centered finite-volume discretization scheme |
  FvBaseGradientCalculator | This class calculates gradients of arbitrary quantities at flux integration points using the two-point approximation scheme |
  FvBaseIntensiveQuantities | Base class for the model specific class which provides access to all intensive (i.e., volume averaged) quantities |
  FvBaseLinearizer | The common code for the linearizers of non-linear systems of equations |
  FvBaseLocalResidual | Element-wise caculation of the residual matrix for models based on a finite volume spatial discretization |
  FvBaseNewtonConvergenceWriter | Writes the intermediate solutions during the Newton scheme for models using a finite volume discretization |
  FvBaseNewtonMethod | A Newton method for models using a finite volume discretization |
  FvBasePrimaryVariables | Represents the primary variables used by the a model |
  FvBaseProblem | Base class for all problems which use a finite volume spatial discretization |
  CopyRestrictProlong | |
  CopyRestrictProlongTraits | |
  EmptyRestrictProlongTraits | |
  EmptyRestrictProlong | |
  EcfvBaseOutputModule | Implements the discretization specific parts of writing files |
  EcfvGridCommHandleFactory | A class which provides types for DUNE grid handles for communication |
  EcfvStencil | Represents the stencil (finite volume geometry) of a single element in the ECFV discretization |
   EcfvSubControlVolumeFace | Represents a face of a sub-control volume |
   SubControlVolume | Represents a sub-control volume |
  P1FeGradientCalculator | This class calculates gradients of arbitrary quantities at flux integration points using first order finite elemens ansatz functions |
  VcfvBaseOutputModule | Implements the discretization specific parts of writing files |
  VcfvDiscretization | The base class for the vertex centered finite volume discretization scheme |
  VcfvGridCommHandleFactory | A class which provides types for DUNE grid handles for communication |
  VcfvStencil | Represents the finite volume geometry of a single element in the VCFV discretization |
   ScvGeometry | |
   SubControlVolume | Finite volume intersected with element |
   SubControlVolumeFace | Interior face of a sub control volume |
  BaseGridManager | Provides the base class for most (all?) grid managers |
  BaseOutputModule | The base class for writer modules |
  BaseOutputWriter | The base class for all output writers |
  CubeGridManager | Provides a grid manager which a regular grid made of quadrilaterals |
  DgfGridManager | Provides a grid manager which reads Dune Grid Format (DGF) files |
  Restart | Load or save a state of a problem to/from the harddisk |
  SimplexGridManager | Provides a grid manager which a regular grid made of simplices |
  StructuredGridManager | Helper class for grid instantiation of the lens problem |
  VtkBlackOilModule | VTK output module for the black oil model's parameters |
  VtkBlackOilPolymerModule | VTK output module for the black oil model's polymer related quantities |
  VtkBlackOilSolventModule | VTK output module for the black oil model's solvent related quantities |
  VtkCompositionModule | VTK output module for the fluid composition |
  VtkDiffusionModule | VTK output module for quantities which make sense for models which incorperate molecular diffusion |
  VtkDiscreteFractureModule | VTK output module for quantities which make sense for all models which deal with discrete fractures in porous media |
  VtkEnergyModule | VTK output module for quantities which make sense for models which assume thermal equilibrium |
  VtkMultiPhaseModule | VTK output module for quantities which make sense for all models which deal with multiple fluid phases in porous media that don't use flashy concepts like interfacial area |
  VtkMultiWriter | Simplifies writing multi-file VTK datasets |
  VtkPhasePresenceModule | VTK output module for the fluid composition |
  VtkPrimaryVarsModule | VTK output module for the fluid composition |
  VtkScalarFunction | Provides a vector-valued function using Dune::FieldVectors as elements |
  VtkTemperatureModule | VTK output module for the temperature in which assume thermal equilibrium |
  VtkTensorFunction | Provides a tensor-valued function using Dune::FieldMatrix objects as elements |
  VtkVectorFunction | Provides a vector-valued function using Dune::FieldVectors as elements |
  BlackOilBoundaryRateVector | Implements a boundary vector for the fully implicit black-oil model |
  BlackOilDarcyExtensiveQuantities | Specifies the extensive quantities for the black-oil model if using Darcy relation |
  BlackOilDarcyFluxModule | Provides a Darcy flux module for the blackoil model |
  BlackOilExtensiveQuantities | This template class contains the data which is required to calculate the fluxes of the fluid phases over a face of a finite volume for the black-oil model |
  BlackOilFluidState | Implements a "taylor-made" fluid state class for the black-oil model |
  BlackOilIndices | The primary variable and equation indices for the black-oil model |
  BlackOilIntensiveQuantities | Contains the quantities which are are constant within a finite volume in the black-oil model |
  BlackOilLocalResidual | Calculates the local residual of the black oil model |
  BlackOilModel | A fully-implicit black-oil flow model |
  EclGridManager | |
  BlackOilNewtonMethod | A newton solver which is specific to the black oil model |
  BlackOilPolymerModule | Contains the high level supplements required to extend the black oil model by polymer |
  BlackOilPolymerIntensiveQuantities | Provides the volumetric quantities required for the equations needed by the polymers extension of the black-oil model |
  BlackOilPolymerIntensiveQuantities< TypeTag, false > | |
  BlackOilPolymerExtensiveQuantities | Provides the polymer specific extensive quantities to the generic black-oil module's extensive quantities |
  BlackOilPolymerExtensiveQuantities< TypeTag, false > | |
  BlackOilSolventModule | Contains the high level supplements required to extend the black oil model by solvents |
  BlackOilPrimaryVariables | Represents the primary variables used by the black-oil model |
  BlackOilProblem | Base class for all problems which use the black-oil model |
  BlackOilRateVector | Implements a vector representing mass, molar or volumetric rates for the black oil model |
  BlackOilSolventIntensiveQuantities | Provides the volumetric quantities required for the equations needed by the solvents extension of the black-oil model |
  BlackOilSolventIntensiveQuantities< TypeTag, false > | |
  BlackOilSolventExtensiveQuantities | Provides the solvent specific extensive quantities to the generic black-oil module's extensive quantities |
  BlackOilSolventExtensiveQuantities< TypeTag, false > | |
  BlackOilTwoPhaseIndices | The primary variable and equation indices for the black-oil model |
  DarcyIntensiveQuantities | Provides the intensive quantities for the Darcy flux module |
  DarcyExtensiveQuantities | Provides the Darcy flux module |
  DarcyBaseProblem | Provides the defaults for the parameters required by the Darcy velocity approach |
  DarcyFluxModule | Specifies a flux module which uses the Darcy relation |
  DiffusionModule | Provides the auxiliary methods required for consideration of the diffusion equation |
  DiffusionModule< TypeTag, false > | Provides the auxiliary methods required for consideration of the diffusion equation. |
  DiffusionModule< TypeTag, true > | Provides the auxiliary methods required for consideration of the diffusion equation. |
  DiffusionIntensiveQuantities | Provides the volumetric quantities required for the calculation of molecular diffusive fluxes |
  DiffusionIntensiveQuantities< TypeTag, false > | Provides the volumetric quantities required for the calculation of molecular diffusive fluxes. |
  DiffusionIntensiveQuantities< TypeTag, true > | Provides the volumetric quantities required for the calculation of molecular diffusive fluxes. |
  DiffusionExtensiveQuantities | Provides the quantities required to calculate diffusive mass fluxes |
  DiffusionExtensiveQuantities< TypeTag, false > | Provides the quantities required to calculate diffusive mass fluxes. |
  DiffusionExtensiveQuantities< TypeTag, true > | Provides the quantities required to calculate diffusive mass fluxes. |
  EnergyModule | Provides the auxiliary methods required for consideration of the energy equation |
  EnergyModule< TypeTag, false > | Provides the auxiliary methods required for consideration of the energy equation. |
  EnergyModule< TypeTag, true > | Provides the auxiliary methods required for consideration of the energy equation. |
  EnergyIndices | Provides the indices required for the energy equation |
  EnergyIndices< PVOffset, false > | Provides the indices required for the energy equation. |
  EnergyIndices< PVOffset, true > | Provides the indices required for the energy equation. |
  EnergyIntensiveQuantities | Provides the volumetric quantities required for the energy equation |
  EnergyIntensiveQuantities< TypeTag, false > | Provides the volumetric quantities required for the energy equation. |
  EnergyIntensiveQuantities< TypeTag, true > | Provides the volumetric quantities required for the energy equation. |
  EnergyExtensiveQuantities | Provides the quantities required to calculate energy fluxes |
  EnergyExtensiveQuantities< TypeTag, false > | Provides the quantities required to calculate energy fluxes. |
  EnergyExtensiveQuantities< TypeTag, true > | Provides the quantities required to calculate energy fluxes. |
  ForchheimerIntensiveQuantities | Provides the intensive quantities for the Forchheimer module |
  ForchheimerExtensiveQuantities | Provides the Forchheimer flux module |
  ForchheimerBaseProblem | Provides the defaults for the parameters required by the Forchheimer velocity approach |
  ForchheimerFluxModule | Specifies a flux module which uses the Forchheimer relation |
  MultiPhaseBaseExtensiveQuantities | This class calculates the pressure potential gradients and the filter velocities for multi-phase flow in porous media |
  MultiPhaseBaseModel | A base class for fully-implicit multi-phase porous-media flow models which assume multiple fluid phases |
  MultiPhaseBaseProblem | The base class for the problems of ECFV discretizations which deal with a multi-phase flow through a porous medium |
  TemperatureCallback | Callback class for temperature |
  PressureCallback | Callback class for a phase pressure |
  BoundaryPressureCallback | Callback class for a phase pressure |
  DensityCallback | Callback class for the density of a phase |
  MolarDensityCallback | Callback class for the molar density of a phase |
  ViscosityCallback | Callback class for the viscosity of a phase |
  VelocityCallback | Callback class for the velocity of a phase at the center of a DOF |
  VelocityComponentCallback | Callback class for the velocity of a phase at the center of a DOF |
  MoleFractionCallback | Callback class for a mole fraction of a component in a phase |
  DiscreteFractureExtensiveQuantities | This class expresses all intensive quantities of the discrete fracture model |
  DiscreteFractureIntensiveQuantities | Contains the quantities which are are constant within a finite volume in the discret fracture immiscible multi-phase model |
  DiscreteFractureLocalResidual | Calculates the local residual of the discrete fracture immiscible multi-phase model |
  DiscreteFractureModel | A fully-implicit multi-phase flow model which assumes immiscibility of the phases and is able to include fractures in the domain |
  DiscreteFracturePrimaryVariables | Represents the primary variables used by the discrete fracture multi-phase model |
  DiscreteFractureProblem | The base class for the problems of ECFV discretizations which deal with a multi-phase flow through a porous medium |
  FractureMapper | Stores the topology of fractures |
  FlashBoundaryRateVector | Implements a boundary vector for the fully implicit compositional multi-phase model which is based on flash calculations |
  FlashExtensiveQuantities | This template class contains the data which is required to calculate all fluxes of components over a face of a finite volume for the compositional multi-phase model based on flash calculations |
  FlashIndices | Defines the primary variable and equation indices for the compositional multi-phase model based on flash calculations |
  FlashIntensiveQuantities | Contains the intensive quantities of the flash-based compositional multi-phase model |
  FlashLocalResidual | Calculates the local residual of the compositional multi-phase model based on flash calculations |
  FlashModel | A compositional multi-phase model based on flash-calculations |
  FlashPrimaryVariables | Represents the primary variables used by the compositional flow model based on flash calculations |
  FlashRateVector | Implements a vector representing rates of conserved quantities. |
  ImmiscibleBoundaryRateVector | Implements a boundary vector for the fully implicit multi-phase model which assumes immiscibility |
  ImmiscibleExtensiveQuantities | This class provides the data all quantities that are required to calculate the fluxes of the fluid phases over a face of a finite volume for the immiscible multi-phase model |
  ImmiscibleIndices | The indices for the isothermal multi-phase model |
  ImmiscibleIntensiveQuantities | Contains the quantities which are are constant within a finite volume for the immiscible multi-phase model |
  ImmiscibleLocalResidual | Calculates the local residual of the immiscible multi-phase model |
  ImmiscibleModel | A fully-implicit multi-phase flow model which assumes immiscibility of the phases |
  ImmisciblePrimaryVariables | Represents the primary variables used by the immiscible multi-phase, model |
  ImmiscibleRateVector | Implements a vector representing rates of conserved quantities |
  NcpBoundaryRateVector | Implements a boundary vector for the fully implicit compositional multi-phase NCP model |
  NcpExtensiveQuantities | This template class represents the extensive quantities of the compositional NCP model |
  NcpIndices | The primary variable and equation indices for the compositional multi-phase NCP model |
  NcpIntensiveQuantities | Contains the quantities which are are constant within a finite volume in the compositional multi-phase NCP model |
  NcpLocalResidual | Details needed to calculate the local residual in the compositional multi-phase NCP-model |
  NcpModel | A compositional multi-phase model based on non-linear complementarity functions |
  NcpNewtonMethod | A Newton solver specific to the NCP model |
  NcpPrimaryVariables | Represents the primary variables used by the compositional multi-phase NCP model |
  NcpRateVector | Implements a vector representing mass, molar or volumetric rates |
  PvsBoundaryRateVector | Implements a rate vector on the boundary for the fully implicit compositional multi-phase primary variable switching compositional model |
  PvsExtensiveQuantities | Contains all data which is required to calculate all fluxes at a flux integration point for the primary variable switching model |
  PvsIndices | The indices for the compositional multi-phase primary variable switching model |
  PvsIntensiveQuantities | Contains the quantities which are are constant within a finite volume in the compositional multi-phase primary variable switching model |
  PvsLocalResidual | Element-wise calculation of the local residual for the compositional multi-phase primary variable switching model |
  PvsModel | A generic compositional multi-phase model using primary-variable switching |
  PvsNewtonMethod | A newton solver which is specific to the compositional multi-phase PVS model |
  PvsPrimaryVariables | Represents the primary variables used in the primary variable switching compositional model |
  PvsRateVector | Implements a vector representing molar, mass or volumetric rates |
  RichardsBoundaryRateVector | Implements a boundary vector for the fully implicit Richards model |
  RichardsExtensiveQuantities | Calculates and stores the data which is required to calculate the flux of fluid over a face of a finite volume |
  RichardsIndices | Indices for the primary variables/conservation equations of the Richards model |
  RichardsIntensiveQuantities | Intensive quantities required by the Richards model |
  RichardsLocalResidual | Element-wise calculation of the residual for the Richards model |
  RichardsModel | This model implements a variant of the Richards equation for quasi-twophase flow |
  RichardsNewtonMethod | A Richards model specific Newton method |
  RichardsPrimaryVariables | Represents the primary variables used in the Richards model |
  RichardsRateVector | Implements a vector representing mass, molar or volumetric rates |
  NewtonMethod | The multi-dimensional Newton method |
  NullConvergenceWriter | A convergence writer for the Newton method which does nothing |
  GridCommHandleSum | Data handle for parallel communication which sums up all values are attached to DOFs |
  GridCommHandleGhostSync | Data handle for parallel communication which can be used to set the values values of ghost and overlap DOFs from their respective master processes |
  GridCommHandleMax | Data handle for parallel communication which takes the maximum of all values that are attached to DOFs |
  GridCommHandleMin | Provides data handle for parallel communication which takes the minimum of all values that are attached to DOFs |
  MpiBuffer | Simplifies handling of buffers to be used in conjunction with MPI |
  ThreadedEntityIterator | Provides an STL-iterator like interface to iterate over the enties of a GridView in OpenMP threaded applications |
  ThreadManager | Simplifies multi-threaded capabilities |
  Co2InjectionFlash | Flash solver used by the CO2 injection problem |
  Co2InjectionProblem | Problem where is injected under a low permeable layer at a depth of 2700m |
  CuvetteProblem | Non-isothermal three-phase gas injection problem where a hot gas is injected into a unsaturated porous medium with a residually trapped NAPL contamination |
  DiffusionProblem | 1D problem which is driven by molecular diffusion |
  FingerProblem | Two-phase problem featuring some gravity-driven saturation fingers |
  FractureProblem | Two-phase problem which involves fractures |
  GroundWaterProblem | Test for the immisicible VCVF discretization with only a single phase |
  InfiltrationProblem | Isothermal NAPL infiltration problem where LNAPL contaminates the unsaturated and the saturated groundwater zone |
  LensProblem | Soil contamination problem where DNAPL infiltrates a fully water saturated medium |
  ObstacleProblem | Problem where liquid water is first stopped by a low-permeability lens and then seeps though it |
  OutflowProblem | Problem where dissolved nitrogen is transported with the water phase from the left side to the right |
  PowerInjectionProblem | 1D Problem with very fast injection of gas on the left |
  ReservoirProblem | Some simple test problem for the black-oil VCVF discretization inspired by an oil reservoir |
  RichardsLensProblem | A water infiltration problem with a low-permeability lens embedded into a high-permeability domain |
  WaterAirProblem | Non-isothermal gas injection problem where a air is injected into a fully water saturated medium |
  Tutorial1Problem | Tutorial problem using the "immiscible" model |
 Doxygen | |
 OmpMutex | |
 ScopedLock | This class implements an exception-safe scoped lock-keeper |