22#ifndef OPM_STANDARDWELL_IMPL_HEADER_INCLUDED
23#define OPM_STANDARDWELL_IMPL_HEADER_INCLUDED
26#ifndef OPM_STANDARDWELL_HEADER_INCLUDED
31#include <opm/common/Exceptions.hpp>
33#include <opm/input/eclipse/Units/Units.hpp>
45#include <fmt/format.h>
50 template<
typename TypeTag>
57 const int pvtRegionIdx,
58 const int num_conservation_quantities,
60 const int index_of_well,
62 :
Base(well, pw_info, time_step, param, rate_converter, pvtRegionIdx, num_conservation_quantities, num_phases, index_of_well, perf_data)
73 template<
typename TypeTag>
76 init(
const std::vector<Scalar>& depth_arg,
78 const std::vector< Scalar >& B_avg,
79 const bool changed_to_open_this_step)
81 Base::init(depth_arg, gravity_arg, B_avg, changed_to_open_this_step);
82 this->StdWellEval::init(this->perf_depth_, depth_arg, Base::has_polymermw);
89 template<
typename TypeTag>
94 const std::vector<Value>& mob,
96 const std::vector<Value>& Tw,
99 std::vector<Value>& cq_s,
103 auto obtain = [
this](
const Eval& value)
105 if constexpr (std::is_same_v<Value, Scalar>) {
106 static_cast<void>(
this);
107 return getValue(value);
109 return this->extendEval(value);
112 auto obtainN = [](
const auto& value)
114 if constexpr (std::is_same_v<Value, Scalar>) {
115 return getValue(value);
120 auto zeroElem = [
this]()
122 if constexpr (std::is_same_v<Value, Scalar>) {
123 static_cast<void>(
this);
126 return Value{this->primary_variables_.numWellEq() + Indices::numEq, 0.0};
130 const auto& fs = intQuants.fluidState();
131 const Value pressure = obtain(this->getPerfCellPressure(fs));
132 const Value rs = obtain(fs.Rs());
133 const Value rv = obtain(fs.Rv());
134 const Value rvw = obtain(fs.Rvw());
135 const Value rsw = obtain(fs.Rsw());
137 std::vector<Value> b_perfcells_dense(this->numConservationQuantities(), zeroElem());
138 for (
unsigned phaseIdx = 0; phaseIdx < FluidSystem::numPhases; ++phaseIdx) {
139 if (!FluidSystem::phaseIsActive(phaseIdx)) {
142 const unsigned compIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::solventComponentIndex(phaseIdx));
143 b_perfcells_dense[compIdx] = obtain(fs.invB(phaseIdx));
145 if constexpr (has_solvent) {
146 b_perfcells_dense[Indices::contiSolventEqIdx] = obtain(intQuants.solventInverseFormationVolumeFactor());
149 if constexpr (has_zFraction) {
150 if (this->isInjector()) {
151 const unsigned gasCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
152 b_perfcells_dense[gasCompIdx] *= (1.0 - this->wsolvent());
153 b_perfcells_dense[gasCompIdx] += this->wsolvent()*intQuants.zPureInvFormationVolumeFactor().value();
157 Value skin_pressure = zeroElem();
159 if (this->isInjector()) {
160 const int pskin_index = Bhp + 1 + this->numLocalPerfs() + perf;
161 skin_pressure = obtainN(this->primary_variables_.eval(pskin_index));
166 std::vector<Value> cmix_s(this->numConservationQuantities(), zeroElem());
167 for (
int componentIdx = 0; componentIdx < this->numConservationQuantities(); ++componentIdx) {
168 cmix_s[componentIdx] = obtainN(this->primary_variables_.surfaceVolumeFraction(componentIdx));
191 template<
typename TypeTag>
192 template<
class Value>
196 const Value& pressure,
202 std::vector<Value>& b_perfcells_dense,
203 const std::vector<Value>& Tw,
206 const Value& skin_pressure,
207 const std::vector<Value>& cmix_s,
208 std::vector<Value>& cq_s,
213 const Value well_pressure = bhp + this->connections_.pressure_diff(perf);
214 Value drawdown = pressure - well_pressure;
215 if (this->isInjector()) {
216 drawdown += skin_pressure;
220 FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx)
221 ? FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx)
223 FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx)
224 ? FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx)
226 FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx)
227 ? FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx)
235 if (!allow_cf && this->isInjector()) {
240 for (
int componentIdx = 0; componentIdx < this->numConservationQuantities(); ++componentIdx) {
241 const Value cq_p = - Tw[componentIdx] * (mob[componentIdx] * drawdown);
242 cq_s[componentIdx] = b_perfcells_dense[componentIdx] * cq_p;
245 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) &&
246 FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx))
248 ratioCalc.gasOilPerfRateProd(cq_s, perf_rates, rv, rs, rvw,
249 FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx),
251 }
else if (FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx) &&
252 FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx))
254 ratioCalc.gasWaterPerfRateProd(cq_s, perf_rates, rvw, rsw, this->isProducer());
258 if (!allow_cf && this->isProducer()) {
263 Value total_mob_dense = mob[0];
264 for (
int componentIdx = 1; componentIdx < this->numConservationQuantities(); ++componentIdx) {
265 total_mob_dense += mob[componentIdx];
269 Value volumeRatio = bhp * 0.0;
271 if (FluidSystem::enableVaporizedWater() && FluidSystem::enableDissolvedGasInWater()) {
272 ratioCalc.disOilVapWatVolumeRatio(volumeRatio, rvw, rsw, pressure,
273 cmix_s, b_perfcells_dense, deferred_logger);
277 assert(FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx));
278 assert(FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx));
279 assert(!FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx));
282 if (FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx)) {
283 const unsigned waterCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
284 volumeRatio += cmix_s[waterCompIdx] / b_perfcells_dense[waterCompIdx];
287 if constexpr (Indices::enableSolvent) {
288 volumeRatio += cmix_s[Indices::contiSolventEqIdx] / b_perfcells_dense[Indices::contiSolventEqIdx];
291 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) &&
292 FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx))
294 ratioCalc.gasOilVolumeRatio(volumeRatio, rv, rs, pressure,
295 cmix_s, b_perfcells_dense,
298 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx)) {
299 const unsigned oilCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx);
300 volumeRatio += cmix_s[oilCompIdx] / b_perfcells_dense[oilCompIdx];
302 if (FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx)) {
303 const unsigned gasCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
304 volumeRatio += cmix_s[gasCompIdx] / b_perfcells_dense[gasCompIdx];
310 for (
int componentIdx = 0; componentIdx < this->numConservationQuantities(); ++componentIdx) {
311 const Value cqt_i = - Tw[componentIdx] * (total_mob_dense * drawdown);
312 Value cqt_is = cqt_i / volumeRatio;
313 cq_s[componentIdx] = cmix_s[componentIdx] * cqt_is;
317 if (this->isProducer()) {
318 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) &&
319 FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx))
321 ratioCalc.gasOilPerfRateInj(cq_s, perf_rates,
322 rv, rs, pressure, rvw,
323 FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx),
326 if (FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx) &&
327 FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx))
330 ratioCalc.gasWaterPerfRateInj(cq_s, perf_rates, rvw, rsw,
331 pressure, deferred_logger);
338 template<
typename TypeTag>
344 const Well::InjectionControls& inj_controls,
345 const Well::ProductionControls& prod_controls,
348 const bool solving_with_zero_rate)
352 if (!this->isOperableAndSolvable() && !this->wellIsStopped())
return;
355 this->linSys_.clear();
357 assembleWellEqWithoutIterationImpl(simulator, wgHelper, dt, inj_controls,
358 prod_controls, well_state,
359 deferred_logger, solving_with_zero_rate);
365 template<
typename TypeTag>
371 const Well::InjectionControls& inj_controls,
372 const Well::ProductionControls& prod_controls,
375 const bool solving_with_zero_rate)
378 const Scalar regularization_factor = this->regularize_? this->param_.regularization_factor_wells_ : 1.0;
379 const Scalar volume = 0.1 * unit::cubic(unit::feet) * regularization_factor;
381 auto& ws = well_state.
well(this->index_of_well_);
382 ws.phase_mixing_rates.fill(0.0);
383 if constexpr (has_energy) {
384 ws.energy_rate = 0.0;
388 const int np = this->number_of_phases_;
390 std::vector<RateVector> connectionRates = this->connectionRates_;
392 auto& perf_data = ws.perf_data;
393 auto& perf_rates = perf_data.phase_rates;
394 for (
int perf = 0; perf < this->number_of_local_perforations_; ++perf) {
396 std::vector<EvalWell> cq_s(this->num_conservation_quantities_, 0.0);
399 calculateSinglePerf(simulator, perf, well_state, connectionRates,
400 cq_s, water_flux_s, cq_s_zfrac_effective, deferred_logger);
403 if constexpr (has_polymer && Base::has_polymermw) {
404 if (this->isInjector()) {
405 handleInjectivityEquations(simulator, well_state, perf,
406 water_flux_s, deferred_logger);
409 for (
int componentIdx = 0; componentIdx < this->num_conservation_quantities_; ++componentIdx) {
411 const EvalWell cq_s_effective = cq_s[componentIdx] * this->well_efficiency_factor_;
413 connectionRates[perf][componentIdx] = Base::restrictEval(cq_s_effective);
416 assemblePerforationEq(cq_s_effective,
419 this->primary_variables_.numWellEq(),
423 if (has_solvent && componentIdx == Indices::contiSolventEqIdx) {
424 auto& perf_rate_solvent = perf_data.solvent_rates;
425 perf_rate_solvent[perf] = cq_s[componentIdx].value();
427 perf_rates[perf*np + FluidSystem::activeCompToActivePhaseIdx(componentIdx)] = cq_s[componentIdx].value();
431 if constexpr (has_zFraction) {
433 assembleZFracEq(cq_s_zfrac_effective,
435 this->primary_variables_.numWellEq(),
440 this->connectionRates_ = connectionRates;
445 const auto& comm = this->parallel_well_info_.communication();
446 comm.sum(ws.phase_mixing_rates.data(), ws.phase_mixing_rates.size());
450 this->linSys_.sumDistributed(this->parallel_well_info_.communication());
453 for (
int componentIdx = 0; componentIdx < numWellConservationEq; ++componentIdx) {
457 if (FluidSystem::numActivePhases() > 1) {
459 resWell_loc += (this->primary_variables_.surfaceVolumeFraction(componentIdx) -
460 this->F0_[componentIdx]) * volume / dt;
462 resWell_loc -= this->primary_variables_.getQs(componentIdx) * this->well_efficiency_factor_;
464 assembleSourceEq(resWell_loc,
466 this->primary_variables_.numWellEq(),
470 const auto& summaryState = simulator.vanguard().summaryState();
471 const Schedule& schedule = simulator.vanguard().schedule();
472 const bool stopped_or_zero_target = this->stoppedOrZeroRateTarget(simulator, well_state, deferred_logger);
478 const auto& group_state = solving_with_zero_rate
482 assembleControlEq(well_state, group_state,
483 schedule, summaryState,
484 inj_controls, prod_controls,
485 this->primary_variables_,
486 this->getRefDensity(),
488 stopped_or_zero_target,
494 this->linSys_.invert();
496 OPM_DEFLOG_PROBLEM(NumericalProblem,
"Error when inverting local well equations for well " + name(), deferred_logger);
503 template<
typename TypeTag>
509 std::vector<RateVector>& connectionRates,
510 std::vector<EvalWell>& cq_s,
515 const bool allow_cf = this->getAllowCrossFlow() || openCrossFlowAvoidSingularity(simulator);
516 const EvalWell& bhp = this->primary_variables_.eval(Bhp);
517 const int cell_idx = this->well_cells_[perf];
518 const auto& intQuants = simulator.model().intensiveQuantities(cell_idx, 0);
519 std::vector<EvalWell> mob(this->num_conservation_quantities_, {0.});
520 getMobility(simulator, perf, mob, deferred_logger);
524 getTransMult(trans_mult, simulator, cell_idx);
525 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
526 std::vector<EvalWell> Tw(this->num_conservation_quantities_, this->well_index_[perf] * trans_mult);
527 this->getTw(Tw, perf, intQuants, trans_mult, wellstate_nupcol);
528 computePerfRate(intQuants, mob, bhp, Tw, perf, allow_cf,
529 cq_s, perf_rates, deferred_logger);
531 auto& ws = well_state.
well(this->index_of_well_);
532 auto& perf_data = ws.perf_data;
533 if constexpr (has_polymer && Base::has_polymermw) {
534 if (this->isInjector()) {
537 const unsigned water_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
538 water_flux_s = cq_s[water_comp_idx];
541 handleInjectivityRate(simulator, perf, cq_s);
546 if (this->isProducer()) {
547 ws.phase_mixing_rates[ws.dissolved_gas] += perf_rates.
dis_gas;
548 ws.phase_mixing_rates[ws.dissolved_gas_in_water] += perf_rates.
dis_gas_in_water;
549 ws.phase_mixing_rates[ws.vaporized_oil] += perf_rates.
vap_oil;
550 ws.phase_mixing_rates[ws.vaporized_water] += perf_rates.
vap_wat;
551 perf_data.phase_mixing_rates[perf][ws.dissolved_gas] = perf_rates.
dis_gas;
552 perf_data.phase_mixing_rates[perf][ws.dissolved_gas_in_water] = perf_rates.
dis_gas_in_water;
553 perf_data.phase_mixing_rates[perf][ws.vaporized_oil] = perf_rates.
vap_oil;
554 perf_data.phase_mixing_rates[perf][ws.vaporized_water] = perf_rates.
vap_wat;
557 if constexpr (has_energy) {
558 connectionRates[perf][Indices::contiEnergyEqIdx] =
559 connectionRateEnergy(cq_s, intQuants, deferred_logger);
560 ws.energy_rate += getValue(connectionRates[perf][Indices::contiEnergyEqIdx]);
563 if constexpr (has_polymer) {
564 std::variant<Scalar,EvalWell> polymerConcentration;
565 if (this->isInjector()) {
566 polymerConcentration = this->wpolymer();
568 polymerConcentration = this->extendEval(intQuants.polymerConcentration() *
569 intQuants.polymerViscosityCorrection());
572 [[maybe_unused]]
EvalWell cq_s_poly;
573 std::tie(connectionRates[perf][Indices::contiPolymerEqIdx],
575 this->connections_.connectionRatePolymer(perf_data.polymer_rates[perf],
576 cq_s, polymerConcentration);
578 if constexpr (Base::has_polymermw) {
579 updateConnectionRatePolyMW(cq_s_poly, intQuants, well_state,
580 perf, connectionRates, deferred_logger);
584 if constexpr (has_foam) {
585 std::variant<Scalar,EvalWell> foamConcentration;
586 if (this->isInjector()) {
587 foamConcentration = this->wfoam();
589 foamConcentration = this->extendEval(intQuants.foamConcentration());
591 connectionRates[perf][Indices::contiFoamEqIdx] =
592 this->connections_.connectionRateFoam(cq_s, foamConcentration,
593 FoamModule::transportPhase(),
597 if constexpr (has_zFraction) {
598 std::variant<Scalar,std::array<EvalWell,2>> solventConcentration;
599 if (this->isInjector()) {
600 solventConcentration = this->wsolvent();
602 solventConcentration = std::array{this->extendEval(intQuants.xVolume()),
603 this->extendEval(intQuants.yVolume())};
605 std::tie(connectionRates[perf][Indices::contiZfracEqIdx],
606 cq_s_zfrac_effective) =
607 this->connections_.connectionRatezFraction(perf_data.solvent_rates[perf],
609 solventConcentration);
612 if constexpr (has_brine) {
613 std::variant<Scalar,EvalWell> saltConcentration;
614 if (this->isInjector()) {
615 saltConcentration = this->wsalt();
617 saltConcentration = this->extendEval(intQuants.fluidState().saltConcentration());
620 connectionRates[perf][Indices::contiBrineEqIdx] =
621 this->connections_.connectionRateBrine(perf_data.brine_rates[perf],
626 if constexpr (has_bioeffects) {
627 std::variant<Scalar,EvalWell> microbialConcentration;
628 if constexpr (has_micp) {
629 std::variant<Scalar,EvalWell> oxygenConcentration;
630 std::variant<Scalar,EvalWell> ureaConcentration;
631 if (this->isInjector()) {
632 microbialConcentration = this->wmicrobes();
633 oxygenConcentration = this->woxygen();
634 ureaConcentration = this->wurea();
636 microbialConcentration = this->extendEval(intQuants.microbialConcentration());
637 oxygenConcentration = this->extendEval(intQuants.oxygenConcentration());
638 ureaConcentration = this->extendEval(intQuants.ureaConcentration());
640 std::tie(connectionRates[perf][Indices::contiMicrobialEqIdx],
641 connectionRates[perf][Indices::contiOxygenEqIdx],
642 connectionRates[perf][Indices::contiUreaEqIdx]) =
643 this->connections_.connectionRatesMICP(perf_data.microbial_rates[perf],
644 perf_data.oxygen_rates[perf],
645 perf_data.urea_rates[perf],
647 microbialConcentration,
652 if (this->isProducer()) {
653 microbialConcentration = this->extendEval(intQuants.microbialConcentration());
654 connectionRates[perf][Indices::contiMicrobialEqIdx] =
655 this->connections_.connectionRateBioeffects(perf_data.microbial_rates[perf],
657 microbialConcentration);
663 perf_data.pressure[perf] = ws.bhp + this->connections_.pressure_diff(perf);
666 if (FluidSystem::phaseUsage().hasCO2orH2Store()) {
667 const unsigned gas_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
668 const Scalar rho = FluidSystem::referenceDensity( FluidSystem::gasPhaseIdx, Base::pvtRegionIdx() );
669 perf_data.gas_mass_rates[perf] = cq_s[gas_comp_idx].value() * rho;
673 if (FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx)) {
674 const unsigned wat_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
675 const Scalar rho = FluidSystem::referenceDensity( FluidSystem::waterPhaseIdx, Base::pvtRegionIdx() );
676 perf_data.wat_mass_rates[perf] = cq_s[wat_comp_idx].value() * rho;
680 template<
typename TypeTag>
681 template<
class Value>
686 const int cell_idx)
const
688 auto obtain = [
this](
const Eval& value)
690 if constexpr (std::is_same_v<Value, Scalar>) {
691 static_cast<void>(
this);
692 return getValue(value);
694 return this->extendEval(value);
700 template<
typename TypeTag>
701 template<
class Value>
706 std::vector<Value>& mob,
709 auto obtain = [
this](
const Eval& value)
711 if constexpr (std::is_same_v<Value, Scalar>) {
712 static_cast<void>(
this);
713 return getValue(value);
715 return this->extendEval(value);
719 obtain, deferred_logger);
722 if constexpr (has_polymer) {
723 if (!FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx)) {
724 OPM_DEFLOG_THROW(std::runtime_error,
"Water is required when polymer is active", deferred_logger);
729 if constexpr (!Base::has_polymermw) {
730 if constexpr (std::is_same_v<Value, Scalar>) {
731 std::vector<EvalWell> mob_eval(this->num_conservation_quantities_, 0.);
732 for (std::size_t i = 0; i < mob.size(); ++i) {
733 mob_eval[i].setValue(mob[i]);
735 updateWaterMobilityWithPolymer(simulator, perf, mob_eval, deferred_logger);
736 for (std::size_t i = 0; i < mob.size(); ++i) {
737 mob[i] = getValue(mob_eval[i]);
740 updateWaterMobilityWithPolymer(simulator, perf, mob, deferred_logger);
747 const Scalar bhp = this->primary_variables_.value(Bhp);
748 const Scalar perf_press = bhp + this->connections_.pressure_diff(perf);
749 const Scalar multiplier = this->getInjMult(perf, bhp, perf_press, deferred_logger);
750 for (std::size_t i = 0; i < mob.size(); ++i) {
751 mob[i] *= multiplier;
757 template<
typename TypeTag>
765 if (!this->isOperableAndSolvable() && !this->wellIsStopped())
return;
767 const bool stop_or_zero_rate_target = this->stoppedOrZeroRateTarget(simulator, well_state, deferred_logger);
768 updatePrimaryVariablesNewton(dwells, stop_or_zero_rate_target, deferred_logger);
770 const auto& summary_state = simulator.vanguard().summaryState();
771 updateWellStateFromPrimaryVariables(well_state, summary_state, deferred_logger);
772 Base::calculateReservoirRates(simulator.vanguard().eclState().runspec().co2Storage(), well_state.
well(this->index_of_well_));
779 template<
typename TypeTag>
783 const bool stop_or_zero_rate_target,
786 const Scalar dFLimit = this->param_.dwell_fraction_max_;
787 const Scalar dBHPLimit = this->param_.dbhp_max_rel_;
788 this->primary_variables_.updateNewton(dwells, stop_or_zero_rate_target, dFLimit, dBHPLimit, deferred_logger);
791 if constexpr (Base::has_polymermw) {
792 this->primary_variables_.updateNewtonPolyMW(dwells);
795 this->primary_variables_.checkFinite(deferred_logger);
802 template<
typename TypeTag>
806 const SummaryState& summary_state,
809 this->primary_variables_.copyToWellState(well_state, deferred_logger);
812 updateThp(getRefDensity(),
813 [
this,&well_state]() {
return this->baseif_.getALQ(well_state); },
814 well_state, summary_state, deferred_logger);
817 if constexpr (Base::has_polymermw) {
818 this->primary_variables_.copyToWellStatePolyMW(well_state);
826 template<
typename TypeTag>
834 std::fill(this->ipr_a_.begin(), this->ipr_a_.end(), 0.);
835 std::fill(this->ipr_b_.begin(), this->ipr_b_.end(), 0.);
837 for (
int perf = 0; perf < this->number_of_local_perforations_; ++perf) {
838 std::vector<Scalar> mob(this->num_conservation_quantities_, 0.0);
839 getMobility(simulator, perf, mob, deferred_logger);
841 const int cell_idx = this->well_cells_[perf];
842 const auto& int_quantities = simulator.model().intensiveQuantities(cell_idx, 0);
843 const auto& fs = int_quantities.fluidState();
845 Scalar p_r = this->getPerfCellPressure(fs).value();
848 std::vector<Scalar> b_perf(this->num_conservation_quantities_);
849 for (std::size_t phase = 0; phase < FluidSystem::numPhases; ++phase) {
850 if (!FluidSystem::phaseIsActive(phase)) {
853 const unsigned comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::solventComponentIndex(phase));
854 b_perf[comp_idx] = fs.invB(phase).value();
856 if constexpr (has_solvent) {
857 b_perf[Indices::contiSolventEqIdx] = int_quantities.solventInverseFormationVolumeFactor().value();
861 const Scalar h_perf = this->connections_.pressure_diff(perf);
862 const Scalar pressure_diff = p_r - h_perf;
867 if ( (this->isProducer() && pressure_diff < 0.) || (this->isInjector() && pressure_diff > 0.) ) {
868 deferred_logger.
debug(
"CROSSFLOW_IPR",
869 "cross flow found when updateIPR for well " + name()
870 +
" . The connection is ignored in IPR calculations");
877 getTransMult(trans_mult, simulator, cell_idx);
878 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
879 std::vector<Scalar> tw_perf(this->num_conservation_quantities_, this->well_index_[perf] * trans_mult);
880 this->getTw(tw_perf, perf, int_quantities, trans_mult, wellstate_nupcol);
881 std::vector<Scalar> ipr_a_perf(this->ipr_a_.size());
882 std::vector<Scalar> ipr_b_perf(this->ipr_b_.size());
883 for (
int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx) {
884 const Scalar tw_mob = tw_perf[comp_idx] * mob[comp_idx] * b_perf[comp_idx];
885 ipr_a_perf[comp_idx] += tw_mob * pressure_diff;
886 ipr_b_perf[comp_idx] += tw_mob;
890 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) && FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx)) {
891 const unsigned oil_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx);
892 const unsigned gas_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
893 const Scalar rs = (fs.Rs()).value();
894 const Scalar rv = (fs.Rv()).value();
896 const Scalar dis_gas_a = rs * ipr_a_perf[oil_comp_idx];
897 const Scalar vap_oil_a = rv * ipr_a_perf[gas_comp_idx];
899 ipr_a_perf[gas_comp_idx] += dis_gas_a;
900 ipr_a_perf[oil_comp_idx] += vap_oil_a;
902 const Scalar dis_gas_b = rs * ipr_b_perf[oil_comp_idx];
903 const Scalar vap_oil_b = rv * ipr_b_perf[gas_comp_idx];
905 ipr_b_perf[gas_comp_idx] += dis_gas_b;
906 ipr_b_perf[oil_comp_idx] += vap_oil_b;
909 for (std::size_t comp_idx = 0; comp_idx < ipr_a_perf.size(); ++comp_idx) {
910 this->ipr_a_[comp_idx] += ipr_a_perf[comp_idx];
911 this->ipr_b_[comp_idx] += ipr_b_perf[comp_idx];
914 this->parallel_well_info_.communication().sum(this->ipr_a_.data(), this->ipr_a_.size());
915 this->parallel_well_info_.communication().sum(this->ipr_b_.data(), this->ipr_b_.size());
918 template<
typename TypeTag>
933 auto rates = well_state.
well(this->index_of_well_).surface_rates;
935 for (std::size_t p = 0; p < rates.size(); ++p) {
936 zero_rates &= rates[p] == 0.0;
938 auto& ws = well_state.
well(this->index_of_well_);
940 const auto msg = fmt::format(
"updateIPRImplicit: Well {} has zero rate, IPRs might be problematic", this->name());
941 deferred_logger.
debug(msg);
954 std::fill(ws.implicit_ipr_a.begin(), ws.implicit_ipr_a.end(), 0.);
955 std::fill(ws.implicit_ipr_b.begin(), ws.implicit_ipr_b.end(), 0.);
957 auto inj_controls = Well::InjectionControls(0);
958 auto prod_controls = Well::ProductionControls(0);
959 prod_controls.addControl(Well::ProducerCMode::BHP);
960 prod_controls.bhp_limit = well_state.
well(this->index_of_well_).bhp;
963 const auto cmode = ws.production_cmode;
964 ws.production_cmode = Well::ProducerCMode::BHP;
965 const double dt = simulator.timeStepSize();
966 assembleWellEqWithoutIteration(simulator, wgHelper, dt, inj_controls, prod_controls, well_state, deferred_logger,
969 const size_t nEq = this->primary_variables_.numWellEq();
973 for (
size_t i=0; i < nEq; ++i){
979 x_well[0].resize(nEq);
980 this->linSys_.solve(rhs, x_well);
982 for (
int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx){
983 EvalWell comp_rate = this->primary_variables_.getQs(comp_idx);
984 const int idx = FluidSystem::activeCompToActivePhaseIdx(comp_idx);
985 for (
size_t pvIdx = 0; pvIdx < nEq; ++pvIdx) {
987 ws.implicit_ipr_b[idx] -= x_well[0][pvIdx]*comp_rate.derivative(pvIdx+Indices::numEq);
989 ws.implicit_ipr_a[idx] = ws.implicit_ipr_b[idx]*ws.bhp - comp_rate.value();
992 ws.production_cmode = cmode;
995 template<
typename TypeTag>
1002 const auto& summaryState = simulator.vanguard().summaryState();
1006 const bool bhp_limit_not_defaulted = bhp_limit > 1.5 * unit::barsa;
1007 if ( bhp_limit_not_defaulted || !this->wellHasTHPConstraints(summaryState) ) {
1010 Scalar total_ipr_mass_rate = 0.0;
1011 for (
unsigned phaseIdx = 0; phaseIdx < FluidSystem::numPhases; ++phaseIdx)
1013 if (!FluidSystem::phaseIsActive(phaseIdx)) {
1017 const unsigned compIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::solventComponentIndex(phaseIdx));
1018 const Scalar ipr_rate = this->ipr_a_[compIdx] - this->ipr_b_[compIdx] * bhp_limit;
1020 const Scalar rho = FluidSystem::referenceDensity( phaseIdx, Base::pvtRegionIdx() );
1021 total_ipr_mass_rate += ipr_rate * rho;
1023 if ( (this->isProducer() && total_ipr_mass_rate < 0.) || (this->isInjector() && total_ipr_mass_rate > 0.) ) {
1024 this->operability_status_.operable_under_only_bhp_limit =
false;
1028 if (this->operability_status_.operable_under_only_bhp_limit && this->wellHasTHPConstraints(summaryState)) {
1032 std::vector<Scalar> well_rates_bhp_limit;
1033 computeWellRatesWithBhp(simulator, bhp_limit, well_rates_bhp_limit, deferred_logger);
1035 this->adaptRatesForVFP(well_rates_bhp_limit);
1036 const Scalar thp_limit = this->getTHPConstraint(summaryState);
1039 this->getRefDensity(),
1040 this->getALQ(well_state),
1043 if ( (this->isProducer() && thp < thp_limit) || (this->isInjector() && thp > thp_limit) ) {
1044 this->operability_status_.obey_thp_limit_under_bhp_limit =
false;
1055 this->operability_status_.operable_under_only_bhp_limit =
true;
1056 this->operability_status_.obey_thp_limit_under_bhp_limit =
false;
1064 template<
typename TypeTag>
1072 const auto& summaryState = simulator.vanguard().summaryState();
1073 const auto obtain_bhp = this->isProducer() ? computeBhpAtThpLimitProd(well_state, simulator, wgHelper, summaryState, deferred_logger)
1074 : computeBhpAtThpLimitInj(simulator, wgHelper, summaryState, deferred_logger);
1077 this->operability_status_.can_obtain_bhp_with_thp_limit =
true;
1080 this->operability_status_.obey_bhp_limit_with_thp_limit = this->isProducer() ?
1081 *obtain_bhp >= bhp_limit : *obtain_bhp <= bhp_limit ;
1083 const Scalar thp_limit = this->getTHPConstraint(summaryState);
1084 if (this->isProducer() && *obtain_bhp < thp_limit) {
1085 const std::string msg =
" obtained bhp " +
std::to_string(unit::convert::to(*obtain_bhp, unit::barsa))
1086 +
" bars is SMALLER than thp limit "
1088 +
" bars as a producer for well " + name();
1089 deferred_logger.
debug(msg);
1091 else if (this->isInjector() && *obtain_bhp > thp_limit) {
1092 const std::string msg =
" obtained bhp " +
std::to_string(unit::convert::to(*obtain_bhp, unit::barsa))
1093 +
" bars is LARGER than thp limit "
1095 +
" bars as a injector for well " + name();
1096 deferred_logger.
debug(msg);
1099 this->operability_status_.can_obtain_bhp_with_thp_limit =
false;
1100 this->operability_status_.obey_bhp_limit_with_thp_limit =
false;
1101 if (!this->wellIsStopped()) {
1102 const Scalar thp_limit = this->getTHPConstraint(summaryState);
1103 deferred_logger.
debug(
" could not find bhp value at thp limit "
1105 +
" bar for well " + name() +
", the well might need to be closed ");
1114 template<
typename TypeTag>
1119 bool all_drawdown_wrong_direction =
true;
1121 for (
int perf = 0; perf < this->number_of_local_perforations_; ++perf) {
1122 const int cell_idx = this->well_cells_[perf];
1123 const auto& intQuants = simulator.model().intensiveQuantities(cell_idx, 0);
1124 const auto& fs = intQuants.fluidState();
1126 const Scalar pressure = this->getPerfCellPressure(fs).value();
1127 const Scalar bhp = this->primary_variables_.eval(Bhp).value();
1130 const Scalar well_pressure = bhp + this->connections_.pressure_diff(perf);
1131 const Scalar drawdown = pressure - well_pressure;
1136 if ( (drawdown < 0. && this->isInjector()) ||
1137 (drawdown > 0. && this->isProducer()) ) {
1138 all_drawdown_wrong_direction =
false;
1143 const auto& comm = this->parallel_well_info_.communication();
1144 if (comm.size() > 1)
1146 all_drawdown_wrong_direction =
1147 (comm.min(all_drawdown_wrong_direction ? 1 : 0) == 1);
1150 return all_drawdown_wrong_direction;
1156 template<
typename TypeTag>
1161 return !this->getAllowCrossFlow() && allDrawDownWrongDirection(simulator);
1167 template<
typename TypeTag>
1173 auto prop_func =
typename StdWellEval::StdWellConnections::PressurePropertyFunctions {
1175 [&model = simulator.model()](
int cell_idx,
int phase_idx)
1177 return model.intensiveQuantities(cell_idx, 0)
1178 .fluidState().temperature(phase_idx).value();
1182 [&model = simulator.model()](
int cell_idx)
1184 return model.intensiveQuantities(cell_idx, 0)
1185 .fluidState().saltConcentration().value();
1189 [&model = simulator.model()](
int cell_idx)
1191 return model.intensiveQuantities(cell_idx, 0)
1192 .fluidState().pvtRegionIndex();
1196 if constexpr (Indices::enableSolvent) {
1197 prop_func.solventInverseFormationVolumeFactor =
1198 [&model = simulator.model()](
int cell_idx)
1200 return model.intensiveQuantities(cell_idx, 0)
1201 .solventInverseFormationVolumeFactor().value();
1204 prop_func.solventRefDensity = [&model = simulator.model()](
int cell_idx)
1206 return model.intensiveQuantities(cell_idx, 0)
1207 .solventRefDensity();
1211 return this->connections_.computePropertiesForPressures(well_state, prop_func);
1218 template<
typename TypeTag>
1223 const std::vector<Scalar>& B_avg,
1225 const bool relax_tolerance)
const
1229 assert((
int(B_avg.size()) == this->num_conservation_quantities_) || has_polymer || has_energy || has_foam || has_brine || has_zFraction || has_bioeffects);
1231 Scalar tol_wells = this->param_.tolerance_wells_;
1233 constexpr Scalar stopped_factor = 1.e-4;
1235 constexpr Scalar dynamic_thp_factor = 1.e-1;
1236 if (this->stoppedOrZeroRateTarget(simulator, well_state, deferred_logger)) {
1237 tol_wells = tol_wells*stopped_factor;
1238 }
else if (this->getDynamicThpLimit()) {
1239 tol_wells = tol_wells*dynamic_thp_factor;
1242 std::vector<Scalar> res;
1245 this->param_.max_residual_allowed_,
1247 this->param_.relaxed_tolerance_flow_well_,
1249 this->wellIsStopped(),
1253 checkConvergenceExtraEqs(res, report);
1262 template<
typename TypeTag>
1270 auto fluidState = [&simulator,
this](
const int perf)
1272 const auto cell_idx = this->well_cells_[perf];
1273 return simulator.model()
1274 .intensiveQuantities(cell_idx, 0).fluidState();
1277 const int np = this->number_of_phases_;
1278 auto setToZero = [np](
Scalar* x) ->
void
1280 std::fill_n(x, np, 0.0);
1283 auto addVector = [np](
const Scalar* src,
Scalar* dest) ->
void
1285 std::transform(src, src + np, dest, dest, std::plus<>{});
1288 auto& ws = well_state.
well(this->index_of_well_);
1289 auto& perf_data = ws.perf_data;
1290 auto* wellPI = ws.productivity_index.data();
1291 auto* connPI = perf_data.prod_index.data();
1295 const auto preferred_phase = this->well_ecl_.getPreferredPhase();
1296 auto subsetPerfID = 0;
1298 for (
const auto& perf : *this->perf_data_) {
1299 auto allPerfID = perf.ecl_index;
1301 auto connPICalc = [&wellPICalc, allPerfID](
const Scalar mobility) ->
Scalar
1306 std::vector<Scalar> mob(this->num_conservation_quantities_, 0.0);
1307 getMobility(simulator,
static_cast<int>(subsetPerfID), mob, deferred_logger);
1309 const auto& fs = fluidState(subsetPerfID);
1312 if (this->isInjector()) {
1313 this->computeConnLevelInjInd(fs, preferred_phase, connPICalc,
1314 mob, connPI, deferred_logger);
1317 this->computeConnLevelProdInd(fs, connPICalc, mob, connPI);
1320 addVector(connPI, wellPI);
1327 const auto& comm = this->parallel_well_info_.communication();
1328 if (comm.size() > 1) {
1329 comm.sum(wellPI, np);
1332 assert ((
static_cast<int>(subsetPerfID) == this->number_of_local_perforations_) &&
1333 "Internal logic error in processing connections for PI/II");
1338 template<
typename TypeTag>
1348 const auto prop_func =
typename StdWellEval::StdWellConnections::DensityPropertyFunctions {
1353 [&model = simulator.model()](
const int cell,
1354 const std::vector<int>& phases,
1355 std::vector<Scalar>& mob)
1357 const auto& iq = model.intensiveQuantities(cell, 0);
1359 std::transform(phases.begin(), phases.end(), mob.begin(),
1360 [&iq](
const int phase) { return iq.mobility(phase).value(); });
1365 [&model = simulator.model()](
const int cell,
1366 const std::vector<int>& phases,
1367 std::vector<Scalar>& rho)
1369 const auto& fs = model.intensiveQuantities(cell, 0).fluidState();
1371 std::transform(phases.begin(), phases.end(), rho.begin(),
1372 [&fs](
const int phase) { return fs.density(phase).value(); });
1376 const auto stopped_or_zero_rate_target = this->
1377 stoppedOrZeroRateTarget(simulator, well_state, deferred_logger);
1380 .computeProperties(stopped_or_zero_rate_target, well_state,
1381 prop_func, props, deferred_logger);
1383 cachedRefDensity = this->connections_.rho(0);
1384 if (this->parallel_well_info_.communication().size() > 1) {
1385 cachedRefDensity = this->parallel_well_info_.broadcastFirstPerforationValue(cachedRefDensity);
1393 template<
typename TypeTag>
1400 const auto props = computePropertiesForWellConnectionPressures
1401 (simulator, well_state);
1403 computeWellConnectionDensitesPressures(simulator, well_state,
1404 props, deferred_logger);
1411 template<
typename TypeTag>
1418 if (!this->isOperableAndSolvable() && !this->wellIsStopped())
return;
1423 dx_well[0].resize(this->primary_variables_.numWellEq());
1424 this->linSys_.solve( dx_well);
1426 updateWellState(simulator, dx_well, well_state, deferred_logger);
1433 template<
typename TypeTag>
1440 updatePrimaryVariables(simulator, well_state, deferred_logger);
1441 computeWellConnectionPressures(simulator, well_state, deferred_logger);
1442 this->computeAccumWell();
1447 template<
typename TypeTag>
1452 if (!this->isOperableAndSolvable() && !this->wellIsStopped())
return;
1454 if (this->param_.matrix_add_well_contributions_)
1460 this->linSys_.apply(x, Ax);
1466 template<
typename TypeTag>
1471 if (!this->isOperableAndSolvable() && !this->wellIsStopped())
return;
1473 this->linSys_.apply(r);
1479 template<
typename TypeTag>
1487 if (!this->isOperableAndSolvable() && !this->wellIsStopped())
return;
1490 xw[0].resize(this->primary_variables_.numWellEq());
1492 this->linSys_.recoverSolutionWell(x, xw);
1493 updateWellState(simulator, xw, well_state, deferred_logger);
1499 template<
typename TypeTag>
1504 std::vector<Scalar>& well_flux,
1508 const int np = this->number_of_phases_;
1509 well_flux.resize(np, 0.0);
1511 const bool allow_cf = this->getAllowCrossFlow();
1513 for (
int perf = 0; perf < this->number_of_local_perforations_; ++perf) {
1514 const int cell_idx = this->well_cells_[perf];
1515 const auto& intQuants = simulator.model().intensiveQuantities(cell_idx, 0);
1517 std::vector<Scalar> mob(this->num_conservation_quantities_, 0.);
1518 getMobility(simulator, perf, mob, deferred_logger);
1520 getTransMult(trans_mult, simulator, cell_idx);
1521 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
1522 std::vector<Scalar> Tw(this->num_conservation_quantities_, this->well_index_[perf] * trans_mult);
1523 this->getTw(Tw, perf, intQuants, trans_mult, wellstate_nupcol);
1525 std::vector<Scalar> cq_s(this->num_conservation_quantities_, 0.);
1527 computePerfRate(intQuants, mob, bhp, Tw, perf, allow_cf,
1528 cq_s, perf_rates, deferred_logger);
1530 for(
int p = 0; p < np; ++p) {
1531 well_flux[FluidSystem::activeCompToActivePhaseIdx(p)] += cq_s[p];
1535 if constexpr (has_solvent) {
1536 assert(FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx));
1538 const int gas_pos = FluidSystem::canonicalToActivePhaseIdx(FluidSystem::gasPhaseIdx);
1539 well_flux[gas_pos] += cq_s[Indices::contiSolventEqIdx];
1542 this->parallel_well_info_.communication().sum(well_flux.data(), well_flux.size());
1547 template<
typename TypeTag>
1553 std::vector<Scalar>& well_flux,
1572 const auto& summary_state = simulator.vanguard().summaryState();
1573 auto inj_controls = well_copy.
well_ecl_.isInjector()
1574 ? well_copy.
well_ecl_.injectionControls(summary_state)
1575 : Well::InjectionControls(0);
1576 auto prod_controls = well_copy.
well_ecl_.isProducer()
1577 ? well_copy.
well_ecl_.productionControls(summary_state) :
1578 Well::ProductionControls(0);
1581 auto& ws = well_state_copy.
well(this->index_of_well_);
1583 inj_controls.bhp_limit = bhp;
1584 ws.injection_cmode = Well::InjectorCMode::BHP;
1586 prod_controls.bhp_limit = bhp;
1587 ws.production_cmode = Well::ProducerCMode::BHP;
1592 const int np = this->number_of_phases_;
1593 const Scalar sign = this->well_ecl_.isInjector() ? 1.0 : -1.0;
1594 for (
int phase = 0; phase < np; ++phase){
1595 well_state_copy.
wellRates(this->index_of_well_)[phase]
1596 = sign * ws.well_potentials[phase];
1601 const double dt = simulator.timeStepSize();
1603 simulator, dt, inj_controls, prod_controls, wgHelper_copy, well_state_copy, deferred_logger
1606 const std::string msg =
" well " + name() +
" did not get converged during well potential calculations "
1607 " potentials are computed based on unconverged solution";
1608 deferred_logger.
debug(msg);
1618 template<
typename TypeTag>
1619 std::vector<typename StandardWell<TypeTag>::Scalar>
1626 std::vector<Scalar> potentials(this->number_of_phases_, 0.0);
1627 const auto& summary_state = simulator.vanguard().summaryState();
1629 const auto& well = this->well_ecl_;
1630 if (well.isInjector()){
1631 const auto& controls = this->well_ecl_.injectionControls(summary_state);
1632 auto bhp_at_thp_limit = computeBhpAtThpLimitInj(simulator, wgHelper, summary_state, deferred_logger);
1633 if (bhp_at_thp_limit) {
1634 const Scalar bhp = std::min(*bhp_at_thp_limit,
1635 static_cast<Scalar>(controls.bhp_limit));
1636 computeWellRatesWithBhp(simulator, bhp, potentials, deferred_logger);
1638 deferred_logger.
warning(
"FAILURE_GETTING_CONVERGED_POTENTIAL",
1639 "Failed in getting converged thp based potential calculation for well "
1640 + name() +
". Instead the bhp based value is used");
1641 const Scalar bhp = controls.bhp_limit;
1642 computeWellRatesWithBhp(simulator, bhp, potentials, deferred_logger);
1645 computeWellRatesWithThpAlqProd(
1646 simulator, wgHelper, summary_state,
1647 deferred_logger, potentials, this->getALQ(well_state)
1654 template<
typename TypeTag>
1659 std::vector<Scalar>& well_potentials,
1674 auto& ws = well_state_copy.
well(this->index_of_well_);
1677 const auto& summary_state = simulator.vanguard().summaryState();
1678 auto inj_controls = well_copy.
well_ecl_.isInjector()
1679 ? well_copy.
well_ecl_.injectionControls(summary_state)
1680 : Well::InjectionControls(0);
1681 auto prod_controls = well_copy.
well_ecl_.isProducer()
1682 ? well_copy.
well_ecl_.productionControls(summary_state) :
1683 Well::ProductionControls(0);
1689 const int num_perf = ws.perf_data.size();
1690 for (
int perf = 0; perf < num_perf; ++perf) {
1694 const int np = this->number_of_phases_;
1695 bool trivial =
true;
1696 for (
int phase = 0; phase < np; ++phase){
1697 trivial = trivial && (ws.well_potentials[phase] == 0.0) ;
1701 for (
int phase = 0; phase < np; ++phase) {
1702 ws.surface_rates[phase] = sign * ws.well_potentials[phase];
1707 const double dt = simulator.timeStepSize();
1709 bool converged =
false;
1710 if (this->well_ecl_.isProducer()) {
1712 simulator, dt, inj_controls, prod_controls, wgHelper_copy, well_state_copy, deferred_logger
1716 simulator, dt, inj_controls, prod_controls, wgHelper_copy, well_state_copy, deferred_logger,
1724 well_potentials.clear();
1725 well_potentials.resize(np, 0.0);
1726 for (
int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx) {
1727 if (has_solvent && comp_idx == Indices::contiSolventEqIdx)
continue;
1729 well_potentials[FluidSystem::activeCompToActivePhaseIdx(comp_idx)] = rate.value();
1733 if constexpr (has_solvent) {
1734 assert(FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx));
1736 const int gas_pos = FluidSystem::canonicalToActivePhaseIdx(FluidSystem::gasPhaseIdx);
1738 well_potentials[gas_pos] += rate.value();
1744 template<
typename TypeTag>
1749 const SummaryState &summary_state,
1751 std::vector<Scalar>& potentials,
1755 auto bhp_at_thp_limit = computeBhpAtThpLimitProdWithAlq(
1756 simulator, wgHelper, summary_state, alq, deferred_logger,
true);
1757 if (bhp_at_thp_limit) {
1758 const auto& controls = this->well_ecl_.productionControls(summary_state);
1759 bhp = std::max(*bhp_at_thp_limit,
1760 static_cast<Scalar>(controls.bhp_limit));
1761 computeWellRatesWithBhp(simulator, bhp, potentials, deferred_logger);
1764 deferred_logger.
warning(
"FAILURE_GETTING_CONVERGED_POTENTIAL",
1765 "Failed in getting converged thp based potential calculation for well "
1766 + name() +
". Instead the bhp based value is used");
1767 const auto& controls = this->well_ecl_.productionControls(summary_state);
1768 bhp = controls.bhp_limit;
1769 computeWellRatesWithBhp(simulator, bhp, potentials, deferred_logger);
1774 template<
typename TypeTag>
1779 const SummaryState& summary_state,
1781 std::vector<Scalar>& potentials,
1785 computeWellRatesAndBhpWithThpAlqProd(simulator,
1793 template<
typename TypeTag>
1799 std::vector<Scalar>& well_potentials,
1802 const auto [compute_potential, bhp_controlled_well] =
1805 if (!compute_potential) {
1809 bool converged_implicit =
false;
1813 if (this->param_.local_well_solver_control_switching_ && !(this->changed_to_open_this_step_ && this->wellUnderZeroRateTarget(simulator, well_state, deferred_logger))) {
1814 converged_implicit = computeWellPotentialsImplicit(
1815 simulator, wgHelper, well_potentials, deferred_logger
1818 if (!converged_implicit) {
1820 const auto& summaryState = simulator.vanguard().summaryState();
1821 if (!Base::wellHasTHPConstraints(summaryState) || bhp_controlled_well) {
1831 const auto& ws = well_state.
well(this->index_of_well_);
1832 if (this->isInjector())
1833 bhp = std::max(ws.bhp, bhp);
1835 bhp = std::min(ws.bhp, bhp);
1837 assert(std::abs(bhp) != std::numeric_limits<Scalar>::max());
1838 computeWellRatesWithBhpIterations(simulator, bhp, wgHelper, well_potentials, deferred_logger);
1841 well_potentials = computeWellPotentialWithTHP(simulator, wgHelper, deferred_logger, well_state);
1845 this->checkNegativeWellPotentials(well_potentials,
1846 this->param_.check_well_operability_,
1856 template<
typename TypeTag>
1860 const int openConnIdx)
const
1862 return (openConnIdx < 0)
1864 : this->connections_.rho(openConnIdx);
1871 template<
typename TypeTag>
1878 if (!this->isOperableAndSolvable() && !this->wellIsStopped())
return;
1880 const bool stop_or_zero_rate_target = this->stoppedOrZeroRateTarget(simulator, well_state, deferred_logger);
1881 this->primary_variables_.update(well_state, stop_or_zero_rate_target, deferred_logger);
1884 if constexpr (Base::has_polymermw) {
1885 this->primary_variables_.updatePolyMW(well_state);
1888 this->primary_variables_.checkFinite(deferred_logger);
1894 template<
typename TypeTag>
1899 return cachedRefDensity;
1905 template<
typename TypeTag>
1910 std::vector<EvalWell>& mob,
1913 const int cell_idx = this->well_cells_[perf];
1914 const auto& int_quant = simulator.model().intensiveQuantities(cell_idx, 0);
1915 const EvalWell polymer_concentration = this->extendEval(int_quant.polymerConcentration());
1919 if (this->isInjector()) {
1921 const auto& visc_mult_table = PolymerModule::plyviscViscosityMultiplierTable(int_quant.pvtRegionIndex());
1922 const unsigned waterCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
1923 mob[waterCompIdx] /= (this->extendEval(int_quant.waterViscosityCorrection()) * visc_mult_table.eval(polymer_concentration,
true) );
1926 if (PolymerModule::hasPlyshlog()) {
1929 if (this->isInjector() && this->wpolymer() == 0.) {
1934 const bool allow_cf = this->getAllowCrossFlow() || openCrossFlowAvoidSingularity(simulator);
1935 const EvalWell& bhp = this->primary_variables_.eval(Bhp);
1937 std::vector<EvalWell> cq_s(this->num_conservation_quantities_, 0.);
1940 getTransMult(trans_mult, simulator, cell_idx);
1941 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
1942 std::vector<EvalWell> Tw(this->num_conservation_quantities_, this->well_index_[perf] * trans_mult);
1943 this->getTw(Tw, perf, int_quant, trans_mult, wellstate_nupcol);
1944 computePerfRate(int_quant, mob, bhp, Tw, perf, allow_cf, cq_s,
1945 perf_rates, deferred_logger);
1947 const Scalar area = 2 * M_PI * this->perf_rep_radius_[perf] * this->perf_length_[perf];
1948 const auto& material_law_manager = simulator.problem().materialLawManager();
1949 const auto& scaled_drainage_info =
1950 material_law_manager->oilWaterScaledEpsInfoDrainage(cell_idx);
1951 const Scalar swcr = scaled_drainage_info.Swcr;
1952 const EvalWell poro = this->extendEval(int_quant.porosity());
1953 const EvalWell sw = this->extendEval(int_quant.fluidState().saturation(FluidSystem::waterPhaseIdx));
1955 const EvalWell denom = max( (area * poro * (sw - swcr)), 1e-12);
1956 const unsigned waterCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
1957 EvalWell water_velocity = cq_s[waterCompIdx] / denom * this->extendEval(int_quant.fluidState().invB(FluidSystem::waterPhaseIdx));
1959 if (PolymerModule::hasShrate()) {
1962 water_velocity *= PolymerModule::shrate( int_quant.pvtRegionIndex() ) / this->bore_diameters_[perf];
1964 const EvalWell shear_factor = PolymerModule::computeShearFactor(polymer_concentration,
1965 int_quant.pvtRegionIndex(),
1968 mob[waterCompIdx] /= shear_factor;
1972 template<
typename TypeTag>
1976 this->linSys_.extract(jacobian);
1980 template <
typename TypeTag>
1984 const int pressureVarIndex,
1985 const bool use_well_weights,
1988 this->linSys_.extractCPRPressureMatrix(jacobian,
1999 template<
typename TypeTag>
2006 if constexpr (Base::has_polymermw) {
2007 const int water_table_id = this->polymerWaterTable_();
2008 if (water_table_id <= 0) {
2010 fmt::format(
"Unused SKPRWAT table id used for well {}", name()),
2013 const auto& water_table_func = PolymerModule::getSkprwatTable(water_table_id);
2014 const EvalWell throughput_eval{throughput};
2016 EvalWell pskin_water = water_table_func.eval(throughput_eval, water_velocity);
2020 fmt::format(
"Polymermw is not activated, while injecting "
2021 "skin pressure is requested for well {}", name()),
2030 template<
typename TypeTag>
2038 if constexpr (Base::has_polymermw) {
2039 const Scalar sign = water_velocity >= 0. ? 1.0 : -1.0;
2040 const EvalWell water_velocity_abs = abs(water_velocity);
2041 if (poly_inj_conc == 0.) {
2042 return sign * pskinwater(throughput, water_velocity_abs, deferred_logger);
2044 const int polymer_table_id = this->polymerTable_();
2045 if (polymer_table_id <= 0) {
2047 fmt::format(
"Unavailable SKPRPOLY table id used for well {}", name()),
2050 const auto& skprpolytable = PolymerModule::getSkprpolyTable(polymer_table_id);
2051 const Scalar reference_concentration = skprpolytable.refConcentration;
2052 const EvalWell throughput_eval{throughput};
2054 const EvalWell pskin_poly = skprpolytable.table_func.eval(throughput_eval, water_velocity_abs);
2055 if (poly_inj_conc == reference_concentration) {
2056 return sign * pskin_poly;
2059 const EvalWell pskin_water = pskinwater(throughput, water_velocity_abs, deferred_logger);
2060 const EvalWell pskin = pskin_water + (pskin_poly - pskin_water) / reference_concentration * poly_inj_conc;
2061 return sign * pskin;
2064 fmt::format(
"Polymermw is not activated, while injecting "
2065 "skin pressure is requested for well {}", name()),
2074 template<
typename TypeTag>
2081 if constexpr (Base::has_polymermw) {
2082 const int table_id = this->polymerInjTable_();
2083 const auto& table_func = PolymerModule::getPlymwinjTable(table_id);
2084 const EvalWell throughput_eval{throughput};
2086 if (this->wpolymer() == 0.) {
2087 return molecular_weight;
2089 molecular_weight = table_func.eval(throughput_eval, abs(water_velocity));
2090 return molecular_weight;
2093 fmt::format(
"Polymermw is not activated, while injecting "
2094 "polymer molecular weight is requested for well {}", name()),
2103 template<
typename TypeTag>
2109 if constexpr (Base::has_polymermw) {
2110 if (!this->isInjector()) {
2114 auto& perf_water_throughput = well_state.
well(this->index_of_well_)
2115 .perf_data.water_throughput;
2117 for (
int perf = 0; perf < this->number_of_local_perforations_; ++perf) {
2118 const Scalar perf_water_vel =
2119 this->primary_variables_.value(Bhp + 1 + perf);
2123 if (perf_water_vel >
Scalar{0}) {
2124 perf_water_throughput[perf] += perf_water_vel * dt;
2134 template<
typename TypeTag>
2139 std::vector<EvalWell>& cq_s)
const
2141 const int cell_idx = this->well_cells_[perf];
2142 const auto& int_quants = simulator.model().intensiveQuantities(cell_idx, 0);
2143 const auto& fs = int_quants.fluidState();
2144 const EvalWell b_w = this->extendEval(fs.invB(FluidSystem::waterPhaseIdx));
2145 const Scalar area = M_PI * this->bore_diameters_[perf] * this->perf_length_[perf];
2146 const int wat_vel_index = Bhp + 1 + perf;
2147 const unsigned water_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
2151 cq_s[water_comp_idx] = area * this->primary_variables_.eval(wat_vel_index) * b_w;
2157 template<
typename TypeTag>
2166 const int cell_idx = this->well_cells_[perf];
2167 const auto& int_quants = simulator.model().intensiveQuantities(cell_idx, 0);
2168 const auto& fs = int_quants.fluidState();
2169 const EvalWell b_w = this->extendEval(fs.invB(FluidSystem::waterPhaseIdx));
2170 const EvalWell water_flux_r = water_flux_s / b_w;
2171 const Scalar area = M_PI * this->bore_diameters_[perf] * this->perf_length_[perf];
2172 const EvalWell water_velocity = water_flux_r / area;
2173 const int wat_vel_index = Bhp + 1 + perf;
2176 const EvalWell eq_wat_vel = this->primary_variables_.eval(wat_vel_index) - water_velocity;
2178 const auto& ws = well_state.
well(this->index_of_well_);
2179 const auto& perf_data = ws.perf_data;
2180 const auto& perf_water_throughput = perf_data.water_throughput;
2181 const Scalar throughput = perf_water_throughput[perf];
2182 const int pskin_index = Bhp + 1 + this->number_of_local_perforations_ + perf;
2184 const EvalWell poly_conc(this->wpolymer());
2187 const EvalWell eq_pskin = this->primary_variables_.eval(pskin_index)
2188 - pskin(throughput, this->primary_variables_.eval(wat_vel_index), poly_conc, deferred_logger);
2191 assembleInjectivityEq(eq_pskin,
2196 this->primary_variables_.numWellEq(),
2204 template<
typename TypeTag>
2213 if constexpr (Base::has_polymermw) {
2215 checkConvergencePolyMW(res, Bhp, this->param_.max_residual_allowed_, report);
2223 template<
typename TypeTag>
2230 std::vector<RateVector>& connectionRates,
2235 if (this->isInjector()) {
2236 const int wat_vel_index = Bhp + 1 + perf;
2237 const EvalWell water_velocity = this->primary_variables_.eval(wat_vel_index);
2238 if (water_velocity > 0.) {
2239 const auto& ws = well_state.
well(this->index_of_well_);
2240 const auto& perf_water_throughput = ws.perf_data.water_throughput;
2241 const Scalar throughput = perf_water_throughput[perf];
2242 const EvalWell molecular_weight = wpolymermw(throughput, water_velocity, deferred_logger);
2243 cq_s_polymw *= molecular_weight;
2249 }
else if (this->isProducer()) {
2250 if (cq_s_polymw < 0.) {
2251 cq_s_polymw *= this->extendEval(int_quants.polymerMoleWeight() );
2258 connectionRates[perf][Indices::contiPolymerMWEqIdx] = Base::restrictEval(cq_s_polymw);
2265 template<
typename TypeTag>
2266 std::optional<typename StandardWell<TypeTag>::Scalar>
2271 const SummaryState& summary_state,
2274 return computeBhpAtThpLimitProdWithAlq(simulator,
2277 this->getALQ(well_state),
2282 template<
typename TypeTag>
2283 std::optional<typename StandardWell<TypeTag>::Scalar>
2287 const SummaryState& summary_state,
2290 bool iterate_if_no_solution)
const
2294 auto frates = [
this, &simulator, &deferred_logger](
const Scalar bhp) {
2300 std::vector<Scalar> rates(3);
2301 computeWellRatesWithBhp(simulator, bhp, rates, deferred_logger);
2302 this->adaptRatesForVFP(rates);
2306 Scalar max_pressure = 0.0;
2307 for (
int perf = 0; perf < this->number_of_local_perforations_; ++perf) {
2308 const int cell_idx = this->well_cells_[perf];
2309 const auto& int_quants = simulator.model().intensiveQuantities(cell_idx, 0);
2310 const auto& fs = int_quants.fluidState();
2311 Scalar pressure_cell = this->getPerfCellPressure(fs).value();
2312 max_pressure = std::max(max_pressure, pressure_cell);
2314 const auto& comm = this->parallel_well_info_.communication();
2315 if (comm.size() > 1) {
2316 max_pressure = comm.max(max_pressure);
2321 this->getRefDensity(),
2323 this->getTHPConstraint(summary_state),
2327 auto v = frates(*bhpAtLimit);
2328 if (std::all_of(v.cbegin(), v.cend(), [](
Scalar i){ return i <= 0; }) ) {
2333 if (!iterate_if_no_solution)
2334 return std::nullopt;
2336 auto fratesIter = [
this, &simulator, &wgHelper, &deferred_logger](
const Scalar bhp) {
2340 std::vector<Scalar> rates(3);
2341 computeWellRatesWithBhpIterations(simulator, bhp, wgHelper, rates, deferred_logger);
2342 this->adaptRatesForVFP(rates);
2349 this->getRefDensity(),
2351 this->getTHPConstraint(summary_state),
2357 auto v = frates(*bhpAtLimit);
2358 if (std::all_of(v.cbegin(), v.cend(), [](
Scalar i){ return i <= 0; }) ) {
2364 return std::nullopt;
2369 template<
typename TypeTag>
2370 std::optional<typename StandardWell<TypeTag>::Scalar>
2374 const SummaryState& summary_state,
2383 auto frates = [
this, &simulator, &deferred_logger](
const Scalar bhp) {
2389 std::vector<Scalar> rates(3);
2390 computeWellRatesWithBhp(simulator, bhp, rates, deferred_logger);
2396 this->getRefDensity(),
2407 template<
typename TypeTag>
2412 const Well::InjectionControls& inj_controls,
2413 const Well::ProductionControls& prod_controls,
2418 updatePrimaryVariables(simulator, well_state, deferred_logger);
2420 const int max_iter = this->param_.max_inner_iter_wells_;
2423 bool relax_convergence =
false;
2424 this->regularize_ =
false;
2426 assembleWellEqWithoutIteration(simulator, wgHelper, dt, inj_controls, prod_controls, well_state, deferred_logger,
2429 if (it > this->param_.strict_inner_iter_wells_) {
2430 relax_convergence =
true;
2431 this->regularize_ =
true;
2434 auto report = getWellConvergence(simulator, well_state, Base::B_avg_, deferred_logger, relax_convergence);
2436 converged = report.converged();
2442 solveEqAndUpdateWellState(simulator, well_state, deferred_logger);
2449 }
while (it < max_iter);
2452 std::ostringstream sstr;
2453 sstr <<
" Well " << this->name() <<
" converged in " << it <<
" inner iterations.";
2454 if (relax_convergence)
2455 sstr <<
" (A relaxed tolerance was used after "<< this->param_.strict_inner_iter_wells_ <<
" iterations)";
2459 deferred_logger.
debug(sstr.str(), OpmLog::defaultDebugVerbosityLevel + (it == 0));
2461 std::ostringstream sstr;
2462 sstr <<
" Well " << this->name() <<
" did not converge in " << it <<
" inner iterations.";
2463 deferred_logger.
debug(sstr.str());
2470 template<
typename TypeTag>
2475 const Well::InjectionControls& inj_controls,
2476 const Well::ProductionControls& prod_controls,
2480 const bool fixed_control ,
2481 const bool fixed_status ,
2482 const bool solving_with_zero_rate )
2484 updatePrimaryVariables(simulator, well_state, deferred_logger);
2486 const int max_iter = this->param_.max_inner_iter_wells_;
2488 bool converged =
false;
2489 bool relax_convergence =
false;
2490 this->regularize_ =
false;
2496 constexpr int min_its_after_switch = 4;
2498 const int max_status_switch = this->param_.max_well_status_switch_inner_iter_;
2499 int its_since_last_switch = min_its_after_switch;
2500 int switch_count= 0;
2502 const auto well_status_orig = this->wellStatus_;
2503 const auto operability_orig = this->operability_status_;
2504 auto well_status_cur = well_status_orig;
2505 int status_switch_count = 0;
2507 const bool allow_open = well_state.
well(this->index_of_well_).status == WellStatus::OPEN;
2509 const bool allow_switching =
2510 !this->wellUnderZeroRateTarget(simulator, well_state, deferred_logger) &&
2511 (!fixed_control || !fixed_status) && allow_open;
2513 bool changed =
false;
2514 bool final_check =
false;
2516 this->operability_status_.resetOperability();
2517 this->operability_status_.solvable =
true;
2519 its_since_last_switch++;
2520 if (allow_switching && its_since_last_switch >= min_its_after_switch && status_switch_count < max_status_switch){
2521 const Scalar wqTotal = this->primary_variables_.eval(WQTotal).value();
2522 changed = this->updateWellControlAndStatusLocalIteration(
2523 simulator, wgHelper, inj_controls, prod_controls, wqTotal,
2524 well_state, deferred_logger, fixed_control, fixed_status,
2525 solving_with_zero_rate
2528 its_since_last_switch = 0;
2530 if (well_status_cur != this->wellStatus_) {
2531 well_status_cur = this->wellStatus_;
2532 status_switch_count++;
2535 if (!changed && final_check) {
2538 final_check =
false;
2540 if (status_switch_count == max_status_switch) {
2541 this->wellStatus_ = well_status_orig;
2545 assembleWellEqWithoutIteration(simulator, wgHelper, dt, inj_controls, prod_controls, well_state, deferred_logger, solving_with_zero_rate);
2547 if (it > this->param_.strict_inner_iter_wells_) {
2548 relax_convergence =
true;
2549 this->regularize_ =
true;
2552 auto report = getWellConvergence(simulator, well_state, Base::B_avg_, deferred_logger, relax_convergence);
2554 converged = report.converged();
2558 if (switch_count > 0 && its_since_last_switch < min_its_after_switch) {
2560 its_since_last_switch = min_its_after_switch;
2567 solveEqAndUpdateWellState(simulator, well_state, deferred_logger);
2569 }
while (it < max_iter);
2572 if (allow_switching){
2574 const bool is_stopped = this->wellIsStopped();
2575 if (this->wellHasTHPConstraints(summary_state)){
2576 this->operability_status_.can_obtain_bhp_with_thp_limit = !is_stopped;
2577 this->operability_status_.obey_thp_limit_under_bhp_limit = !is_stopped;
2579 this->operability_status_.operable_under_only_bhp_limit = !is_stopped;
2582 std::string message = fmt::format(
" Well {} converged in {} inner iterations ("
2583 "{} control/status switches).", this->name(), it, switch_count);
2584 if (relax_convergence) {
2585 message.append(fmt::format(
" (A relaxed tolerance was used after {} iterations)",
2586 this->param_.strict_inner_iter_wells_));
2588 deferred_logger.
debug(message, OpmLog::defaultDebugVerbosityLevel + ((it == 0) && (switch_count == 0)));
2591 this->wellStatus_ = well_status_orig;
2592 this->operability_status_ = operability_orig;
2593 const std::string message = fmt::format(
" Well {} did not converge in {} inner iterations ("
2594 "{} switches, {} status changes).", this->name(), it, switch_count, status_switch_count);
2595 deferred_logger.
debug(message);
2601 template<
typename TypeTag>
2602 std::vector<typename StandardWell<TypeTag>::Scalar>
2608 std::vector<Scalar> well_q_s(this->num_conservation_quantities_, 0.);
2609 const EvalWell& bhp = this->primary_variables_.eval(Bhp);
2610 const bool allow_cf = this->getAllowCrossFlow() || openCrossFlowAvoidSingularity(simulator);
2611 for (
int perf = 0; perf < this->number_of_local_perforations_; ++perf) {
2612 const int cell_idx = this->well_cells_[perf];
2613 const auto& intQuants = simulator.model().intensiveQuantities(cell_idx, 0);
2614 std::vector<Scalar> mob(this->num_conservation_quantities_, 0.);
2615 getMobility(simulator, perf, mob, deferred_logger);
2616 std::vector<Scalar> cq_s(this->num_conservation_quantities_, 0.);
2618 getTransMult(trans_mult, simulator, cell_idx);
2619 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
2620 std::vector<Scalar> Tw(this->num_conservation_quantities_, this->well_index_[perf] * trans_mult);
2621 this->getTw(Tw, perf, intQuants, trans_mult, wellstate_nupcol);
2623 computePerfRate(intQuants, mob, bhp.value(), Tw, perf, allow_cf,
2624 cq_s, perf_rates, deferred_logger);
2625 for (
int comp = 0; comp < this->num_conservation_quantities_; ++comp) {
2626 well_q_s[comp] += cq_s[comp];
2629 const auto& comm = this->parallel_well_info_.communication();
2630 if (comm.size() > 1)
2632 comm.sum(well_q_s.data(), well_q_s.size());
2639 template <
typename TypeTag>
2640 std::vector<typename StandardWell<TypeTag>::Scalar>
2644 const int num_pri_vars = this->primary_variables_.numWellEq();
2645 std::vector<Scalar> retval(num_pri_vars);
2646 for (
int ii = 0; ii < num_pri_vars; ++ii) {
2647 retval[ii] = this->primary_variables_.value(ii);
2656 template <
typename TypeTag>
2661 const int num_pri_vars = this->primary_variables_.numWellEq();
2662 for (
int ii = 0; ii < num_pri_vars; ++ii) {
2663 this->primary_variables_.setValue(ii, it[ii]);
2665 return num_pri_vars;
2669 template <
typename TypeTag>
2673 const IntensiveQuantities& intQuants,
2676 auto fs = intQuants.fluidState();
2678 for (
unsigned phaseIdx = 0; phaseIdx < FluidSystem::numPhases; ++phaseIdx) {
2679 if (!FluidSystem::phaseIsActive(phaseIdx)) {
2684 EvalWell cq_r_thermal{0.};
2685 const unsigned activeCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::solventComponentIndex(phaseIdx));
2686 const bool both_oil_gas = FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) && FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx);
2687 if (!both_oil_gas || FluidSystem::waterPhaseIdx == phaseIdx) {
2688 cq_r_thermal = cq_s[activeCompIdx] / this->extendEval(fs.invB(phaseIdx));
2691 const unsigned oilCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx);
2692 const unsigned gasCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
2697 const EvalWell d = this->extendEval(1.0 - fs.Rv() * fs.Rs());
2699 deferred_logger.
debug(
2700 fmt::format(
"Problematic d value {} obtained for well {}"
2701 " during calculateSinglePerf with rs {}"
2702 ", rv {}. Continue as if no dissolution (rs = 0) and"
2703 " vaporization (rv = 0) for this connection.",
2704 d, this->name(), fs.Rs(), fs.Rv()));
2705 cq_r_thermal = cq_s[activeCompIdx] / this->extendEval(fs.invB(phaseIdx));
2707 if (FluidSystem::gasPhaseIdx == phaseIdx) {
2708 cq_r_thermal = (cq_s[gasCompIdx] -
2709 this->extendEval(fs.Rs()) * cq_s[oilCompIdx]) /
2710 (d * this->extendEval(fs.invB(phaseIdx)) );
2711 }
else if (FluidSystem::oilPhaseIdx == phaseIdx) {
2713 cq_r_thermal = (cq_s[oilCompIdx] - this->extendEval(fs.Rv()) *
2715 (d * this->extendEval(fs.invB(phaseIdx)) );
2721 if (this->isInjector() && !this->wellIsStopped() && cq_r_thermal > 0.0){
2723 assert(this->well_ecl_.injectorType() != InjectorType::MULTI);
2724 fs.setTemperature(this->well_ecl_.inj_temperature());
2725 typedef typename std::decay<
decltype(fs)>::type::Scalar FsScalar;
2726 typename FluidSystem::template ParameterCache<FsScalar> paramCache;
2727 const unsigned pvtRegionIdx = intQuants.pvtRegionIndex();
2728 paramCache.setRegionIndex(pvtRegionIdx);
2729 paramCache.updatePhase(fs, phaseIdx);
2731 const auto& rho = FluidSystem::density(fs, paramCache, phaseIdx);
2732 fs.setDensity(phaseIdx, rho);
2733 const auto& h = FluidSystem::enthalpy(fs, paramCache, phaseIdx);
2734 fs.setEnthalpy(phaseIdx, h);
2735 cq_r_thermal *= this->extendEval(fs.enthalpy(phaseIdx)) * this->extendEval(fs.density(phaseIdx));
2736 result += getValue(cq_r_thermal);
2737 }
else if (cq_r_thermal > 0.0) {
2738 cq_r_thermal *= getValue(fs.enthalpy(phaseIdx)) * getValue(fs.density(phaseIdx));
2739 result += Base::restrictEval(cq_r_thermal);
2742 cq_r_thermal *= this->extendEval(fs.enthalpy(phaseIdx)) * this->extendEval(fs.density(phaseIdx));
2743 result += Base::restrictEval(cq_r_thermal);
2747 return result * this->well_efficiency_factor_;
#define OPM_DEFLOG_THROW(Exception, message, deferred_logger)
Definition: DeferredLoggingErrorHelpers.hpp:45
#define OPM_DEFLOG_PROBLEM(Exception, message, deferred_logger)
Definition: DeferredLoggingErrorHelpers.hpp:61
Definition: ConvergenceReport.hpp:38
Definition: DeferredLogger.hpp:57
void warning(const std::string &tag, const std::string &message)
void debug(const std::string &tag, const std::string &message)
Definition: GroupState.hpp:41
Class encapsulating some information about parallel wells.
Definition: ParallelWellInfo.hpp:198
Definition: RatioCalculator.hpp:38
Class handling assemble of the equation system for StandardWell.
Definition: StandardWellAssemble.hpp:43
Scalar pressure_diff(const unsigned perf) const
Returns pressure drop for a given perforation.
Definition: StandardWellConnections.hpp:101
StdWellConnections connections_
Connection level values.
Definition: StandardWellEval.hpp:101
PrimaryVariables primary_variables_
Primary variables for well.
Definition: StandardWellEval.hpp:95
Definition: StandardWell.hpp:60
void calculateExplicitQuantities(const Simulator &simulator, const WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:1436
EvalWell wpolymermw(const Scalar throughput, const EvalWell &water_velocity, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:2077
typename StdWellEval::EvalWell EvalWell
Definition: StandardWell.hpp:121
void updateWellStateFromPrimaryVariables(WellStateType &well_state, const SummaryState &summary_state, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:805
WellConnectionProps computePropertiesForWellConnectionPressures(const Simulator &simulator, const WellStateType &well_state) const
Definition: StandardWell_impl.hpp:1170
typename StdWellEval::BVectorWell BVectorWell
Definition: StandardWell.hpp:122
std::vector< Scalar > computeWellPotentialWithTHP(const Simulator &ebosSimulator, const WellGroupHelperType &wgHelper, DeferredLogger &deferred_logger, const WellStateType &well_state) const
Definition: StandardWell_impl.hpp:1621
void addWellContributions(SparseMatrixAdapter &mat) const override
Definition: StandardWell_impl.hpp:1974
std::vector< Scalar > getPrimaryVars() const override
Definition: StandardWell_impl.hpp:2642
void addWellPressureEquations(PressureMatrix &mat, const BVector &x, const int pressureVarIndex, const bool use_well_weights, const WellStateType &well_state) const override
Definition: StandardWell_impl.hpp:1982
void computeWellPotentials(const Simulator &simulator, const WellStateType &well_state, const WellGroupHelperType &wgHelper, std::vector< Scalar > &well_potentials, DeferredLogger &deferred_logger) override
computing the well potentials for group control
Definition: StandardWell_impl.hpp:1796
void updateWaterMobilityWithPolymer(const Simulator &simulator, const int perf, std::vector< EvalWell > &mob_water, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:1908
std::vector< Scalar > computeCurrentWellRates(const Simulator &ebosSimulator, DeferredLogger &deferred_logger) const override
Definition: StandardWell_impl.hpp:2604
void calculateSinglePerf(const Simulator &simulator, const int perf, WellStateType &well_state, std::vector< RateVector > &connectionRates, std::vector< EvalWell > &cq_s, EvalWell &water_flux_s, EvalWell &cq_s_zfrac_effective, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:506
bool iterateWellEqWithControl(const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, const WellGroupHelperType &wgHelper, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:2410
void updatePrimaryVariablesNewton(const BVectorWell &dwells, const bool stop_or_zero_rate_target, DeferredLogger &deferred_logger)
Definition: StandardWell_impl.hpp:782
GetPropType< TypeTag, Properties::Scalar > Scalar
Definition: WellInterface.hpp:83
bool computeWellPotentialsImplicit(const Simulator &ebos_simulator, const WellGroupHelperType &wgHelper, std::vector< Scalar > &well_potentials, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:1657
void computeWellRatesWithBhpIterations(const Simulator &ebosSimulator, const Scalar &bhp, const WellGroupHelperType &wgHelper, std::vector< Scalar > &well_flux, DeferredLogger &deferred_logger) const override
Definition: StandardWell_impl.hpp:1550
void computeWellConnectionPressures(const Simulator &simulator, const WellStateType &well_state, DeferredLogger &deferred_logger)
Definition: StandardWell_impl.hpp:1396
StandardWell(const Well &well, const ParallelWellInfo< Scalar > &pw_info, const int time_step, const ModelParameters ¶m, const RateConverterType &rate_converter, const int pvtRegionIdx, const int num_conservation_quantities, const int num_phases, const int index_of_well, const std::vector< PerforationData< Scalar > > &perf_data)
Definition: StandardWell_impl.hpp:52
typename StdWellEval::StdWellConnections::Properties WellConnectionProps
Definition: StandardWell.hpp:271
void updateConnectionRatePolyMW(const EvalWell &cq_s_poly, const IntensiveQuantities &int_quants, const WellStateType &well_state, const int perf, std::vector< RateVector > &connectionRates, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:2226
void assembleWellEqWithoutIteration(const Simulator &simulator, const WellGroupHelperType &wgHelper, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, WellStateType &well_state, DeferredLogger &deferred_logger, const bool solving_with_zero_rate) override
Definition: StandardWell_impl.hpp:341
void computeWellRatesWithBhp(const Simulator &ebosSimulator, const Scalar &bhp, std::vector< Scalar > &well_flux, DeferredLogger &deferred_logger) const override
Definition: StandardWell_impl.hpp:1502
void getMobility(const Simulator &simulator, const int perf, std::vector< Value > &mob, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:704
void getTransMult(Value &trans_mult, const Simulator &simulator, const int cell_indx) const
Definition: StandardWell_impl.hpp:684
void updateIPRImplicit(const Simulator &simulator, const WellGroupHelperType &wgHelper, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:921
void updateIPR(const Simulator &simulator, DeferredLogger &deferred_logger) const override
Definition: StandardWell_impl.hpp:829
void computeWellConnectionDensitesPressures(const Simulator &simulator, const WellStateType &well_state, const WellConnectionProps &props, DeferredLogger &deferred_logger)
Definition: StandardWell_impl.hpp:1340
std::optional< Scalar > computeBhpAtThpLimitProdWithAlq(const Simulator &ebos_simulator, const WellGroupHelperType &wgHelper, const SummaryState &summary_state, const Scalar alq_value, DeferredLogger &deferred_logger, bool iterate_if_no_solution) const override
Definition: StandardWell_impl.hpp:2285
void updateWellState(const Simulator &simulator, const BVectorWell &dwells, WellStateType &well_state, DeferredLogger &deferred_logger)
Definition: StandardWell_impl.hpp:760
void assembleWellEqWithoutIterationImpl(const Simulator &simulator, const WellGroupHelperType &wgHelper, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, WellStateType &well_state, DeferredLogger &deferred_logger, const bool solving_with_zero_rate)
Definition: StandardWell_impl.hpp:368
void handleInjectivityEquations(const Simulator &simulator, const WellStateType &well_state, const int perf, const EvalWell &water_flux_s, DeferredLogger &deferred_logger)
Definition: StandardWell_impl.hpp:2160
virtual void apply(const BVector &x, BVector &Ax) const override
Ax = Ax - C D^-1 B x.
Definition: StandardWell_impl.hpp:1450
virtual ConvergenceReport getWellConvergence(const Simulator &simulator, const WellStateType &well_state, const std::vector< Scalar > &B_avg, DeferredLogger &deferred_logger, const bool relax_tolerance) const override
check whether the well equations get converged for this well
Definition: StandardWell_impl.hpp:1221
void checkConvergenceExtraEqs(const std::vector< Scalar > &res, ConvergenceReport &report) const
Definition: StandardWell_impl.hpp:2207
typename StdWellEval::Eval Eval
Definition: StandardWell.hpp:120
bool iterateWellEqWithSwitching(const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, const WellGroupHelperType &wgHelper, WellStateType &well_state, DeferredLogger &deferred_logger, const bool fixed_control, const bool fixed_status, const bool solving_with_zero_rate) override
Definition: StandardWell_impl.hpp:2473
bool openCrossFlowAvoidSingularity(const Simulator &simulator) const
Definition: StandardWell_impl.hpp:1159
void computeWellRatesWithThpAlqProd(const Simulator &ebos_simulator, const WellGroupHelperType &wgHelper, const SummaryState &summary_state, DeferredLogger &deferred_logger, std::vector< Scalar > &potentials, Scalar alq) const
Definition: StandardWell_impl.hpp:1777
Scalar computeWellRatesAndBhpWithThpAlqProd(const Simulator &ebos_simulator, const WellGroupHelperType &wgHelper, const SummaryState &summary_state, DeferredLogger &deferred_logger, std::vector< Scalar > &potentials, Scalar alq) const
Definition: StandardWell_impl.hpp:1747
bool allDrawDownWrongDirection(const Simulator &simulator) const
Definition: StandardWell_impl.hpp:1117
EvalWell pskin(const Scalar throughput, const EvalWell &water_velocity, const EvalWell &poly_inj_conc, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:2033
void computePerfRate(const IntensiveQuantities &intQuants, const std::vector< Value > &mob, const Value &bhp, const std::vector< Value > &Tw, const int perf, const bool allow_cf, std::vector< Value > &cq_s, PerforationRates< Scalar > &perf_rates, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:93
static constexpr int numWellConservationEq
Definition: StandardWell.hpp:97
int setPrimaryVars(typename std::vector< Scalar >::const_iterator it) override
Definition: StandardWell_impl.hpp:2659
void updateWaterThroughput(const double dt, WellStateType &well_state) const override
Definition: StandardWell_impl.hpp:2106
void checkOperabilityUnderTHPLimit(const Simulator &simulator, const WellStateType &well_state, const WellGroupHelperType &wgHelper, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:1067
void checkOperabilityUnderBHPLimit(const WellStateType &well_state, const Simulator &simulator, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:998
std::optional< Scalar > computeBhpAtThpLimitInj(const Simulator &simulator, const WellGroupHelperType &wgHelper, const SummaryState &summary_state, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:2372
void recoverWellSolutionAndUpdateWellState(const Simulator &simulator, const BVector &x, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:1482
EvalWell pskinwater(const Scalar throughput, const EvalWell &water_velocity, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:2002
void solveEqAndUpdateWellState(const Simulator &simulator, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:1414
void handleInjectivityRate(const Simulator &simulator, const int perf, std::vector< EvalWell > &cq_s) const
Definition: StandardWell_impl.hpp:2137
virtual void init(const std::vector< Scalar > &depth_arg, const Scalar gravity_arg, const std::vector< Scalar > &B_avg, const bool changed_to_open_this_step) override
Definition: StandardWell_impl.hpp:76
void updateProductivityIndex(const Simulator &simulator, const WellProdIndexCalculator< Scalar > &wellPICalc, WellStateType &well_state, DeferredLogger &deferred_logger) const override
Definition: StandardWell_impl.hpp:1265
void updatePrimaryVariables(const Simulator &simulator, const WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:1874
std::optional< Scalar > computeBhpAtThpLimitProd(const WellStateType &well_state, const Simulator &simulator, const WellGroupHelperType &wgHelper, const SummaryState &summary_state, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:2268
Scalar getRefDensity() const override
Definition: StandardWell_impl.hpp:1897
Scalar connectionDensity(const int globalConnIdx, const int openConnIdx) const override
Definition: StandardWell_impl.hpp:1859
EvalWell getQs(const int compIdx) const
Returns scaled rate for a component.
Class for computing BHP limits.
Definition: WellBhpThpCalculator.hpp:41
Scalar calculateThpFromBhp(const std::vector< Scalar > &rates, const Scalar bhp, const Scalar rho, const std::optional< Scalar > &alq, const Scalar thp_limit, DeferredLogger &deferred_logger) const
Calculates THP from BHP.
std::optional< Scalar > computeBhpAtThpLimitProd(const std::function< std::vector< Scalar >(const Scalar)> &frates, const SummaryState &summary_state, const Scalar maxPerfPress, const Scalar rho, const Scalar alq_value, const Scalar thp_limit, DeferredLogger &deferred_logger) const
Compute BHP from THP limit for a producer.
Scalar mostStrictBhpFromBhpLimits(const SummaryState &summaryState) const
Obtain the most strict BHP from BHP limits.
std::optional< Scalar > computeBhpAtThpLimitInj(const std::function< std::vector< Scalar >(const Scalar)> &frates, const SummaryState &summary_state, const Scalar rho, const Scalar flo_rel_tol, const int max_iteration, const bool throwOnError, DeferredLogger &deferred_logger) const
Compute BHP from THP limit for an injector.
Definition: WellConvergence.hpp:38
Definition: WellGroupHelper.hpp:59
const GroupState< Scalar > & groupState() const
Definition: WellGroupHelper.hpp:183
const SummaryState & summaryState() const
Definition: WellGroupHelper.hpp:260
const WellState< Scalar, IndexTraits > & wellState() const
Definition: WellGroupHelper.hpp:312
WellStateGuard pushWellState(WellState< Scalar, IndexTraits > &well_state)
Definition: WellGroupHelper.hpp:198
const int num_conservation_quantities_
Definition: WellInterfaceGeneric.hpp:314
Well well_ecl_
Definition: WellInterfaceGeneric.hpp:304
void onlyKeepBHPandTHPcontrols(const SummaryState &summary_state, WellStateType &well_state, Well::InjectionControls &inj_controls, Well::ProductionControls &prod_controls) const
void resetDampening()
Definition: WellInterfaceGeneric.hpp:247
std::pair< bool, bool > computeWellPotentials(std::vector< Scalar > &well_potentials, const WellStateType &well_state)
Definition: WellInterfaceIndices.hpp:34
Definition: WellInterface.hpp:77
GetPropType< TypeTag, Properties::Simulator > Simulator
Definition: WellInterface.hpp:82
typename WellInterfaceFluidSystem< FluidSystem >::RateConverterType RateConverterType
Definition: WellInterface.hpp:105
void getTransMult(Value &trans_mult, const Simulator &simulator, const int cell_idx, Callback &extendEval) const
Definition: WellInterface_impl.hpp:2072
Dune::BCRSMatrix< Opm::MatrixBlock< Scalar, 1, 1 > > PressureMatrix
Definition: WellInterface.hpp:98
void getMobility(const Simulator &simulator, const int local_perf_index, std::vector< Value > &mob, Callback &extendEval, DeferredLogger &deferred_logger) const
Definition: WellInterface_impl.hpp:2085
GetPropType< TypeTag, Properties::IntensiveQuantities > IntensiveQuantities
Definition: WellInterface.hpp:87
GetPropType< TypeTag, Properties::Scalar > Scalar
Definition: WellInterface.hpp:83
Dune::BlockVector< VectorBlockType > BVector
Definition: WellInterface.hpp:97
typename Base::ModelParameters ModelParameters
Definition: WellInterface.hpp:111
GetPropType< TypeTag, Properties::FluidSystem > FluidSystem
Definition: WellInterface.hpp:84
GetPropType< TypeTag, Properties::Indices > Indices
Definition: WellInterface.hpp:86
bool solveWellWithOperabilityCheck(const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, const WellGroupHelperType &wgHelper, WellStateType &well_state, DeferredLogger &deferred_logger)
Definition: WellInterface_impl.hpp:589
GetPropType< TypeTag, Properties::SparseMatrixAdapter > SparseMatrixAdapter
Definition: WellInterface.hpp:89
Definition: WellProdIndexCalculator.hpp:37
Scalar connectionProdIndStandard(const std::size_t connIdx, const Scalar connMobility) const
Definition: WellState.hpp:66
const SingleWellState< Scalar, IndexTraits > & well(std::size_t well_index) const
Definition: WellState.hpp:290
std::vector< Scalar > & wellRates(std::size_t well_index)
One rate per well and phase.
Definition: WellState.hpp:255
@ NONE
Definition: DeferredLogger.hpp:46
Definition: blackoilbioeffectsmodules.hh:43
std::string to_string(const ConvergenceReport::ReservoirFailure::Type t)
Static data associated with a well perforation.
Definition: PerforationData.hpp:30
Definition: PerforationData.hpp:41
Scalar dis_gas
Definition: PerforationData.hpp:42
Scalar vap_wat
Definition: PerforationData.hpp:45
Scalar vap_oil
Definition: PerforationData.hpp:44
Scalar dis_gas_in_water
Definition: PerforationData.hpp:43