▼ opm | |
▼ models | |
► blackoil | |
blackoilboundaryratevector.hh | Implements a boundary vector for the fully implicit black-oil model. |
blackoilbrinemodules.hh | Contains the classes required to extend the black-oil model by brine |
blackoilbrineparams.hpp | Contains the parameters required to extend the black-oil model by brine |
blackoilconvectivemixingmodule.hh | Classes required for dynamic convective mixing |
blackoildarcyfluxmodule.hh | This file contains the default flux module of the blackoil model |
blackoildiffusionmodule.hh | Classes required for molecular diffusion |
blackoildispersionmodule.hh | Classes required for mechanical dispersion |
blackoilenergymodules.hh | Contains the classes required to extend the black-oil model by energy |
blackoilextbomodules.hh | Contains the classes required to extend the black-oil model by solvent component |
blackoilextboparams.hpp | Contains the parameters required to extend the black-oil model by solvent component |
blackoilextensivequantities.hh | 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. |
blackoilfoammodules.hh | Contains the classes required to extend the black-oil model to include the effects of foam |
blackoilfoamparams.hpp | Contains the parameters to extend the black-oil model to include the effects of foam |
blackoilindices.hh | The primary variable and equation indices for the black-oil model. |
blackoilintensivequantities.hh | Contains the quantities which are are constant within a finite volume in the black-oil model. |
blackoillocalresidual.hh | Calculates the local residual of the black oil model. |
blackoillocalresidualtpfa.hh | Calculates the local residual of the black oil model. |
blackoilmicpmodules.hh | Contains the classes required to extend the black-oil model by MICP |
blackoilmicpparams.hpp | Contains the parameters required to extend the black-oil model by MICP |
blackoilmodel.hh | A fully-implicit black-oil flow model. |
blackoilnewtonmethod.hpp | A newton solver which is specific to the black oil model. |
blackoilnewtonmethodparams.hpp | A newton solver which is specific to the black oil model. |
blackoilonephaseindices.hh | |
blackoilpolymermodules.hh | Contains the classes required to extend the black-oil model by polymer |
blackoilpolymerparams.hpp | Contains the parameters required to extend the black-oil model by polymer |
blackoilprimaryvariables.hh | Represents the primary variables used by the black-oil model. |
blackoilproblem.hh | Base class for all problems which use the black-oil model. |
blackoilproperties.hh | Declares the properties required by the black oil model |
blackoilratevector.hh | Implements a vector representing mass, molar or volumetric rates for the black oil model. |
blackoilsolventmodules.hh | Contains the classes required to extend the black-oil model by solvents |
blackoilsolventparams.hpp | Contains the parameters required to extend the black-oil model by solvents |
blackoiltwophaseindices.hh | The primary variable and equation indices for the black-oil model. |
► common | |
darcyfluxmodule.hh | This file contains the necessary classes to calculate the volumetric fluxes out of a pressure potential gradient using the Darcy relation |
diffusionmodule.hh | Classes required for molecular diffusion |
directionalmobility.hh | This file contains definitions related to directional mobilities |
energymodule.hh | Contains the classes required to consider energy as a conservation quantity in a multi-phase module |
flux.hh | This file contains the necessary classes to calculate the velocity out of a pressure potential gradient |
forchheimerfluxmodule.hh | This file contains the necessary classes to calculate the volumetric fluxes out of a pressure potential gradient using the Forchhheimer approach |
multiphasebaseextensivequantities.hh | This class calculates the pressure potential gradients and the filter velocities for multi-phase flow in porous media. |
multiphasebasemodel.hh | A base class for fully-implicit multi-phase porous-media flow models which assume multiple fluid phases. |
multiphasebaseparameters.hh | Defines the common parameters for the porous medium multi-phase models |
multiphasebaseproblem.hh | The base class for the problems of ECFV discretizations which deal with a multi-phase flow through a porous medium. |
multiphasebaseproperties.hh | Defines the common properties required by the porous medium multi-phase models |
quantitycallbacks.hh | This method contains all callback classes for quantities that are required by some extensive quantities |
transfluxmodule.hh | This file contains the flux module that uses transmissibilities |
► discretefracture | |
discretefractureextensivequantities.hh | This class expresses all intensive quantities of the discrete fracture model. |
discretefractureintensivequantities.hh | Contains the quantities which are are constant within a finite volume in the discret fracture immiscible multi-phase model. |
discretefracturelocalresidual.hh | Calculates the local residual of the discrete fracture immiscible multi-phase model. |
discretefracturemodel.hh | A fully-implicit multi-phase flow model which assumes immiscibility of the phases and is able to include fractures in the domain. |
discretefractureprimaryvariables.hh | Represents the primary variables used by the discrete fracture multi-phase model. |
discretefractureproblem.hh | The base class for the problems of ECFV discretizations which deal with a multi-phase flow through a porous medium. |
discretefractureproperties.hh | Defines the properties required for the immiscible multi-phase model which considers discrete fractures |
fracturemapper.hh | Stores the topology of fractures. |
► discretization | |
► common | |
baseauxiliarymodule.hh | Base class for specifying auxiliary equations. |
fvbaseadlocallinearizer.hh | Calculates the local residual and its Jacobian for a single element of the grid. |
fvbaseboundarycontext.hh | Represents all quantities which available on boundary segments. |
fvbaseconstraints.hh | Class to specify constraints for a finite volume spatial discretization. |
fvbaseconstraintscontext.hh | Represents all quantities which available for calculating constraints. |
fvbasediscretization.hh | The base class for the finite volume discretization schemes. |
fvbasediscretizationfemadapt.hh | The base class for the finite volume discretization schemes. |
fvbaseelementcontext.hh | This class stores an array of IntensiveQuantities objects, one intensive quantities object for each of the element's vertices. |
fvbaseextensivequantities.hh | Provide the properties at a face which make sense indepentently of the conserved quantities. |
fvbasefdlocallinearizer.hh | Calculates the Jacobian of the local residual for finite volume spatial discretizations using a finite difference method. |
fvbasegradientcalculator.hh | This class calculates gradients of arbitrary quantities at flux integration points using the two-point approximation scheme. |
fvbaseintensivequantities.hh | Base class for the model specific class which provides access to all intensive (i.e., volume averaged) quantities. |
fvbaselinearizer.hh | The common code for the linearizers of non-linear systems of equations. |
fvbaselocalresidual.hh | Element-wise caculation of the residual matrix for models based on a finite volume spatial discretization. |
fvbasenewtonconvergencewriter.hh | Writes the intermediate solutions during the Newton scheme for models using a finite volume discretization. |
fvbasenewtonmethod.hh | A Newton method for models using a finite volume discretization. |
fvbaseparameters.hh | Declare the properties used by the infrastructure code of the finite volume discretizations |
fvbaseprimaryvariables.hh | Represents the primary variables used by the a model. |
fvbaseproblem.hh | Base class for all problems which use a finite volume spatial discretization. |
fvbaseproperties.hh | Declare the properties used by the infrastructure code of the finite volume discretizations |
linearizationtype.hh | The common code for the linearizers of non-linear systems of equations. |
restrictprolong.hh | |
tpfalinearizer.hh | The common code for the linearizers of non-linear systems of equations. |
► ecfv | |
ecfvbaseoutputmodule.hh | Implements the discretization specific parts of writing files. |
ecfvdiscretization.hh | The base class for the element-centered finite-volume discretization scheme. |
ecfvgridcommhandlefactory.hh | A class which provides types for DUNE grid handles for communication. |
ecfvproperties.hh | Declare the basic properties used by the common infrastructure of the element-centered finite volume discretization |
ecfvstencil.hh | Represents the stencil (finite volume geometry) of a single element in the ECFV discretization. |
► vcfv | |
p1fegradientcalculator.hh | This class calculates gradients of arbitrary quantities at flux integration points using first order finite elemens ansatz functions. |
vcfvbaseoutputmodule.hh | Implements the discretization specific parts of writing files. |
vcfvdiscretization.hh | The base class for the vertex centered finite volume discretization scheme. |
vcfvgridcommhandlefactory.hh | A class which provides types for DUNE grid handles for communication. |
vcfvproperties.hh | Declares the basic properties used by the common infrastructure of the vertex-centered finite volume discretization |
vcfvstencil.hh | Represents the finite volume geometry of a single element in the VCFV discretization. |
► flash | |
flashboundaryratevector.hh | Implements a boundary vector for the fully implicit compositional multi-phase model which is based on flash calculations. |
flashextensivequantities.hh | 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.hh | Defines the primary variable and equation indices for the compositional multi-phase model based on flash calculations. |
flashintensivequantities.hh | Contains the intensive quantities of the flash-based compositional multi-phase model. |
flashlocalresidual.hh | Calculates the local residual of the compositional multi-phase model based on flash calculations. |
flashmodel.hh | A compositional multi-phase model based on flash-calculations. |
flashparameters.hh | Declares the parameters for the compositional multi-phase model based on flash calculations |
flashprimaryvariables.hh | Represents the primary variables used by the compositional flow model based on flash calculations. |
flashproperties.hh | Declares the properties required by the compositional multi-phase model based on flash calculations |
flashratevector.hh | Implements a vector representing rates of conserved quantities. |
► immiscible | |
immiscibleboundaryratevector.hh | Implements a boundary vector for the fully implicit multi-phase model which assumes immiscibility. |
immiscibleextensivequantities.hh | 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.hh | The indices for the isothermal multi-phase model. |
immiscibleintensivequantities.hh | Contains the quantities which are are constant within a finite volume for the immiscible multi-phase model. |
immisciblelocalresidual.hh | Calculates the local residual of the immiscible multi-phase model. |
immisciblemodel.hh | A fully-implicit multi-phase flow model which assumes immiscibility of the phases. |
immiscibleprimaryvariables.hh | Represents the primary variables used by the immiscible multi-phase, model. |
immiscibleproperties.hh | Defines the properties required for the immiscible multi-phase model |
immiscibleratevector.hh | Implements a vector representing rates of conserved quantities. |
► io | |
baseoutputmodule.hh | The base class for writer modules. |
baseoutputwriter.hh | The base class for all output writers. |
basevanguard.hh | Provides the base class for most (all?) simulator vanguards. |
cubegridvanguard.hh | Provides a simulator vanguad which creates a regular grid made of quadrilaterals. |
dgfvanguard.hh | Provides a simulator vanguard which creates a grid by parsing a Dune Grid Format (DGF) file. |
restart.hpp | Load or save a state of a problem to/from the harddisk. |
simplexvanguard.hh | Provides a simulator vanguard which a creates regular grid made of simplices. |
structuredgridvanguard.hh | Helper class for grid instantiation of the lens problem. |
unstructuredgridvanguard.hh | Provides a simulator vanguard which creates a grid by parsing an unstructured grid file. |
vtkblackoilenergymodule.hpp | VTK output module for the black oil model's energy related quantities. |
vtkblackoilenergyparams.hpp | VTK output module for the black oil model's energy related quantities. |
vtkblackoilmicpmodule.hpp | VTK output module for the MICP model's related quantities. |
vtkblackoilmicpparams.hpp | VTK output module for the MICP model's related quantities. |
vtkblackoilmodule.hpp | VTK output module for the black oil model's parameters. |
vtkblackoilparams.hpp | VTK output module for the black oil model's parameters. |
vtkblackoilpolymermodule.hpp | VTK output module for the black oil model's polymer related quantities. |
vtkblackoilpolymerparams.hpp | VTK output module for the black oil model's polymer related quantities. |
vtkblackoilsolventmodule.hpp | VTK output module for the black oil model's solvent related quantities. |
vtkblackoilsolventparams.hpp | VTK output module for the black oil model's solvent related quantities. |
vtkcompositionmodule.hpp | VTK output module for the fluid composition. |
vtkcompositionparams.hpp | VTK output module for the fluid composition. |
vtkdiffusionmodule.hpp | VTK output module for quantities which make sense for models which incorperate molecular diffusion. |
vtkdiffusionparams.hpp | VTK output module for quantities which make sense for models which incorperate molecular diffusion. |
vtkdiscretefracturemodule.hpp | VTK output module for quantities which make sense for all models which deal with discrete fractures in porous media. |
vtkdiscretefractureparams.hpp | VTK output module for quantities which make sense for all models which deal with discrete fractures in porous media. |
vtkenergymodule.hpp | VTK output module for quantities which make sense for models which assume thermal equilibrium. |
vtkenergyparams.hpp | VTK output module for quantities which make sense for models which assume thermal equilibrium. |
vtkmultiphasemodule.hpp | 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. |
vtkmultiphaseparams.hpp | 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.hh | Simplifies writing multi-file VTK datasets. |
vtkphasepresencemodule.hpp | VTK output module for the fluid composition. |
vtkphasepresenceparams.hpp | VTK output module for the fluid composition. |
vtkprimaryvarsmodule.hpp | VTK output module for the fluid composition. |
vtkprimaryvarsparams.hpp | VTK output module for the fluid composition. |
vtkptflashmodule.hpp | VTK output module for the PT Flash calculation This module deals with the following quantities: K, equilibrium ratio for all the components L, liquid fraction in the two-phase system. |
vtkptflashparams.hpp | VTK output module for the PT Flash calculation This module deals with the following quantities: K, equilibrium ratio for all the components L, liquid fraction in the two-phase system. |
vtkscalarfunction.hh | Provides a vector-valued function using Dune::FieldVectors as elements. |
vtktemperaturemodule.hpp | VTK output module for the temperature in which assume thermal equilibrium. |
vtktemperatureparams.hpp | VTK output module for the temperature in which assume thermal equilibrium. |
vtktensorfunction.hh | Provides a tensor-valued function using Dune::FieldMatrix objects as elements. |
vtkvectorfunction.hh | Provides a vector-valued function using Dune::FieldVectors as elements. |
► ncp | |
ncpboundaryratevector.hh | Implements a boundary vector for the fully implicit compositional multi-phase NCP model. |
ncpextensivequantities.hh | This template class represents the extensive quantities of the compositional NCP model. |
ncpindices.hh | The primary variable and equation indices for the compositional multi-phase NCP model. |
ncpintensivequantities.hh | Contains the quantities which are are constant within a finite volume in the compositional multi-phase NCP model. |
ncplocalresidual.hh | Details needed to calculate the local residual in the compositional multi-phase NCP-model . |
ncpmodel.hh | A compositional multi-phase model based on non-linear complementarity functions. |
ncpnewtonmethod.hh | A Newton solver specific to the NCP model. |
ncpprimaryvariables.hh | Represents the primary variables used by the compositional multi-phase NCP model. |
ncpproperties.hh | Declares the properties required for the NCP compositional multi-phase model |
ncpratevector.hh | Implements a vector representing mass, molar or volumetric rates. |
► nonlinear | |
newtonmethod.hh | The multi-dimensional Newton method. |
newtonmethodparams.hpp | |
newtonmethodproperties.hh | |
nullconvergencewriter.hh | A convergence writer for the Newton method which does nothing. |
► parallel | |
gridcommhandles.hh | Provides data handles for parallel communication which operate on DOFs |
mpibuffer.hh | Simplifies handling of buffers to be used in conjunction with MPI. |
mpiutil.hpp | Simplifies handling of buffers to be used in conjunction with MPI. |
tasklets.hpp | Provides a mechanism to dispatch work to separate threads |
threadedentityiterator.hh | Provides an STL-iterator like interface to iterate over the enties of a GridView in OpenMP threaded applications. |
threadmanager.hpp | Simplifies multi-threaded capabilities. |
► ptflash | |
flashindices.hh | Defines the primary variable and equation indices for the compositional multi-phase model based on flash calculations. |
flashintensivequantities.hh | Contains the intensive quantities of the flash-based compositional multi-phase model. |
flashlocalresidual.hh | Calculates the local residual of the compositional multi-phase model based on flash calculations. |
flashmodel.hh | A compositional multi-phase model based on flash-calculations. |
flashnewtonmethod.hh | A Newton solver specific to the PTFlash model. |
flashparameters.hh | Declares the parameters for the compositional multi-phase model based on flash calculations |
flashprimaryvariables.hh | Represents the primary variables used by the compositional flow model based on flash calculations. |
► pvs | |
pvsboundaryratevector.hh | Implements a rate vector on the boundary for the fully implicit compositional multi-phase primary variable switching compositional model. |
pvsextensivequantities.hh | Contains all data which is required to calculate all fluxes at a flux integration point for the primary variable switching model. |
pvsindices.hh | The indices for the compositional multi-phase primary variable switching model. |
pvsintensivequantities.hh | Contains the quantities which are are constant within a finite volume in the compositional multi-phase primary variable switching model. |
pvslocalresidual.hh | Element-wise calculation of the local residual for the compositional multi-phase primary variable switching model. |
pvsmodel.hh | A generic compositional multi-phase model using primary-variable switching. |
pvsnewtonmethod.hh | A newton solver which is specific to the compositional multi-phase PVS model. |
pvsprimaryvariables.hh | Represents the primary variables used in the primary variable switching compositional model. |
pvsproperties.hh | Declares the properties required for the compositional multi-phase primary variable switching model |
pvsratevector.hh | Implements a vector representing molar, mass or volumetric rates. |
► richards | |
richardsboundaryratevector.hh | Implements a boundary vector for the fully implicit Richards model. |
richardsextensivequantities.hh | Calculates and stores the data which is required to calculate the flux of fluid over a face of a finite volume. |
richardsindices.hh | Indices for the primary variables/conservation equations of the Richards model. |
richardsintensivequantities.hh | Intensive quantities required by the Richards model. |
richardslocalresidual.hh | Element-wise calculation of the residual for the Richards model. |
richardsmodel.hh | This model implements a variant of the Richards equation for quasi-twophase flow. |
richardsnewtonmethod.hh | A Richards model specific Newton method. |
richardsprimaryvariables.hh | Represents the primary variables used in the Richards model. |
richardsproperties.hh | Contains the property declarations for the Richards model |
richardsratevector.hh | Implements a vector representing mass, molar or volumetric rates. |
► utils | |
alignedallocator.hh | This is a stand-alone version of boost::alignment::aligned_allocator from Boost 1.58 |
basicparameters.hh | Defines some fundamental parameters for all models |
basicproperties.hh | Defines a type tags and some fundamental properties all models |
genericguard.hh | A simple class which makes sure that a cleanup function is called once the object is destroyed. |
parametersystem.cpp | This file provides the infrastructure to retrieve run-time parameters |
parametersystem.hpp | This file provides the infrastructure to retrieve run-time parameters |
pffgridvector.hh | |
prefetch.hh | |
propertysystem.hh | The Opm property system, traits with inheritance |
quadraturegeometries.hh | Quadrature geometry for quadrilaterals. |
signum.hh | |
simulator.hh | Manages the initializing and running of time dependent problems. |
simulatorutils.hpp | |
start.hh | Provides convenience routines to bring up the simulation at runtime |
terminal.hpp | |
timer.hpp | Provides an encapsulation to measure the system time. |
timerguard.hh | A simple class which makes sure that a timer gets stopped if an exception is thrown. |
▼ simulators | |
► aquifers | |
AquiferAnalytical.hpp | |
AquiferCarterTracy.hpp | |
AquiferConstantFlux.hpp | |
AquiferFetkovich.hpp | |
AquiferGridUtils.hpp | |
AquiferInterface.hpp | |
AquiferNumerical.hpp | |
BlackoilAquiferModel.hpp | |
BlackoilAquiferModel_impl.hpp | |
SupportsFaceTag.hpp | |
► flow | |
► equil | |
EquilibrationHelpers.hpp | Auxiliary routines that to solve the ODEs that emerge from the hydrostatic equilibrium problem |
EquilibrationHelpers_impl.hpp | |
InitStateEquil.hpp | Routines that actually solve the ODEs that emerge from the hydrostatic equilibrium problem |
InitStateEquil_impl.hpp | |
► python | |
Pybind11Exporter.hpp | |
PyBlackOilSimulator.hpp | |
PyFluidState.hpp | |
PyFluidState_impl.hpp | |
PyMaterialState.hpp | |
PyMaterialState_impl.hpp | |
ActionHandler.hpp | |
AluGridCartesianIndexMapper.hpp | |
AluGridVanguard.hpp | Helper class for grid instantiation of ECL file-format using problems. |
Banners.hpp | |
BaseAquiferModel.hpp | The base class which specifies the API of aquifer models. |
BlackoilModel.hpp | |
BlackoilModelNldd.hpp | |
BlackoilModelParameters.hpp | |
CollectDataOnIORank.hpp | |
CollectDataOnIORank_impl.hpp | |
ConvergenceOutputConfiguration.hpp | |
countGlobalCells.hpp | |
CpGridVanguard.hpp | Helper class for grid instantiation of ECL file-format using problems. |
DamarisParameters.hpp | Collects necessary output values and pass them to Damaris server processes. |
DamarisWriter.hpp | Collects necessary output values and pass them to Damaris server processes. |
DummyGradientCalculator.hpp | This is a "dummy" gradient calculator which does not do anything. |
EclGenericWriter.hpp | Collects necessary output values and pass it to opm-common's ECL output. |
EclGenericWriter_impl.hpp | |
EclWriter.hpp | Collects necessary output values and pass it to opm-common's ECL output. |
EquilInitializer.hpp | Computes the initial condition based on the EQUIL keyword from ECL. |
ExtraConvergenceOutputThread.hpp | |
FemCpGridCompat.hpp | This file ensures that flow can be compiled in the presence of dune-fem |
FIBlackoilModel.hpp | |
FlowBaseProblemProperties.hpp | |
FlowBaseVanguard.hpp | Helper class for grid instantiation of ECL file-format using problems. |
FlowGenericProblem.hpp | This problem simulates an input file given in the data format used by the commercial ECLiPSE simulator. |
FlowGenericProblem_impl.hpp | |
FlowGenericVanguard.hpp | Helper class for grid instantiation of ECL file-format using problems. |
FlowMain.hpp | |
FlowProblem.hpp | This problem simulates an input file given in the data format used by the commercial ECLiPSE simulator. |
FlowProblemBlackoil.hpp | This problem simulates an input file given in the data format used by the commercial ECLiPSE simulator. |
FlowProblemBlackoilProperties.hpp | |
FlowProblemComp.hpp | This problem simulates an input file given in the data format used by the commercial ECLiPSE simulator. |
FlowProblemCompProperties.hpp | |
FlowProblemParameters.hpp | This problem simulates an input file given in the data format used by the commercial ECLiPSE simulator. |
FlowsData.hpp | |
FlowThresholdPressure.hpp | This class calculates the threshold pressure for grid faces according to the Eclipse Reference Manual. |
FlowUtils.hpp | |
GenericCpGridVanguard.hpp | Helper class for grid instantiation of ECL file-format using problems. |
GenericOutputBlackoilModule.hpp | Output module for the results black oil model writing in ECL binary format. |
GenericThresholdPressure.hpp | |
GenericThresholdPressure_impl.hpp | |
GenericTracerModel.hpp | A class which handles tracers as specified in by ECL. |
GenericTracerModel_impl.hpp | A class which handles tracers as specified in by ECL. |
InterRegFlows.hpp | MPI-aware facility for converting collection of tuples of region ID pairs and associate flow rates into a sparse (CSR) adjacency matrix representation of a graph |
KeywordValidation.hpp | |
LogOutputHelper.hpp | |
Main.hpp | |
MixingRateControls.cpp | This problem simulates an input file given in the data format used by the commercial ECLiPSE simulator. |
MixingRateControls.hpp | This problem simulates an input file given in the data format used by the commercial ECLiPSE simulator. |
NewTranFluxModule.hpp | This file contains the flux module which is used for flow problems |
NonlinearSolver.hpp | |
OutputBlackoilModule.hpp | Output module for the results black oil model writing in ECL binary format. |
partitionCells.hpp | |
PolyhedralGridVanguard.hpp | Helper class for grid instantiation of ECL file-format using problems. |
priVarsPacking.hpp | |
RegionPhasePVAverage.hpp | |
RSTConv.hpp | |
SimulatorFullyImplicitBlackoil.hpp | |
SimulatorReportBanners.hpp | |
SimulatorSerializer.hpp | |
SolutionContainers.cpp | This problem simulates an input file given in the data format used by the commercial ECLiPSE simulator. |
SolutionContainers.hpp | This problem simulates an input file given in the data format used by the commercial ECLiPSE simulator. |
SubDomain.hpp | |
TracerModel.hpp | A class which handles tracers as specified in by ECL. |
Transmissibility.hpp | |
Transmissibility_impl.hpp | |
ValidationFunctions.hpp | |
VtkTracerModule.hpp | VTK output module for the tracer model's parameters. |
► linalg | |
► bda | |
► cuda | |
cuda_header.hpp | |
cusparseSolverBackend.hpp | |
cuWellContributions.hpp | |
► opencl | |
ChowPatelIlu.hpp | |
opencl.hpp | |
openclBILU0.hpp | |
openclBISAI.hpp | |
openclCPR.hpp | |
openclKernels.hpp | |
OpenclMatrix.hpp | |
openclPreconditioner.hpp | |
openclSolverBackend.hpp | |
openclWellContributions.hpp | |
► rocm | |
hipKernels.hpp | |
rocalutionSolverBackend.hpp | |
rocsparseBILU0.hpp | |
rocsparseCPR.hpp | |
rocsparseMatrix.hpp | |
rocsparsePreconditioner.hpp | |
rocsparseSolverBackend.hpp | |
rocsparseWellContributions.hpp | |
amgclSolverBackend.hpp | |
BdaBridge.hpp | |
BdaResult.hpp | |
BdaSolver.hpp | |
BlockedMatrix.hpp | |
CprCreation.hpp | |
Matrix.hpp | |
Misc.hpp | |
MultisegmentWellContribution.hpp | |
Preconditioner.hpp | |
Reorder.hpp | |
WellContributions.hpp | |
► gpuistl | |
► detail | |
► preconditionerKernels | |
DILUKernels.hpp | |
ILU0Kernels.hpp | |
JacKernels.hpp | |
autotuner.hpp | |
coloringAndReorderingUtils.hpp | |
cublas_safe_call.hpp | |
cublas_wrapper.hpp | |
CuBlasHandle.hpp | |
cuda_check_last_error.hpp | |
CuMatrixDescription.hpp | |
cusparse_constants.hpp | |
cusparse_safe_call.hpp | |
cusparse_wrapper.hpp | |
CuSparseHandle.hpp | |
CuSparseResource.hpp | |
CuSparseResource_impl.hpp | |
deviceBlockOperations.hpp | |
fix_zero_diagonal.hpp | |
gpu_safe_call.hpp | |
gpusparse_matrix_operations.hpp | |
gpuThreadUtils.hpp | |
has_function.hpp | |
preconditioner_should_call_post_pre.hpp | |
safe_conversion.hpp | |
vector_operations.hpp | |
GpuBlockPreconditioner.hpp | |
GpuBuffer.hpp | |
GpuDILU.hpp | |
GpuJac.hpp | |
GpuOwnerOverlapCopy.hpp | |
GpuSeqILU0.hpp | |
GpuSparseMatrix.hpp | |
GpuVector.hpp | |
GpuView.hpp | |
OpmGpuILU0.hpp | |
PreconditionerAdapter.hpp | |
PreconditionerConvertFieldTypeAdapter.hpp | |
PreconditionerHolder.hpp | |
set_device.hpp | |
SolverAdapter.hpp | |
amgcpr.hh | The AMG preconditioner |
bicgstabsolver.hh | Implements a preconditioned stabilized BiCG linear solver. |
blacklist.hh | Expresses which degrees of freedom are blacklisted for the parallel linear solvers and which domestic indices they correspond to. |
combinedcriterion.hh | Convergence criterion which looks at the absolute value of the residual and fails if the linear solver stagnates. |
convergencecriterion.hh | |
DILU.hpp | |
domesticoverlapfrombcrsmatrix.hh | This class creates and manages the foreign overlap given an initial list of border indices and a BCRS matrix. |
elementborderlistfromgrid.hh | Uses communication on the grid to find the initial seed list of indices for methods which use element-based degrees of freedom. |
extractMatrix.hpp | |
ExtractParallelGridInformationToISTL.hpp | |
ExtraSmoothers.hpp | |
findOverlapRowsAndColumns.hpp | |
fixpointcriterion.hh | |
FlexibleSolver.hpp | |
FlexibleSolver_impl.hpp | |
FlowLinearSolverParameters.hpp | |
foreignoverlapfrombcrsmatrix.hh | This class creates and manages the foreign overlap given an initial list of border indices and a BCRS matrix. |
getQuasiImpesWeights.hpp | |
globalindices.hh | This class maps domestic row indices to and from "global" indices which is used to construct an algebraic overlap for the parallel linear solvers. |
GraphColoring.hpp | |
ilufirstelement.hh | |
istlpreconditionerwrappers.hh | Provides wrapper classes for the (non-AMG) preconditioners provided by dune-istl |
ISTLSolver.hpp | |
ISTLSolverBda.hpp | |
istlsolverwrappers.hh | Provides wrapper classes for the iterative linear solvers available in dune-istl |
istlsparsematrixadapter.hh | A sparse matrix interface backend for BCRSMatrix from dune-istl. |
linalgparameters.hh | Declares the parameters for the black oil model |
linalgproperties.hh | Declares the properties required by the black oil model |
linearsolverreport.hh | Collects summary information about the execution of the linear solver. |
matrixblock.hh | |
MatrixMarketSpecializations.hpp | |
MILU.hpp | |
nullborderlistmanager.hh | This is a grid manager which does not create any border list. |
overlappingbcrsmatrix.hh | An overlap aware block-compressed row storage (BCRS) matrix. |
overlappingblockvector.hh | An overlap aware block vector. |
overlappingoperator.hh | An overlap aware linear operator usable by ISTL. |
overlappingpreconditioner.hh | An overlap aware preconditioner for any ISTL linear solver. |
overlappingscalarproduct.hh | An overlap aware ISTL scalar product. |
overlaptypes.hh | This files provides several data structures for storing tuples of indices of remote and/or local processes |
OwningBlockPreconditioner.hpp | |
OwningTwoLevelPreconditioner.hpp | |
parallelamgbackend.hh | Provides a linear solver backend using the parallel algebraic multi-grid (AMG) linear solver from DUNE-ISTL. |
parallelbasebackend.hh | Provides the common code which is required by most linear solvers. |
parallelbicgstabbackend.hh | Implements a generic linear solver abstraction. |
parallelistlbackend.hh | Provides all unmodified linear solvers from dune-istl. |
ParallelIstlInformation.hpp | |
ParallelOverlappingILU0.hpp | |
ParallelOverlappingILU0_impl.hpp | |
ParallelRestrictedAdditiveSchwarz.hpp | |
PreconditionerFactory.hpp | |
PreconditionerFactory_impl.hpp | |
PreconditionerFactoryGPUIncludeWrapper.hpp | |
PreconditionerWithUpdate.hpp | |
PressureBhpTransferPolicy.hpp | |
PressureSolverPolicy.hpp | |
PressureTransferPolicy.hpp | |
PropertyTree.hpp | |
residreductioncriterion.hh | Provides a convergence criterion which looks at the reduction of the two-norm of the residual for the linear solvers. |
setupPropertyTree.hpp | |
SmallDenseMatrixUtils.hpp | |
superlubackend.hh | |
twolevelmethodcpr.hh | Algebraic twolevel methods |
vertexborderlistfromgrid.hh | Uses communication on the grid to find the initial seed list of indices. |
weightedresidreductioncriterion.hh | Convergence criterion which looks at the weighted absolute value of the residual. |
WellOperators.hpp | |
WriteSystemMatrixHelper.hpp | |
► timestepping | |
AdaptiveSimulatorTimer.hpp | |
AdaptiveTimeStepping.hpp | |
ConvergenceReport.hpp | |
EclTimeSteppingParams.hpp | |
gatherConvergenceReport.hpp | |
SimulatorReport.hpp | |
SimulatorTimer.hpp | |
SimulatorTimerInterface.hpp | |
TimeStepControl.hpp | |
TimeStepControlInterface.hpp | |
► utils | |
► satfunc | |
GasPhaseConsistencyChecks.hpp | |
OilPhaseConsistencyChecks.hpp | |
PhaseCheckBase.hpp | |
RelpermDiagnostics.hpp | |
SatfuncConsistencyChecks.hpp | |
ThreePointHorizontalConsistencyChecks.hpp | |
WaterPhaseConsistencyChecks.hpp | |
BlackoilPhases.hpp | |
ComponentName.hpp | |
compressPartition.hpp | |
DamarisKeywords.hpp | |
DamarisOutputModule.hpp | |
DamarisVar.hpp | |
DeferredLogger.hpp | |
DeferredLoggingErrorHelpers.hpp | |
gatherDeferredLogger.hpp | |
GridDataOutput.hpp | Allows model geometry data to be passed to external code - via a copy direct to input pointers |
GridDataOutput_impl.hpp | |
HDF5File.hpp | |
HDF5Serializer.hpp | |
moduleVersion.hpp | |
MPIPacker.hpp | |
MPISerializer.hpp | |
ParallelCommunication.hpp | |
ParallelEclipseState.hpp | |
ParallelFileMerger.hpp | |
ParallelNLDDPartitioningZoltan.hpp | |
ParallelRestart.hpp | |
ParallelSerialization.hpp | |
PartiallySupportedFlowKeywords.hpp | |
phaseUsageFromDeck.hpp | |
PressureAverage.hpp | |
PropsDataHandle.hpp | |
readDeck.hpp | |
SerializationPackers.hpp | |
SetupPartitioningParams.hpp | |
UnsupportedFlowKeywords.hpp | |
VectorVectorDataHandle.hpp | A datahandle sending data located in multiple vectors |
► wells | |
ALQState.hpp | |
BlackoilWellModel.hpp | |
BlackoilWellModel_impl.hpp | |
BlackoilWellModelConstraints.hpp | |
BlackoilWellModelGeneric.hpp | |
BlackoilWellModelGuideRates.hpp | |
BlackoilWellModelRestart.hpp | |
ConnFiltrateData.hpp | |
FractionCalculator.hpp | |
GasLiftCommon.hpp | |
GasLiftGroupInfo.hpp | |
GasLiftSingleWell.hpp | |
GasLiftSingleWell_impl.hpp | |
GasLiftSingleWellGeneric.hpp | |
GasLiftStage2.hpp | |
GasLiftWellState.hpp | |
GlobalWellInfo.hpp | |
GroupEconomicLimitsChecker.hpp | |
GroupState.hpp | |
MSWellHelpers.hpp | |
MultisegmentWell.hpp | |
MultisegmentWell_impl.hpp | |
MultisegmentWellAssemble.hpp | |
MultisegmentWellEquations.hpp | |
MultisegmentWellEval.hpp | |
MultisegmentWellGeneric.hpp | |
MultisegmentWellPrimaryVariables.hpp | |
MultisegmentWellSegments.hpp | |
ParallelPAvgCalculator.hpp | |
ParallelPAvgDynamicSourceData.hpp | |
ParallelWBPCalculation.hpp | |
ParallelWellInfo.hpp | |
PerfData.hpp | |
PerforationData.hpp | |
RateConverter.hpp | Facility for converting component rates at surface conditions to phase (voidage) rates at reservoir conditions |
RegionAttributeHelpers.hpp | |
RegionAverageCalculator.hpp | Facility for converting component rates at surface conditions to phase (voidage) rates at reservoir conditions |
SegmentState.hpp | |
SingleWellState.hpp | |
StandardWell.hpp | |
StandardWell_impl.hpp | |
StandardWellAssemble.hpp | |
StandardWellConnections.hpp | |
StandardWellEquations.hpp | |
StandardWellEval.hpp | |
StandardWellPrimaryVariables.hpp | |
TargetCalculator.hpp | |
VFPHelpers.hpp | |
VFPInjProperties.hpp | |
VFPProdProperties.hpp | |
VFPProperties.hpp | |
WellAssemble.hpp | |
WellBhpThpCalculator.hpp | |
WellConnectionAuxiliaryModule.hpp | |
WellConstraints.hpp | |
WellContainer.hpp | |
WellConvergence.hpp | |
WellFilterCake.hpp | |
WellGroupConstraints.hpp | |
WellGroupControls.hpp | |
WellGroupHelpers.hpp | |
WellHelpers.hpp | |
WellInterface.hpp | |
WellInterface_impl.hpp | |
WellInterfaceFluidSystem.hpp | |
WellInterfaceGeneric.hpp | |
WellInterfaceIndices.hpp | |
WellProdIndexCalculator.hpp | |
WellState.hpp | |
WellTest.hpp | |
WGState.hpp | |
opm-simulators_doxygen_main.hpp | |