mirror of
https://github.com/OPM/opm-simulators.git
synced 2025-02-25 18:55:30 -06:00
Move files out of opm/core/simulator.
This commit is contained in:
@@ -1,194 +0,0 @@
|
||||
/*
|
||||
Copyright 2012 SINTEF ICT, Applied Mathematics.
|
||||
|
||||
This file is part of the Open Porous Media project (OPM).
|
||||
|
||||
OPM is free software: you can redistribute it and/or modify
|
||||
it under the terms of the GNU General Public License as published by
|
||||
the Free Software Foundation, either version 3 of the License, or
|
||||
(at your option) any later version.
|
||||
|
||||
OPM is distributed in the hope that it will be useful,
|
||||
but WITHOUT ANY WARRANTY; without even the implied warranty of
|
||||
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
|
||||
GNU General Public License for more details.
|
||||
|
||||
You should have received a copy of the GNU General Public License
|
||||
along with OPM. If not, see <http://www.gnu.org/licenses/>.
|
||||
*/
|
||||
|
||||
#include "config.h"
|
||||
|
||||
#include <opm/core/simulator/SimulatorReport.hpp>
|
||||
|
||||
#include <iomanip>
|
||||
#include <ostream>
|
||||
#include <sstream>
|
||||
|
||||
namespace Opm
|
||||
{
|
||||
SimulatorReport::SimulatorReport(bool verbose)
|
||||
: pressure_time(0.0),
|
||||
transport_time(0.0),
|
||||
total_time(0.0),
|
||||
solver_time(0.0),
|
||||
assemble_time(0.0),
|
||||
linear_solve_setup_time(0.0),
|
||||
linear_solve_time(0.0),
|
||||
update_time(0.0),
|
||||
output_write_time(0.0),
|
||||
total_well_iterations(0),
|
||||
total_linearizations( 0 ),
|
||||
total_newton_iterations( 0 ),
|
||||
total_linear_iterations( 0 ),
|
||||
converged(false),
|
||||
verbose_(verbose)
|
||||
{
|
||||
}
|
||||
|
||||
void SimulatorReport::operator+=(const SimulatorReport& sr)
|
||||
{
|
||||
pressure_time += sr.pressure_time;
|
||||
transport_time += sr.transport_time;
|
||||
linear_solve_setup_time += sr.linear_solve_setup_time;
|
||||
linear_solve_time += sr.linear_solve_time;
|
||||
solver_time += sr.solver_time;
|
||||
assemble_time += sr.assemble_time;
|
||||
update_time += sr.update_time;
|
||||
output_write_time += sr.output_write_time;
|
||||
total_time += sr.total_time;
|
||||
total_well_iterations += sr.total_well_iterations;
|
||||
total_linearizations += sr.total_linearizations;
|
||||
total_newton_iterations += sr.total_newton_iterations;
|
||||
total_linear_iterations += sr.total_linear_iterations;
|
||||
}
|
||||
|
||||
void SimulatorReport::report(std::ostream& os)
|
||||
{
|
||||
if ( verbose_ )
|
||||
{
|
||||
os << "Total time taken: " << total_time
|
||||
<< "\n Pressure time: " << pressure_time
|
||||
<< "\n Transport time: " << transport_time
|
||||
<< "\n Overall Newton Iterations: " << total_newton_iterations
|
||||
<< "\n Overall Linear Iterations: " << total_linear_iterations
|
||||
<< std::endl;
|
||||
}
|
||||
}
|
||||
|
||||
void SimulatorReport::reportStep(std::ostringstream& ss)
|
||||
{
|
||||
if ( verbose_ )
|
||||
{
|
||||
ss << "Time step summary: ";
|
||||
if (total_well_iterations != 0) {
|
||||
ss << "well its = " << std::setw(2) << total_well_iterations << ", ";
|
||||
}
|
||||
ss << "newton its = " << std::setw(2) << total_newton_iterations << ", "
|
||||
<< "linearizations = " << std::setw(2) << total_linearizations
|
||||
<< " (" << std::fixed << std::setprecision(3) << std::setw(6) << assemble_time << " sec), "
|
||||
<< "linear its = " << std::setw(3) << total_linear_iterations
|
||||
<< " (" << std::fixed << std::setprecision(3) << std::setw(6) << linear_solve_time << " sec)";
|
||||
}
|
||||
}
|
||||
|
||||
void SimulatorReport::reportFullyImplicit(std::ostream& os, const SimulatorReport* failureReport)
|
||||
{
|
||||
if ( verbose_ )
|
||||
{
|
||||
double t = total_time;
|
||||
os << "Total time (seconds): " << t;
|
||||
os << std::endl;
|
||||
|
||||
t = solver_time + (failureReport ? failureReport->solver_time : 0.0);
|
||||
os << "Solver time (seconds): " << t;
|
||||
os << std::endl;
|
||||
|
||||
if (assemble_time > 0.0 || linear_solve_time > 0.0) {
|
||||
t = assemble_time + (failureReport ? failureReport->assemble_time : 0.0);
|
||||
os << " Assembly time (seconds): " << t;
|
||||
if (failureReport) {
|
||||
os << " (Failed: " << failureReport->assemble_time << "; "
|
||||
<< 100*failureReport->assemble_time/t << "%)";
|
||||
}
|
||||
os << std::endl;
|
||||
|
||||
t = linear_solve_time + (failureReport ? failureReport->linear_solve_time : 0.0);
|
||||
os << " Linear solve time (seconds): " << t;
|
||||
if (failureReport) {
|
||||
os << " (Failed: " << failureReport->linear_solve_time << "; "
|
||||
<< 100*failureReport->linear_solve_time/t << "%)";
|
||||
}
|
||||
os << std::endl;
|
||||
|
||||
t = linear_solve_setup_time + (failureReport ? failureReport->linear_solve_setup_time : 0.0);
|
||||
os << " Linear solve setup time (seconds): " << t;
|
||||
if (failureReport) {
|
||||
os << " (Failed: " << failureReport->linear_solve_setup_time << "; "
|
||||
<< 100*failureReport->linear_solve_setup_time/t << "%)";
|
||||
}
|
||||
os << std::endl;
|
||||
|
||||
t = update_time + (failureReport ? failureReport->update_time : 0.0);
|
||||
os << " Update time (seconds): " << t;
|
||||
if (failureReport) {
|
||||
os << " (Failed: " << failureReport->update_time << "; "
|
||||
<< 100*failureReport->update_time/t << "%)";
|
||||
}
|
||||
os << std::endl;
|
||||
|
||||
t = output_write_time + (failureReport ? failureReport->output_write_time : 0.0);
|
||||
os << " Output write time (seconds): " << t;
|
||||
os << std::endl;
|
||||
|
||||
}
|
||||
|
||||
int n = total_well_iterations + (failureReport ? failureReport->total_well_iterations : 0);
|
||||
os << "Overall Well Iterations: " << n;
|
||||
if (failureReport) {
|
||||
os << " (Failed: " << failureReport->total_well_iterations << "; "
|
||||
<< 100.0*failureReport->total_well_iterations/n << "%)";
|
||||
}
|
||||
os << std::endl;
|
||||
|
||||
n = total_linearizations + (failureReport ? failureReport->total_linearizations : 0);
|
||||
os << "Overall Linearizations: " << n;
|
||||
if (failureReport) {
|
||||
os << " (Failed: " << failureReport->total_linearizations << "; "
|
||||
<< 100.0*failureReport->total_linearizations/n << "%)";
|
||||
}
|
||||
os << std::endl;
|
||||
|
||||
n = total_newton_iterations + (failureReport ? failureReport->total_newton_iterations : 0);
|
||||
os << "Overall Newton Iterations: " << n;
|
||||
if (failureReport) {
|
||||
os << " (Failed: " << failureReport->total_newton_iterations << "; "
|
||||
<< 100.0*failureReport->total_newton_iterations/n << "%)";
|
||||
}
|
||||
os << std::endl;
|
||||
|
||||
n = total_linear_iterations + (failureReport ? failureReport->total_linear_iterations : 0);
|
||||
os << "Overall Linear Iterations: " << n;
|
||||
if (failureReport) {
|
||||
os << " (Failed: " << failureReport->total_linear_iterations << "; "
|
||||
<< 100.0*failureReport->total_linear_iterations/n << "%)";
|
||||
}
|
||||
os << std::endl;
|
||||
}
|
||||
}
|
||||
|
||||
void SimulatorReport::reportParam(std::ostream& os)
|
||||
{
|
||||
if ( verbose_ )
|
||||
{
|
||||
os << "/timing/total_time=" << total_time
|
||||
<< "\n/timing/pressure/total_time=" << pressure_time
|
||||
<< "\n/timing/transport/total_time=" << transport_time
|
||||
<< "\n/timing/newton/iterations=" << total_newton_iterations
|
||||
<< "\n/timing/linear/iterations=" << total_linear_iterations
|
||||
<< std::endl;
|
||||
}
|
||||
}
|
||||
|
||||
|
||||
} // namespace Opm
|
||||
@@ -1,67 +0,0 @@
|
||||
/*
|
||||
Copyright 2012 SINTEF ICT, Applied Mathematics.
|
||||
|
||||
This file is part of the Open Porous Media project (OPM).
|
||||
|
||||
OPM is free software: you can redistribute it and/or modify
|
||||
it under the terms of the GNU General Public License as published by
|
||||
the Free Software Foundation, either version 3 of the License, or
|
||||
(at your option) any later version.
|
||||
|
||||
OPM is distributed in the hope that it will be useful,
|
||||
but WITHOUT ANY WARRANTY; without even the implied warranty of
|
||||
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
|
||||
GNU General Public License for more details.
|
||||
|
||||
You should have received a copy of the GNU General Public License
|
||||
along with OPM. If not, see <http://www.gnu.org/licenses/>.
|
||||
*/
|
||||
|
||||
#ifndef OPM_SIMULATORREPORT_HEADER_INCLUDED
|
||||
#define OPM_SIMULATORREPORT_HEADER_INCLUDED
|
||||
|
||||
#include <iosfwd>
|
||||
|
||||
namespace Opm
|
||||
{
|
||||
|
||||
/// A struct for returning timing data from a simulator to its caller.
|
||||
struct SimulatorReport
|
||||
{
|
||||
double pressure_time;
|
||||
double transport_time;
|
||||
double total_time;
|
||||
double solver_time;
|
||||
double assemble_time;
|
||||
double linear_solve_setup_time;
|
||||
double linear_solve_time;
|
||||
double update_time;
|
||||
double output_write_time;
|
||||
|
||||
unsigned int total_well_iterations;
|
||||
unsigned int total_linearizations;
|
||||
unsigned int total_newton_iterations;
|
||||
unsigned int total_linear_iterations;
|
||||
|
||||
bool converged;
|
||||
|
||||
/// Default constructor initializing all times to 0.0.
|
||||
explicit SimulatorReport(bool verbose=true);
|
||||
/// Copy constructor
|
||||
SimulatorReport(const SimulatorReport&) = default;
|
||||
/// Increment this report's times by those in sr.
|
||||
void operator+=(const SimulatorReport& sr);
|
||||
/// Print a report to the given stream.
|
||||
void report(std::ostream& os);
|
||||
void reportStep(std::ostringstream& os);
|
||||
/// Print a report, leaving out the transport time.
|
||||
void reportFullyImplicit(std::ostream& os, const SimulatorReport* failedReport = nullptr);
|
||||
void reportParam(std::ostream& os);
|
||||
private:
|
||||
// Whether to print statistics to std::cout
|
||||
bool verbose_;
|
||||
};
|
||||
|
||||
} // namespace Opm
|
||||
|
||||
#endif // OPM_SIMULATORREPORT_HEADER_INCLUDED
|
||||
@@ -1,320 +0,0 @@
|
||||
/*
|
||||
Copyright 2012 SINTEF ICT, Applied Mathematics.
|
||||
|
||||
This file is part of the Open Porous Media project (OPM).
|
||||
|
||||
OPM is free software: you can redistribute it and/or modify
|
||||
it under the terms of the GNU General Public License as published by
|
||||
the Free Software Foundation, either version 3 of the License, or
|
||||
(at your option) any later version.
|
||||
|
||||
OPM is distributed in the hope that it will be useful,
|
||||
but WITHOUT ANY WARRANTY; without even the implied warranty of
|
||||
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
|
||||
GNU General Public License for more details.
|
||||
|
||||
You should have received a copy of the GNU General Public License
|
||||
along with OPM. If not, see <http://www.gnu.org/licenses/>.
|
||||
*/
|
||||
|
||||
#ifndef OPM_WELLSTATE_HEADER_INCLUDED
|
||||
#define OPM_WELLSTATE_HEADER_INCLUDED
|
||||
|
||||
#include <opm/core/props/BlackoilPhases.hpp>
|
||||
#include <opm/core/wells.h>
|
||||
#include <opm/core/well_controls.h>
|
||||
#include <opm/output/data/Wells.hpp>
|
||||
|
||||
#include <array>
|
||||
#include <map>
|
||||
#include <memory>
|
||||
#include <string>
|
||||
#include <vector>
|
||||
#include <cassert>
|
||||
#include <cstddef>
|
||||
|
||||
namespace Opm
|
||||
{
|
||||
/// The state of a set of wells.
|
||||
class WellState
|
||||
{
|
||||
public:
|
||||
typedef std::array< int, 3 > mapentry_t;
|
||||
typedef std::map< std::string, mapentry_t > WellMapType;
|
||||
|
||||
template <class State>
|
||||
void init(const Wells* wells, const State& state)
|
||||
{
|
||||
init(wells, state.pressure());
|
||||
}
|
||||
|
||||
/// Allocate and initialize if wells is non-null.
|
||||
/// Also tries to give useful initial values to the bhp() and
|
||||
/// wellRates() fields, depending on controls. The
|
||||
/// perfRates() field is filled with zero, and perfPress()
|
||||
/// with -1e100.
|
||||
void init(const Wells* wells, const std::vector<double>& cellPressures)
|
||||
{
|
||||
// clear old name mapping
|
||||
wellMap_.clear();
|
||||
wells_.reset( clone_wells( wells ) );
|
||||
|
||||
if (wells) {
|
||||
const int nw = wells->number_of_wells;
|
||||
const int np = wells->number_of_phases;
|
||||
bhp_.resize(nw);
|
||||
thp_.resize(nw);
|
||||
temperature_.resize(nw, 273.15 + 20); // standard temperature for now
|
||||
wellrates_.resize(nw * np, 0.0);
|
||||
for (int w = 0; w < nw; ++w) {
|
||||
assert((wells->type[w] == INJECTOR) || (wells->type[w] == PRODUCER));
|
||||
const WellControls* ctrl = wells->ctrls[w];
|
||||
const int num_perf_this_well = wells->well_connpos[w + 1] - wells->well_connpos[w];
|
||||
|
||||
// setup wellname -> well index mapping
|
||||
{
|
||||
assert( wells->name[ w ] );
|
||||
std::string name( wells->name[ w ] );
|
||||
assert( name.size() > 0 );
|
||||
mapentry_t& wellMapEntry = wellMap_[name];
|
||||
wellMapEntry[ 0 ] = w;
|
||||
wellMapEntry[ 1 ] = wells->well_connpos[w];
|
||||
// also store the number of perforations in this well
|
||||
wellMapEntry[ 2 ] = num_perf_this_well;
|
||||
}
|
||||
|
||||
if ( num_perf_this_well == 0 )
|
||||
{
|
||||
// No perforations of the well. Initialize to zero.
|
||||
for (int p = 0; p < np; ++p) {
|
||||
wellrates_[np*w + p] = 0.0;
|
||||
}
|
||||
bhp_[w] = 0.;
|
||||
thp_[w] = 0.;
|
||||
continue;
|
||||
}
|
||||
|
||||
if (well_controls_well_is_stopped(ctrl)) {
|
||||
// Stopped well:
|
||||
// 1. Rates: assign zero well rates.
|
||||
for (int p = 0; p < np; ++p) {
|
||||
wellrates_[np*w + p] = 0.0;
|
||||
}
|
||||
// 2. Bhp: assign bhp equal to bhp control, if
|
||||
// applicable, otherwise assign equal to
|
||||
// first perforation cell pressure.
|
||||
if (well_controls_get_current_type(ctrl) == BHP) {
|
||||
bhp_[w] = well_controls_get_current_target( ctrl );
|
||||
} else {
|
||||
const int first_cell = wells->well_cells[wells->well_connpos[w]];
|
||||
bhp_[w] = cellPressures[first_cell];
|
||||
}
|
||||
} else {
|
||||
// Open well:
|
||||
// 1. Rates: initialize well rates to match controls
|
||||
// if type is SURFACE_RATE. Otherwise, we
|
||||
// cannot set the correct value here, so we
|
||||
// assign a small rate with the correct
|
||||
// sign so that any logic depending on that
|
||||
// sign will work as expected.
|
||||
if (well_controls_get_current_type(ctrl) == SURFACE_RATE) {
|
||||
const double rate_target = well_controls_get_current_target(ctrl);
|
||||
const double * distr = well_controls_get_current_distr( ctrl );
|
||||
for (int p = 0; p < np; ++p) {
|
||||
wellrates_[np*w + p] = rate_target * distr[p];
|
||||
}
|
||||
} else {
|
||||
const double small_rate = 0.0; //1e-14;
|
||||
const double sign = (wells->type[w] == INJECTOR) ? 1.0 : -1.0;
|
||||
for (int p = 0; p < np; ++p) {
|
||||
wellrates_[np*w + p] = small_rate * sign;
|
||||
}
|
||||
}
|
||||
|
||||
// 2. Bhp: initialize bhp to be target pressure if
|
||||
// bhp-controlled well, otherwise set to a
|
||||
// little above or below (depending on if
|
||||
// the well is an injector or producer)
|
||||
// pressure in first perforation cell.
|
||||
if (well_controls_get_current_type(ctrl) == BHP) {
|
||||
bhp_[w] = well_controls_get_current_target( ctrl );
|
||||
} else {
|
||||
const int first_cell = wells->well_cells[wells->well_connpos[w]];
|
||||
const double safety_factor = (wells->type[w] == INJECTOR) ? 1.01 : 0.99;
|
||||
bhp_[w] = safety_factor*cellPressures[first_cell];
|
||||
}
|
||||
}
|
||||
|
||||
// 3. Thp: assign thp equal to thp target/limit, if applicable,
|
||||
// otherwise keep it zero. Basically, the value should not be used
|
||||
// in the simulation at all.
|
||||
const int nwc = well_controls_get_num(ctrl);
|
||||
for (int ctrl_index = 0; ctrl_index < nwc; ++ctrl_index) {
|
||||
if (well_controls_iget_type(ctrl, ctrl_index) == THP) {
|
||||
thp_[w] = well_controls_iget_target(ctrl, ctrl_index);
|
||||
break;
|
||||
}
|
||||
}
|
||||
}
|
||||
|
||||
// The perforation rates and perforation pressures are
|
||||
// not expected to be consistent with bhp_ and wellrates_
|
||||
// after init().
|
||||
perfrates_.resize(wells->well_connpos[nw], 0.0);
|
||||
perfpress_.resize(wells->well_connpos[nw], -1e100);
|
||||
}
|
||||
}
|
||||
|
||||
/// One bhp pressure per well.
|
||||
std::vector<double>& bhp() { return bhp_; }
|
||||
const std::vector<double>& bhp() const { return bhp_; }
|
||||
|
||||
/// One thp pressure per well.
|
||||
std::vector<double>& thp() { return thp_; }
|
||||
const std::vector<double>& thp() const { return thp_; }
|
||||
|
||||
/// One temperature per well.
|
||||
std::vector<double>& temperature() { return temperature_; }
|
||||
const std::vector<double>& temperature() const { return temperature_; }
|
||||
|
||||
/// One rate per well and phase.
|
||||
std::vector<double>& wellRates() { return wellrates_; }
|
||||
const std::vector<double>& wellRates() const { return wellrates_; }
|
||||
|
||||
/// One rate per well connection.
|
||||
std::vector<double>& perfRates() { return perfrates_; }
|
||||
const std::vector<double>& perfRates() const { return perfrates_; }
|
||||
|
||||
/// One pressure per well connection.
|
||||
std::vector<double>& perfPress() { return perfpress_; }
|
||||
const std::vector<double>& perfPress() const { return perfpress_; }
|
||||
|
||||
size_t getRestartBhpOffset() const {
|
||||
return 0;
|
||||
}
|
||||
|
||||
size_t getRestartPerfPressOffset() const {
|
||||
return bhp_.size();
|
||||
}
|
||||
|
||||
size_t getRestartPerfRatesOffset() const {
|
||||
return getRestartPerfPressOffset() + perfpress_.size();
|
||||
}
|
||||
|
||||
size_t getRestartTemperatureOffset() const {
|
||||
return getRestartPerfRatesOffset() + perfrates_.size();
|
||||
}
|
||||
|
||||
size_t getRestartWellRatesOffset() const {
|
||||
return getRestartTemperatureOffset() + temperature_.size();
|
||||
}
|
||||
|
||||
const WellMapType& wellMap() const { return wellMap_; }
|
||||
WellMapType& wellMap() { return wellMap_; }
|
||||
|
||||
/// The number of wells present.
|
||||
int numWells() const
|
||||
{
|
||||
return bhp().size();
|
||||
}
|
||||
|
||||
/// The number of phases present.
|
||||
int numPhases() const
|
||||
{
|
||||
return wellRates().size() / numWells();
|
||||
}
|
||||
|
||||
virtual data::Wells report(const PhaseUsage& pu, const int* globalCellIdxMap) const
|
||||
{
|
||||
using rt = data::Rates::opt;
|
||||
|
||||
data::Wells dw;
|
||||
for( const auto& itr : this->wellMap_ ) {
|
||||
const auto well_index = itr.second[ 0 ];
|
||||
|
||||
auto& well = dw[ itr.first ];
|
||||
well.bhp = this->bhp().at( well_index );
|
||||
well.thp = this->thp().at( well_index );
|
||||
well.temperature = this->temperature().at( well_index );
|
||||
|
||||
const auto wellrate_index = well_index * pu.num_phases;
|
||||
const auto& wv = this->wellRates();
|
||||
if( pu.phase_used[BlackoilPhases::Aqua] ) {
|
||||
well.rates.set( rt::wat, wv[ wellrate_index + pu.phase_pos[BlackoilPhases::Aqua] ] );
|
||||
}
|
||||
|
||||
if( pu.phase_used[BlackoilPhases::Liquid] ) {
|
||||
well.rates.set( rt::oil, wv[ wellrate_index + pu.phase_pos[BlackoilPhases::Liquid] ] );
|
||||
}
|
||||
|
||||
if( pu.phase_used[BlackoilPhases::Vapour] ) {
|
||||
well.rates.set( rt::gas, wv[ wellrate_index + pu.phase_pos[BlackoilPhases::Vapour] ] );
|
||||
}
|
||||
|
||||
const int num_perf_well = this->wells_->well_connpos[ well_index + 1 ]
|
||||
- this->wells_->well_connpos[ well_index ];
|
||||
well.connections.resize(num_perf_well);
|
||||
|
||||
for( int i = 0; i < num_perf_well; ++i ) {
|
||||
const auto wi = this->wells_->well_connpos[ well_index ] + i;
|
||||
const auto active_index = this->wells_->well_cells[ wi ];
|
||||
|
||||
auto& connection = well.connections[ i ];
|
||||
connection.index = globalCellIdxMap[active_index];
|
||||
connection.pressure = this->perfPress()[ itr.second[1] + i ];
|
||||
connection.reservoir_rate = this->perfRates()[ itr.second[1] + i ];
|
||||
}
|
||||
assert(num_perf_well == int(well.connections.size()));
|
||||
}
|
||||
|
||||
return dw;
|
||||
|
||||
}
|
||||
|
||||
virtual ~WellState() {}
|
||||
|
||||
WellState() = default;
|
||||
WellState( const WellState& rhs ) :
|
||||
bhp_( rhs.bhp_ ),
|
||||
thp_( rhs.thp_ ),
|
||||
temperature_( rhs.temperature_ ),
|
||||
wellrates_( rhs.wellrates_ ),
|
||||
perfrates_( rhs.perfrates_ ),
|
||||
perfpress_( rhs.perfpress_ ),
|
||||
wellMap_( rhs.wellMap_ ),
|
||||
wells_( clone_wells( rhs.wells_.get() ) )
|
||||
{}
|
||||
|
||||
WellState& operator=( const WellState& rhs ) {
|
||||
this->bhp_ = rhs.bhp_;
|
||||
this->thp_ = rhs.thp_;
|
||||
this->temperature_ = rhs.temperature_;
|
||||
this->wellrates_ = rhs.wellrates_;
|
||||
this->perfrates_ = rhs.perfrates_;
|
||||
this->perfpress_ = rhs.perfpress_;
|
||||
this->wellMap_ = rhs.wellMap_;
|
||||
this->wells_.reset( clone_wells( rhs.wells_.get() ) );
|
||||
|
||||
return *this;
|
||||
}
|
||||
|
||||
private:
|
||||
std::vector<double> bhp_;
|
||||
std::vector<double> thp_;
|
||||
std::vector<double> temperature_;
|
||||
std::vector<double> wellrates_;
|
||||
std::vector<double> perfrates_;
|
||||
std::vector<double> perfpress_;
|
||||
|
||||
WellMapType wellMap_;
|
||||
|
||||
protected:
|
||||
struct wdel {
|
||||
void operator()( Wells* w ) { destroy_wells( w ); }
|
||||
};
|
||||
std::unique_ptr< Wells, wdel > wells_;
|
||||
};
|
||||
|
||||
} // namespace Opm
|
||||
|
||||
#endif // OPM_WELLSTATE_HEADER_INCLUDED
|
||||
Reference in New Issue
Block a user