My Project
Loading...
Searching...
No Matches
Opm::MultisegmentWell< TypeTag > Class Template Reference
Inheritance diagram for Opm::MultisegmentWell< TypeTag >:
Opm::WellInterface< TypeTag > Opm::MultisegmentWellEval< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > > Opm::WellInterfaceIndices< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > > Opm::MultisegmentWellGeneric< FluidSystem::Scalar > Opm::WellInterfaceFluidSystem< FluidSystem > Opm::WellInterfaceGeneric

Public Types

using Base = WellInterface< TypeTag >
 
using MSWEval = MultisegmentWellEval< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > >
 
using Simulator = GetPropType< TypeTag, Properties::Simulator >
 
using IntensiveQuantities = GetPropType< TypeTag, Properties::IntensiveQuantities >
 
using FluidSystem = GetPropType< TypeTag, Properties::FluidSystem >
 
using ModelParameters = BlackoilModelParameters< TypeTag >
 
using MaterialLaw = GetPropType< TypeTag, Properties::MaterialLaw >
 
using Indices = GetPropType< TypeTag, Properties::Indices >
 
using RateConverterType = typename WellInterfaceFluidSystem< FluidSystem >::RateConverterType
 
using SparseMatrixAdapter = GetPropType< TypeTag, Properties::SparseMatrixAdapter >
 
using FluidState = BlackOilFluidState< Eval, FluidSystem, has_temperature, has_energy, Indices::compositionSwitchIdx >=0, has_watVapor, has_brine, has_saltPrecip, has_disgas_in_water, Indices::numPhases >
 
using Scalar = GetPropType< TypeTag, Properties::Scalar >
 
using BVector = Dune::BlockVector< VectorBlockType >
 
using Eval = typename Base::Eval
 
using PressureMatrix = Dune::BCRSMatrix< Opm::MatrixBlock< double, 1, 1 > >
 
- Public Types inherited from Opm::WellInterface< TypeTag >
enum class  IndividualOrGroup { Individual , Group , Both }
 
using ModelParameters = BlackoilModelParameters< 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 Eval = typename Base::Eval
 
using BVector = Dune::BlockVector< VectorBlockType >
 
using PressureMatrix = Dune::BCRSMatrix< Opm::MatrixBlock< double, 1, 1 > >
 
using RateConverterType = typename WellInterfaceFluidSystem< FluidSystem >::RateConverterType
 
using FluidState = BlackOilFluidState< Eval, FluidSystem, has_temperature, has_energy, Indices::compositionSwitchIdx >=0, has_watVapor, has_brine, has_saltPrecip, has_disgas_in_water, Indices::numPhases >
 
- Public Types inherited from Opm::WellInterfaceIndices< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > >
using Scalar = typename FluidSystem::Scalar
 
using Eval = DenseAd::Evaluation< Scalar, Indices::numEq >
 

Public Member Functions

 MultisegmentWell (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)
 
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) override
 
void initPrimaryVariablesEvaluation () override
 
virtual void updateWellStateWithTarget (const Simulator &simulator, const GroupState &group_state, WellState &well_state, DeferredLogger &deferred_logger) const override
 updating the well state based the current control mode
 
virtual ConvergenceReport getWellConvergence (const SummaryState &summary_state, const WellState &well_state, const std::vector< double > &B_avg, DeferredLogger &deferred_logger, const bool relax_tolerance) const override
 check whether the well equations get converged for this well
 
virtual void apply (const BVector &x, BVector &Ax) const override
 Ax = Ax - C D^-1 B x.
 
virtual void apply (BVector &r) const override
 r = r - C D^-1 Rw
 
void recoverWellSolutionAndUpdateWellState (const SummaryState &summary_state, const BVector &x, WellState &well_state, DeferredLogger &deferred_logger) override
 using the solution x to recover the solution xw for wells and applying xw to update Well State
 
virtual void computeWellPotentials (const Simulator &simulator, const WellState &well_state, std::vector< double > &well_potentials, DeferredLogger &deferred_logger) override
 computing the well potentials for group control
 
void updatePrimaryVariables (const SummaryState &summary_state, const WellState &well_state, DeferredLogger &deferred_logger) override
 
virtual void solveEqAndUpdateWellState (const SummaryState &summary_state, WellState &well_state, DeferredLogger &deferred_logger) override
 
virtual void calculateExplicitQuantities (const Simulator &simulator, const WellState &well_state, DeferredLogger &deferred_logger) override
 
void updateIPRImplicit (const Simulator &simulator, WellState &well_state, DeferredLogger &deferred_logger) override
 
virtual void updateProductivityIndex (const Simulator &simulator, const WellProdIndexCalculator &wellPICalc, WellState &well_state, DeferredLogger &deferred_logger) const override
 
double connectionDensity (const int globalConnIdx, const int openConnIdx) const override
 
void addWellContributions (SparseMatrixAdapter &jacobian) const override
 
void addWellPressureEquations (PressureMatrix &mat, const BVector &x, const int pressureVarIndex, const bool use_well_weights, const WellState &well_state) const override
 
std::vector< double > computeCurrentWellRates (const Simulator &simulator, DeferredLogger &deferred_logger) const override
 Compute well rates based on current reservoir conditions and well variables.
 
std::optional< double > computeBhpAtThpLimitProdWithAlq (const Simulator &simulator, const SummaryState &summary_state, const double alq_value, DeferredLogger &deferred_logger) const override
 
std::vector< double > getPrimaryVars () const override
 
int setPrimaryVars (std::vector< double >::const_iterator it) override
 
- Public Member Functions inherited from Opm::WellInterface< TypeTag >
 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)
 
void assembleWellEq (const Simulator &simulator, const double dt, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
void assembleWellEqWithoutIteration (const Simulator &simulator, const double dt, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
void prepareWellBeforeAssembling (const Simulator &simulator, const double dt, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
virtual void computeWellRatesWithBhpIterations (const Simulator &simulator, const Scalar &bhp, std::vector< double > &well_flux, DeferredLogger &deferred_logger) const =0
 
bool updateWellStateWithTHPTargetProd (const Simulator &simulator, WellState &well_state, DeferredLogger &deferred_logger) const
 
bool updateWellControl (const Simulator &simulator, const IndividualOrGroup iog, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
bool updateWellControlAndStatusLocalIteration (const Simulator &simulator, WellState &well_state, const GroupState &group_state, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, const double WQTotal, DeferredLogger &deferred_logger, const bool fixed_control=false, const bool fixed_status=false)
 
virtual bool jacobianContainsWellContributions () const
 Wether the Jacobian will also have well contributions in it.
 
void addCellRates (RateVector &rates, int cellIdx) const
 
Scalar volumetricSurfaceRateForConnection (int cellIdx, int phaseIdx) 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 &simulator, const WellState &well_state, DeferredLogger &deferred_logger)
 
bool gliftBeginTimeStepWellTestIterateWellEquations (const Simulator &simulator, const double dt, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
void gliftBeginTimeStepWellTestUpdateALQ (const Simulator &simulator, WellState &well_state, DeferredLogger &deferred_logger)
 
void updateWellOperability (const Simulator &simulator, const WellState &well_state, DeferredLogger &deferred_logger)
 
bool updateWellOperabilityFromWellEq (const Simulator &simulator, const WellState &well_state, DeferredLogger &deferred_logger)
 
void updateWellStateRates (const Simulator &simulator, WellState &well_state, DeferredLogger &deferred_logger) const
 Modify the well_state's rates if there is only one nonzero rate.
 
void solveWellEquation (const Simulator &simulator, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
const std::vector< RateVector > & connectionRates () const
 
std::vector< double > wellIndex (const int perf, const IntensiveQuantities &intQuants, const double trans_mult, const SingleWellState &ws) const
 
void updateConnectionDFactor (const Simulator &simulator, SingleWellState &ws) const
 
void updateConnectionTransmissibilityFactor (const Simulator &simulator, SingleWellState &ws) const
 
- Public Member Functions inherited from Opm::WellInterfaceIndices< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > >
int flowPhaseToModelCompIdx (const int phaseIdx) const
 
int modelCompIdxToFlowCompIdx (const unsigned compIdx) const
 
double scalingFactor (const int phaseIdx) const
 
Eval restrictEval (const EvalWell &in) const
 
- Public Member Functions inherited from Opm::WellInterfaceFluidSystem< FluidSystem >
int flowPhaseToModelPhaseIdx (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
 
Well & wellEcl ()
 
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 setPrevSurfaceRates (WellState &well_state, const WellState &prev_well_state) const
 
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
 
const std::map< int, std::vector< int > > & getCompletions () const
 
double getTHPConstraint (const SummaryState &summaryState) const
 
double getALQ (const WellState &well_state) const
 
double wsolvent () const
 
double rsRvInj () const
 
void initInjMult (const std::vector< double > &max_inj_mult)
 
void updateInjMult (std::vector< double > &inj_multipliers, DeferredLogger &deferred_logger) const
 
double getInjMult (const int perf, const double bhp, const double perf_pres) const
 
bool isVFPActive (DeferredLogger &deferred_logger) const
 
void reportWellSwitching (const SingleWellState &ws, DeferredLogger &deferred_logger) const
 
bool changedToOpenThisStep () const
 
void updateWellTestState (const SingleWellState &ws, const double &simulationTime, const bool &writeMessageToOPMLog, WellTestState &wellTestState, DeferredLogger &deferred_logger) const
 
bool isPressureControlled (const WellState &well_state) const
 
bool stopppedOrZeroRateTarget (const SummaryState &summary_state, const WellState &well_state) const
 
double wellEfficiencyFactor () const
 
void updateFilterCakeMultipliers (const std::vector< double > &inj_fc_multiplier)
 Update filter cake multipliers.
 
void resetWellOperability ()
 
- Public Member Functions inherited from Opm::MultisegmentWellEval< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > >
const EquationslinSys () const
 Returns a const reference to equation system.
 
- Public Member Functions inherited from Opm::MultisegmentWellGeneric< FluidSystem::Scalar >
const WellSegments & segmentSet () const
 
int segmentNumberToIndex (const int segment_number) const
 
int numberOfSegments () const
 number of segments for this well
 

Static Public Attributes

static constexpr bool has_solvent
 
static constexpr bool has_polymer
 
- Static Public Attributes inherited from Opm::WellInterface< TypeTag >
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::EnableVapwat>()
 
static constexpr bool has_disgas_in_water = getPropValue<TypeTag, Properties::EnableDisgasInWater>()
 
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
 

Protected Member Functions

void updateWellState (const SummaryState &summary_state, const BVectorWell &dwells, WellState &well_state, DeferredLogger &deferred_logger, const double relaxation_factor=1.0)
 
void computeInitialSegmentFluids (const Simulator &simulator)
 
void computePerfCellPressDiffs (const Simulator &simulator)
 
template<class Value >
void computePerfRate (const IntensiveQuantities &int_quants, const std::vector< Value > &mob_perfcells, const std::vector< Scalar > &Tw, const int seg, const int perf, const Value &segment_pressure, const bool &allow_cf, std::vector< Value > &cq_s, Value &perf_press, PerforationRates &perf_rates, DeferredLogger &deferred_logger) const
 
template<class Value >
void computePerfRate (const Value &pressure_cell, const Value &rs, const Value &rv, const std::vector< Value > &b_perfcells, const std::vector< Value > &mob_perfcells, const std::vector< Scalar > &Tw, const int perf, const Value &segment_pressure, const Value &segment_density, const bool &allow_cf, const std::vector< Value > &cmix_s, std::vector< Value > &cq_s, Value &perf_press, PerforationRates &perf_rates, DeferredLogger &deferred_logger) const
 
void computeSegmentFluidProperties (const Simulator &simulator, DeferredLogger &deferred_logger)
 
template<class Value >
void getMobility (const Simulator &simulator, const int perf, std::vector< Value > &mob, DeferredLogger &deferred_logger) const
 
void computeWellRatesAtBhpLimit (const Simulator &simulator, std::vector< double > &well_flux, DeferredLogger &deferred_logger) const
 
void computeWellRatesWithBhp (const Simulator &simulator, const double &bhp, std::vector< double > &well_flux, DeferredLogger &deferred_logger) const override
 
void computeWellRatesWithBhpIterations (const Simulator &simulator, const Scalar &bhp, std::vector< double > &well_flux, DeferredLogger &deferred_logger) const override
 
std::vector< double > computeWellPotentialWithTHP (const WellState &well_state, const Simulator &simulator, DeferredLogger &deferred_logger) const
 
bool computeWellPotentialsImplicit (const Simulator &simulator, std::vector< double > &well_potentials, DeferredLogger &deferred_logger) const
 
virtual double getRefDensity () const override
 
virtual bool iterateWellEqWithControl (const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger) override
 
virtual bool iterateWellEqWithSwitching (const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger, const bool fixed_control=false, const bool fixed_status=false) override
 
virtual void assembleWellEqWithoutIteration (const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger) override
 
virtual void updateWaterThroughput (const double dt, WellState &well_state) const override
 
EvalWell getSegmentSurfaceVolume (const Simulator &simulator, const int seg_idx) const
 
bool openCrossFlowAvoidSingularity (const Simulator &simulator) const
 
bool allDrawDownWrongDirection (const Simulator &simulator) const
 
std::optional< double > computeBhpAtThpLimitProd (const WellState &well_state, const Simulator &simulator, const SummaryState &summary_state, DeferredLogger &deferred_logger) const
 
std::optional< double > computeBhpAtThpLimitInj (const Simulator &simulator, const SummaryState &summary_state, DeferredLogger &deferred_logger) const
 
double maxPerfPress (const Simulator &simulator) const
 
void checkOperabilityUnderBHPLimit (const WellState &well_state, const Simulator &simulator, DeferredLogger &deferred_logger) override
 
void checkOperabilityUnderTHPLimit (const Simulator &simulator, const WellState &well_state, DeferredLogger &deferred_logger) override
 
void updateIPR (const Simulator &simulator, DeferredLogger &deferred_logger) const override
 
- Protected Member Functions inherited from Opm::WellInterface< TypeTag >
double wpolymer () const
 
double wfoam () const
 
double wsalt () const
 
double wmicrobes () const
 
double woxygen () const
 
double wurea () const
 
const std::vector< double > & compFrac () const
 
std::vector< double > initialWellRateFractions (const Simulator &simulator, const WellState &well_state) const
 
virtual void assembleWellEqWithoutIteration (const Simulator &simulator, const double dt, const WellInjectionControls &inj_controls, const WellProductionControls &prod_controls, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)=0
 
virtual bool iterateWellEqWithControl (const Simulator &simulator, const double dt, const WellInjectionControls &inj_controls, const WellProductionControls &prod_controls, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)=0
 
virtual bool iterateWellEqWithSwitching (const Simulator &simulator, const double dt, const WellInjectionControls &inj_controls, const WellProductionControls &prod_controls, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger, const bool fixed_control=false, const bool fixed_status=false)=0
 
bool iterateWellEquations (const Simulator &simulator, const double dt, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
bool solveWellWithTHPConstraint (const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
std::optional< double > estimateOperableBhp (const Simulator &simulator, const double dt, WellState &well_state, const SummaryState &summary_state, DeferredLogger &deferred_logger)
 
bool solveWellWithBhp (const Simulator &simulator, const double dt, const double bhp, WellState &well_state, DeferredLogger &deferred_logger)
 
bool solveWellWithZeroRate (const Simulator &simulator, const double dt, WellState &well_state, DeferredLogger &deferred_logger)
 
bool solveWellForTesting (const Simulator &simulator, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger)
 
Eval getPerfCellPressure (const FluidState &fs) const
 
template<class Value , class Callback >
void getMobility (const Simulator &simulator, const int perf, std::vector< Value > &mob, Callback &extendEval, DeferredLogger &deferred_logger) const
 
void computeConnLevelProdInd (const FluidState &fs, const std::function< double(const double)> &connPICalc, const std::vector< Scalar > &mobility, double *connPI) const
 
void computeConnLevelInjInd (const FluidState &fs, const Phase preferred_phase, const std::function< double(const double)> &connIICalc, const std::vector< Scalar > &mobility, double *connII, DeferredLogger &deferred_logger) const
 
double computeConnectionDFactor (const int perf, const IntensiveQuantities &intQuants, const SingleWellState &ws) const
 
- Protected Member Functions inherited from Opm::WellInterfaceIndices< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > >
 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 std::optional< Well::InjectionControls > &inj_controls=std::nullopt, const std::optional< Well::ProductionControls > &prod_controls=std::nullopt) 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
 
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, DeferredLogger &deferred_logger) const
 
- Protected Member Functions inherited from Opm::WellInterfaceGeneric
bool getAllowCrossFlow () const
 
double wmicrobes_ () const
 
double wfoam_ () const
 
double woxygen_ () const
 
double wpolymer_ () const
 
double wsalt_ () const
 
double wurea_ () const
 
int polymerTable_ () const
 
int polymerInjTable_ () const
 
int polymerWaterTable_ () const
 
bool wellUnderZeroRateTarget (const SummaryState &summary_state, const WellState &well_state) const
 
std::pair< bool, bool > computeWellPotentials (std::vector< double > &well_potentials, const WellState &well_state)
 
void checkNegativeWellPotentials (std::vector< double > &well_potentials, const bool checkOperability, DeferredLogger &deferred_logger)
 
void prepareForPotentialCalculations (const SummaryState &summary_state, WellState &well_state, Well::InjectionControls &inj_controls, Well::ProductionControls &prod_controls) const
 
- Protected Member Functions inherited from Opm::MultisegmentWellEval< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > >
 MultisegmentWellEval (WellInterfaceIndices< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > > &baseif)
 
void initMatrixAndVectors (const int num_cells)
 
void assembleDefaultPressureEq (const int seg, WellState &well_state, const bool use_average_density)
 
void assembleICDPressureEq (const int seg, const UnitSystem &unit_system, WellState &well_state, const SummaryState &summary_state, const bool use_average_density, DeferredLogger &deferred_logger)
 
void assembleAccelerationAndHydroPressureLosses (const int seg, WellState &well_state, const bool use_average_density)
 
void assemblePressureEq (const int seg, const UnitSystem &unit_system, WellState &well_state, const SummaryState &summary_state, const bool use_average_density, DeferredLogger &deferred_logger)
 
ConvergenceReport getWellConvergence (const WellState &well_state, const std::vector< double > &B_avg, DeferredLogger &deferred_logger, const double max_residual_allowed, const double tolerance_wells, const double relaxed_inner_tolerance_flow_ms_well, const double tolerance_pressure_ms_wells, const double relaxed_inner_tolerance_pressure_ms_well, const bool relax_tolerance, const bool well_is_stopped) const
 check whether the well equations get converged for this well
 
std::pair< bool, std::vector< Scalar > > getFiniteWellResiduals (const std::vector< Scalar > &B_avg, DeferredLogger &deferred_logger) const
 
double getControlTolerance (const WellState &well_state, const double tolerance_wells, const double tolerance_pressure_ms_wells, DeferredLogger &deferred_logger) const
 
double getResidualMeasureValue (const WellState &well_state, const std::vector< double > &residuals, const double tolerance_wells, const double tolerance_pressure_ms_wells, DeferredLogger &deferred_logger) const
 
void assembleAccelerationPressureLoss (const int seg, WellState &well_state)
 
EvalWell pressureDropAutoICD (const int seg, const UnitSystem &unit_system) const
 
EvalWell extendEval (const Eval &in) const
 
- Protected Member Functions inherited from Opm::MultisegmentWellGeneric< FluidSystem::Scalar >
 MultisegmentWellGeneric (WellInterfaceGeneric &baseif)
 
void scaleSegmentRatesWithWellRates (const std::vector< std::vector< int > > &segment_inlets, const std::vector< std::vector< int > > &segment_perforations, WellState &well_state) const
 
void scaleSegmentPressuresWithBhp (WellState &well_state) const
 
WellSegmentCompPressureDrop compPressureDrop () const
 
void detectOscillations (const std::vector< double > &measure_history, bool &oscillate, bool &stagnate) const
 Detect oscillation or stagnation based on the residual measure history.
 
bool accelerationalPressureLossConsidered () const
 
bool frictionalPressureLossConsidered () const
 
double getSegmentDp (const int seg, const double density, const std::vector< double > &seg_dp) const
 

Protected Attributes

bool regularize_
 
std::vector< std::vector< double > > segment_fluid_initial_
 
int debug_cost_counter_ = 0
 
- Protected Attributes inherited from Opm::WellInterface< TypeTag >
const ModelParametersparam_
 
std::vector< RateVector > connectionRates_
 
std::vector< Scalar > B_avg_
 
bool changed_to_stopped_this_step_ = false
 
bool thp_update_iterations = 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_
 
std::vector< double > inj_multiplier_
 
std::vector< double > prev_inj_multiplier_
 
std::vector< double > inj_fc_multiplier_
 
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::MultisegmentWellEval< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > >
const WellInterfaceIndices< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > > & baseif_
 
Equations linSys_
 The equation system.
 
PrimaryVariables primary_variables_
 The primary variables.
 
MSWSegments segments_
 Segment properties.
 
std::vector< double > cell_perforation_depth_diffs_
 
std::vector< double > cell_perforation_pressure_diffs_
 
- Protected Attributes inherited from Opm::MultisegmentWellGeneric< FluidSystem::Scalar >
const WellInterfaceGenericbaseif_
 

Additional Inherited Members

- Protected Types inherited from Opm::WellInterfaceFluidSystem< FluidSystem >
using RateConverterType = RateConverter::SurfaceToReservoirVoidage< FluidSystem, std::vector< int > >
 
- Protected Types inherited from Opm::MultisegmentWellEval< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > >
using Scalar = typename FluidSystem::Scalar
 
using PrimaryVariables = MultisegmentWellPrimaryVariables< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > >
 
using Equations = MultisegmentWellEquations< Scalar, numWellEq, Indices::numEq >
 
using MSWSegments = MultisegmentWellSegments< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > >
 
using BVector = typename Equations::BVector
 
using BVectorWell = typename Equations::BVectorWell
 
using EvalWell = typename PrimaryVariables::EvalWell
 
using Eval = DenseAd::Evaluation< Scalar, Indices::numEq >
 
- Static Protected Attributes inherited from Opm::WellInterfaceFluidSystem< FluidSystem >
static constexpr int INVALIDCOMPLETION = std::numeric_limits<int>::max()
 
- Static Protected Attributes inherited from Opm::MultisegmentWellEval< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices > >
static constexpr int numWellEq
 
static constexpr int SPres
 
static constexpr int WQTotal
 

Member Function Documentation

◆ addWellContributions()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::addWellContributions ( SparseMatrixAdapter &  jacobian) const
overridevirtual

◆ addWellPressureEquations()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::addWellPressureEquations ( PressureMatrix &  mat,
const BVector &  x,
const int  pressureVarIndex,
const bool  use_well_weights,
const WellState well_state 
) const
overridevirtual

◆ apply() [1/2]

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::apply ( BVector &  r) const
overridevirtual

r = r - C D^-1 Rw

Implements Opm::WellInterface< TypeTag >.

◆ apply() [2/2]

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::apply ( const BVector &  x,
BVector &  Ax 
) const
overridevirtual

Ax = Ax - C D^-1 B x.

Implements Opm::WellInterface< TypeTag >.

◆ calculateExplicitQuantities()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::calculateExplicitQuantities ( const Simulator &  simulator,
const WellState well_state,
DeferredLogger deferred_logger 
)
overridevirtual

◆ checkOperabilityUnderBHPLimit()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::checkOperabilityUnderBHPLimit ( const WellState well_state,
const Simulator &  simulator,
DeferredLogger deferred_logger 
)
overrideprotectedvirtual

◆ checkOperabilityUnderTHPLimit()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::checkOperabilityUnderTHPLimit ( const Simulator &  simulator,
const WellState well_state,
DeferredLogger deferred_logger 
)
overrideprotectedvirtual

◆ computeBhpAtThpLimitProdWithAlq()

template<typename TypeTag >
std::optional< double > Opm::MultisegmentWell< TypeTag >::computeBhpAtThpLimitProdWithAlq ( const Simulator &  simulator,
const SummaryState &  summary_state,
const double  alq_value,
DeferredLogger deferred_logger 
) const
overridevirtual

◆ computeCurrentWellRates()

template<typename TypeTag >
std::vector< double > Opm::MultisegmentWell< TypeTag >::computeCurrentWellRates ( const Simulator &  simulator,
DeferredLogger deferred_logger 
) const
overridevirtual

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

Used in updateWellStateRates().

Implements Opm::WellInterface< TypeTag >.

◆ computeWellPotentials()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::computeWellPotentials ( const Simulator &  simulator,
const WellState well_state,
std::vector< double > &  well_potentials,
DeferredLogger deferred_logger 
)
overridevirtual

computing the well potentials for group control

Implements Opm::WellInterface< TypeTag >.

◆ computeWellRatesWithBhp()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::computeWellRatesWithBhp ( const Simulator &  simulator,
const double &  bhp,
std::vector< double > &  well_flux,
DeferredLogger deferred_logger 
) const
overrideprotectedvirtual

◆ connectionDensity()

template<typename TypeTag >
double Opm::MultisegmentWell< TypeTag >::connectionDensity ( const int  globalConnIdx,
const int  openConnIdx 
) const
overridevirtual

◆ getPrimaryVars()

template<typename TypeTag >
std::vector< double > Opm::MultisegmentWell< TypeTag >::getPrimaryVars ( ) const
overridevirtual

Reimplemented from Opm::WellInterface< TypeTag >.

◆ getRefDensity()

template<typename TypeTag >
double Opm::MultisegmentWell< TypeTag >::getRefDensity ( ) const
overrideprotectedvirtual

◆ getWellConvergence()

template<typename TypeTag >
ConvergenceReport Opm::MultisegmentWell< TypeTag >::getWellConvergence ( const SummaryState &  summary_state,
const WellState well_state,
const std::vector< double > &  B_avg,
DeferredLogger deferred_logger,
const bool  relax_tolerance 
) const
overridevirtual

check whether the well equations get converged for this well

Implements Opm::WellInterface< TypeTag >.

◆ initPrimaryVariablesEvaluation()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::initPrimaryVariablesEvaluation ( )
overridevirtual

◆ recoverWellSolutionAndUpdateWellState()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::recoverWellSolutionAndUpdateWellState ( const SummaryState &  summary_state,
const BVector &  x,
WellState well_state,
DeferredLogger deferred_logger 
)
overridevirtual

using the solution x to recover the solution xw for wells and applying xw to update Well State

Implements Opm::WellInterface< TypeTag >.

◆ setPrimaryVars()

template<typename TypeTag >
int Opm::MultisegmentWell< TypeTag >::setPrimaryVars ( std::vector< double >::const_iterator  it)
overridevirtual

Reimplemented from Opm::WellInterface< TypeTag >.

◆ solveEqAndUpdateWellState()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::solveEqAndUpdateWellState ( const SummaryState &  summary_state,
WellState well_state,
DeferredLogger deferred_logger 
)
overridevirtual

◆ updateIPR()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::updateIPR ( const Simulator &  simulator,
DeferredLogger deferred_logger 
) const
overrideprotectedvirtual

◆ updateIPRImplicit()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::updateIPRImplicit ( const Simulator &  simulator,
WellState well_state,
DeferredLogger deferred_logger 
)
overridevirtual

◆ updatePrimaryVariables()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::updatePrimaryVariables ( const SummaryState &  summary_state,
const WellState well_state,
DeferredLogger deferred_logger 
)
overridevirtual

◆ updateProductivityIndex()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::updateProductivityIndex ( const Simulator &  simulator,
const WellProdIndexCalculator wellPICalc,
WellState well_state,
DeferredLogger deferred_logger 
) const
overridevirtual

◆ updateWaterThroughput()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::updateWaterThroughput ( const double  dt,
WellState well_state 
) const
overrideprotectedvirtual

◆ updateWellStateWithTarget()

template<typename TypeTag >
void Opm::MultisegmentWell< TypeTag >::updateWellStateWithTarget ( const Simulator &  simulator,
const GroupState group_state,
WellState well_state,
DeferredLogger deferred_logger 
) const
overridevirtual

updating the well state based the current control mode

Reimplemented from Opm::WellInterface< TypeTag >.


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