My Project
Opm::WellInterface< TypeTag > Class Template Referenceabstract
Inheritance diagram for Opm::WellInterface< TypeTag >:
Opm::WellInterfaceIndices< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices >, GetPropType< TypeTag, Properties::Scalar > > Opm::WellInterfaceFluidSystem< FluidSystem > Opm::WellInterfaceEval< FluidSystem > Opm::WellInterfaceGeneric Opm::MultisegmentWell< TypeTag > Opm::StandardWell< TypeTag >

Public Types

enum class  IndividualOrGroup { Individual , Group , Both }
 
using ModelParameters = BlackoilModelParametersEbos< TypeTag >
 
using Grid = GetPropType< TypeTag, Properties::Grid >
 
using Simulator = GetPropType< TypeTag, Properties::Simulator >
 
using FluidSystem = GetPropType< TypeTag, Properties::FluidSystem >
 
using Indices = GetPropType< TypeTag, Properties::Indices >
 
using IntensiveQuantities = GetPropType< TypeTag, Properties::IntensiveQuantities >
 
using MaterialLaw = GetPropType< TypeTag, Properties::MaterialLaw >
 
using SparseMatrixAdapter = GetPropType< TypeTag, Properties::SparseMatrixAdapter >
 
using RateVector = GetPropType< TypeTag, Properties::RateVector >
 
using GasLiftSingleWell = ::Opm::GasLiftSingleWell< TypeTag >
 
using GLiftOptWells = typename BlackoilWellModel< TypeTag >::GLiftOptWells
 
using GLiftProdWells = typename BlackoilWellModel< TypeTag >::GLiftProdWells
 
using GLiftWellStateMap = typename BlackoilWellModel< TypeTag >::GLiftWellStateMap
 
using GLiftSyncGroups = typename GasLiftSingleWellGeneric::GLiftSyncGroups
 
using Scalar = GetPropType< TypeTag, Properties::Scalar >
 
using VectorBlockType = Dune::FieldVector< Scalar, Indices::numEq >
 
using MatrixBlockType = Dune::FieldMatrix< Scalar, Indices::numEq, Indices::numEq >
 
using BVector = Dune::BlockVector< VectorBlockType >
 
using Eval = DenseAd::Evaluation< Scalar, Indices::numEq >
 
using PressureMatrix = Dune::BCRSMatrix< Opm::MatrixBlock< double, 1, 1 > >
 
using RateConverterType = typename WellInterfaceFluidSystem< FluidSystem >::RateConverterType
 
using RatioLimitCheckReport = typename WellInterfaceFluidSystem< FluidSystem >::RatioLimitCheckReport
 
using FluidState = BlackOilFluidState< Eval, FluidSystem, has_temperature, has_energy, Indices::compositionSwitchIdx >=0, has_watVapor, has_brine, has_saltPrecip, Indices::numPhases >
 

Public Member Functions

 WellInterface (const Well &well, const ParallelWellInfo &pw_info, const int time_step, const ModelParameters &param, const RateConverterType &rate_converter, const int pvtRegionIdx, const int num_components, const int num_phases, const int index_of_well, const std::vector< PerforationData > &perf_data)
 Constructor.
 
virtual ~WellInterface ()=default
 Virtual destructor.
 
virtual void init (const PhaseUsage *phase_usage_arg, const std::vector< double > &depth_arg, const double gravity_arg, const int num_cells, const std::vector< Scalar > &B_avg, const bool changed_to_open_this_step)
 
virtual void initPrimaryVariablesEvaluation () const =0
 
virtual ConvergenceReport getWellConvergence (const WellState &well_state, const std::vector< double > &B_avg, DeferredLogger &deferred_logger, const bool relax_tolerance) const =0
 
virtual void solveEqAndUpdateWellState (WellState &well_state, DeferredLogger &deferred_logger)=0
 
void assembleWellEq (const Simulator &ebosSimulator, const double dt, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
virtual void computeWellRatesWithBhp (const Simulator &ebosSimulator, const double &bhp, std::vector< double > &well_flux, DeferredLogger &deferred_logger) const =0
 
virtual std::optional< double > computeBhpAtThpLimitProdWithAlq (const Simulator &ebos_simulator, const SummaryState &summary_state, DeferredLogger &deferred_logger, double alq_value) const =0
 
virtual void recoverWellSolutionAndUpdateWellState (const BVector &x, WellState &well_state, DeferredLogger &deferred_logger) const =0
 using the solution x to recover the solution xw for wells and applying xw to update Well State
 
virtual void apply (const BVector &x, BVector &Ax) const =0
 Ax = Ax - C D^-1 B x.
 
virtual void apply (BVector &r) const =0
 r = r - C D^-1 Rw
 
virtual void computeWellPotentials (const Simulator &ebosSimulator, const WellState &well_state, std::vector< double > &well_potentials, DeferredLogger &deferred_logger)=0
 
virtual void updateWellStateWithTarget (const Simulator &ebos_simulator, const GroupState &group_state, WellState &well_state, DeferredLogger &deferred_logger) const
 
bool updateWellControl (const Simulator &ebos_simulator, const IndividualOrGroup iog, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
virtual void updatePrimaryVariables (const WellState &well_state, DeferredLogger &deferred_logger) const =0
 
virtual void calculateExplicitQuantities (const Simulator &ebosSimulator, const WellState &well_state, DeferredLogger &deferred_logger)=0
 
virtual void updateProductivityIndex (const Simulator &ebosSimulator, const WellProdIndexCalculator &wellPICalc, WellState &well_state, DeferredLogger &deferred_logger) const =0
 
virtual bool jacobianContainsWellContributions () const
 Wether the Jacobian will also have well contributions in it.
 
virtual void addWellContributions (SparseMatrixAdapter &) const =0
 
virtual bool isPressureControlled (const WellState &well_state) const
 
virtual void addWellPressureEquations (PressureMatrix &mat, const BVector &x, const int pressureVarIndex, const bool use_well_weights, const WellState &well_state) const =0
 
void addCellRates (RateVector &rates, int cellIdx) const
 
Scalar volumetricSurfaceRateForConnection (int cellIdx, int phaseIdx) const
 
template<class EvalWell >
Eval restrictEval (const EvalWell &in) const
 
void wellTesting (const Simulator &simulator, const double simulation_time, WellState &well_state, const GroupState &group_state, WellTestState &welltest_state, DeferredLogger &deferred_logger)
 
void checkWellOperability (const Simulator &ebos_simulator, const WellState &well_state, DeferredLogger &deferred_logger)
 
void gliftBeginTimeStepWellTestUpdateALQ (const Simulator &ebos_simulator, WellState &well_state, DeferredLogger &deferred_logger)
 
void updateWellOperability (const Simulator &ebos_simulator, const WellState &well_state, DeferredLogger &deferred_logger)
 
virtual void updateWaterThroughput (const double dt, WellState &well_state) const =0
 
virtual std::vector< double > computeCurrentWellRates (const Simulator &ebosSimulator, DeferredLogger &deferred_logger) const =0
 Compute well rates based on current reservoir conditions and well variables. More...
 
void updateWellStateRates (const Simulator &ebosSimulator, WellState &well_state, DeferredLogger &deferred_logger) const
 Modify the well_state's rates if there is only one nonzero rate. More...
 
void solveWellEquation (const Simulator &ebosSimulator, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
- Public Member Functions inherited from Opm::WellInterfaceIndices< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices >, GetPropType< TypeTag, Properties::Scalar > >
int flowPhaseToEbosCompIdx (const int phaseIdx) const
 
int ebosCompIdxToFlowCompIdx (const unsigned compIdx) const
 
double scalingFactor (const int phaseIdx) const
 
- Public Member Functions inherited from Opm::WellInterfaceFluidSystem< FluidSystem >
void updateWellTestState (const SingleWellState &ws, const double &simulationTime, const bool &writeMessageToOPMLog, WellTestState &wellTestState, DeferredLogger &deferred_logger) const
 
int flowPhaseToEbosPhaseIdx (const int phaseIdx) const
 
const RateConverterTyperateConverter () const
 
- Public Member Functions inherited from Opm::WellInterfaceGeneric
 WellInterfaceGeneric (const Well &well, const ParallelWellInfo &parallel_well_info, const int time_step, const int pvtRegionIdx, const int num_components, const int num_phases, const int index_of_well, const std::vector< PerforationData > &perf_data)
 
const std::vector< PerforationData > & perforationData () const
 Get the perforations of the well.
 
const std::string & name () const
 Well name.
 
bool isInjector () const
 True if the well is an injector.
 
bool isProducer () const
 True if the well is a producer.
 
const std::vector< int > & cells () const
 Well cells.
 
int indexOfWell () const
 Index of well in the wells struct and wellState.
 
void adaptRatesForVFP (std::vector< double > &rates) const
 
const Well & wellEcl () const
 
const PhaseUsagephaseUsage () const
 
bool underPredictionMode () const
 Returns true if the well is currently in prediction mode (i.e. not history mode).
 
bool isOperableAndSolvable () const
 
bool useVfpExplicit () const
 
bool thpLimitViolatedButNotSwitched () const
 
void initCompletions ()
 
void closeCompletions (const WellTestState &wellTestState)
 
void setVFPProperties (const VFPProperties *vfp_properties_arg)
 
void setGuideRate (const GuideRate *guide_rate_arg)
 
void setWellEfficiencyFactor (const double efficiency_factor)
 
void setRepRadiusPerfLength ()
 
void setWsolvent (const double wsolvent)
 
void setDynamicThpLimit (const double thp_limit)
 
std::optional< double > getDynamicThpLimit () const
 
void updatePerforatedCell (std::vector< bool > &is_cell_perforated)
 
bool wellHasTHPConstraints (const SummaryState &summaryState) const
 Returns true if the well has one or more THP limits/constraints.
 
void stopWell ()
 
void openWell ()
 
bool wellIsStopped () const
 
int currentStep () const
 
int pvtRegionIdx () const
 
const GuideRate * guideRate () const
 
int numComponents () const
 
int numPhases () const
 
int numPerfs () const
 
double refDepth () const
 
double gravity () const
 
const VFPPropertiesvfpProperties () const
 
const ParallelWellInfoparallelWellInfo () const
 
const std::vector< double > & perfDepth () const
 
std::vector< double > & perfDepth ()
 
const std::vector< double > & wellIndex () const
 
double getTHPConstraint (const SummaryState &summaryState) const
 
double getALQ (const WellState &well_state) const
 
double wsolvent () const
 
double rsRvInj () const
 
bool isVFPActive (DeferredLogger &deferred_logger) const
 
void reportWellSwitching (const SingleWellState &ws, DeferredLogger &deferred_logger) const
 
bool changedToOpenThisStep () const
 
std::optional< double > computeBhpAtThpLimitProdCommon (const std::function< std::vector< double >(const double)> &frates, const SummaryState &summary_state, const double maxPerfPress, const double rho, const double alq_value, DeferredLogger &deferred_logger) const
 
- Public Member Functions inherited from Opm::WellInterfaceEval< FluidSystem >
template<class EvalWell >
EvalWell calculateBhpFromThp (const WellState &well_state, const std::vector< EvalWell > &rates, const Well &well, const SummaryState &summaryState, const double rho, DeferredLogger &deferred_logger) const
 
template<class EvalWell >
void getGroupInjectionControl (const Group &group, const WellState &well_state, const GroupState &group_state, const Schedule &schedule, const SummaryState &summaryState, const InjectorType &injectorType, const EvalWell &bhp, const EvalWell &injection_rate, EvalWell &control_eq, double efficiencyFactor, DeferredLogger &deferred_logger) const
 
template<class EvalWell >
void getGroupProductionControl (const Group &group, const WellState &well_state, const GroupState &group_state, const Schedule &schedule, const SummaryState &summaryState, const EvalWell &bhp, const std::vector< EvalWell > &rates, EvalWell &control_eq, double efficiencyFactor) const
 
template<class EvalWell , class BhpFromThpFunc >
void assembleControlEqProd (const WellState &well_state, const GroupState &group_state, const Schedule &schedule, const SummaryState &summaryState, const Well::ProductionControls &controls, const EvalWell &bhp, const std::vector< EvalWell > &rates, BhpFromThpFunc bhp_from_thp, EvalWell &control_eq, DeferredLogger &deferred_logger) const
 
template<class EvalWell >
void assembleControlEqProd_ (const WellState &well_state, const GroupState &group_state, const Schedule &schedule, const SummaryState &summaryState, const Well::ProductionControls &controls, const EvalWell &bhp, const std::vector< EvalWell > &rates, const std::function< EvalWell()> &bhp_from_thp, EvalWell &control_eq, DeferredLogger &deferred_logger) const
 
template<class EvalWell , class BhpFromThpFunc >
void assembleControlEqInj (const WellState &well_state, const GroupState &group_state, const Schedule &schedule, const SummaryState &summaryState, const Well::InjectionControls &controls, const EvalWell &bhp, const EvalWell &injection_rate, BhpFromThpFunc bhp_from_thp, EvalWell &control_eq, DeferredLogger &deferred_logger) const
 
template<class EvalWell >
void assembleControlEqInj_ (const WellState &well_state, const GroupState &group_state, const Schedule &schedule, const SummaryState &summaryState, const Well::InjectionControls &controls, const EvalWell &bhp, const EvalWell &injection_rate, const std::function< EvalWell()> &bhp_from_thp, EvalWell &control_eq, DeferredLogger &deferred_logger) const
 

Static Public Attributes

static constexpr bool has_solvent = getPropValue<TypeTag, Properties::EnableSolvent>()
 
static constexpr bool has_zFraction = getPropValue<TypeTag, Properties::EnableExtbo>()
 
static constexpr bool has_polymer = getPropValue<TypeTag, Properties::EnablePolymer>()
 
static constexpr bool has_energy = getPropValue<TypeTag, Properties::EnableEnergy>()
 
static const bool has_temperature = getPropValue<TypeTag, Properties::EnableTemperature>()
 
static constexpr bool has_polymermw = getPropValue<TypeTag, Properties::EnablePolymerMW>()
 
static constexpr bool has_foam = getPropValue<TypeTag, Properties::EnableFoam>()
 
static constexpr bool has_brine = getPropValue<TypeTag, Properties::EnableBrine>()
 
static constexpr bool has_watVapor = getPropValue<TypeTag, Properties::EnableEvaporation>()
 
static constexpr bool has_saltPrecip = getPropValue<TypeTag, Properties::EnableSaltPrecipitation>()
 
static constexpr bool has_micp = getPropValue<TypeTag, Properties::EnableMICP>()
 
- Static Public Attributes inherited from Opm::WellInterfaceFluidSystem< FluidSystem >
static constexpr int Water = BlackoilPhases::Aqua
 
static constexpr int Oil = BlackoilPhases::Liquid
 
static constexpr int Gas = BlackoilPhases::Vapour
 
- Static Public Attributes inherited from Opm::WellInterfaceGeneric
static constexpr bool extraBhpAtThpLimitProdOutput = false
 

Protected Member Functions

double wpolymer () const
 
double wfoam () const
 
double wsalt () const
 
double wmicrobes () const
 
double woxygen () const
 
double wurea () const
 
virtual double getRefDensity () const =0
 
const std::vector< double > & compFrac () const
 
std::vector< double > initialWellRateFractions (const Simulator &ebosSimulator, const WellState &well_state) const
 
virtual void checkOperabilityUnderBHPLimit (const WellState &well_state, const Simulator &ebos_simulator, DeferredLogger &deferred_logger)=0
 
virtual void checkOperabilityUnderTHPLimit (const Simulator &ebos_simulator, const WellState &well_state, DeferredLogger &deferred_logger)=0
 
virtual void updateIPR (const Simulator &ebos_simulator, DeferredLogger &deferred_logger) const =0
 
virtual void assembleWellEqWithoutIteration (const Simulator &ebosSimulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)=0
 
virtual bool iterateWellEqWithControl (const Simulator &ebosSimulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)=0
 
bool iterateWellEquations (const Simulator &ebosSimulator, const double dt, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
bool solveWellForTesting (const Simulator &ebosSimulator, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
Eval getPerfCellPressure (const FluidState &fs) const
 
- Protected Member Functions inherited from Opm::WellInterfaceIndices< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices >, GetPropType< TypeTag, Properties::Scalar > >
 WellInterfaceIndices (const Well &well, const ParallelWellInfo &parallel_well_info, const int time_step, const typename WellInterfaceFluidSystem< GetPropType< TypeTag, Properties::FluidSystem > >::RateConverterType &rate_converter, const int pvtRegionIdx, const int num_components, const int num_phases, const int index_of_well, const std::vector< PerforationData > &perf_data)
 
- Protected Member Functions inherited from Opm::WellInterfaceFluidSystem< FluidSystem >
 WellInterfaceFluidSystem (const Well &well, const ParallelWellInfo &parallel_well_info, const int time_step, const RateConverterType &rate_converter, const int pvtRegionIdx, const int num_components, const int num_phases, const int index_of_well, const std::vector< PerforationData > &perf_data)
 
void calculateReservoirRates (SingleWellState &ws) const
 
bool checkIndividualConstraints (SingleWellState &ws, const SummaryState &summaryState, DeferredLogger &deferred_logger) const
 
Well::InjectorCMode activeInjectionConstraint (const SingleWellState &ws, const SummaryState &summaryState, DeferredLogger &deferred_logger) const
 
Well::ProducerCMode activeProductionConstraint (const SingleWellState &ws, const SummaryState &summaryState, DeferredLogger &deferred_logger) const
 
std::pair< bool, double > checkGroupConstraintsInj (const Group &group, const WellState &well_state, const GroupState &group_state, const double efficiencyFactor, const Schedule &schedule, const SummaryState &summaryState, DeferredLogger &deferred_logger) const
 
std::pair< bool, double > checkGroupConstraintsProd (const Group &group, const WellState &well_state, const GroupState &group_state, const double efficiencyFactor, const Schedule &schedule, const SummaryState &summaryState, DeferredLogger &deferred_logger) const
 
bool checkGroupConstraints (WellState &well_state, const GroupState &group_state, const Schedule &schedule, const SummaryState &summaryState, DeferredLogger &deferred_logger) const
 
bool checkConstraints (WellState &well_state, const GroupState &group_state, const Schedule &schedule, const SummaryState &summaryState, DeferredLogger &deferred_logger) const
 
bool checkRateEconLimits (const WellEconProductionLimits &econ_production_limits, const double *rates_or_potentials, Opm::DeferredLogger &deferred_logger) const
 
void checkMaxWaterCutLimit (const WellEconProductionLimits &econ_production_limits, const SingleWellState &ws, RatioLimitCheckReport &report) const
 
void checkMaxGORLimit (const WellEconProductionLimits &econ_production_limits, const SingleWellState &ws, RatioLimitCheckReport &report) const
 
void checkMaxWGRLimit (const WellEconProductionLimits &econ_production_limits, const SingleWellState &ws, RatioLimitCheckReport &report) const
 
void checkRatioEconLimits (const WellEconProductionLimits &econ_production_limits, const SingleWellState &ws, RatioLimitCheckReport &report, DeferredLogger &deferred_logger) const
 
void updateWellTestStateEconomic (const SingleWellState &ws, const double simulation_time, const bool write_message_to_opmlog, WellTestState &well_test_state, DeferredLogger &deferred_logger) const
 
std::optional< double > getGroupInjectionTargetRate (const Group &group, const WellState &well_state, const GroupState &group_state, const Schedule &schedule, const SummaryState &summaryState, const InjectorType &injectorType, double efficiencyFactor, DeferredLogger &deferred_logger) const
 
double getGroupProductionTargetRate (const Group &group, const WellState &well_state, const GroupState &group_state, const Schedule &schedule, const SummaryState &summaryState, double efficiencyFactor) const
 
- Protected Member Functions inherited from Opm::WellInterfaceGeneric
bool getAllowCrossFlow () const
 
double mostStrictBhpFromBhpLimits (const SummaryState &summaryState) const
 
void updateWellTestStatePhysical (const double simulation_time, const bool write_message_to_opmlog, WellTestState &well_test_state, DeferredLogger &deferred_logger) const
 
std::optional< double > bhpMax (const std::function< double(const double)> &fflo, const double bhp_limit, const double maxPerfPress, const double vfp_flo_front, DeferredLogger &deferred_logger) const
 
std::optional< double > computeBhpAtThpLimitCommon (const std::function< std::vector< double >(const double)> &frates, const std::function< double(const std::vector< double >)> &fbhp, const std::array< double, 2 > &range, DeferredLogger &deferred_logger) const
 
bool bruteForceBracket (const std::function< double(const double)> &eq, const std::array< double, 2 > &range, double &low, double &high, DeferredLogger &deferred_logger) const
 
bool bisectBracket (const std::function< double(const double)> &eq, const std::array< double, 2 > &range, double &low, double &high, std::optional< double > &approximate_solution, DeferredLogger &deferred_logger) const
 
- Protected Member Functions inherited from Opm::WellInterfaceEval< FluidSystem >
 WellInterfaceEval (const WellInterfaceFluidSystem< FluidSystem > &baseif)
 

Protected Attributes

const ModelParametersparam_
 
std::vector< RateVector > connectionRates_
 
std::vector< Scalar > B_avg_
 
bool changed_to_stopped_this_step_ = false
 
- Protected Attributes inherited from Opm::WellInterfaceFluidSystem< FluidSystem >
const RateConverterTyperateConverter_
 
- Protected Attributes inherited from Opm::WellInterfaceGeneric
OperabilityStatus operability_status_
 
Well well_ecl_
 
const ParallelWellInfoparallel_well_info_
 
const int current_step_
 
const int pvtRegionIdx_
 
const int num_components_
 
int number_of_phases_
 
int index_of_well_
 
const std::vector< PerforationData > * perf_data_
 
std::vector< double > ipr_a_
 
std::vector< double > ipr_b_
 
std::vector< int > well_cells_
 
std::vector< double > well_index_
 
int number_of_perforations_
 
std::vector< double > perf_depth_
 
std::vector< double > perf_rep_radius_
 
std::vector< double > perf_length_
 
std::vector< double > bore_diameters_
 
std::map< int, std::vector< int > > completions_
 
double ref_depth_
 
std::vector< int > saturation_table_number_
 
Well::Status wellStatus_
 
const PhaseUsagephase_usage_
 
double gravity_
 
double wsolvent_
 
std::optional< double > dynamic_thp_limit_
 
double well_efficiency_factor_
 
const VFPPropertiesvfp_properties_
 
const GuideRate * guide_rate_
 
std::vector< std::string > well_control_log_
 
bool changed_to_open_this_step_ = true
 
- Protected Attributes inherited from Opm::WellInterfaceEval< FluidSystem >
const WellInterfaceFluidSystem< FluidSystem > & baseif_
 

Additional Inherited Members

- Protected Types inherited from Opm::WellInterfaceFluidSystem< FluidSystem >
using RateConverterType = RateConverter::SurfaceToReservoirVoidage< FluidSystem, std::vector< int > >
 
- Static Protected Attributes inherited from Opm::WellInterfaceFluidSystem< FluidSystem >
static constexpr int INVALIDCOMPLETION = std::numeric_limits<int>::max()
 

Member Function Documentation

◆ computeCurrentWellRates()

template<typename TypeTag >
virtual std::vector<double> Opm::WellInterface< TypeTag >::computeCurrentWellRates ( const Simulator &  ebosSimulator,
DeferredLogger deferred_logger 
) const
pure virtual

Compute well rates based on current reservoir conditions and well variables.

Used in updateWellStateRates().

Implemented in Opm::StandardWell< TypeTag >, and Opm::MultisegmentWell< TypeTag >.

◆ updateWellStateRates()

template<typename TypeTag >
void Opm::WellInterface< TypeTag >::updateWellStateRates ( const Simulator &  ebosSimulator,
WellState well_state,
DeferredLogger deferred_logger 
) const

Modify the well_state's rates if there is only one nonzero rate.

If so, that rate is kept as is, but the others are set proportionally to the rates returned by computeCurrentWellRates().


The documentation for this class was generated from the following files: