|
using | Base = WellInterface< TypeTag > |
|
using | MSWEval = MultisegmentWellEval< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices >, GetPropType< TypeTag, Properties::Scalar > > |
|
using | Simulator = GetPropType< TypeTag, Properties::Simulator > |
|
using | IntensiveQuantities = GetPropType< TypeTag, Properties::IntensiveQuantities > |
|
using | FluidSystem = GetPropType< TypeTag, Properties::FluidSystem > |
|
using | ModelParameters = BlackoilModelParametersEbos< 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 > > |
|
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 | 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 > |
|
using | Eval = DenseAd::Evaluation< GetPropType< TypeTag, Properties::Scalar >, Indices::numEq > |
|
|
| MultisegmentWell (const Well &well, const ParallelWellInfo &pw_info, const int time_step, const ModelParameters ¶m, 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 &ebos_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 &ebosSimulator, 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 &ebosSimulator, const WellState &well_state, DeferredLogger &deferred_logger) override |
|
virtual void | updateProductivityIndex (const Simulator &ebosSimulator, 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 |
|
virtual std::vector< double > | computeCurrentWellRates (const Simulator &ebosSimulator, DeferredLogger &deferred_logger) const override |
| Compute well rates based on current reservoir conditions and well variables.
|
|
std::optional< double > | computeBhpAtThpLimitProdWithAlq (const Simulator &ebos_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 |
|
| WellInterface (const Well &well, const ParallelWellInfo &pw_info, const int time_step, const ModelParameters ¶m, 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.
|
|
void | assembleWellEq (const Simulator &ebosSimulator, const double dt, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger) |
|
void | assembleWellEqWithoutIteration (const Simulator &ebosSimulator, const double dt, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger) |
|
void | prepareWellBeforeAssembling (const Simulator &ebosSimulator, const double dt, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger) |
|
bool | updateWellStateWithTHPTargetProd (const Simulator &ebos_simulator, 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) |
|
bool | updateWellControlAndStatusLocalIteration (const Simulator &ebos_simulator, WellState &well_state, const GroupState &group_state, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, const double WQTotal, DeferredLogger &deferred_logger) |
|
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 &ebos_simulator, const WellState &well_state, DeferredLogger &deferred_logger) |
|
bool | gliftBeginTimeStepWellTestIterateWellEquations (const Simulator &ebos_simulator, const double dt, WellState &well_state, const GroupState &group_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) |
|
bool | updateWellOperabilityFromWellEq (const Simulator &ebos_simulator, const WellState &well_state, DeferredLogger &deferred_logger) |
|
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.
|
|
void | solveWellEquation (const Simulator &ebosSimulator, WellState &well_state, const GroupState &group_state, DeferredLogger &deferred_logger) |
|
const std::vector< RateVector > & | connectionRates () const |
|
int | flowPhaseToEbosCompIdx (const int phaseIdx) const |
|
int | ebosCompIdxToFlowCompIdx (const unsigned compIdx) const |
|
double | scalingFactor (const int phaseIdx) const |
|
Eval | restrictEval (const EvalWell &in) const |
|
int | flowPhaseToEbosPhaseIdx (const int phaseIdx) const |
|
const RateConverterType & | rateConverter () const |
|
| WellInterfaceGeneric (const Well &well, const ParallelWellInfo ¶llel_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 PhaseUsage & | phaseUsage () 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 VFPProperties * | vfpProperties () const |
|
const ParallelWellInfo & | parallelWellInfo () 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 () |
|
const Equations & | linSys () const |
| Returns a const reference to equation system.
|
|
const WellSegments & | segmentSet () const |
|
int | segmentNumberToIndex (const int segment_number) const |
|
int | numberOfSegments () const |
| number of segments for this well
|
|
|
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 &ebos_simulator) |
|
void | computePerfCellPressDiffs (const Simulator &ebosSimulator) |
|
template<class Value > |
void | computePerfRate (const IntensiveQuantities &int_quants, const std::vector< Value > &mob_perfcells, const double 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 double 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 &ebosSimulator, DeferredLogger &deferred_logger) |
|
template<class Value > |
void | getMobility (const Simulator &ebosSimulator, const int perf, std::vector< Value > &mob, DeferredLogger &deferred_logger) const |
|
void | computeWellRatesAtBhpLimit (const Simulator &ebosSimulator, std::vector< double > &well_flux, DeferredLogger &deferred_logger) const |
|
void | computeWellRatesWithBhp (const Simulator &ebosSimulator, const double &bhp, std::vector< double > &well_flux, DeferredLogger &deferred_logger) const override |
|
void | computeWellRatesWithBhpIterations (const Simulator &ebosSimulator, const Scalar &bhp, std::vector< double > &well_flux, DeferredLogger &deferred_logger) const override |
|
std::vector< double > | computeWellPotentialWithTHP (const WellState &well_state, const Simulator &ebos_simulator, DeferredLogger &deferred_logger) const |
|
virtual double | getRefDensity () const override |
|
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) override |
|
virtual bool | iterateWellEqWithSwitching (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) override |
|
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) override |
|
virtual void | updateWaterThroughput (const double dt, WellState &well_state) const override |
|
EvalWell | getSegmentSurfaceVolume (const Simulator &ebos_simulator, const int seg_idx) const |
|
bool | openCrossFlowAvoidSingularity (const Simulator &ebos_simulator) const |
|
bool | allDrawDownWrongDirection (const Simulator &ebos_simulator) const |
|
std::optional< double > | computeBhpAtThpLimitProd (const WellState &well_state, const Simulator &ebos_simulator, const SummaryState &summary_state, DeferredLogger &deferred_logger) const |
|
std::optional< double > | computeBhpAtThpLimitInj (const Simulator &ebos_simulator, const SummaryState &summary_state, DeferredLogger &deferred_logger) const |
|
double | maxPerfPress (const Simulator &ebos_simulator) const |
|
virtual void | checkOperabilityUnderBHPLimit (const WellState &well_state, const Simulator &ebos_simulator, DeferredLogger &deferred_logger) override |
|
virtual void | checkOperabilityUnderTHPLimit (const Simulator &ebos_simulator, const WellState &well_state, DeferredLogger &deferred_logger) override |
|
virtual void | updateIPR (const Simulator &ebos_simulator, DeferredLogger &deferred_logger) const override |
|
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 &ebosSimulator, const WellState &well_state) const |
|
virtual void | assembleWellEqWithoutIteration (const Simulator &ebosSimulator, 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 &ebosSimulator, 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 &ebosSimulator, const double dt, const WellInjectionControls &inj_controls, const WellProductionControls &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 |
|
template<class Value , class Callback > |
void | getMobility (const Simulator &ebosSimulator, 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 |
|
| WellInterfaceIndices (const Well &well, const ParallelWellInfo ¶llel_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) |
|
| WellInterfaceFluidSystem (const Well &well, const ParallelWellInfo ¶llel_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 |
|
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) |
|
| MultisegmentWellEval (WellInterfaceIndices< GetPropType< TypeTag, Properties::FluidSystem >, GetPropType< TypeTag, Properties::Indices >, GetPropType< TypeTag, Properties::Scalar > > &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 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 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 |
| check whether the well equations get converged for this well
|
|
std::pair< bool, std::vector< GetPropType< TypeTag, Properties::Scalar > > > | getFiniteWellResiduals (const std::vector< GetPropType< TypeTag, Properties::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 | handleAccelerationPressureLoss (const int seg, WellState &well_state) |
|
EvalWell | pressureDropAutoICD (const int seg, const UnitSystem &unit_system) const |
|
EvalWell | extendEval (const Eval &in) const |
|
| 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 |
|