|
class | AdaptiveSimulatorTimer |
| Simulation timer for adaptive time stepping. More...
|
|
class | AdaptiveTimeStepping |
|
class | AdditionalObjectDeleter |
| A custom deleter that will delete an additional object, too. More...
|
|
class | AutoDiff |
| A simple class for forward-mode automatic differentiation. More...
|
|
class | AutoDiffBlock |
| A class for forward-mode automatic differentiation with vector values and sparse jacobian matrices. More...
|
|
class | AutoDiffMatrix |
| AutoDiffMatrix is a wrapper class that optimizes matrix operations. More...
|
|
class | BlackoilMatlabWriter |
|
class | BlackoilModel |
| A model implementation for three-phase black oil. More...
|
|
class | BlackoilModelBase |
| A model implementation for three-phase black oil. More...
|
|
class | BlackoilModelEbos |
| A model implementation for three-phase black oil. More...
|
|
struct | BlackoilModelParameters |
| Solver parameters for the BlackoilModel. More...
|
|
class | BlackoilMultiSegmentModel |
| A model implementation for three-phase black oil with support for multi-segment wells. More...
|
|
struct | BlackoilMultiSegmentSolutionState |
|
class | BlackoilOutputWriter |
| Wrapper class for VTK, Matlab, and ECL output. More...
|
|
class | BlackoilPolymerModel |
| A model implementation for three-phase black oil with polymer. More...
|
|
struct | BlackoilPolymerSolutionState |
| Need to include concentration in our state variables, otherwise all is as the default blackoil model. More...
|
|
class | BlackoilPressureModel |
| A model implementation for the pressure equation in three-phase black oil. More...
|
|
class | BlackoilPropsAdFromDeck |
| This class implements the AD-adapted fluid interface for three-phase black-oil. More...
|
|
class | BlackoilReorderingTransportModel |
| A model implementation for the transport equation in three-phase black oil. More...
|
|
class | BlackoilSequentialModel |
| A sequential splitting model implementation for three-phase black oil. More...
|
|
struct | BlackoilSequentialModelParameters |
|
class | BlackoilSolventModel |
| A model implementation for three-phase black oil with one extra component. More...
|
|
struct | BlackoilSolventSolutionState |
| Need to include concentration in our state variables, otherwise all is as the default blackoil model. More...
|
|
class | BlackoilSubWriter |
|
class | BlackoilTransportModel |
| A model implementation for the transport equation in three-phase black oil. More...
|
|
class | BlackoilVTKWriter |
|
class | BlackoilWellModel |
| Class for handling the blackoil well model. More...
|
|
class | CompressibleTpfaPolymer |
| Encapsulating a tpfa pressure solver for the compressible-fluid case with polymer. More...
|
|
struct | CPRParameter |
|
class | CPRPreconditioner |
| CPR preconditioner. More...
|
|
class | DebugTimeReport |
|
struct | DefaultBlackoilSolutionState |
| Struct for containing iteration variables. More...
|
|
class | DerivedGeology |
| Class containing static geological properties that are derived from grid and petrophysical properties: More...
|
|
class | DuneMatrix |
|
struct | ExtraData |
| Extra data to read/write for OPM restarting. More...
|
|
class | FIPData |
|
struct | FIPDataEnums |
|
class | FixedSizeIterCopyHandle |
| A handle that copies a fixed number data per index. More...
|
|
class | FlowMain |
|
class | FlowMainBase |
| This class encapsulates the setup and running of a simulator based on an input deck. More...
|
|
class | FlowMainEbos |
|
class | FlowMainPolymer |
|
class | FlowMainSequential |
|
class | FlowMainSolvent |
|
class | GravityColumnSolverPolymer |
| Class for doing gravity segregation (only), on a vertical column of cells. More...
|
|
class | GridInit |
| A class intended to give a generic interface to initializing and accessing UnstructuredGrid and CpGrid, using specialized templates to accomplish this. More...
|
|
class | GridInit< UnstructuredGrid > |
| Specialization for UnstructuredGrid. More...
|
|
class | HardcodedTimeStepControl |
| HardcodedTimeStepControl Input generated from summary file using the ert application: More...
|
|
struct | HelperOps |
| Contains vectors and sparse matrices that represent subsets or operations on (AD or regular) vectors of data. More...
|
|
class | ImpesTPFAAD |
| Class for solving black-oil impes problems. More...
|
|
class | IncompPropertiesDefaultPolymer |
|
class | IncompTpfaPolymer |
| Encapsulating a tpfa pressure solver for the incompressible-fluid case with polymer. More...
|
|
class | ISTLSolver |
| This class solves the fully implicit black-oil system by solving the reduced system (after eliminating well variables) as a block-structured matrix (one block for all cell variables) for a fixed number of cell variables np . More...
|
|
struct | IterationReport |
| Class used for reporting the outcome of a nonlinearIteration() call. More...
|
|
struct | LinearisedBlackoilResidual |
| Residual structure of the fully implicit solver. More...
|
|
struct | ModelTraits |
| Traits to encapsulate the types used by classes using or extending this model. More...
|
|
struct | ModelTraits< BlackoilModel< Grid > > |
| Providing types by template specialisation of ModelTraits for BlackoilModel. More...
|
|
struct | ModelTraits< BlackoilMultiSegmentModel< GridT > > |
| Providing types by template specialisation of ModelTraits for BlackoilMultiSegmentModel. More...
|
|
struct | ModelTraits< BlackoilPolymerModel< Grid > > |
| Providing types by template specialisation of ModelTraits for BlackoilPolymerModel. More...
|
|
struct | ModelTraits< BlackoilPressureModel< Grid, WellModel > > |
| Providing types by template specialisation of ModelTraits for BlackoilPressureModel. More...
|
|
struct | ModelTraits< BlackoilReorderingTransportModel< Grid, WellModel > > |
| Providing types by template specialisation of ModelTraits for BlackoilReorderingTransportModel. More...
|
|
struct | ModelTraits< BlackoilSolventModel< Grid > > |
| Providing types by template specialisation of ModelTraits for BlackoilSolventModel. More...
|
|
struct | ModelTraits< BlackoilTransportModel< Grid, WellModel > > |
| Providing types by template specialisation of ModelTraits for BlackoilTransportModel. More...
|
|
class | MultisegmentWell |
|
class | MultisegmentWells |
| Class for handling the multi-segment well model. More...
|
|
class | NewtonIterationBlackoilCPR |
| This class solves the fully implicit black-oil system by applying a Constrained Pressure Residual preconditioning strategy. More...
|
|
class | NewtonIterationBlackoilInterface |
| Interface class for (linear) solvers for the fully implicit black-oil system. More...
|
|
class | NewtonIterationBlackoilInterleaved |
| This class solves the fully implicit black-oil system by solving the reduced system (after eliminating well variables) as a block-structured matrix (one block for all cell variables). More...
|
|
class | NewtonIterationBlackoilInterleavedImpl |
| This class solves the fully implicit black-oil system by solving the reduced system (after eliminating well variables) as a block-structured matrix (one block for all cell variables) for a fixed number of cell variables np . More...
|
|
struct | NewtonIterationBlackoilInterleavedParameters |
| This class carries all parameters for the NewtonIterationBlackoilInterleaved class. More...
|
|
class | NewtonIterationBlackoilSimple |
| This class solves the fully implicit black-oil system by simply concatenating the Jacobian matrices and passing the resulting system to a linear solver. More...
|
|
class | NonlinearSolver |
| A nonlinear solver class suitable for general fully-implicit models, as well as pressure, transport and sequential models. More...
|
|
class | ParallelDebugOutput |
|
class | ParallelDebugOutputInterface |
|
class | ParallelOverlappingILU0 |
| A two-step version of an overlapping Schwarz preconditioner using one step ILU0 as. More...
|
|
class | ParallelRestrictedOverlappingSchwarz |
| Block parallel preconditioner. More...
|
|
class | PIDAndIterationCountTimeStepControl |
| PID controller based adaptive time step control as above that also takes an target iteration into account. More...
|
|
class | PIDTimeStepControl |
| PID controller based adaptive time step control as suggested in: Turek and Kuzmin. More...
|
|
class | PolymerBlackoilState |
| Simulator state for a compressible two-phase simulator with polymer. More...
|
|
class | PolymerInflowBasic |
| Basic polymer injection behaviour class. More...
|
|
class | PolymerInflowFromDeck |
| Polymer injection behaviour class using deck WPOLYMER. More...
|
|
class | PolymerInflowInterface |
| Interface for classes encapsulating polymer inflow information. More...
|
|
class | PolymerProperties |
|
class | PolymerPropsAd |
|
class | PolymerState |
| Simulator state for a two-phase simulator with polymer. More...
|
|
struct | QuickSort |
|
struct | QuickSort< 0 > |
|
class | RelativeChangeInterface |
| RelativeChangeInterface. More...
|
|
class | Selector |
| Selection. Choose first of two elements if selection basis element is nonnegative. More...
|
|
class | SimpleIterationCountTimeStepControl |
| A simple iteration count based adaptive time step control. More...
|
|
class | SimulatorBase |
| Class collecting all necessary components for a two-phase simulation. More...
|
|
class | SimulatorCompressiblePolymer |
| Class collecting all necessary components for a two-phase simulation. More...
|
|
class | SimulatorCompressibleTwophase |
| Class collecting all necessary components for a two-phase simulation. More...
|
|
class | SimulatorFullyImplicitBlackoil |
| a simulator for the blackoil model More...
|
|
class | SimulatorFullyImplicitBlackoilEbos |
| a simulator for the blackoil model More...
|
|
class | SimulatorFullyImplicitBlackoilMultiSegment |
| a simulator for the blackoil model More...
|
|
class | SimulatorFullyImplicitBlackoilPolymer |
| Class collecting all necessary components for a blackoil simulation with polymer injection. More...
|
|
class | SimulatorFullyImplicitBlackoilSolvent |
| Class collecting all necessary components for a blackoil simulation with polymer injection. More...
|
|
class | SimulatorIncompTwophase |
| Class collecting all necessary components for a two-phase simulation. More...
|
|
class | SimulatorIncompTwophaseAd |
| Class collecting all necessary components for a two-phase simulation. More...
|
|
class | SimulatorPolymer |
| Class collecting all necessary components for a two-phase simulation. More...
|
|
class | SimulatorSequentialBlackoil |
| a simulator for the blackoil model More...
|
|
class | SimulatorTimer |
|
class | SimulatorTimerInterface |
| Interface class for SimulatorTimer objects, to be improved. More...
|
|
struct | SimulatorTraits |
|
struct | SimulatorTraits< SimulatorFullyImplicitBlackoil< GridT > > |
|
struct | SimulatorTraits< SimulatorFullyImplicitBlackoilMultiSegment< GridT > > |
|
struct | SimulatorTraits< SimulatorFullyImplicitBlackoilPolymer< GridT > > |
|
struct | SimulatorTraits< SimulatorFullyImplicitBlackoilSolvent< GridT > > |
|
struct | SimulatorTraits< SimulatorSequentialBlackoil< GridT, WellModelT, PressureModel, TransportModel > > |
|
class | SinglePointUpwindTwoPhasePolymer |
|
class | SolventPropsAdFromDeck |
|
class | Span |
|
class | StandardWell |
|
class | StandardWells |
| Class for handling the standard well model. More...
|
|
class | StandardWellsSolvent |
| Class for handling the standard well model for solvent model. More...
|
|
struct | Tag |
|
class | ThreadHandle |
|
class | TimeStepControlInterface |
| TimeStepControlInterface. More...
|
|
class | TransportSolverTwophaseAd |
| Implements an implicit transport solver for incompressible two-phase flow, using automatic differentiation. More...
|
|
class | TransportSolverTwophaseCompressiblePolymer |
| Implements a reordering transport solver for incompressible two-phase flow with polymer in the water phase. More...
|
|
class | TransportSolverTwophasePolymer |
| Implements a reordering transport solver for incompressible two-phase flow with polymer in the water phase. More...
|
|
class | UpwindSelector |
| Upwind selection in absence of counter-current flow (i.e., without effects of gravity and/or capillary pressure). More...
|
|
class | VFPInjProperties |
|
class | VFPProdProperties |
| Class which linearly interpolates BHP as a function of rate, tubing head pressure, water fraction, gas fraction, and artificial lift for production VFP tables, and similarly the BHP as a function of the rate and tubing head pressure. More...
|
|
class | VFPProperties |
| A thin wrapper class that holds one VFPProdProperties and one VFPInjProperties object. More...
|
|
class | WellDensitySegmented |
| A class giving a well model, by which we mean a way to compute the pressure deltas of each perforation and the bottom-hole pressure. More...
|
|
class | WellInterface |
|
class | WellMultiSegment |
|
class | WellStateFullyImplicitBlackoil |
| The state of a set of wells, tailored for use by the fully implicit blackoil simulator. More...
|
|
class | WellStateFullyImplicitBlackoilPolymer |
|
class | WellStateFullyImplicitBlackoilSolvent |
|
class | WellStateMultiSegment |
| The state of a set of multi-sgemnet wells. More...
|
|
|
template<class Ostream , typename Scalar > |
Ostream & | operator<< (Ostream &os, const AutoDiff< Scalar > &fw) |
|
template<typename Scalar > |
AutoDiff< Scalar > | operator+ (const AutoDiff< Scalar > &lhs, const AutoDiff< Scalar > &rhs) |
|
template<typename Scalar , typename T > |
AutoDiff< Scalar > | operator+ (const T lhs, const AutoDiff< Scalar > &rhs) |
|
template<typename Scalar , typename T > |
AutoDiff< Scalar > | operator+ (const AutoDiff< Scalar > &lhs, const T rhs) |
|
template<typename Scalar > |
AutoDiff< Scalar > | operator- (const AutoDiff< Scalar > &lhs, const AutoDiff< Scalar > &rhs) |
|
template<typename Scalar , typename T > |
AutoDiff< Scalar > | operator- (const T lhs, const AutoDiff< Scalar > &rhs) |
|
template<typename Scalar , typename T > |
AutoDiff< Scalar > | operator- (const AutoDiff< Scalar > &lhs, const T rhs) |
|
template<typename Scalar > |
AutoDiff< Scalar > | operator* (const AutoDiff< Scalar > &lhs, const AutoDiff< Scalar > &rhs) |
|
template<typename Scalar , typename T > |
AutoDiff< Scalar > | operator* (const T lhs, const AutoDiff< Scalar > &rhs) |
|
template<typename Scalar , typename T > |
AutoDiff< Scalar > | operator* (const AutoDiff< Scalar > &lhs, const T rhs) |
|
template<typename Scalar > |
AutoDiff< Scalar > | operator/ (const AutoDiff< Scalar > &lhs, const AutoDiff< Scalar > &rhs) |
|
template<typename Scalar , typename T > |
AutoDiff< Scalar > | operator/ (const T lhs, const AutoDiff< Scalar > &rhs) |
|
template<typename Scalar , typename T > |
AutoDiff< Scalar > | operator/ (const AutoDiff< Scalar > &lhs, const T rhs) |
|
template<typename Scalar > |
AutoDiff< Scalar > | cos (const AutoDiff< Scalar > &x) |
|
template<typename Scalar > |
AutoDiff< Scalar > | sqrt (const AutoDiff< Scalar > &x) |
|
template<class Ostream , typename Scalar > |
Ostream & | operator<< (Ostream &os, const AutoDiffBlock< Scalar > &fw) |
| Stream output.
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator* (const typename AutoDiffBlock< Scalar >::M &lhs, const AutoDiffBlock< Scalar > &rhs) |
| Multiply with AutoDiffMatrix from the left.
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator* (const Eigen::SparseMatrix< Scalar > &lhs, const AutoDiffBlock< Scalar > &rhs) |
| Multiply with Eigen sparse matrix from the left.
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator* (const typename AutoDiffBlock< Scalar >::V &lhs, const AutoDiffBlock< Scalar > &rhs) |
| Elementwise multiplication with constant on the left.
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator* (const AutoDiffBlock< Scalar > &lhs, const typename AutoDiffBlock< Scalar >::V &rhs) |
| Elementwise multiplication with constant on the right.
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator+ (const typename AutoDiffBlock< Scalar >::V &lhs, const AutoDiffBlock< Scalar > &rhs) |
| Elementwise addition with constant on the left.
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator+ (const AutoDiffBlock< Scalar > &lhs, const typename AutoDiffBlock< Scalar >::V &rhs) |
| Elementwise addition with constant on the right.
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator- (const typename AutoDiffBlock< Scalar >::V &lhs, const AutoDiffBlock< Scalar > &rhs) |
| Elementwise subtraction with constant on the left.
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator- (const AutoDiffBlock< Scalar > &lhs, const typename AutoDiffBlock< Scalar >::V &rhs) |
| Elementwise subtraction with constant on the right.
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator/ (const typename AutoDiffBlock< Scalar >::V &lhs, const AutoDiffBlock< Scalar > &rhs) |
| Elementwise division with constant on the left.
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator/ (const AutoDiffBlock< Scalar > &lhs, const typename AutoDiffBlock< Scalar >::V &rhs) |
| Elementwise division with constant on the right.
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator* (const AutoDiffBlock< Scalar > &lhs, const Scalar &rhs) |
| Operator for multiplication with a scalar on the right-hand side. More...
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | operator* (const Scalar &lhs, const AutoDiffBlock< Scalar > &rhs) |
| Operator for multiplication with a scalar on the left-hand side. More...
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | pow (const AutoDiffBlock< Scalar > &base, const double exponent) |
| Computes the value of base raised to the power of exponent. More...
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | pow (const AutoDiffBlock< Scalar > &base, const typename AutoDiffBlock< Scalar >::V &exponent) |
| Computes the value of base raised to the power of exponent. More...
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | pow (const typename AutoDiffBlock< Scalar >::V &base, const AutoDiffBlock< Scalar > &exponent) |
| Computes the value of base raised to the power of exponent. More...
|
|
template<typename Scalar > |
AutoDiffBlock< Scalar > | pow (const AutoDiffBlock< Scalar > &base, const AutoDiffBlock< Scalar > &exponent) |
| Computes the value of base raised to the power of exponent. More...
|
|
template<typename Scalar , class IntVec > |
Eigen::Array< Scalar, Eigen::Dynamic, 1 > | subset (const Eigen::Array< Scalar, Eigen::Dynamic, 1 > &x, const IntVec &indices) |
| Returns x(indices).
|
|
template<typename Scalar , class IntVec > |
AutoDiffBlock< Scalar > | subset (const AutoDiffBlock< Scalar > &x, const IntVec &indices) |
| Returns x(indices).
|
|
template<typename Scalar , class IntVec > |
AutoDiffBlock< Scalar > | superset (const AutoDiffBlock< Scalar > &x, const IntVec &indices, const int n) |
| Returns v where v(indices) == x, v(!indices) == 0 and v.size() == n.
|
|
template<typename Scalar , class IntVec > |
Eigen::Array< Scalar, Eigen::Dynamic, 1 > | superset (const Eigen::Array< Scalar, Eigen::Dynamic, 1 > &x, const IntVec &indices, const int n) |
| Returns v where v(indices) == x, v(!indices) == 0 and v.size() == n.
|
|
Eigen::SparseMatrix< double > | spdiag (const AutoDiffBlock< double >::V &d) |
| Construct square sparse matrix with the elements of d on the diagonal. More...
|
|
template<class Matrix > |
void | collapseJacs (const AutoDiffBlock< double > &x, Matrix &jacobian) |
| Returns the input expression, but with all Jacobians collapsed to one.
|
|
AutoDiffBlock< double > | collapseJacs (const AutoDiffBlock< double > &x) |
| Returns the input expression, but with all Jacobians collapsed to one.
|
|
AutoDiffBlock< double > | vertcat (const AutoDiffBlock< double > &x, const AutoDiffBlock< double > &y) |
| Returns the vertical concatenation [ x; y ] of the inputs.
|
|
AutoDiffBlock< double > | vertcatCollapseJacs (const std::vector< AutoDiffBlock< double > > &x) |
| Returns the vertical concatenation [ x[0]; x[1]; ...; x[n-1] ] of the inputs. More...
|
|
Eigen::ArrayXd | sign (const Eigen::ArrayXd &x) |
| Return a vector of (-1.0, 0.0 or 1.0), depending on sign per element.
|
|
void | fastSparseProduct (const AutoDiffMatrix &lhs, const AutoDiffMatrix &rhs, AutoDiffMatrix &res) |
| Utility function to lessen code changes required elsewhere.
|
|
void | fastSparseProduct (const Eigen::SparseMatrix< double > &lhs, const AutoDiffMatrix &rhs, AutoDiffMatrix &res) |
| Utility function to lessen code changes required elsewhere.
|
|
AutoDiffMatrix | operator* (const Eigen::SparseMatrix< double > &lhs, const AutoDiffMatrix &rhs) |
| Multiplies an Eigen sparse matrix with an AutoDiffMatrix.
|
|
std::ostream & | operator<< (std::ostream &out, const SimulationDataContainer &state) |
|
std::istream & | operator>> (std::istream &in, SimulationDataContainer &state) |
|
std::ostream & | operator<< (std::ostream &out, const WellState &state) |
|
std::istream & | operator>> (std::istream &in, WellState &state) |
|
std::ostream & | operator<< (std::ostream &out, const WellStateFullyImplicitBlackoil &state) |
|
std::istream & | operator>> (std::istream &in, WellStateFullyImplicitBlackoil &state) |
|
std::vector< double > | destripe (const std::vector< double > &v, size_t stride, size_t offset) |
| Extract single data vector from striped data. More...
|
|
std::vector< double > & | stripe (const std::vector< double > &v, size_t stride, size_t offset, std::vector< double > &dst) |
| Inject single data vector into striped data. More...
|
|
data::Solution | simToSolution (const SimulationDataContainer &reservoir, const bool use_si_units, PhaseUsage phases) |
| Returns Solution with the following fields: PRESSURE, TEMP (unconditionally) SWAT, SGAS, RS, RV, SSOL (if appropriate fields present in input) If use_si_units is true, the fields will have the measure UnitSystem::measure::identity, and therefore not be converted to customary units (depending on family) upon output. More...
|
|
void | solutionToSim (const data::Solution &sol, const std::map< std::string, std::vector< double > > &extra, PhaseUsage phases, SimulationDataContainer &state) |
| Copies the following fields from sol into state (all conditionally): PRESSURE, TEMP, SWAT, SGAS, RS, RV, SSOL Also handles extra data such as hysteresis parameters, SOMAX, etc. More...
|
|
void | wellsToState (const data::Wells &wells, PhaseUsage phases, WellStateFullyImplicitBlackoil &state) |
| Copies the following fields from wells into state. More...
|
|
template<class Grid > |
void | createGlobalCellArray (const Grid &grid, std::vector< int > &dest) |
| Create a mapping from a global cell index of a grid to the logically Cartesian index of the ECL deck.
|
|
template<typename Lhs , typename Rhs , typename ResultType > |
void | fastSparseProduct (const Lhs &lhs, const Rhs &rhs, ResultType &res) |
|
void | fastDiagSparseProduct (const std::vector< double > &lhs, const Eigen::SparseMatrix< double > &rhs, Eigen::SparseMatrix< double > &res) |
|
void | fastSparseDiagProduct (const Eigen::SparseMatrix< double > &lhs, const std::vector< double > &rhs, Eigen::SparseMatrix< double > &res) |
|
template<typename Lhs , typename Rhs > |
bool | equalSparsityPattern (const Lhs &lhs, const Rhs &rhs) |
|
template<typename Lhs , typename Rhs > |
void | fastSparseAdd (Lhs &lhs, const Rhs &rhs) |
|
template<typename Lhs , typename Rhs > |
void | fastSparseSubstract (Lhs &lhs, const Rhs &rhs) |
|
std::string | moduleVersionName () |
| Return the version name of the module, for example "2015.10" (for a release branch) or "2016.04-pre" (for a master branch). More...
|
|
std::string | moduleVersionHash () |
| Return a (short) git hash for the current version of the module if this is a Release build (as defined by CMake), or "debug" for Debug builds. More...
|
|
std::string | moduleVersion () |
| Return a string containing both the name and hash, if N is the name and H is the hash it will be "N (H)". More...
|
|
std::array< double, 3 > | connectionMultiPhaseUpwind (const std::array< double, 3 > &head_diff, const std::array< double, 3 > &mob1, const std::array< double, 3 > &mob2, const double transmissibility, const double flux) |
| Compute upwind directions for three-phase flow across a connection. More...
|
|
std::vector< ADB > | eliminateVariable (const std::vector< ADB > &eqs, const int n) |
| Eliminate a variable via Schur complement. More...
|
|
V | recoverVariable (const ADB &equation, const V &partial_solution, const int n) |
|
void | formEllipticSystem (const int num_phases, const std::vector< ADB > &eqs_in, Eigen::SparseMatrix< double, Eigen::RowMajor > &A, V &b) |
| Form an elliptic system of equations. More...
|
|
bool | isIORank (const boost::any ¶llel_info) |
| Return true if this is a serial run, or rank zero on an MPI run.
|
|
std::vector< AutoDiffBlock< double > > | eliminateVariable (const std::vector< AutoDiffBlock< double > > &eqs, const int n) |
| Eliminate a variable via Schur complement. More...
|
|
AutoDiffBlock< double >::V | recoverVariable (const AutoDiffBlock< double > &equation, const AutoDiffBlock< double >::V &partial_solution, const int n) |
| Recover that value of a variable previously eliminated. More...
|
|
void | formEllipticSystem (const int num_phases, const std::vector< AutoDiffBlock< double > > &eqs, Eigen::SparseMatrix< double, Eigen::RowMajor > &A, AutoDiffBlock< double >::V &b) |
| Form an elliptic system of equations. More...
|
|
template<class Grid > |
std::unordered_set< std::string > | distributeGridAndData (Grid &, const Opm::Deck &, const EclipseState &, BlackoilState &, BlackoilPropsAdFromDeck &, DerivedGeology &, std::shared_ptr< BlackoilPropsAdFromDeck::MaterialLawManager > &, std::vector< double > &, boost::any &, const bool) |
|
void | outputStateVtk (const UnstructuredGrid &grid, const SimulationDataContainer &state, const int step, const std::string &output_dir) |
|
void | outputWellStateMatlab (const Opm::WellState &well_state, const int step, const std::string &output_dir) |
|
void | outputStateVtk (const UnstructuredGrid &grid, const Opm::SimulationDataContainer &state, const int step, const std::string &output_dir) |
|
template<class Grid > |
void | outputStateMatlab (const Grid &grid, const Opm::SimulationDataContainer &state, const int step, const std::string &output_dir) |
|
void | computeTotalMobility (const Opm::IncompPropertiesInterface &props, const Opm::PolymerProperties &polyprops, const std::vector< int > &cells, const std::vector< double > &s, const std::vector< double > &c, const std::vector< double > &cmax, std::vector< double > &totmob) |
| Computes total mobility for a set of s/c values. More...
|
|
void | computeTotalMobilityOmega (const Opm::IncompPropertiesInterface &props, const Opm::PolymerProperties &polyprops, const std::vector< int > &cells, const std::vector< double > &s, const std::vector< double > &c, const std::vector< double > &cmax, std::vector< double > &totmob, std::vector< double > &omega) |
| Computes total mobility and omega for a set of s/c values. More...
|
|
void | computeFractionalFlow (const Opm::IncompPropertiesInterface &props, const Opm::PolymerProperties &polyprops, const std::vector< int > &cells, const std::vector< double > &s, const std::vector< double > &c, const std::vector< double > &cmax, std::vector< double > &fractional_flows) |
| Computes the fractional flow for each cell in the cells argument. More...
|
|
void | computeFractionalFlow (const Opm::BlackoilPropertiesInterface &props, const Opm::PolymerProperties &polyprops, const std::vector< int > &cells, const std::vector< double > &p, const std::vector< double > &T, const std::vector< double > &z, const std::vector< double > &s, const std::vector< double > &c, const std::vector< double > &cmax, std::vector< double > &fractional_flows) |
| Computes the fractional flow for each cell in the cells argument. More...
|
|
void | computeInjectedProduced (const IncompPropertiesInterface &props, const Opm::PolymerProperties &polyprops, const PolymerState &state, const std::vector< double > &transport_src, const std::vector< double > &inj_c, const double dt, double *injected, double *produced, double &polyinj, double &polyprod) |
| Computes injected and produced volumes of all phases, and injected and produced polymer mass. More...
|
|
void | computeInjectedProduced (const BlackoilPropertiesInterface &props, const Opm::PolymerProperties &polyprops, const PolymerBlackoilState &state, const std::vector< double > &transport_src, const std::vector< double > &inj_c, const double dt, double *injected, double *produced, double &polyinj, double &polyprod) |
| Computes injected and produced volumes of all phases, and injected and produced polymer mass - in the compressible case. More...
|
|
double | computePolymerMass (const std::vector< double > &pv, const std::vector< double > &s, const std::vector< double > &c, const double dps) |
| Computes total polymer mass over all grid cells. More...
|
|
double | computePolymerAdsorbed (const IncompPropertiesInterface &props, const Opm::PolymerProperties &polyprops, const std::vector< double > &pv, const std::vector< double > &cmax) |
| Computes total absorbed polymer mass over all grid cells. More...
|
|
double | computePolymerAdsorbed (const UnstructuredGrid &grid, const BlackoilPropertiesInterface &props, const Opm::PolymerProperties &polyprops, const PolymerBlackoilState &state, const RockCompressibility *rock_comp) |
| Computes total absorbed polymer mass over all grid cells. More...
|
|
void | ensureDirectoryExists (const boost::filesystem::path &dirpath) |
| The directory pointed to by 'dirpath' will be created if it does not already exist. More...
|
|
void | flowEbosBlackoilSetDeck (Deck &deck, EclipseState &eclState) |
|
int | flowEbosBlackoilMain (int argc, char **argv) |
|
void | flowEbosGasOilSetDeck (Deck &deck, EclipseState &eclState) |
|
int | flowEbosGasOilMain (int argc, char **argv) |
|
void | flowEbosOilWaterSetDeck (Deck &deck, EclipseState &eclState) |
|
int | flowEbosOilWaterMain (int argc, char **argv) |
|
void | flowEbosPolymerSetDeck (Deck &deck, EclipseState &eclState) |
|
int | flowEbosPolymerMain (int argc, char **argv) |
|
void | flowEbosSolventSetDeck (Deck &deck, EclipseState &eclState) |
|
int | flowEbosSolventMain (int argc, char **argv) |
|
template<class Grid > |
void | computeMaxDp (std::map< std::pair< int, int >, double > &maxDp, const Deck &deck, const EclipseState &eclipseState, const Grid &grid, const BlackoilState &initialState, const BlackoilPropertiesFromDeck &props, const double gravity) |
| Compute the maximum gravity corrected pressure difference of all equilibration regions given a reservoir state. More...
|
|
template<class Grid > |
std::vector< double > | thresholdPressures (const Deck &, const EclipseState &eclipseState, const Grid &grid, const std::map< std::pair< int, int >, double > &maxDp) |
| Get a vector of pressure thresholds from EclipseState. More...
|
|
std::vector< double > | thresholdPressuresNNC (const EclipseState &eclipseState, const NNC &nnc, const std::map< std::pair< int, int >, double > &maxDp) |
| Get a vector of pressure thresholds from either EclipseState or maxDp (for defaulted values) for all Non-neighbour connections (NNCs). More...
|
|
void | writeVtkData (const std::array< int, 3 > &dims, const std::array< double, 3 > &cell_size, const std::map< std::string, const std::vector< double > *> &data, std::ostream &os) |
| Vtk output for cartesian grids.
|
|
void | writeVtkData (const UnstructuredGrid &, const std::map< std::string, const std::vector< double > *> &data, std::ostream &os) |
| Vtk output for general grids.
|
|