Rename Extended to Solvent

- classes and files are renamed to use solvent instead of extended in
their names.
This commit is contained in:
Tor Harald Sandve
2015-08-14 11:24:43 +02:00
parent 7c3f184d43
commit 3b99338bd0
7 changed files with 70 additions and 69 deletions

View File

@@ -108,8 +108,9 @@ list (APPEND PUBLIC_HEADER_FILES
opm/autodiff/SolventPropsAdFromDeck.hpp opm/autodiff/SolventPropsAdFromDeck.hpp
opm/autodiff/BlackoilPropsAdInterface.hpp opm/autodiff/BlackoilPropsAdInterface.hpp
opm/autodiff/CPRPreconditioner.hpp opm/autodiff/CPRPreconditioner.hpp
opm/autodiff/ExtendedBlackoilModel.hpp opm/autodiff/BlackoilModelSolvent.hpp
opm/autodiff/ExtendedBlackoilModel_impl.hpp opm/autodiff/BlackoilModelSolvent_impl.hpp
opm/autodiff/BlackoilModelState.hpp
opm/autodiff/fastSparseProduct.hpp opm/autodiff/fastSparseProduct.hpp
opm/autodiff/DuneMatrix.hpp opm/autodiff/DuneMatrix.hpp
opm/autodiff/ExtractParallelGridInformationToISTL.hpp opm/autodiff/ExtractParallelGridInformationToISTL.hpp
@@ -129,8 +130,8 @@ list (APPEND PUBLIC_HEADER_FILES
opm/autodiff/SimulatorBase.hpp opm/autodiff/SimulatorBase.hpp
opm/autodiff/SimulatorBase_impl.hpp opm/autodiff/SimulatorBase_impl.hpp
opm/autodiff/SimulatorFullyImplicitBlackoil.hpp opm/autodiff/SimulatorFullyImplicitBlackoil.hpp
opm/autodiff/SimulatorFullyImplicitExtendedBlackoil.hpp opm/autodiff/SimulatorFullyImplicitBlackoilSolvent.hpp
opm/autodiff/SimulatorFullyImplicitExtendedBlackoil_impl.hpp opm/autodiff/SimulatorFullyImplicitBlackoilSolvent_impl.hpp
opm/autodiff/SimulatorIncompTwophaseAd.hpp opm/autodiff/SimulatorIncompTwophaseAd.hpp
opm/autodiff/TransportSolverTwophaseAd.hpp opm/autodiff/TransportSolverTwophaseAd.hpp
opm/autodiff/WellDensitySegmented.hpp opm/autodiff/WellDensitySegmented.hpp

View File

@@ -75,7 +75,7 @@
#include <opm/core/simulator/BlackoilState.hpp> #include <opm/core/simulator/BlackoilState.hpp>
#include <opm/autodiff/WellStateFullyImplicitBlackoil.hpp> #include <opm/autodiff/WellStateFullyImplicitBlackoil.hpp>
#include <opm/autodiff/SimulatorFullyImplicitExtendedBlackoil.hpp> #include <opm/autodiff/SimulatorFullyImplicitBlackoilSolvent.hpp>
#include <opm/autodiff/BlackoilPropsAdFromDeck.hpp> #include <opm/autodiff/BlackoilPropsAdFromDeck.hpp>
#include <opm/autodiff/SolventPropsAdFromDeck.hpp> #include <opm/autodiff/SolventPropsAdFromDeck.hpp>
#include <opm/autodiff/RedistributeDataHandles.hpp> #include <opm/autodiff/RedistributeDataHandles.hpp>
@@ -273,7 +273,7 @@ try
// Gravity. // Gravity.
gravity[2] = deck->hasKeyword("NOGRAV") ? 0.0 : unit::gravity; gravity[2] = deck->hasKeyword("NOGRAV") ? 0.0 : unit::gravity;
ExtendedBlackoilState state; BlackoilSolventState state;
// Init state variables (saturation and pressure). // Init state variables (saturation and pressure).
if (param.has("init_saturation")) { if (param.has("init_saturation")) {
initStateBasic(Opm::UgGridHelpers::numCells(grid), initStateBasic(Opm::UgGridHelpers::numCells(grid),
@@ -381,7 +381,7 @@ try
std::vector<double> threshold_pressures = thresholdPressures(eclipseState, grid); std::vector<double> threshold_pressures = thresholdPressures(eclipseState, grid);
SimulatorFullyImplicitExtendedBlackoil< Grid > simulator(param, SimulatorFullyImplicitBlackoilSolvent< Grid > simulator(param,
grid, grid,
geoprops, geoprops,
new_props, new_props,

View File

@@ -17,12 +17,12 @@
along with OPM. If not, see <http://www.gnu.org/licenses/>. along with OPM. If not, see <http://www.gnu.org/licenses/>.
*/ */
#ifndef OPM_EXTENDEDBLACKOILMODEL_HEADER_INCLUDED #ifndef OPM_BLACKOILSOLVENTMODEL_HEADER_INCLUDED
#define OPM_EXTENDEDBLACKOILMODEL_HEADER_INCLUDED #define OPM_BLACKOILSOLVENTMODEL_HEADER_INCLUDED
#include <opm/autodiff/BlackoilModelBase.hpp> #include <opm/autodiff/BlackoilModelBase.hpp>
#include <opm/autodiff/BlackoilModelParameters.hpp> #include <opm/autodiff/BlackoilModelParameters.hpp>
#include <opm/autodiff/ExtendedBlackoilState.hpp> #include <opm/autodiff/BlackoilSolventState.hpp>
#include <opm/autodiff/WellStateFullyImplicitBlackoilSolvent.hpp> #include <opm/autodiff/WellStateFullyImplicitBlackoilSolvent.hpp>
#include <opm/autodiff/SolventPropsAdFromDeck.hpp> #include <opm/autodiff/SolventPropsAdFromDeck.hpp>
@@ -35,18 +35,18 @@ namespace Opm {
/// It uses automatic differentiation via the class AutoDiffBlock /// It uses automatic differentiation via the class AutoDiffBlock
/// to simplify assembly of the jacobian matrix. /// to simplify assembly of the jacobian matrix.
template<class Grid> template<class Grid>
class ExtendedBlackoilModel : public BlackoilModelBase<Grid, ExtendedBlackoilModel<Grid> > class BlackoilSolventModel : public BlackoilModelBase<Grid, BlackoilSolventModel<Grid> >
{ {
public: public:
// --------- Types and enums --------- // --------- Types and enums ---------
typedef BlackoilModelBase<Grid, ExtendedBlackoilModel<Grid> > Base; typedef BlackoilModelBase<Grid, BlackoilSolventModel<Grid> > Base;
typedef typename Base::ReservoirState ReservoirState; typedef typename Base::ReservoirState ReservoirState;
typedef typename Base::WellState WellState; typedef typename Base::WellState WellState;
// The next line requires C++11 support available in g++ 4.7. // The next line requires C++11 support available in g++ 4.7.
// friend Base; // friend Base;
friend class BlackoilModelBase<Grid, ExtendedBlackoilModel<Grid> >; friend class BlackoilModelBase<Grid, BlackoilSolventModel<Grid> >;
/// Construct the model. It will retain references to the /// Construct the model. It will retain references to the
/// arguments of this functions, and they are expected to /// arguments of this functions, and they are expected to
@@ -63,7 +63,7 @@ namespace Opm {
/// \param[in] has_vapoil turn on vaporized oil feature /// \param[in] has_vapoil turn on vaporized oil feature
/// \param[in] terminal_output request output to cout/cerr /// \param[in] terminal_output request output to cout/cerr
/// \param[in] has_solvent turn on solvent feature /// \param[in] has_solvent turn on solvent feature
ExtendedBlackoilModel(const typename Base::ModelParameters& param, BlackoilSolventModel(const typename Base::ModelParameters& param,
const Grid& grid, const Grid& grid,
const BlackoilPropsAdInterface& fluid, const BlackoilPropsAdInterface& fluid,
const DerivedGeology& geo, const DerivedGeology& geo,
@@ -257,9 +257,9 @@ namespace Opm {
/// Need to include concentration in our state variables, otherwise all is as /// Need to include concentration in our state variables, otherwise all is as
/// the default blackoil model. /// the default blackoil model.
struct ExtendedBlackoilSolutionState : public DefaultBlackoilSolutionState struct BlackoilSolventSolutionState : public DefaultBlackoilSolutionState
{ {
explicit ExtendedBlackoilSolutionState(const int np) explicit BlackoilSolventSolutionState(const int np)
: DefaultBlackoilSolutionState(np), : DefaultBlackoilSolutionState(np),
solvent_saturation( ADB::null()) solvent_saturation( ADB::null())
{ {
@@ -269,18 +269,18 @@ namespace Opm {
/// Providing types by template specialisation of ModelTraits for BlackoilPolymerModel. /// Providing types by template specialisation of ModelTraits for BlackoilSolventModel.
template <class Grid> template <class Grid>
struct ModelTraits< ExtendedBlackoilModel<Grid> > struct ModelTraits< BlackoilSolventModel<Grid> >
{ {
typedef ExtendedBlackoilState ReservoirState; typedef BlackoilSolventState ReservoirState;
typedef WellStateFullyImplicitBlackoilSolvent WellState; typedef WellStateFullyImplicitBlackoilSolvent WellState;
typedef BlackoilModelParameters ModelParameters; typedef BlackoilModelParameters ModelParameters;
typedef ExtendedBlackoilSolutionState SolutionState; typedef BlackoilSolventSolutionState SolutionState;
}; };
} // namespace Opm } // namespace Opm
#include "ExtendedBlackoilModel_impl.hpp" #include "BlackoilSolventModel_impl.hpp"
#endif // OPM_EXTENDEDBLACKOILMODEL_HEADER_INCLUDED #endif // OPM_BLACKOILSOLVENTMODEL_HEADER_INCLUDED

View File

@@ -17,10 +17,10 @@
along with OPM. If not, see <http://www.gnu.org/licenses/>. along with OPM. If not, see <http://www.gnu.org/licenses/>.
*/ */
#ifndef OPM_EXTENDEDBLACKOILMODEL_IMPL_HEADER_INCLUDED #ifndef OPM_BLACKOILSOLVENTMODEL_IMPL_HEADER_INCLUDED
#define OPM_EXTENDEDBLACKOILMODEL_IMPL_HEADER_INCLUDED #define OPM_BLACKOILSOLVENTMODEL_IMPL_HEADER_INCLUDED
#include <opm/autodiff/ExtendedBlackoilModel.hpp> #include <opm/autodiff/BlackoilSolventModel.hpp>
#include <opm/autodiff/AutoDiffBlock.hpp> #include <opm/autodiff/AutoDiffBlock.hpp>
#include <opm/autodiff/AutoDiffHelpers.hpp> #include <opm/autodiff/AutoDiffHelpers.hpp>
@@ -70,7 +70,7 @@ namespace Opm {
template <class Grid> template <class Grid>
ExtendedBlackoilModel<Grid>::ExtendedBlackoilModel(const typename Base::ModelParameters& param, BlackoilSolventModel<Grid>::BlackoilSolventModel(const typename Base::ModelParameters& param,
const Grid& grid, const Grid& grid,
const BlackoilPropsAdInterface& fluid, const BlackoilPropsAdInterface& fluid,
const DerivedGeology& geo, const DerivedGeology& geo,
@@ -105,7 +105,7 @@ namespace Opm {
template <class Grid> template <class Grid>
void void
ExtendedBlackoilModel<Grid>:: BlackoilSolventModel<Grid>::
prepareStep(const double dt, prepareStep(const double dt,
ReservoirState& reservoir_state, ReservoirState& reservoir_state,
WellState& well_state) WellState& well_state)
@@ -118,7 +118,7 @@ namespace Opm {
template <class Grid> template <class Grid>
void void
ExtendedBlackoilModel<Grid>:: BlackoilSolventModel<Grid>::
afterStep(const double /* dt */, afterStep(const double /* dt */,
ReservoirState& /* reservoir_state */, ReservoirState& /* reservoir_state */,
WellState& /* well_state */) WellState& /* well_state */)
@@ -133,7 +133,7 @@ namespace Opm {
template <class Grid> template <class Grid>
void void
ExtendedBlackoilModel<Grid>::makeConstantState(SolutionState& state) const BlackoilSolventModel<Grid>::makeConstantState(SolutionState& state) const
{ {
Base::makeConstantState(state); Base::makeConstantState(state);
state.solvent_saturation = ADB::constant(state.solvent_saturation.value()); state.solvent_saturation = ADB::constant(state.solvent_saturation.value());
@@ -145,7 +145,7 @@ namespace Opm {
template <class Grid> template <class Grid>
std::vector<V> std::vector<V>
ExtendedBlackoilModel<Grid>::variableStateInitials(const ReservoirState& x, BlackoilSolventModel<Grid>::variableStateInitials(const ReservoirState& x,
const WellState& xw) const const WellState& xw) const
{ {
std::vector<V> vars0 = Base::variableStateInitials(x, xw); std::vector<V> vars0 = Base::variableStateInitials(x, xw);
@@ -170,7 +170,7 @@ namespace Opm {
template <class Grid> template <class Grid>
std::vector<int> std::vector<int>
ExtendedBlackoilModel<Grid>::variableStateIndices() const BlackoilSolventModel<Grid>::variableStateIndices() const
{ {
std::vector<int> ind = Base::variableStateIndices(); std::vector<int> ind = Base::variableStateIndices();
assert(ind.size() == 5); assert(ind.size() == 5);
@@ -189,8 +189,8 @@ namespace Opm {
template <class Grid> template <class Grid>
typename ExtendedBlackoilModel<Grid>::SolutionState typename BlackoilSolventModel<Grid>::SolutionState
ExtendedBlackoilModel<Grid>::variableStateExtractVars(const ReservoirState& x, BlackoilSolventModel<Grid>::variableStateExtractVars(const ReservoirState& x,
const std::vector<int>& indices, const std::vector<int>& indices,
std::vector<ADB>& vars) const std::vector<ADB>& vars) const
{ {
@@ -212,7 +212,7 @@ namespace Opm {
template <class Grid> template <class Grid>
void void
ExtendedBlackoilModel<Grid>::computeAccum(const SolutionState& state, BlackoilSolventModel<Grid>::computeAccum(const SolutionState& state,
const int aix ) const int aix )
{ {
Base::computeAccum(state, aix); Base::computeAccum(state, aix);
@@ -236,7 +236,7 @@ namespace Opm {
template <class Grid> template <class Grid>
void void
ExtendedBlackoilModel<Grid>:: BlackoilSolventModel<Grid>::
assembleMassBalanceEq(const SolutionState& state) assembleMassBalanceEq(const SolutionState& state)
{ {
@@ -255,7 +255,7 @@ namespace Opm {
template <class Grid> template <class Grid>
void ExtendedBlackoilModel<Grid>::addWellContributionToMassBalanceEq(std::vector<ADB>& cq_s, void BlackoilSolventModel<Grid>::addWellContributionToMassBalanceEq(std::vector<ADB>& cq_s,
const SolutionState& state, const SolutionState& state,
WellState& xw) WellState& xw)
@@ -309,7 +309,7 @@ namespace Opm {
template <class Grid> template <class Grid>
void ExtendedBlackoilModel<Grid>::updateState(const V& dx, void BlackoilSolventModel<Grid>::updateState(const V& dx,
ReservoirState& reservoir_state, ReservoirState& reservoir_state,
WellState& well_state) WellState& well_state)
{ {
@@ -355,7 +355,7 @@ namespace Opm {
template <class Grid> template <class Grid>
void void
ExtendedBlackoilModel<Grid>::computeMassFlux(const int actph , BlackoilSolventModel<Grid>::computeMassFlux(const int actph ,
const V& transi, const V& transi,
const ADB& kr , const ADB& kr ,
const ADB& phasePressure, const ADB& phasePressure,
@@ -400,7 +400,7 @@ namespace Opm {
template <class Grid> template <class Grid>
std::vector<ADB> std::vector<ADB>
ExtendedBlackoilModel<Grid>::computeRelPerm(const SolutionState& state) const BlackoilSolventModel<Grid>::computeRelPerm(const SolutionState& state) const
{ {
using namespace Opm::AutoDiffGrid; using namespace Opm::AutoDiffGrid;
const int nc = numCells(grid_); const int nc = numCells(grid_);
@@ -432,7 +432,7 @@ namespace Opm {
template <class Grid> template <class Grid>
void void
ExtendedBlackoilModel<Grid>::assemble(const ReservoirState& reservoir_state, BlackoilSolventModel<Grid>::assemble(const ReservoirState& reservoir_state,
WellState& well_state, WellState& well_state,
const bool initial_assembly) const bool initial_assembly)
{ {
@@ -500,7 +500,7 @@ namespace Opm {
template <class Grid> template <class Grid>
double double
ExtendedBlackoilModel<Grid>::convergenceReduction(const Eigen::Array<double, Eigen::Dynamic, MaxNumPhases+1>& B, BlackoilSolventModel<Grid>::convergenceReduction(const Eigen::Array<double, Eigen::Dynamic, MaxNumPhases+1>& B,
const Eigen::Array<double, Eigen::Dynamic, MaxNumPhases+1>& tempV, const Eigen::Array<double, Eigen::Dynamic, MaxNumPhases+1>& tempV,
const Eigen::Array<double, Eigen::Dynamic, MaxNumPhases+1>& R, const Eigen::Array<double, Eigen::Dynamic, MaxNumPhases+1>& R,
std::array<double,MaxNumPhases+1>& R_sum, std::array<double,MaxNumPhases+1>& R_sum,
@@ -589,7 +589,7 @@ namespace Opm {
template <class Grid> template <class Grid>
bool bool
ExtendedBlackoilModel<Grid>::getConvergence(const double dt, const int iteration) BlackoilSolventModel<Grid>::getConvergence(const double dt, const int iteration)
{ {
const double tol_mb = param_.tolerance_mb_; const double tol_mb = param_.tolerance_mb_;
const double tol_cnv = param_.tolerance_cnv_; const double tol_cnv = param_.tolerance_cnv_;
@@ -700,4 +700,4 @@ namespace Opm {
} }
#endif // OPM_EXTENDEDBLACKOIL_IMPL_HEADER_INCLUDED #endif // OPM_BLACKOILSOLVENT_IMPL_HEADER_INCLUDED

View File

@@ -17,10 +17,10 @@
along with OPM. If not, see <http://www.gnu.org/licenses/>. along with OPM. If not, see <http://www.gnu.org/licenses/>.
*/ */
#ifndef OPM_EXTENDEDBLACKOILSTATE_HEADER_INCLUDED #ifndef OPM_BLACKOILSOLVENTSTATE_HEADER_INCLUDED
#define OPM_EXTENDEDBLACKOILSTATE_HEADER_INCLUDED #define OPM_BLACKOILSOLVENTSTATE_HEADER_INCLUDED
#include <opm/autodiff/ExtendedBlackoilState.hpp> #include <opm/autodiff/BlackoilSolventState.hpp>
#include <opm/core/simulator/BlackoilState.hpp> #include <opm/core/simulator/BlackoilState.hpp>
#include <opm/core/grid.h> #include <opm/core/grid.h>
#include <vector> #include <vector>
@@ -31,7 +31,7 @@ namespace Opm
/// Simulator state for blackoil simulator with solvent. /// Simulator state for blackoil simulator with solvent.
/// We use the Blackoil state parameters. /// We use the Blackoil state parameters.
class ExtendedBlackoilState : public BlackoilState class BlackoilSolventState : public BlackoilState
{ {
public: public:
void init(const UnstructuredGrid& g, int num_phases) void init(const UnstructuredGrid& g, int num_phases)
@@ -57,4 +57,4 @@ namespace Opm
#endif // OPM_EXTENDEDBLACKOILSTATE_HEADER_INCLUDED #endif // OPM_BLACKOILSOLVENTSTATE_HEADER_INCLUDED

View File

@@ -17,13 +17,13 @@
along with OPM. If not, see <http://www.gnu.org/licenses/>. along with OPM. If not, see <http://www.gnu.org/licenses/>.
*/ */
#ifndef OPM_SIMULATORFULLYIMPLICITEXTENDEDBLACKOIL_HEADER_INCLUDED #ifndef OPM_SIMULATORFULLYIMPLICITBLACKOILSOLVENT_HEADER_INCLUDED
#define OPM_SIMULATORFULLYIMPLICITEXTENDEDBLACKOIL_HEADER_INCLUDED #define OPM_SIMULATORFULLYIMPLICITBLACKOILSOLVENT_HEADER_INCLUDED
#include <opm/autodiff/SimulatorBase.hpp> #include <opm/autodiff/SimulatorBase.hpp>
#include <opm/autodiff/SimulatorFullyImplicitBlackoilOutput.hpp> #include <opm/autodiff/SimulatorFullyImplicitBlackoilOutput.hpp>
#include <opm/autodiff/ExtendedBlackoilState.hpp> #include <opm/autodiff/BlackoilSolventState.hpp>
#include <opm/autodiff/ExtendedBlackoilModel.hpp> #include <opm/autodiff/BlackoilSolventModel.hpp>
#include <opm/core/utility/parameters/ParameterGroup.hpp> #include <opm/core/utility/parameters/ParameterGroup.hpp>
#include <opm/core/utility/ErrorMacros.hpp> #include <opm/core/utility/ErrorMacros.hpp>
@@ -78,33 +78,33 @@
namespace Opm namespace Opm
{ {
template <class GridT> template <class GridT>
class SimulatorFullyImplicitExtendedBlackoil; class SimulatorFullyImplicitBlackoilSolvent;
template<class GridT> template<class GridT>
struct SimulatorTraits<SimulatorFullyImplicitExtendedBlackoil<GridT> > struct SimulatorTraits<SimulatorFullyImplicitBlackoilSolvent<GridT> >
{ {
typedef WellStateFullyImplicitBlackoilSolvent WellState; typedef WellStateFullyImplicitBlackoilSolvent WellState;
typedef ExtendedBlackoilState ReservoirState; typedef BlackoilSolventState ReservoirState;
typedef BlackoilOutputWriter OutputWriter; typedef BlackoilOutputWriter OutputWriter;
typedef GridT Grid; typedef GridT Grid;
typedef ExtendedBlackoilModel<Grid> Model; typedef BlackoilSolventModel<Grid> Model;
typedef NewtonSolver<Model> Solver; typedef NewtonSolver<Model> Solver;
}; };
/// Class collecting all necessary components for a blackoil simulation with polymer /// Class collecting all necessary components for a blackoil simulation with polymer
/// injection. /// injection.
template <class GridT> template <class GridT>
class SimulatorFullyImplicitExtendedBlackoil class SimulatorFullyImplicitBlackoilSolvent
: public SimulatorBase<SimulatorFullyImplicitExtendedBlackoil<GridT> > : public SimulatorBase<SimulatorFullyImplicitBlackoilSolvent<GridT> >
{ {
typedef SimulatorFullyImplicitExtendedBlackoil<GridT> ThisType; typedef SimulatorFullyImplicitBlackoilSolvent<GridT> ThisType;
typedef SimulatorBase<ThisType> BaseType; typedef SimulatorBase<ThisType> BaseType;
typedef SimulatorTraits<ThisType> Traits; typedef SimulatorTraits<ThisType> Traits;
typedef typename Traits::Solver Solver; typedef typename Traits::Solver Solver;
public: public:
SimulatorFullyImplicitExtendedBlackoil(const parameter::ParameterGroup& param, SimulatorFullyImplicitBlackoilSolvent(const parameter::ParameterGroup& param,
const GridT& grid, const GridT& grid,
const DerivedGeology& geo, const DerivedGeology& geo,
BlackoilPropsAdInterface& props, BlackoilPropsAdInterface& props,
@@ -136,6 +136,6 @@ namespace Opm
} // namespace Opm } // namespace Opm
#include "SimulatorFullyImplicitExtendedBlackoil_impl.hpp" #include "SimulatorFullyImplicitBlackoilSolvent_impl.hpp"
#endif // OPM_SIMULATORFULLYIMPLICITEXTENDEDBLACKOIL_HEADER_INCLUDED #endif // OPM_SIMULATORFULLYIMPLICITBLACKOILSOLVENT_HEADER_INCLUDED

View File

@@ -17,14 +17,14 @@
along with OPM. If not, see <http://www.gnu.org/licenses/>. along with OPM. If not, see <http://www.gnu.org/licenses/>.
*/ */
#ifndef OPM_SIMULATORFULLYIMPLICITEXTENDEDBLACKOIL_IMPL_HEADER_INCLUDED #ifndef OPM_SIMULATORFULLYIMPLICITBLACKOILSOLVENT_IMPL_HEADER_INCLUDED
#define OPM_SIMULATORFULLYIMPLICITEXTENDEDBLACKOIL_IMPL_HEADER_INCLUDED #define OPM_SIMULATORFULLYIMPLICITBLACKOILSOLVENT_IMPL_HEADER_INCLUDED
namespace Opm namespace Opm
{ {
template <class GridT> template <class GridT>
SimulatorFullyImplicitExtendedBlackoil<GridT>:: SimulatorFullyImplicitBlackoilSolvent<GridT>::
SimulatorFullyImplicitExtendedBlackoil(const parameter::ParameterGroup& param, SimulatorFullyImplicitBlackoilSolvent(const parameter::ParameterGroup& param,
const GridT& grid, const GridT& grid,
const DerivedGeology& geo, const DerivedGeology& geo,
BlackoilPropsAdInterface& props, BlackoilPropsAdInterface& props,
@@ -61,7 +61,7 @@ namespace Opm
} }
template <class GridT> template <class GridT>
auto SimulatorFullyImplicitExtendedBlackoil<GridT>:: auto SimulatorFullyImplicitBlackoilSolvent<GridT>::
createSolver(const Wells* wells) createSolver(const Wells* wells)
-> std::unique_ptr<Solver> -> std::unique_ptr<Solver>
{ {
@@ -90,7 +90,7 @@ namespace Opm
} }
template <class GridT> template <class GridT>
void SimulatorFullyImplicitExtendedBlackoil<GridT>:: void SimulatorFullyImplicitBlackoilSolvent<GridT>::
handleAdditionalWellInflow(SimulatorTimer& timer, handleAdditionalWellInflow(SimulatorTimer& timer,
WellsManager& wells_manager, WellsManager& wells_manager,
typename BaseType::WellState& well_state, typename BaseType::WellState& well_state,
@@ -142,4 +142,4 @@ namespace Opm
} // namespace Opm } // namespace Opm
#endif // OPM_SIMULATORFULLYIMPLICITEXTENDEDBLACKOIL_IMPL_HEADER_INCLUDED #endif // OPM_SIMULATORFULLYIMPLICITBLACKOILSOLVENT_IMPL_HEADER_INCLUDED