StandardWell_impl.hpp
Go to the documentation of this file.
1/*
2 Copyright 2017 SINTEF Digital, Mathematics and Cybernetics.
3 Copyright 2017 Statoil ASA.
4 Copyright 2016 - 2017 IRIS AS.
5
6 This file is part of the Open Porous Media project (OPM).
7
8 OPM is free software: you can redistribute it and/or modify
9 it under the terms of the GNU General Public License as published by
10 the Free Software Foundation, either version 3 of the License, or
11 (at your option) any later version.
12
13 OPM is distributed in the hope that it will be useful,
14 but WITHOUT ANY WARRANTY; without even the implied warranty of
15 MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
16 GNU General Public License for more details.
17
18 You should have received a copy of the GNU General Public License
19 along with OPM. If not, see <http://www.gnu.org/licenses/>.
20*/
21
22#ifndef OPM_STANDARDWELL_IMPL_HEADER_INCLUDED
23#define OPM_STANDARDWELL_IMPL_HEADER_INCLUDED
24
25// Improve IDE experience
26#ifndef OPM_STANDARDWELL_HEADER_INCLUDED
27#include <config.h>
29#endif
30
31#include <opm/common/Exceptions.hpp>
32
33#include <opm/input/eclipse/Units/Units.hpp>
34
40
41#include <algorithm>
42#include <cstddef>
43#include <functional>
44
45#include <fmt/format.h>
46
47namespace Opm
48{
49
50 template<typename TypeTag>
52 StandardWell(const Well& well,
53 const ParallelWellInfo<Scalar>& pw_info,
54 const int time_step,
55 const ModelParameters& param,
56 const RateConverterType& rate_converter,
57 const int pvtRegionIdx,
58 const int num_conservation_quantities,
59 const int num_phases,
60 const int index_of_well,
61 const std::vector<PerforationData<Scalar>>& perf_data)
62 : Base(well, pw_info, time_step, param, rate_converter, pvtRegionIdx, num_conservation_quantities, num_phases, index_of_well, perf_data)
63 , StdWellEval(static_cast<const WellInterfaceIndices<FluidSystem,Indices>&>(*this))
64 , regularize_(false)
65 {
67 }
68
69
70
71
72
73 template<typename TypeTag>
74 void
76 init(const std::vector<Scalar>& depth_arg,
77 const Scalar gravity_arg,
78 const std::vector< Scalar >& B_avg,
79 const bool changed_to_open_this_step)
80 {
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);
83 }
84
85
86
87
88
89 template<typename TypeTag>
90 template<class Value>
91 void
94 const std::vector<Value>& mob,
95 const Value& bhp,
96 const std::vector<Value>& Tw,
97 const int perf,
98 const bool allow_cf,
99 std::vector<Value>& cq_s,
100 PerforationRates<Scalar>& perf_rates,
101 DeferredLogger& deferred_logger) const
102 {
103 auto obtain = [this](const Eval& value)
104 {
105 if constexpr (std::is_same_v<Value, Scalar>) {
106 static_cast<void>(this); // suppress clang warning
107 return getValue(value);
108 } else {
109 return this->extendEval(value);
110 }
111 };
112 auto obtainN = [](const auto& value)
113 {
114 if constexpr (std::is_same_v<Value, Scalar>) {
115 return getValue(value);
116 } else {
117 return value;
118 }
119 };
120 auto zeroElem = [this]()
121 {
122 if constexpr (std::is_same_v<Value, Scalar>) {
123 static_cast<void>(this); // suppress clang warning
124 return 0.0;
125 } else {
126 return Value{this->primary_variables_.numWellEq() + Indices::numEq, 0.0};
127 }
128 };
129
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());
136
137 std::vector<Value> b_perfcells_dense(this->numConservationQuantities(), zeroElem());
138 for (unsigned phaseIdx = 0; phaseIdx < FluidSystem::numPhases; ++phaseIdx) {
139 if (!FluidSystem::phaseIsActive(phaseIdx)) {
140 continue;
141 }
142 const unsigned compIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::solventComponentIndex(phaseIdx));
143 b_perfcells_dense[compIdx] = obtain(fs.invB(phaseIdx));
144 }
145 if constexpr (has_solvent) {
146 b_perfcells_dense[Indices::contiSolventEqIdx] = obtain(intQuants.solventInverseFormationVolumeFactor());
147 }
148
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();
154 }
155 }
156
157 Value skin_pressure = zeroElem();
158 if (has_polymermw) {
159 if (this->isInjector()) {
160 const int pskin_index = Bhp + 1 + this->numLocalPerfs() + perf;
161 skin_pressure = obtainN(this->primary_variables_.eval(pskin_index));
162 }
163 }
164
165 // surface volume fraction of fluids within wellbore
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));
169 }
170
171 computePerfRate(mob,
172 pressure,
173 bhp,
174 rs,
175 rv,
176 rvw,
177 rsw,
178 b_perfcells_dense,
179 Tw,
180 perf,
181 allow_cf,
182 skin_pressure,
183 cmix_s,
184 cq_s,
185 perf_rates,
186 deferred_logger);
187 }
188
189
190
191 template<typename TypeTag>
192 template<class Value>
193 void
195 computePerfRate(const std::vector<Value>& mob,
196 const Value& pressure,
197 const Value& bhp,
198 const Value& rs,
199 const Value& rv,
200 const Value& rvw,
201 const Value& rsw,
202 std::vector<Value>& b_perfcells_dense,
203 const std::vector<Value>& Tw,
204 const int perf,
205 const bool allow_cf,
206 const Value& skin_pressure,
207 const std::vector<Value>& cmix_s,
208 std::vector<Value>& cq_s,
209 PerforationRates<Scalar>& perf_rates,
210 DeferredLogger& deferred_logger) const
211 {
212 // Pressure drawdown (also used to determine direction of flow)
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;
217 }
218
219 RatioCalculator<Value> ratioCalc{
220 FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx)
221 ? FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx)
222 : -1,
223 FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx)
224 ? FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx)
225 : -1,
226 FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx)
227 ? FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx)
228 : -1,
229 this->name()
230 };
231
232 // producing perforations
233 if (drawdown > 0) {
234 // Do nothing if crossflow is not allowed
235 if (!allow_cf && this->isInjector()) {
236 return;
237 }
238
239 // compute component volumetric rates at standard conditions
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;
243 }
244
245 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) &&
246 FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx))
247 {
248 ratioCalc.gasOilPerfRateProd(cq_s, perf_rates, rv, rs, rvw,
249 FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx),
250 this->isProducer());
251 } else if (FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx) &&
252 FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx))
253 {
254 ratioCalc.gasWaterPerfRateProd(cq_s, perf_rates, rvw, rsw, this->isProducer());
255 }
256 } else {
257 // Do nothing if crossflow is not allowed
258 if (!allow_cf && this->isProducer()) {
259 return;
260 }
261
262 // Using total mobilities
263 Value total_mob_dense = mob[0];
264 for (int componentIdx = 1; componentIdx < this->numConservationQuantities(); ++componentIdx) {
265 total_mob_dense += mob[componentIdx];
266 }
267
268 // compute volume ratio between connection at standard conditions
269 Value volumeRatio = bhp * 0.0; // initialize it with the correct type
270
271 if (FluidSystem::enableVaporizedWater() && FluidSystem::enableDissolvedGasInWater()) {
272 ratioCalc.disOilVapWatVolumeRatio(volumeRatio, rvw, rsw, pressure,
273 cmix_s, b_perfcells_dense, deferred_logger);
274 // DISGASW only supported for gas-water CO2STORE/H2STORE case
275 // and the simulator will throw long before it reach to this point in the code
276 // For blackoil support of DISGASW we need to add the oil component here
277 assert(FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx));
278 assert(FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx));
279 assert(!FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx));
280 } else {
281
282 if (FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx)) {
283 const unsigned waterCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
284 volumeRatio += cmix_s[waterCompIdx] / b_perfcells_dense[waterCompIdx];
285 }
286
287 if constexpr (Indices::enableSolvent) {
288 volumeRatio += cmix_s[Indices::contiSolventEqIdx] / b_perfcells_dense[Indices::contiSolventEqIdx];
289 }
290
291 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) &&
292 FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx))
293 {
294 ratioCalc.gasOilVolumeRatio(volumeRatio, rv, rs, pressure,
295 cmix_s, b_perfcells_dense,
296 deferred_logger);
297 } else {
298 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx)) {
299 const unsigned oilCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx);
300 volumeRatio += cmix_s[oilCompIdx] / b_perfcells_dense[oilCompIdx];
301 }
302 if (FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx)) {
303 const unsigned gasCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
304 volumeRatio += cmix_s[gasCompIdx] / b_perfcells_dense[gasCompIdx];
305 }
306 }
307 }
308
309 // injecting connections total volumerates at standard conditions
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;
314 }
315
316 // calculating the perforation solution gas rate and solution oil rates
317 if (this->isProducer()) {
318 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) &&
319 FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx))
320 {
321 ratioCalc.gasOilPerfRateInj(cq_s, perf_rates,
322 rv, rs, pressure, rvw,
323 FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx),
324 deferred_logger);
325 }
326 if (FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx) &&
327 FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx))
328 {
329 //no oil
330 ratioCalc.gasWaterPerfRateInj(cq_s, perf_rates, rvw, rsw,
331 pressure, deferred_logger);
332 }
333 }
334 }
335 }
336
337
338 template<typename TypeTag>
339 void
342 const GroupStateHelperType& groupStateHelper,
343 const double dt,
344 const Well::InjectionControls& inj_controls,
345 const Well::ProductionControls& prod_controls,
346 WellStateType& well_state,
347 DeferredLogger& deferred_logger,
348 const bool solving_with_zero_rate)
349 {
350 // TODO: only_wells should be put back to save some computation
351 // for example, the matrices B C does not need to update if only_wells
352 if (!this->isOperableAndSolvable() && !this->wellIsStopped()) return;
353
354 // clear all entries
355 this->linSys_.clear();
356
357 assembleWellEqWithoutIterationImpl(simulator, groupStateHelper, dt, inj_controls,
358 prod_controls, well_state,
359 deferred_logger, solving_with_zero_rate);
360 }
361
362
363
364
365 template<typename TypeTag>
366 void
369 const GroupStateHelperType& groupStateHelper,
370 const double dt,
371 const Well::InjectionControls& inj_controls,
372 const Well::ProductionControls& prod_controls,
373 WellStateType& well_state,
374 DeferredLogger& deferred_logger,
375 const bool solving_with_zero_rate)
376 {
377 // try to regularize equation if the well does not converge
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;
380
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;
385 }
386
387
388 const int np = this->number_of_phases_;
389
390 std::vector<RateVector> connectionRates = this->connectionRates_; // Copy to get right size.
391
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) {
395 // Calculate perforation quantities.
396 std::vector<EvalWell> cq_s(this->num_conservation_quantities_, 0.0);
397 EvalWell water_flux_s{0.0};
398 EvalWell cq_s_zfrac_effective{0.0};
399 calculateSinglePerf(simulator, perf, well_state, connectionRates,
400 cq_s, water_flux_s, cq_s_zfrac_effective, deferred_logger);
401
402 // Equation assembly for this perforation.
403 if constexpr (has_polymer && Base::has_polymermw) {
404 if (this->isInjector()) {
405 handleInjectivityEquations(simulator, well_state, perf,
406 water_flux_s, deferred_logger);
407 }
408 }
409 for (int componentIdx = 0; componentIdx < this->num_conservation_quantities_; ++componentIdx) {
410 // the cq_s entering mass balance equations need to consider the efficiency factors.
411 const EvalWell cq_s_effective = cq_s[componentIdx] * this->well_efficiency_factor_;
412
413 connectionRates[perf][componentIdx] = Base::restrictEval(cq_s_effective);
414
416 assemblePerforationEq(cq_s_effective,
417 componentIdx,
418 perf,
419 this->primary_variables_.numWellEq(),
420 this->linSys_);
421
422 // Store the perforation phase flux for later usage.
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();
426 } else {
427 perf_rates[perf*np + FluidSystem::activeCompToActivePhaseIdx(componentIdx)] = cq_s[componentIdx].value();
428 }
429 }
430
431 if constexpr (has_zFraction) {
433 assembleZFracEq(cq_s_zfrac_effective,
434 perf,
435 this->primary_variables_.numWellEq(),
436 this->linSys_);
437 }
438 }
439 // Update the connection
440 this->connectionRates_ = connectionRates;
441
442 // Accumulate dissolved gas and vaporized oil flow rates across all
443 // ranks sharing this well (this->index_of_well_).
444 {
445 const auto& comm = this->parallel_well_info_.communication();
446 comm.sum(ws.phase_mixing_rates.data(), ws.phase_mixing_rates.size());
447 }
448
449 // accumulate resWell_ and duneD_ in parallel to get effects of all perforations (might be distributed)
450 this->linSys_.sumDistributed(this->parallel_well_info_.communication());
451
452 // add vol * dF/dt + Q to the well equations;
453 for (int componentIdx = 0; componentIdx < numWellConservationEq; ++componentIdx) {
454 // TODO: following the development in MSW, we need to convert the volume of the wellbore to be surface volume
455 // since all the rates are under surface condition
456 EvalWell resWell_loc(0.0);
457 if (FluidSystem::numActivePhases() > 1) {
458 assert(dt > 0);
459 resWell_loc += (this->primary_variables_.surfaceVolumeFraction(componentIdx) -
460 this->F0_[componentIdx]) * volume / dt;
461 }
462 resWell_loc -= this->primary_variables_.getQs(componentIdx) * this->well_efficiency_factor_;
464 assembleSourceEq(resWell_loc,
465 componentIdx,
466 this->primary_variables_.numWellEq(),
467 this->linSys_);
468 }
469
470 const bool stopped_or_zero_target = this->stoppedOrZeroRateTarget(groupStateHelper, deferred_logger);
471 {
472 // When solving_with_zero_rate=true (called from solveWellWithZeroRate),
473 // we use an empty GroupState to isolate the well from group constraints during assembly.
474 // This allows us to solve the well equations independently of group controls/targets.
475 GroupState<Scalar> empty_group_state;
476 auto& group_state = solving_with_zero_rate
477 ? empty_group_state
478 : groupStateHelper.groupState();
479 GroupStateHelperType groupStateHelper_copy = groupStateHelper;
480 auto group_guard = groupStateHelper_copy.pushGroupState(group_state);
482 assembleControlEq(groupStateHelper_copy,
483 inj_controls, prod_controls,
484 this->primary_variables_,
485 this->getRefDensity(),
486 this->linSys_,
487 stopped_or_zero_target,
488 deferred_logger);
489 }
490
491 // do the local inversion of D.
492 try {
493 this->linSys_.invert();
494 } catch( ... ) {
495 OPM_DEFLOG_PROBLEM(NumericalProblem, "Error when inverting local well equations for well " + name(), deferred_logger);
496 }
497 }
498
499
500
501
502 template<typename TypeTag>
503 void
505 calculateSinglePerf(const Simulator& simulator,
506 const int perf,
507 WellStateType& well_state,
508 std::vector<RateVector>& connectionRates,
509 std::vector<EvalWell>& cq_s,
510 EvalWell& water_flux_s,
511 EvalWell& cq_s_zfrac_effective,
512 DeferredLogger& deferred_logger) const
513 {
514 const bool allow_cf = this->getAllowCrossFlow() || openCrossFlowAvoidSingularity(simulator);
515 const EvalWell& bhp = this->primary_variables_.eval(Bhp);
516 const int cell_idx = this->well_cells_[perf];
517 const auto& intQuants = simulator.model().intensiveQuantities(cell_idx, /*timeIdx=*/ 0);
518 std::vector<EvalWell> mob(this->num_conservation_quantities_, {0.});
519 getMobility(simulator, perf, mob, deferred_logger);
520
521 PerforationRates<Scalar> perf_rates;
522 EvalWell trans_mult(0.0);
523 getTransMult(trans_mult, simulator, cell_idx);
524 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
525 std::vector<EvalWell> Tw(this->num_conservation_quantities_, this->well_index_[perf] * trans_mult);
526 this->getTw(Tw, perf, intQuants, trans_mult, wellstate_nupcol);
527 computePerfRate(intQuants, mob, bhp, Tw, perf, allow_cf,
528 cq_s, perf_rates, deferred_logger);
529
530 auto& ws = well_state.well(this->index_of_well_);
531 auto& perf_data = ws.perf_data;
532 if constexpr (has_polymer && Base::has_polymermw) {
533 if (this->isInjector()) {
534 // Store the original water flux computed from the reservoir quantities.
535 // It will be required to assemble the injectivity equations.
536 const unsigned water_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
537 water_flux_s = cq_s[water_comp_idx];
538 // Modify the water flux for the rest of this function to depend directly on the
539 // local water velocity primary variable.
540 handleInjectivityRate(simulator, perf, cq_s);
541 }
542 }
543
544 // updating the solution gas rate and solution oil rate
545 if (this->isProducer()) {
546 ws.phase_mixing_rates[ws.dissolved_gas] += perf_rates.dis_gas;
547 ws.phase_mixing_rates[ws.dissolved_gas_in_water] += perf_rates.dis_gas_in_water;
548 ws.phase_mixing_rates[ws.vaporized_oil] += perf_rates.vap_oil;
549 ws.phase_mixing_rates[ws.vaporized_water] += perf_rates.vap_wat;
550 perf_data.phase_mixing_rates[perf][ws.dissolved_gas] = perf_rates.dis_gas;
551 perf_data.phase_mixing_rates[perf][ws.dissolved_gas_in_water] = perf_rates.dis_gas_in_water;
552 perf_data.phase_mixing_rates[perf][ws.vaporized_oil] = perf_rates.vap_oil;
553 perf_data.phase_mixing_rates[perf][ws.vaporized_water] = perf_rates.vap_wat;
554 }
555
556 if constexpr (has_energy) {
557 connectionRates[perf][Indices::contiEnergyEqIdx] =
558 connectionRateEnergy(cq_s, intQuants, deferred_logger);
559 ws.energy_rate += getValue(connectionRates[perf][Indices::contiEnergyEqIdx]);
560 }
561
562 if constexpr (has_polymer) {
563 std::variant<Scalar,EvalWell> polymerConcentration;
564 if (this->isInjector()) {
565 polymerConcentration = this->wpolymer();
566 } else {
567 polymerConcentration = this->extendEval(intQuants.polymerConcentration() *
568 intQuants.polymerViscosityCorrection());
569 }
570
571 [[maybe_unused]] EvalWell cq_s_poly;
572 std::tie(connectionRates[perf][Indices::contiPolymerEqIdx],
573 cq_s_poly) =
574 this->connections_.connectionRatePolymer(perf_data.polymer_rates[perf],
575 cq_s, polymerConcentration);
576
577 if constexpr (Base::has_polymermw) {
578 updateConnectionRatePolyMW(cq_s_poly, intQuants, well_state,
579 perf, connectionRates, deferred_logger);
580 }
581 }
582
583 if constexpr (has_foam) {
584 std::variant<Scalar,EvalWell> foamConcentration;
585 if (this->isInjector()) {
586 foamConcentration = this->wfoam();
587 } else {
588 foamConcentration = this->extendEval(intQuants.foamConcentration());
589 }
590 connectionRates[perf][Indices::contiFoamEqIdx] =
591 this->connections_.connectionRateFoam(cq_s, foamConcentration,
592 FoamModule::transportPhase(),
593 deferred_logger);
594 }
595
596 if constexpr (has_zFraction) {
597 std::variant<Scalar,std::array<EvalWell,2>> solventConcentration;
598 if (this->isInjector()) {
599 solventConcentration = this->wsolvent();
600 } else {
601 solventConcentration = std::array{this->extendEval(intQuants.xVolume()),
602 this->extendEval(intQuants.yVolume())};
603 }
604 std::tie(connectionRates[perf][Indices::contiZfracEqIdx],
605 cq_s_zfrac_effective) =
606 this->connections_.connectionRatezFraction(perf_data.solvent_rates[perf],
607 perf_rates.dis_gas, cq_s,
608 solventConcentration);
609 }
610
611 if constexpr (has_brine) {
612 std::variant<Scalar,EvalWell> saltConcentration;
613 if (this->isInjector()) {
614 saltConcentration = this->wsalt();
615 } else {
616 saltConcentration = this->extendEval(intQuants.fluidState().saltConcentration());
617 }
618
619 connectionRates[perf][Indices::contiBrineEqIdx] =
620 this->connections_.connectionRateBrine(perf_data.brine_rates[perf],
621 perf_rates.vap_wat, cq_s,
622 saltConcentration);
623 }
624
625 if constexpr (has_bioeffects) {
626 std::variant<Scalar,EvalWell> microbialConcentration;
627 if constexpr (has_micp) {
628 std::variant<Scalar,EvalWell> oxygenConcentration;
629 std::variant<Scalar,EvalWell> ureaConcentration;
630 if (this->isInjector()) {
631 microbialConcentration = this->wmicrobes();
632 oxygenConcentration = this->woxygen();
633 ureaConcentration = this->wurea();
634 } else {
635 microbialConcentration = this->extendEval(intQuants.microbialConcentration());
636 oxygenConcentration = this->extendEval(intQuants.oxygenConcentration());
637 ureaConcentration = this->extendEval(intQuants.ureaConcentration());
638 }
639 std::tie(connectionRates[perf][Indices::contiMicrobialEqIdx],
640 connectionRates[perf][Indices::contiOxygenEqIdx],
641 connectionRates[perf][Indices::contiUreaEqIdx]) =
642 this->connections_.connectionRatesMICP(perf_data.microbial_rates[perf],
643 perf_data.oxygen_rates[perf],
644 perf_data.urea_rates[perf],
645 cq_s,
646 microbialConcentration,
647 oxygenConcentration,
648 ureaConcentration);
649 }
650 else {
651 if (this->isProducer()) {
652 microbialConcentration = this->extendEval(intQuants.microbialConcentration());
653 connectionRates[perf][Indices::contiMicrobialEqIdx] =
654 this->connections_.connectionRateBioeffects(perf_data.microbial_rates[perf],
655 perf_rates.vap_wat, cq_s,
656 microbialConcentration);
657 }
658 }
659 }
660
661 // Store the perforation pressure for later usage.
662 perf_data.pressure[perf] = ws.bhp + this->connections_.pressure_diff(perf);
663
664 // Store the perforation gass mass rate.
665 if (FluidSystem::phaseUsage().hasCO2orH2Store()) {
666 const unsigned gas_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
667 const Scalar rho = FluidSystem::referenceDensity( FluidSystem::gasPhaseIdx, Base::pvtRegionIdx() );
668 perf_data.gas_mass_rates[perf] = cq_s[gas_comp_idx].value() * rho;
669 }
670
671 // Store the perforation water mass rate.
672 if (FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx)) {
673 const unsigned wat_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
674 const Scalar rho = FluidSystem::referenceDensity( FluidSystem::waterPhaseIdx, Base::pvtRegionIdx() );
675 perf_data.wat_mass_rates[perf] = cq_s[wat_comp_idx].value() * rho;
676 }
677 }
678
679 template<typename TypeTag>
680 template<class Value>
681 void
683 getTransMult(Value& trans_mult,
684 const Simulator& simulator,
685 const int cell_idx) const
686 {
687 auto obtain = [this](const Eval& value)
688 {
689 if constexpr (std::is_same_v<Value, Scalar>) {
690 static_cast<void>(this); // suppress clang warning
691 return getValue(value);
692 } else {
693 return this->extendEval(value);
694 }
695 };
696 WellInterface<TypeTag>::getTransMult(trans_mult, simulator, cell_idx, obtain);
697 }
698
699 template<typename TypeTag>
700 template<class Value>
701 void
703 getMobility(const Simulator& simulator,
704 const int perf,
705 std::vector<Value>& mob,
706 DeferredLogger& deferred_logger) const
707 {
708 auto obtain = [this](const Eval& value)
709 {
710 if constexpr (std::is_same_v<Value, Scalar>) {
711 static_cast<void>(this); // suppress clang warning
712 return getValue(value);
713 } else {
714 return this->extendEval(value);
715 }
716 };
717 WellInterface<TypeTag>::getMobility(simulator, perf, mob,
718 obtain, deferred_logger);
719
720 // modify the water mobility if polymer is present
721 if constexpr (has_polymer) {
722 if (!FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx)) {
723 OPM_DEFLOG_THROW(std::runtime_error, "Water is required when polymer is active", deferred_logger);
724 }
725
726 // for the cases related to polymer molecular weight, we assume fully mixing
727 // as a result, the polymer and water share the same viscosity
728 if constexpr (!Base::has_polymermw) {
729 if constexpr (std::is_same_v<Value, Scalar>) {
730 std::vector<EvalWell> mob_eval(this->num_conservation_quantities_, 0.);
731 for (std::size_t i = 0; i < mob.size(); ++i) {
732 mob_eval[i].setValue(mob[i]);
733 }
734 updateWaterMobilityWithPolymer(simulator, perf, mob_eval, deferred_logger);
735 for (std::size_t i = 0; i < mob.size(); ++i) {
736 mob[i] = getValue(mob_eval[i]);
737 }
738 } else {
739 updateWaterMobilityWithPolymer(simulator, perf, mob, deferred_logger);
740 }
741 }
742 }
743
744 // if the injecting well has WINJMULT setup, we update the mobility accordingly
745 if (this->isInjector() && this->well_ecl_.getInjMultMode() != Well::InjMultMode::NONE) {
746 const Scalar bhp = this->primary_variables_.value(Bhp);
747 const Scalar perf_press = bhp + this->connections_.pressure_diff(perf);
748 const Scalar multiplier = this->getInjMult(perf, bhp, perf_press, deferred_logger);
749 for (std::size_t i = 0; i < mob.size(); ++i) {
750 mob[i] *= multiplier;
751 }
752 }
753 }
754
755
756 template<typename TypeTag>
757 void
759 updateWellState(const Simulator& simulator,
760 const BVectorWell& dwells,
761 const GroupStateHelperType& groupStateHelper,
762 WellStateType& well_state,
763 DeferredLogger& deferred_logger)
764 {
765 if (!this->isOperableAndSolvable() && !this->wellIsStopped()) return;
766
767 const bool stop_or_zero_rate_target = this->stoppedOrZeroRateTarget(groupStateHelper, deferred_logger);
768 updatePrimaryVariablesNewton(dwells, stop_or_zero_rate_target, deferred_logger);
769
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_));
773 }
774
775
776
777
778
779 template<typename TypeTag>
780 void
783 const bool stop_or_zero_rate_target,
784 DeferredLogger& deferred_logger)
785 {
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);
789
790 // for the water velocity and skin pressure
791 if constexpr (Base::has_polymermw) {
792 this->primary_variables_.updateNewtonPolyMW(dwells);
793 }
794
795 this->primary_variables_.checkFinite(deferred_logger, "Newton update");
796 }
797
798
799
800
801
802 template<typename TypeTag>
803 void
806 const SummaryState& summary_state,
807 DeferredLogger& deferred_logger) const
808 {
809 this->primary_variables_.copyToWellState(well_state, deferred_logger);
810
811 WellBhpThpCalculator(this->baseif_).
812 updateThp(getRefDensity(),
813 [this,&well_state]() { return this->baseif_.getALQ(well_state); },
814 well_state, summary_state, deferred_logger);
815
816 // other primary variables related to polymer injectivity study
817 if constexpr (Base::has_polymermw) {
818 this->primary_variables_.copyToWellStatePolyMW(well_state);
819 }
820 }
821
822
823
824
825
826 template<typename TypeTag>
827 void
829 updateIPR(const Simulator& simulator, DeferredLogger& deferred_logger) const
830 {
831 // TODO: not handling solvent related here for now
832
833 // initialize all the values to be zero to begin with
834 std::fill(this->ipr_a_.begin(), this->ipr_a_.end(), 0.);
835 std::fill(this->ipr_b_.begin(), this->ipr_b_.end(), 0.);
836
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);
840
841 const int cell_idx = this->well_cells_[perf];
842 const auto& int_quantities = simulator.model().intensiveQuantities(cell_idx, /*timeIdx=*/ 0);
843 const auto& fs = int_quantities.fluidState();
844 // the pressure of the reservoir grid block the well connection is in
845 Scalar p_r = this->getPerfCellPressure(fs).value();
846
847 // calculating the b for the connection
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)) {
851 continue;
852 }
853 const unsigned comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::solventComponentIndex(phase));
854 b_perf[comp_idx] = fs.invB(phase).value();
855 }
856 if constexpr (has_solvent) {
857 b_perf[Indices::contiSolventEqIdx] = int_quantities.solventInverseFormationVolumeFactor().value();
858 }
859
860 // the pressure difference between the connection and BHP
861 const Scalar h_perf = this->connections_.pressure_diff(perf);
862 const Scalar pressure_diff = p_r - h_perf;
863
864 // Let us add a check, since the pressure is calculated based on zero value BHP
865 // it should not be negative anyway. If it is negative, we might need to re-formulate
866 // to taking into consideration the crossflow here.
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");
871 // we ignore these connections for now
872 continue;
873 }
874
875 // the well index associated with the connection
876 Scalar trans_mult(0.0);
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;
887 }
888
889 // we need to handle the rs and rv when both oil and gas are present
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();
895
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];
898
899 ipr_a_perf[gas_comp_idx] += dis_gas_a;
900 ipr_a_perf[oil_comp_idx] += vap_oil_a;
901
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];
904
905 ipr_b_perf[gas_comp_idx] += dis_gas_b;
906 ipr_b_perf[oil_comp_idx] += vap_oil_b;
907 }
908
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];
912 }
913 }
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());
916 }
917
918 template<typename TypeTag>
919 void
921 updateIPRImplicit(const Simulator& simulator,
922 const GroupStateHelperType& groupStateHelper,
923 WellStateType& well_state,
924 DeferredLogger& deferred_logger)
925 {
926 // Compute IPR based on *converged* well-equation:
927 // For a component rate r the derivative dr/dbhp is obtained by
928 // dr/dbhp = - (partial r/partial x) * inv(partial Eq/partial x) * (partial Eq/partial bhp_target)
929 // where Eq(x)=0 is the well equation setup with bhp control and primary variables x
930
931 // We shouldn't have zero rates at this stage, but check
932 bool zero_rates;
933 auto rates = well_state.well(this->index_of_well_).surface_rates;
934 zero_rates = true;
935 for (std::size_t p = 0; p < rates.size(); ++p) {
936 zero_rates &= rates[p] == 0.0;
937 }
938 auto& ws = well_state.well(this->index_of_well_);
939 if (zero_rates) {
940 const auto msg = fmt::format("updateIPRImplicit: Well {} has zero rate, IPRs might be problematic", this->name());
941 deferred_logger.debug(msg);
942 /*
943 // could revert to standard approach here:
944 updateIPR(simulator, deferred_logger);
945 for (int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx){
946 const int idx = this->activeCompToActivePhaseIdx(comp_idx);
947 ws.implicit_ipr_a[idx] = this->ipr_a_[comp_idx];
948 ws.implicit_ipr_b[idx] = this->ipr_b_[comp_idx];
949 }
950 return;
951 */
952 }
953
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.);
956
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;
961
962 // Set current control to bhp, and bhp value in state, modify bhp limit in control object.
963 const auto cmode = ws.production_cmode;
964 ws.production_cmode = Well::ProducerCMode::BHP;
965 const double dt = simulator.timeStepSize();
966 assembleWellEqWithoutIteration(simulator, groupStateHelper, dt, inj_controls, prod_controls, well_state, deferred_logger,
967 /*solving_with_zero_rate=*/false);
968
969 const size_t nEq = this->primary_variables_.numWellEq();
970 BVectorWell rhs(1);
971 rhs[0].resize(nEq);
972 // rhs = 0 except -1 for control eq
973 for (size_t i=0; i < nEq; ++i){
974 rhs[0][i] = 0.0;
975 }
976 rhs[0][Bhp] = -1.0;
977
978 BVectorWell x_well(1);
979 x_well[0].resize(nEq);
980 this->linSys_.solve(rhs, x_well);
981
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) {
986 // well primary variable derivatives in EvalWell start at position Indices::numEq
987 ws.implicit_ipr_b[idx] -= x_well[0][pvIdx]*comp_rate.derivative(pvIdx+Indices::numEq);
988 }
989 ws.implicit_ipr_a[idx] = ws.implicit_ipr_b[idx]*ws.bhp - comp_rate.value();
990 }
991 // reset cmode
992 ws.production_cmode = cmode;
993 }
994
995 template<typename TypeTag>
996 void
999 const Simulator& simulator,
1000 DeferredLogger& deferred_logger)
1001 {
1002 const auto& summaryState = simulator.vanguard().summaryState();
1003 const Scalar bhp_limit = WellBhpThpCalculator(*this).mostStrictBhpFromBhpLimits(summaryState);
1004 // Crude but works: default is one atmosphere.
1005 // TODO: a better way to detect whether the BHP is defaulted or not
1006 const bool bhp_limit_not_defaulted = bhp_limit > 1.5 * unit::barsa;
1007 if ( bhp_limit_not_defaulted || !this->wellHasTHPConstraints(summaryState) ) {
1008 // if the BHP limit is not defaulted or the well does not have a THP limit
1009 // we need to check the BHP limit
1010 Scalar total_ipr_mass_rate = 0.0;
1011 for (unsigned phaseIdx = 0; phaseIdx < FluidSystem::numPhases; ++phaseIdx)
1012 {
1013 if (!FluidSystem::phaseIsActive(phaseIdx)) {
1014 continue;
1015 }
1016
1017 const unsigned compIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::solventComponentIndex(phaseIdx));
1018 const Scalar ipr_rate = this->ipr_a_[compIdx] - this->ipr_b_[compIdx] * bhp_limit;
1019
1020 const Scalar rho = FluidSystem::referenceDensity( phaseIdx, Base::pvtRegionIdx() );
1021 total_ipr_mass_rate += ipr_rate * rho;
1022 }
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;
1025 }
1026
1027 // checking whether running under BHP limit will violate THP limit
1028 if (this->operability_status_.operable_under_only_bhp_limit && this->wellHasTHPConstraints(summaryState)) {
1029 // option 1: calculate well rates based on the BHP limit.
1030 // option 2: stick with the above IPR curve
1031 // we use IPR here
1032 std::vector<Scalar> well_rates_bhp_limit;
1033 computeWellRatesWithBhp(simulator, bhp_limit, well_rates_bhp_limit, deferred_logger);
1034
1035 this->adaptRatesForVFP(well_rates_bhp_limit);
1036 const Scalar thp_limit = this->getTHPConstraint(summaryState);
1037 const Scalar thp = WellBhpThpCalculator(*this).calculateThpFromBhp(well_rates_bhp_limit,
1038 bhp_limit,
1039 this->getRefDensity(),
1040 this->getALQ(well_state),
1041 thp_limit,
1042 deferred_logger);
1043 if ( (this->isProducer() && thp < thp_limit) || (this->isInjector() && thp > thp_limit) ) {
1044 this->operability_status_.obey_thp_limit_under_bhp_limit = false;
1045 }
1046 }
1047 } else {
1048 // defaulted BHP and there is a THP constraint
1049 // default BHP limit is about 1 atm.
1050 // when applied the hydrostatic pressure correction dp,
1051 // most likely we get a negative value (bhp + dp)to search in the VFP table,
1052 // which is not desirable.
1053 // we assume we can operate under defaulted BHP limit and will violate the THP limit
1054 // when operating under defaulted BHP limit.
1055 this->operability_status_.operable_under_only_bhp_limit = true;
1056 this->operability_status_.obey_thp_limit_under_bhp_limit = false;
1057 }
1058 }
1059
1060
1061
1062
1063
1064 template<typename TypeTag>
1065 void
1068 const WellStateType& well_state,
1069 const GroupStateHelperType& groupStateHelper,
1070 DeferredLogger& deferred_logger)
1071 {
1072 const auto& summaryState = simulator.vanguard().summaryState();
1073 const auto obtain_bhp = this->isProducer() ? computeBhpAtThpLimitProd(well_state, simulator, groupStateHelper, summaryState, deferred_logger)
1074 : computeBhpAtThpLimitInj(simulator, groupStateHelper, summaryState, deferred_logger);
1075
1076 if (obtain_bhp) {
1077 this->operability_status_.can_obtain_bhp_with_thp_limit = true;
1078
1079 const Scalar bhp_limit = WellBhpThpCalculator(*this).mostStrictBhpFromBhpLimits(summaryState);
1080 this->operability_status_.obey_bhp_limit_with_thp_limit = this->isProducer() ?
1081 *obtain_bhp >= bhp_limit : *obtain_bhp <= bhp_limit ;
1082
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 "
1087 + std::to_string(unit::convert::to(thp_limit, unit::barsa))
1088 + " bars as a producer for well " + name();
1089 deferred_logger.debug(msg);
1090 }
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 "
1094 + std::to_string(unit::convert::to(thp_limit, unit::barsa))
1095 + " bars as a injector for well " + name();
1096 deferred_logger.debug(msg);
1097 }
1098 } else {
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 "
1104 + std::to_string(unit::convert::to(thp_limit, unit::barsa))
1105 + " bar for well " + name() + ", the well might need to be closed ");
1106 }
1107 }
1108 }
1109
1110
1111
1112
1113
1114 template<typename TypeTag>
1115 bool
1117 allDrawDownWrongDirection(const Simulator& simulator) const
1118 {
1119 bool all_drawdown_wrong_direction = true;
1120
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, /*timeIdx=*/0);
1124 const auto& fs = intQuants.fluidState();
1125
1126 const Scalar pressure = this->getPerfCellPressure(fs).value();
1127 const Scalar bhp = this->primary_variables_.eval(Bhp).value();
1128
1129 // Pressure drawdown (also used to determine direction of flow)
1130 const Scalar well_pressure = bhp + this->connections_.pressure_diff(perf);
1131 const Scalar drawdown = pressure - well_pressure;
1132
1133 // for now, if there is one perforation can produce/inject in the correct
1134 // direction, we consider this well can still produce/inject.
1135 // TODO: it can be more complicated than this to cause wrong-signed rates
1136 if ( (drawdown < 0. && this->isInjector()) ||
1137 (drawdown > 0. && this->isProducer()) ) {
1138 all_drawdown_wrong_direction = false;
1139 break;
1140 }
1141 }
1142
1143 const auto& comm = this->parallel_well_info_.communication();
1144 if (comm.size() > 1)
1145 {
1146 all_drawdown_wrong_direction =
1147 (comm.min(all_drawdown_wrong_direction ? 1 : 0) == 1);
1148 }
1149
1150 return all_drawdown_wrong_direction;
1151 }
1152
1153
1154
1155
1156 template<typename TypeTag>
1157 bool
1159 openCrossFlowAvoidSingularity(const Simulator& simulator) const
1160 {
1161 return !this->getAllowCrossFlow() && allDrawDownWrongDirection(simulator);
1162 }
1163
1164
1165
1166
1167 template<typename TypeTag>
1171 const WellStateType& well_state) const
1172 {
1173 auto prop_func = typename StdWellEval::StdWellConnections::PressurePropertyFunctions {
1174 // getTemperature
1175 [&model = simulator.model()](int cell_idx, int phase_idx)
1176 {
1177 return model.intensiveQuantities(cell_idx, /* time_idx = */ 0)
1178 .fluidState().temperature(phase_idx).value();
1179 },
1180
1181 // getSaltConcentration
1182 [&model = simulator.model()](int cell_idx)
1183 {
1184 return model.intensiveQuantities(cell_idx, /* time_idx = */ 0)
1185 .fluidState().saltConcentration().value();
1186 },
1187
1188 // getPvtRegionIdx
1189 [&model = simulator.model()](int cell_idx)
1190 {
1191 return model.intensiveQuantities(cell_idx, /* time_idx = */ 0)
1192 .fluidState().pvtRegionIndex();
1193 }
1194 };
1195
1196 if constexpr (Indices::enableSolvent) {
1197 prop_func.solventInverseFormationVolumeFactor =
1198 [&model = simulator.model()](int cell_idx)
1199 {
1200 return model.intensiveQuantities(cell_idx, /* time_idx = */ 0)
1201 .solventInverseFormationVolumeFactor().value();
1202 };
1203
1204 prop_func.solventRefDensity = [&model = simulator.model()](int cell_idx)
1205 {
1206 return model.intensiveQuantities(cell_idx, /* time_idx = */ 0)
1207 .solventRefDensity();
1208 };
1209 }
1210
1211 return this->connections_.computePropertiesForPressures(well_state, prop_func);
1212 }
1213
1214
1215
1216
1217
1218 template<typename TypeTag>
1221 getWellConvergence(const GroupStateHelperType& groupStateHelper,
1222 const std::vector<Scalar>& B_avg,
1223 DeferredLogger& deferred_logger,
1224 const bool relax_tolerance) const
1225 {
1226 // the following implementation assume that the polymer is always after the w-o-g phases
1227 // For the polymer, energy and foam cases, there is one more mass balance equations of reservoir than wells
1228 assert((int(B_avg.size()) == this->num_conservation_quantities_) || has_polymer || has_energy || has_foam || has_brine || has_zFraction || has_bioeffects);
1229
1230 Scalar tol_wells = this->param_.tolerance_wells_;
1231 // use stricter tolerance for stopped wells and wells under zero rate target control.
1232 constexpr Scalar stopped_factor = 1.e-4;
1233 // use stricter tolerance for dynamic thp to ameliorate network convergence
1234 constexpr Scalar dynamic_thp_factor = 1.e-1;
1235 if (this->stoppedOrZeroRateTarget(groupStateHelper, deferred_logger)) {
1236 tol_wells = tol_wells*stopped_factor;
1237 } else if (this->getDynamicThpLimit()) {
1238 tol_wells = tol_wells*dynamic_thp_factor;
1239 }
1240
1241 std::vector<Scalar> res;
1242 ConvergenceReport report = this->StdWellEval::getWellConvergence(groupStateHelper.wellState(),
1243 B_avg,
1244 this->param_.max_residual_allowed_,
1245 tol_wells,
1246 this->param_.relaxed_tolerance_flow_well_,
1247 relax_tolerance,
1248 this->wellIsStopped(),
1249 res,
1250 deferred_logger);
1251
1252 checkConvergenceExtraEqs(res, report);
1253
1254 return report;
1255 }
1256
1257
1258
1259
1260
1261 template<typename TypeTag>
1262 void
1264 updateProductivityIndex(const Simulator& simulator,
1265 const WellProdIndexCalculator<Scalar>& wellPICalc,
1266 WellStateType& well_state,
1267 DeferredLogger& deferred_logger) const
1268 {
1269 auto fluidState = [&simulator, this](const int perf)
1270 {
1271 const auto cell_idx = this->well_cells_[perf];
1272 return simulator.model()
1273 .intensiveQuantities(cell_idx, /*timeIdx=*/ 0).fluidState();
1274 };
1275
1276 const int np = this->number_of_phases_;
1277 auto setToZero = [np](Scalar* x) -> void
1278 {
1279 std::fill_n(x, np, 0.0);
1280 };
1281
1282 auto addVector = [np](const Scalar* src, Scalar* dest) -> void
1283 {
1284 std::transform(src, src + np, dest, dest, std::plus<>{});
1285 };
1286
1287 auto& ws = well_state.well(this->index_of_well_);
1288 auto& perf_data = ws.perf_data;
1289 auto* wellPI = ws.productivity_index.data();
1290 auto* connPI = perf_data.prod_index.data();
1291
1292 setToZero(wellPI);
1293
1294 const auto preferred_phase = this->well_ecl_.getPreferredPhase();
1295 auto subsetPerfID = 0;
1296
1297 for (const auto& perf : *this->perf_data_) {
1298 auto allPerfID = perf.ecl_index;
1299
1300 auto connPICalc = [&wellPICalc, allPerfID](const Scalar mobility) -> Scalar
1301 {
1302 return wellPICalc.connectionProdIndStandard(allPerfID, mobility);
1303 };
1304
1305 std::vector<Scalar> mob(this->num_conservation_quantities_, 0.0);
1306 getMobility(simulator, static_cast<int>(subsetPerfID), mob, deferred_logger);
1307
1308 const auto& fs = fluidState(subsetPerfID);
1309 setToZero(connPI);
1310
1311 if (this->isInjector()) {
1312 this->computeConnLevelInjInd(fs, preferred_phase, connPICalc,
1313 mob, connPI, deferred_logger);
1314 }
1315 else { // Production or zero flow rate
1316 this->computeConnLevelProdInd(fs, connPICalc, mob, connPI);
1317 }
1318
1319 addVector(connPI, wellPI);
1320
1321 ++subsetPerfID;
1322 connPI += np;
1323 }
1324
1325 // Sum with communication in case of distributed well.
1326 const auto& comm = this->parallel_well_info_.communication();
1327 if (comm.size() > 1) {
1328 comm.sum(wellPI, np);
1329 }
1330
1331 assert ((static_cast<int>(subsetPerfID) == this->number_of_local_perforations_) &&
1332 "Internal logic error in processing connections for PI/II");
1333 }
1334
1335
1336
1337 template<typename TypeTag>
1340 const GroupStateHelperType& groupStateHelper,
1341 const WellConnectionProps& props,
1342 DeferredLogger& deferred_logger)
1343 {
1344 const auto& well_state = groupStateHelper.wellState();
1345 // Cell level dynamic property call-back functions as fall-back
1346 // option for calculating connection level mixture densities in
1347 // stopped or zero-rate producer wells.
1348 const auto prop_func = typename StdWellEval::StdWellConnections::DensityPropertyFunctions {
1349 // This becomes slightly more palatable with C++20's designated
1350 // initialisers.
1351
1352 // mobility: Phase mobilities in specified cell.
1353 [&model = simulator.model()](const int cell,
1354 const std::vector<int>& phases,
1355 std::vector<Scalar>& mob)
1356 {
1357 const auto& iq = model.intensiveQuantities(cell, /* time_idx = */ 0);
1358
1359 std::transform(phases.begin(), phases.end(), mob.begin(),
1360 [&iq](const int phase) { return iq.mobility(phase).value(); });
1361 },
1362
1363 // densityInCell: Reservoir condition phase densities in
1364 // specified cell.
1365 [&model = simulator.model()](const int cell,
1366 const std::vector<int>& phases,
1367 std::vector<Scalar>& rho)
1368 {
1369 const auto& fs = model.intensiveQuantities(cell, /* time_idx = */ 0).fluidState();
1370
1371 std::transform(phases.begin(), phases.end(), rho.begin(),
1372 [&fs](const int phase) { return fs.density(phase).value(); });
1373 }
1374 };
1375
1376 const auto stopped_or_zero_rate_target = this->
1377 stoppedOrZeroRateTarget(groupStateHelper, deferred_logger);
1378
1379 this->connections_
1380 .computeProperties(stopped_or_zero_rate_target, well_state,
1381 prop_func, props, deferred_logger);
1382 // density was updated
1383 cachedRefDensity = this->connections_.rho(0);
1384 if (this->parallel_well_info_.communication().size() > 1) {
1385 cachedRefDensity = this->parallel_well_info_.broadcastFirstPerforationValue(cachedRefDensity);
1386 }
1387 }
1388
1389
1390
1391
1392
1393 template<typename TypeTag>
1394 void
1397 const GroupStateHelperType& groupStateHelper,
1398 DeferredLogger& deferred_logger)
1399 {
1400 const auto& well_state = groupStateHelper.wellState();
1401 const auto props = computePropertiesForWellConnectionPressures
1402 (simulator, well_state);
1403
1404 computeWellConnectionDensitesPressures(simulator, groupStateHelper,
1405 props, deferred_logger);
1406 }
1407
1408
1409
1410
1411
1412 template<typename TypeTag>
1413 void
1415 solveEqAndUpdateWellState(const Simulator& simulator,
1416 const GroupStateHelperType& groupStateHelper,
1417 WellStateType& well_state,
1418 DeferredLogger& deferred_logger)
1419 {
1420 if (!this->isOperableAndSolvable() && !this->wellIsStopped()) return;
1421
1422 // We assemble the well equations, then we check the convergence,
1423 // which is why we do not put the assembleWellEq here.
1424 BVectorWell dx_well(1);
1425 dx_well[0].resize(this->primary_variables_.numWellEq());
1426 this->linSys_.solve( dx_well);
1427
1428 updateWellState(simulator, dx_well, groupStateHelper, well_state, deferred_logger);
1429 }
1430
1431
1432
1433
1434
1435 template<typename TypeTag>
1436 void
1439 const GroupStateHelperType& groupStateHelper,
1440 DeferredLogger& deferred_logger)
1441 {
1442 updatePrimaryVariables(groupStateHelper, deferred_logger);
1443 computeWellConnectionPressures(simulator, groupStateHelper, deferred_logger);
1444 this->computeAccumWell();
1445 }
1446
1447
1448
1449 template<typename TypeTag>
1450 void
1452 apply(const BVector& x, BVector& Ax) const
1453 {
1454 if (!this->isOperableAndSolvable() && !this->wellIsStopped()) return;
1455
1456 if (this->param_.matrix_add_well_contributions_)
1457 {
1458 // Contributions are already in the matrix itself
1459 return;
1460 }
1461
1462 this->linSys_.apply(x, Ax);
1463 }
1464
1465
1466
1467
1468 template<typename TypeTag>
1469 void
1471 apply(BVector& r) const
1472 {
1473 if (!this->isOperableAndSolvable() && !this->wellIsStopped()) return;
1474
1475 this->linSys_.apply(r);
1476 }
1477
1478
1479
1480
1481 template<typename TypeTag>
1482 void
1485 const BVector& x,
1486 const GroupStateHelperType& groupStateHelper,
1487 WellStateType& well_state,
1488 DeferredLogger& deferred_logger)
1489 {
1490 if (!this->isOperableAndSolvable() && !this->wellIsStopped()) return;
1491
1492 BVectorWell xw(1);
1493 xw[0].resize(this->primary_variables_.numWellEq());
1494
1495 this->linSys_.recoverSolutionWell(x, xw);
1496 updateWellState(simulator, xw, groupStateHelper, well_state, deferred_logger);
1497 }
1498
1499
1500
1501
1502 template<typename TypeTag>
1503 void
1505 computeWellRatesWithBhp(const Simulator& simulator,
1506 const Scalar& bhp,
1507 std::vector<Scalar>& well_flux,
1508 DeferredLogger& deferred_logger) const
1509 {
1510 OPM_TIMEFUNCTION();
1511 const int np = this->number_of_phases_;
1512 well_flux.resize(np, 0.0);
1513
1514 const bool allow_cf = this->getAllowCrossFlow();
1515
1516 for (int perf = 0; perf < this->number_of_local_perforations_; ++perf) {
1517 const int cell_idx = this->well_cells_[perf];
1518 const auto& intQuants = simulator.model().intensiveQuantities(cell_idx, /*timeIdx=*/ 0);
1519 // flux for each perforation
1520 std::vector<Scalar> mob(this->num_conservation_quantities_, 0.);
1521 getMobility(simulator, perf, mob, deferred_logger);
1522 Scalar trans_mult(0.0);
1523 getTransMult(trans_mult, simulator, cell_idx);
1524 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
1525 std::vector<Scalar> Tw(this->num_conservation_quantities_, this->well_index_[perf] * trans_mult);
1526 this->getTw(Tw, perf, intQuants, trans_mult, wellstate_nupcol);
1527
1528 std::vector<Scalar> cq_s(this->num_conservation_quantities_, 0.);
1529 PerforationRates<Scalar> perf_rates;
1530 computePerfRate(intQuants, mob, bhp, Tw, perf, allow_cf,
1531 cq_s, perf_rates, deferred_logger);
1532
1533 for(int p = 0; p < np; ++p) {
1534 well_flux[FluidSystem::activeCompToActivePhaseIdx(p)] += cq_s[p];
1535 }
1536
1537 // the solvent contribution is added to the gas potentials
1538 if constexpr (has_solvent) {
1539 assert(FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx));
1540 // TODO: should we use compIdx here?
1541 const int gas_pos = FluidSystem::canonicalToActivePhaseIdx(FluidSystem::gasPhaseIdx);
1542 well_flux[gas_pos] += cq_s[Indices::contiSolventEqIdx];
1543 }
1544 }
1545 this->parallel_well_info_.communication().sum(well_flux.data(), well_flux.size());
1546 }
1547
1548
1549
1550 template<typename TypeTag>
1551 void
1554 const Scalar& bhp,
1555 const GroupStateHelperType& groupStateHelper,
1556 std::vector<Scalar>& well_flux,
1557 DeferredLogger& deferred_logger) const
1558 {
1559 // creating a copy of the well itself, to avoid messing up the explicit information
1560 // during this copy, the only information not copied properly is the well controls
1561 StandardWell<TypeTag> well_copy(*this);
1562 well_copy.resetDampening();
1563
1564 // iterate to get a more accurate well density
1565 // create a copy of the well_state to use. If the operability checking is sucessful, we use this one
1566 // to replace the original one
1567 GroupStateHelperType groupStateHelper_copy = groupStateHelper;
1568 WellStateType well_state_copy = groupStateHelper_copy.wellState();
1569 // Ensure that groupStateHelper_copy uses well_state_copy as WellState for the rest of this function,
1570 // and the guard ensures that the original well state is restored at scope exit, i.e. at
1571 // the end of this function.
1572 auto guard = groupStateHelper_copy.pushWellState(well_state_copy);
1573
1574 // Get the current controls.
1575 const auto& summary_state = simulator.vanguard().summaryState();
1576 auto inj_controls = well_copy.well_ecl_.isInjector()
1577 ? well_copy.well_ecl_.injectionControls(summary_state)
1578 : Well::InjectionControls(0);
1579 auto prod_controls = well_copy.well_ecl_.isProducer()
1580 ? well_copy.well_ecl_.productionControls(summary_state) :
1581 Well::ProductionControls(0);
1582
1583 // Set current control to bhp, and bhp value in state, modify bhp limit in control object.
1584 auto& ws = well_state_copy.well(this->index_of_well_);
1585 if (well_copy.well_ecl_.isInjector()) {
1586 inj_controls.bhp_limit = bhp;
1587 ws.injection_cmode = Well::InjectorCMode::BHP;
1588 } else {
1589 prod_controls.bhp_limit = bhp;
1590 ws.production_cmode = Well::ProducerCMode::BHP;
1591 }
1592 ws.bhp = bhp;
1593
1594 // initialized the well rates with the potentials i.e. the well rates based on bhp
1595 const int np = this->number_of_phases_;
1596 const Scalar sign = this->well_ecl_.isInjector() ? 1.0 : -1.0;
1597 for (int phase = 0; phase < np; ++phase){
1598 well_state_copy.wellRates(this->index_of_well_)[phase]
1599 = sign * ws.well_potentials[phase];
1600 }
1601 well_copy.updatePrimaryVariables(groupStateHelper_copy, deferred_logger);
1602 well_copy.computeAccumWell();
1603
1604 const double dt = simulator.timeStepSize();
1605 const bool converged = well_copy.iterateWellEqWithControl(
1606 simulator, dt, inj_controls, prod_controls, groupStateHelper_copy, well_state_copy, deferred_logger
1607 );
1608 if (!converged) {
1609 const std::string msg = " well " + name() + " did not get converged during well potential calculations "
1610 " potentials are computed based on unconverged solution";
1611 deferred_logger.debug(msg);
1612 }
1613 well_copy.updatePrimaryVariables(groupStateHelper_copy, deferred_logger);
1614 well_copy.computeWellConnectionPressures(simulator, groupStateHelper_copy, deferred_logger);
1615 well_copy.computeWellRatesWithBhp(simulator, bhp, well_flux, deferred_logger);
1616 }
1617
1618
1619
1620
1621 template<typename TypeTag>
1622 std::vector<typename StandardWell<TypeTag>::Scalar>
1625 const GroupStateHelperType& groupStateHelper,
1626 DeferredLogger& deferred_logger,
1627 const WellStateType& well_state) const
1628 {
1629 std::vector<Scalar> potentials(this->number_of_phases_, 0.0);
1630 const auto& summary_state = simulator.vanguard().summaryState();
1631
1632 const auto& well = this->well_ecl_;
1633 if (well.isInjector()){
1634 const auto& controls = this->well_ecl_.injectionControls(summary_state);
1635 auto bhp_at_thp_limit = computeBhpAtThpLimitInj(simulator, groupStateHelper, summary_state, deferred_logger);
1636 if (bhp_at_thp_limit) {
1637 const Scalar bhp = std::min(*bhp_at_thp_limit,
1638 static_cast<Scalar>(controls.bhp_limit));
1639 computeWellRatesWithBhp(simulator, bhp, potentials, deferred_logger);
1640 } else {
1641 deferred_logger.warning("FAILURE_GETTING_CONVERGED_POTENTIAL",
1642 "Failed in getting converged thp based potential calculation for well "
1643 + name() + ". Instead the bhp based value is used");
1644 const Scalar bhp = controls.bhp_limit;
1645 computeWellRatesWithBhp(simulator, bhp, potentials, deferred_logger);
1646 }
1647 } else {
1648 computeWellRatesWithThpAlqProd(
1649 simulator, groupStateHelper, summary_state,
1650 deferred_logger, potentials, this->getALQ(well_state)
1651 );
1652 }
1653
1654 return potentials;
1655 }
1656
1657 template<typename TypeTag>
1658 bool
1661 const GroupStateHelperType& groupStateHelper,
1662 std::vector<Scalar>& well_potentials,
1663 DeferredLogger& deferred_logger) const
1664 {
1665 // Create a copy of the well.
1666 // TODO: check if we can avoid taking multiple copies. Call from updateWellPotentials
1667 // is allready a copy, but not from other calls.
1668 StandardWell<TypeTag> well_copy(*this);
1669
1670 // store a copy of the well state, we don't want to update the real well state
1671 WellStateType well_state_copy = groupStateHelper.wellState();
1672 GroupStateHelperType groupStateHelper_copy = groupStateHelper;
1673 // Ensure that groupStateHelper_copy uses well_state_copy as WellState for the rest of this function,
1674 // and the guard ensures that the original well state is restored at scope exit, i.e. at
1675 // the end of this function.
1676 auto guard = groupStateHelper_copy.pushWellState(well_state_copy);
1677 auto& ws = well_state_copy.well(this->index_of_well_);
1678
1679 // get current controls
1680 const auto& summary_state = simulator.vanguard().summaryState();
1681 auto inj_controls = well_copy.well_ecl_.isInjector()
1682 ? well_copy.well_ecl_.injectionControls(summary_state)
1683 : Well::InjectionControls(0);
1684 auto prod_controls = well_copy.well_ecl_.isProducer()
1685 ? well_copy.well_ecl_.productionControls(summary_state) :
1686 Well::ProductionControls(0);
1687
1688 // prepare/modify well state and control
1689 well_copy.onlyKeepBHPandTHPcontrols(summary_state, well_state_copy, inj_controls, prod_controls);
1690
1691 // update connection pressures relative to updated bhp to get better estimate of connection dp
1692 const int num_perf = ws.perf_data.size();
1693 for (int perf = 0; perf < num_perf; ++perf) {
1694 ws.perf_data.pressure[perf] = ws.bhp + well_copy.connections_.pressure_diff(perf);
1695 }
1696 // initialize rates from previous potentials
1697 const int np = this->number_of_phases_;
1698 bool trivial = true;
1699 for (int phase = 0; phase < np; ++phase){
1700 trivial = trivial && (ws.well_potentials[phase] == 0.0) ;
1701 }
1702 if (!trivial) {
1703 const Scalar sign = well_copy.well_ecl_.isInjector() ? 1.0 : -1.0;
1704 for (int phase = 0; phase < np; ++phase) {
1705 ws.surface_rates[phase] = sign * ws.well_potentials[phase];
1706 }
1707 }
1708
1709 well_copy.calculateExplicitQuantities(simulator, groupStateHelper_copy, deferred_logger);
1710 const double dt = simulator.timeStepSize();
1711 // iterate to get a solution at the given bhp.
1712 bool converged = false;
1713 if (this->well_ecl_.isProducer()) {
1714 converged = well_copy.solveWellWithOperabilityCheck(
1715 simulator, dt, inj_controls, prod_controls, groupStateHelper_copy, well_state_copy, deferred_logger
1716 );
1717 } else {
1718 converged = well_copy.iterateWellEqWithSwitching(
1719 simulator, dt, inj_controls, prod_controls, groupStateHelper_copy, well_state_copy, deferred_logger,
1720 /*fixed_control=*/false,
1721 /*fixed_status=*/false,
1722 /*solving_with_zero_rate=*/false
1723 );
1724 }
1725
1726 // fetch potentials (sign is updated on the outside).
1727 well_potentials.clear();
1728 well_potentials.resize(np, 0.0);
1729 for (int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx) {
1730 if (has_solvent && comp_idx == Indices::contiSolventEqIdx) continue; // we do not store the solvent in the well_potentials
1731 const EvalWell rate = well_copy.primary_variables_.getQs(comp_idx);
1732 well_potentials[FluidSystem::activeCompToActivePhaseIdx(comp_idx)] = rate.value();
1733 }
1734
1735 // the solvent contribution is added to the gas potentials
1736 if constexpr (has_solvent) {
1737 assert(FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx));
1738 // TODO: should we use compIdx here?
1739 const int gas_pos = FluidSystem::canonicalToActivePhaseIdx(FluidSystem::gasPhaseIdx);
1740 const EvalWell rate = well_copy.primary_variables_.getQs(Indices::contiSolventEqIdx);
1741 well_potentials[gas_pos] += rate.value();
1742 }
1743 return converged;
1744 }
1745
1746
1747 template<typename TypeTag>
1751 const GroupStateHelperType& groupStateHelper,
1752 const SummaryState &summary_state,
1753 DeferredLogger& deferred_logger,
1754 std::vector<Scalar>& potentials,
1755 Scalar alq) const
1756 {
1757 Scalar bhp;
1758 auto bhp_at_thp_limit = computeBhpAtThpLimitProdWithAlq(
1759 simulator, groupStateHelper, summary_state, alq, deferred_logger, /*iterate_if_no_solution */ true);
1760 if (bhp_at_thp_limit) {
1761 const auto& controls = this->well_ecl_.productionControls(summary_state);
1762 bhp = std::max(*bhp_at_thp_limit,
1763 static_cast<Scalar>(controls.bhp_limit));
1764 computeWellRatesWithBhp(simulator, bhp, potentials, deferred_logger);
1765 }
1766 else {
1767 deferred_logger.warning("FAILURE_GETTING_CONVERGED_POTENTIAL",
1768 "Failed in getting converged thp based potential calculation for well "
1769 + name() + ". Instead the bhp based value is used");
1770 const auto& controls = this->well_ecl_.productionControls(summary_state);
1771 bhp = controls.bhp_limit;
1772 computeWellRatesWithBhp(simulator, bhp, potentials, deferred_logger);
1773 }
1774 return bhp;
1775 }
1776
1777 template<typename TypeTag>
1778 void
1781 const GroupStateHelperType& groupStateHelper,
1782 const SummaryState& summary_state,
1783 DeferredLogger& deferred_logger,
1784 std::vector<Scalar>& potentials,
1785 Scalar alq) const
1786 {
1787 /*double bhp =*/
1788 computeWellRatesAndBhpWithThpAlqProd(simulator,
1789 groupStateHelper,
1790 summary_state,
1791 deferred_logger,
1792 potentials,
1793 alq);
1794 }
1795
1796 template<typename TypeTag>
1797 void
1799 computeWellPotentials(const Simulator& simulator,
1800 const WellStateType& well_state,
1801 const GroupStateHelperType& groupStateHelper,
1802 std::vector<Scalar>& well_potentials,
1803 DeferredLogger& deferred_logger) // const
1804 {
1805 const auto [compute_potential, bhp_controlled_well] =
1807
1808 if (!compute_potential) {
1809 return;
1810 }
1811
1812 bool converged_implicit = false;
1813 // for newly opened wells we dont compute the potentials implicit
1814 // group controlled wells with defaulted guiderates will have zero targets as
1815 // the potentials are used to compute the well fractions.
1816 if (this->param_.local_well_solver_control_switching_ && !(this->changed_to_open_this_step_ && this->wellUnderZeroRateTarget(groupStateHelper, deferred_logger))) {
1817 converged_implicit = computeWellPotentialsImplicit(
1818 simulator, groupStateHelper, well_potentials, deferred_logger
1819 );
1820 }
1821 if (!converged_implicit) {
1822 // does the well have a THP related constraint?
1823 const auto& summaryState = simulator.vanguard().summaryState();
1824 if (!Base::wellHasTHPConstraints(summaryState) || bhp_controlled_well) {
1825 // get the bhp value based on the bhp constraints
1826 Scalar bhp = WellBhpThpCalculator(*this).mostStrictBhpFromBhpLimits(summaryState);
1827
1828 // In some very special cases the bhp pressure target are
1829 // temporary violated. This may lead to too small or negative potentials
1830 // that could lead to premature shutting of wells.
1831 // As a remedy the bhp that gives the largest potential is used.
1832 // For converged cases, ws.bhp <=bhp for injectors and ws.bhp >= bhp,
1833 // and the potentials will be computed using the limit as expected.
1834 const auto& ws = well_state.well(this->index_of_well_);
1835 if (this->isInjector())
1836 bhp = std::max(ws.bhp, bhp);
1837 else
1838 bhp = std::min(ws.bhp, bhp);
1839
1840 assert(std::abs(bhp) != std::numeric_limits<Scalar>::max());
1841 computeWellRatesWithBhpIterations(simulator, bhp, groupStateHelper, well_potentials, deferred_logger);
1842 } else {
1843 // the well has a THP related constraint
1844 well_potentials = computeWellPotentialWithTHP(simulator, groupStateHelper, deferred_logger, well_state);
1845 }
1846 }
1847
1848 this->checkNegativeWellPotentials(well_potentials,
1849 this->param_.check_well_operability_,
1850 deferred_logger);
1851 }
1852
1853
1854
1855
1856
1857
1858
1859 template<typename TypeTag>
1862 connectionDensity([[maybe_unused]] const int globalConnIdx,
1863 const int openConnIdx) const
1864 {
1865 return (openConnIdx < 0)
1866 ? 0.0
1867 : this->connections_.rho(openConnIdx);
1868 }
1869
1870
1871
1872
1873
1874 template<typename TypeTag>
1875 void
1877 updatePrimaryVariables(const GroupStateHelperType& groupStateHelper,
1878 DeferredLogger& deferred_logger)
1879 {
1880 if (!this->isOperableAndSolvable() && !this->wellIsStopped()) return;
1881
1882 const auto& well_state = groupStateHelper.wellState();
1883 const bool stop_or_zero_rate_target = this->stoppedOrZeroRateTarget(groupStateHelper, deferred_logger);
1884 this->primary_variables_.update(well_state, stop_or_zero_rate_target, deferred_logger);
1885
1886 // other primary variables related to polymer injection
1887 if constexpr (Base::has_polymermw) {
1888 this->primary_variables_.updatePolyMW(well_state);
1889 }
1890
1891 this->primary_variables_.checkFinite(deferred_logger, "updating from well state");
1892 }
1893
1894
1895
1896
1897 template<typename TypeTag>
1900 getRefDensity() const
1901 {
1902 return cachedRefDensity;
1903 }
1904
1905
1906
1907
1908 template<typename TypeTag>
1909 void
1912 const int perf,
1913 std::vector<EvalWell>& mob,
1914 DeferredLogger& deferred_logger) const
1915 {
1916 const int cell_idx = this->well_cells_[perf];
1917 const auto& int_quant = simulator.model().intensiveQuantities(cell_idx, /*timeIdx=*/ 0);
1918 const EvalWell polymer_concentration = this->extendEval(int_quant.polymerConcentration());
1919
1920 // TODO: not sure should based on the well type or injecting/producing peforations
1921 // it can be different for crossflow
1922 if (this->isInjector()) {
1923 // assume fully mixing within injecting wellbore
1924 const auto& visc_mult_table = PolymerModule::plyviscViscosityMultiplierTable(int_quant.pvtRegionIndex());
1925 const unsigned waterCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
1926 mob[waterCompIdx] /= (this->extendEval(int_quant.waterViscosityCorrection()) * visc_mult_table.eval(polymer_concentration, /*extrapolate=*/true) );
1927 }
1928
1929 if (PolymerModule::hasPlyshlog()) {
1930 // we do not calculate the shear effects for injection wells when they do not
1931 // inject polymer.
1932 if (this->isInjector() && this->wpolymer() == 0.) {
1933 return;
1934 }
1935 // compute the well water velocity with out shear effects.
1936 // TODO: do we need to turn on crossflow here?
1937 const bool allow_cf = this->getAllowCrossFlow() || openCrossFlowAvoidSingularity(simulator);
1938 const EvalWell& bhp = this->primary_variables_.eval(Bhp);
1939
1940 std::vector<EvalWell> cq_s(this->num_conservation_quantities_, 0.);
1941 PerforationRates<Scalar> perf_rates;
1942 EvalWell trans_mult(0.0);
1943 getTransMult(trans_mult, simulator, cell_idx);
1944 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
1945 std::vector<EvalWell> Tw(this->num_conservation_quantities_, this->well_index_[perf] * trans_mult);
1946 this->getTw(Tw, perf, int_quant, trans_mult, wellstate_nupcol);
1947 computePerfRate(int_quant, mob, bhp, Tw, perf, allow_cf, cq_s,
1948 perf_rates, deferred_logger);
1949 // TODO: make area a member
1950 const Scalar area = 2 * M_PI * this->perf_rep_radius_[perf] * this->perf_length_[perf];
1951 const auto& material_law_manager = simulator.problem().materialLawManager();
1952 const auto& scaled_drainage_info =
1953 material_law_manager->oilWaterScaledEpsInfoDrainage(cell_idx);
1954 const Scalar swcr = scaled_drainage_info.Swcr;
1955 const EvalWell poro = this->extendEval(int_quant.porosity());
1956 const EvalWell sw = this->extendEval(int_quant.fluidState().saturation(FluidSystem::waterPhaseIdx));
1957 // guard against zero porosity and no water
1958 const EvalWell denom = max( (area * poro * (sw - swcr)), 1e-12);
1959 const unsigned waterCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
1960 EvalWell water_velocity = cq_s[waterCompIdx] / denom * this->extendEval(int_quant.fluidState().invB(FluidSystem::waterPhaseIdx));
1961
1962 if (PolymerModule::hasShrate()) {
1963 // the equation for the water velocity conversion for the wells and reservoir are from different version
1964 // of implementation. It can be changed to be more consistent when possible.
1965 water_velocity *= PolymerModule::shrate( int_quant.pvtRegionIndex() ) / this->bore_diameters_[perf];
1966 }
1967 const EvalWell shear_factor = PolymerModule::computeShearFactor(polymer_concentration,
1968 int_quant.pvtRegionIndex(),
1969 water_velocity);
1970 // modify the mobility with the shear factor.
1971 mob[waterCompIdx] /= shear_factor;
1972 }
1973 }
1974
1975 template<typename TypeTag>
1976 void
1978 {
1979 this->linSys_.extract(jacobian);
1980 }
1981
1982
1983 template <typename TypeTag>
1984 void
1986 const BVector& weights,
1987 const int pressureVarIndex,
1988 const bool use_well_weights,
1989 const WellStateType& well_state) const
1990 {
1991 this->linSys_.extractCPRPressureMatrix(jacobian,
1992 weights,
1993 pressureVarIndex,
1994 use_well_weights,
1995 *this,
1996 Bhp,
1997 well_state);
1998 }
1999
2000
2001
2002 template<typename TypeTag>
2005 pskinwater(const Scalar throughput,
2006 const EvalWell& water_velocity,
2007 DeferredLogger& deferred_logger) const
2008 {
2009 if constexpr (Base::has_polymermw) {
2010 const int water_table_id = this->polymerWaterTable_();
2011 if (water_table_id <= 0) {
2012 OPM_DEFLOG_THROW(std::runtime_error,
2013 fmt::format("Unused SKPRWAT table id used for well {}", name()),
2014 deferred_logger);
2015 }
2016 const auto& water_table_func = PolymerModule::getSkprwatTable(water_table_id);
2017 const EvalWell throughput_eval{throughput};
2018 // the skin pressure when injecting water, which also means the polymer concentration is zero
2019 EvalWell pskin_water = water_table_func.eval(throughput_eval, water_velocity);
2020 return pskin_water;
2021 } else {
2022 OPM_DEFLOG_THROW(std::runtime_error,
2023 fmt::format("Polymermw is not activated, while injecting "
2024 "skin pressure is requested for well {}", name()),
2025 deferred_logger);
2026 }
2027 }
2028
2029
2030
2031
2032
2033 template<typename TypeTag>
2036 pskin(const Scalar throughput,
2037 const EvalWell& water_velocity,
2038 const EvalWell& poly_inj_conc,
2039 DeferredLogger& deferred_logger) const
2040 {
2041 if constexpr (Base::has_polymermw) {
2042 const Scalar sign = water_velocity >= 0. ? 1.0 : -1.0;
2043 const EvalWell water_velocity_abs = abs(water_velocity);
2044 if (poly_inj_conc == 0.) {
2045 return sign * pskinwater(throughput, water_velocity_abs, deferred_logger);
2046 }
2047 const int polymer_table_id = this->polymerTable_();
2048 if (polymer_table_id <= 0) {
2049 OPM_DEFLOG_THROW(std::runtime_error,
2050 fmt::format("Unavailable SKPRPOLY table id used for well {}", name()),
2051 deferred_logger);
2052 }
2053 const auto& skprpolytable = PolymerModule::getSkprpolyTable(polymer_table_id);
2054 const Scalar reference_concentration = skprpolytable.refConcentration;
2055 const EvalWell throughput_eval{throughput};
2056 // the skin pressure when injecting water, which also means the polymer concentration is zero
2057 const EvalWell pskin_poly = skprpolytable.table_func.eval(throughput_eval, water_velocity_abs);
2058 if (poly_inj_conc == reference_concentration) {
2059 return sign * pskin_poly;
2060 }
2061 // poly_inj_conc != reference concentration of the table, then some interpolation will be required
2062 const EvalWell pskin_water = pskinwater(throughput, water_velocity_abs, deferred_logger);
2063 const EvalWell pskin = pskin_water + (pskin_poly - pskin_water) / reference_concentration * poly_inj_conc;
2064 return sign * pskin;
2065 } else {
2066 OPM_DEFLOG_THROW(std::runtime_error,
2067 fmt::format("Polymermw is not activated, while injecting "
2068 "skin pressure is requested for well {}", name()),
2069 deferred_logger);
2070 }
2071 }
2072
2073
2074
2075
2076
2077 template<typename TypeTag>
2080 wpolymermw(const Scalar throughput,
2081 const EvalWell& water_velocity,
2082 DeferredLogger& deferred_logger) const
2083 {
2084 if constexpr (Base::has_polymermw) {
2085 const int table_id = this->polymerInjTable_();
2086 const auto& table_func = PolymerModule::getPlymwinjTable(table_id);
2087 const EvalWell throughput_eval{throughput};
2088 EvalWell molecular_weight{0.};
2089 if (this->wpolymer() == 0.) { // not injecting polymer
2090 return molecular_weight;
2091 }
2092 molecular_weight = table_func.eval(throughput_eval, abs(water_velocity));
2093 return molecular_weight;
2094 } else {
2095 OPM_DEFLOG_THROW(std::runtime_error,
2096 fmt::format("Polymermw is not activated, while injecting "
2097 "polymer molecular weight is requested for well {}", name()),
2098 deferred_logger);
2099 }
2100 }
2101
2102
2103
2104
2105
2106 template<typename TypeTag>
2107 void
2109 updateWaterThroughput([[maybe_unused]] const double dt,
2110 WellStateType& well_state) const
2111 {
2112 if constexpr (Base::has_polymermw) {
2113 if (!this->isInjector()) {
2114 return;
2115 }
2116
2117 auto& perf_water_throughput = well_state.well(this->index_of_well_)
2118 .perf_data.water_throughput;
2119
2120 for (int perf = 0; perf < this->number_of_local_perforations_; ++perf) {
2121 const Scalar perf_water_vel =
2122 this->primary_variables_.value(Bhp + 1 + perf);
2123
2124 // we do not consider the formation damage due to water
2125 // flowing from reservoir into wellbore
2126 if (perf_water_vel > Scalar{0}) {
2127 perf_water_throughput[perf] += perf_water_vel * dt;
2128 }
2129 }
2130 }
2131 }
2132
2133
2134
2135
2136
2137 template<typename TypeTag>
2138 void
2140 handleInjectivityRate(const Simulator& simulator,
2141 const int perf,
2142 std::vector<EvalWell>& cq_s) const
2143 {
2144 const int cell_idx = this->well_cells_[perf];
2145 const auto& int_quants = simulator.model().intensiveQuantities(cell_idx, /*timeIdx=*/ 0);
2146 const auto& fs = int_quants.fluidState();
2147 const EvalWell b_w = this->extendEval(fs.invB(FluidSystem::waterPhaseIdx));
2148 const Scalar area = M_PI * this->bore_diameters_[perf] * this->perf_length_[perf];
2149 const int wat_vel_index = Bhp + 1 + perf;
2150 const unsigned water_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
2151
2152 // water rate is update to use the form from water velocity, since water velocity is
2153 // a primary variable now
2154 cq_s[water_comp_idx] = area * this->primary_variables_.eval(wat_vel_index) * b_w;
2155 }
2156
2157
2158
2159
2160 template<typename TypeTag>
2161 void
2163 handleInjectivityEquations(const Simulator& simulator,
2164 const WellStateType& well_state,
2165 const int perf,
2166 const EvalWell& water_flux_s,
2167 DeferredLogger& deferred_logger)
2168 {
2169 const int cell_idx = this->well_cells_[perf];
2170 const auto& int_quants = simulator.model().intensiveQuantities(cell_idx, /*timeIdx=*/ 0);
2171 const auto& fs = int_quants.fluidState();
2172 const EvalWell b_w = this->extendEval(fs.invB(FluidSystem::waterPhaseIdx));
2173 const EvalWell water_flux_r = water_flux_s / b_w;
2174 const Scalar area = M_PI * this->bore_diameters_[perf] * this->perf_length_[perf];
2175 const EvalWell water_velocity = water_flux_r / area;
2176 const int wat_vel_index = Bhp + 1 + perf;
2177
2178 // equation for the water velocity
2179 const EvalWell eq_wat_vel = this->primary_variables_.eval(wat_vel_index) - water_velocity;
2180
2181 const auto& ws = well_state.well(this->index_of_well_);
2182 const auto& perf_data = ws.perf_data;
2183 const auto& perf_water_throughput = perf_data.water_throughput;
2184 const Scalar throughput = perf_water_throughput[perf];
2185 const int pskin_index = Bhp + 1 + this->number_of_local_perforations_ + perf;
2186
2187 const EvalWell poly_conc(this->wpolymer());
2188
2189 // equation for the skin pressure
2190 const EvalWell eq_pskin = this->primary_variables_.eval(pskin_index)
2191 - pskin(throughput, this->primary_variables_.eval(wat_vel_index), poly_conc, deferred_logger);
2192
2194 assembleInjectivityEq(eq_pskin,
2195 eq_wat_vel,
2196 pskin_index,
2197 wat_vel_index,
2198 perf,
2199 this->primary_variables_.numWellEq(),
2200 this->linSys_);
2201 }
2202
2203
2204
2205
2206
2207 template<typename TypeTag>
2208 void
2210 checkConvergenceExtraEqs(const std::vector<Scalar>& res,
2211 ConvergenceReport& report) const
2212 {
2213 // if different types of extra equations are involved, this function needs to be refactored further
2214
2215 // checking the convergence of the extra equations related to polymer injectivity
2216 if constexpr (Base::has_polymermw) {
2217 WellConvergence(*this).
2218 checkConvergencePolyMW(res, Bhp, this->param_.max_residual_allowed_, report);
2219 }
2220 }
2221
2222
2223
2224
2225
2226 template<typename TypeTag>
2227 void
2229 updateConnectionRatePolyMW(const EvalWell& cq_s_poly,
2230 const IntensiveQuantities& int_quants,
2231 const WellStateType& well_state,
2232 const int perf,
2233 std::vector<RateVector>& connectionRates,
2234 DeferredLogger& deferred_logger) const
2235 {
2236 // the source term related to transport of molecular weight
2237 EvalWell cq_s_polymw = cq_s_poly;
2238 if (this->isInjector()) {
2239 const int wat_vel_index = Bhp + 1 + perf;
2240 const EvalWell water_velocity = this->primary_variables_.eval(wat_vel_index);
2241 if (water_velocity > 0.) { // injecting
2242 const auto& ws = well_state.well(this->index_of_well_);
2243 const auto& perf_water_throughput = ws.perf_data.water_throughput;
2244 const Scalar throughput = perf_water_throughput[perf];
2245 const EvalWell molecular_weight = wpolymermw(throughput, water_velocity, deferred_logger);
2246 cq_s_polymw *= molecular_weight;
2247 } else {
2248 // we do not consider the molecular weight from the polymer
2249 // going-back to the wellbore through injector
2250 cq_s_polymw *= 0.;
2251 }
2252 } else if (this->isProducer()) {
2253 if (cq_s_polymw < 0.) {
2254 cq_s_polymw *= this->extendEval(int_quants.polymerMoleWeight() );
2255 } else {
2256 // we do not consider the molecular weight from the polymer
2257 // re-injecting back through producer
2258 cq_s_polymw *= 0.;
2259 }
2260 }
2261 connectionRates[perf][Indices::contiPolymerMWEqIdx] = Base::restrictEval(cq_s_polymw);
2262 }
2263
2264
2265
2266
2267
2268 template<typename TypeTag>
2269 std::optional<typename StandardWell<TypeTag>::Scalar>
2272 const Simulator& simulator,
2273 const GroupStateHelperType& groupStateHelper,
2274 const SummaryState& summary_state,
2275 DeferredLogger& deferred_logger) const
2276 {
2277 return computeBhpAtThpLimitProdWithAlq(simulator,
2278 groupStateHelper,
2279 summary_state,
2280 this->getALQ(well_state),
2281 deferred_logger,
2282 /*iterate_if_no_solution */ true);
2283 }
2284
2285 template<typename TypeTag>
2286 std::optional<typename StandardWell<TypeTag>::Scalar>
2289 const GroupStateHelperType& groupStateHelper,
2290 const SummaryState& summary_state,
2291 const Scalar alq_value,
2292 DeferredLogger& deferred_logger,
2293 bool iterate_if_no_solution) const
2294 {
2295 OPM_TIMEFUNCTION();
2296 // Make the frates() function.
2297 auto frates = [this, &simulator, &deferred_logger](const Scalar bhp) {
2298 // Not solving the well equations here, which means we are
2299 // calculating at the current Fg/Fw values of the
2300 // well. This does not matter unless the well is
2301 // crossflowing, and then it is likely still a good
2302 // approximation.
2303 std::vector<Scalar> rates(3);
2304 computeWellRatesWithBhp(simulator, bhp, rates, deferred_logger);
2305 this->adaptRatesForVFP(rates);
2306 return rates;
2307 };
2308 auto bhpAtLimit = WellBhpThpCalculator(*this).computeBhpAtThpLimitProd(frates,
2309 summary_state,
2310 maxPerfPress(simulator),
2311 this->getRefDensity(),
2312 alq_value,
2313 this->getTHPConstraint(summary_state),
2314 deferred_logger);
2315
2316 if (bhpAtLimit) {
2317 auto v = frates(*bhpAtLimit);
2318 if (std::all_of(v.cbegin(), v.cend(), [](Scalar i){ return i <= 0; }) ) {
2319 return bhpAtLimit;
2320 }
2321 }
2322
2323 if (!iterate_if_no_solution)
2324 return std::nullopt;
2325
2326 auto fratesIter = [this, &simulator, &groupStateHelper, &deferred_logger](const Scalar bhp) {
2327 // Solver the well iterations to see if we are
2328 // able to get a solution with an update
2329 // solution
2330 std::vector<Scalar> rates(3);
2331 computeWellRatesWithBhpIterations(simulator, bhp, groupStateHelper, rates, deferred_logger);
2332 this->adaptRatesForVFP(rates);
2333 return rates;
2334 };
2335
2336 bhpAtLimit = WellBhpThpCalculator(*this).computeBhpAtThpLimitProd(fratesIter,
2337 summary_state,
2338 maxPerfPress(simulator),
2339 this->getRefDensity(),
2340 alq_value,
2341 this->getTHPConstraint(summary_state),
2342 deferred_logger);
2343
2344
2345 if (bhpAtLimit) {
2346 // should we use fratesIter here since fratesIter is used in computeBhpAtThpLimitProd above?
2347 auto v = frates(*bhpAtLimit);
2348 if (std::all_of(v.cbegin(), v.cend(), [](Scalar i){ return i <= 0; }) ) {
2349 return bhpAtLimit;
2350 }
2351 }
2352
2353 // we still don't get a valied solution.
2354 return std::nullopt;
2355 }
2356
2357
2358
2359 template<typename TypeTag>
2360 std::optional<typename StandardWell<TypeTag>::Scalar>
2362 computeBhpAtThpLimitInj(const Simulator& simulator,
2363 [[maybe_unused]] const GroupStateHelperType& groupStateHelper,
2364 const SummaryState& summary_state,
2365 DeferredLogger& deferred_logger) const
2366 {
2367 // Note: groupStateHelper parameter is currently unused in StandardWell but kept for consistency
2368 // with MultisegmentWell::computeBhpAtThpLimitInj which uses it in fratesIter lambda.
2369 // This maintains parallel API structure between well types and allows for future
2370 // enhancements without breaking the interface.
2371
2372 // Make the frates() function.
2373 auto frates = [this, &simulator, &deferred_logger](const Scalar bhp) {
2374 // Not solving the well equations here, which means we are
2375 // calculating at the current Fg/Fw values of the
2376 // well. This does not matter unless the well is
2377 // crossflowing, and then it is likely still a good
2378 // approximation.
2379 std::vector<Scalar> rates(3);
2380 computeWellRatesWithBhp(simulator, bhp, rates, deferred_logger);
2381 return rates;
2382 };
2383
2384 return WellBhpThpCalculator(*this).computeBhpAtThpLimitInj(frates,
2385 summary_state,
2386 this->getRefDensity(),
2387 1e-6,
2388 50,
2389 true,
2390 deferred_logger);
2391 }
2392
2393
2394
2395
2396
2397 template<typename TypeTag>
2398 bool
2400 iterateWellEqWithControl(const Simulator& simulator,
2401 const double dt,
2402 const Well::InjectionControls& inj_controls,
2403 const Well::ProductionControls& prod_controls,
2404 const GroupStateHelperType& groupStateHelper,
2405 WellStateType& well_state,
2406 DeferredLogger& deferred_logger)
2407 {
2408 updatePrimaryVariables(groupStateHelper, deferred_logger);
2409
2410 const int max_iter = this->param_.max_inner_iter_wells_;
2411 int it = 0;
2412 bool converged;
2413 bool relax_convergence = false;
2414 this->regularize_ = false;
2415 do {
2416 assembleWellEqWithoutIteration(simulator, groupStateHelper, dt, inj_controls, prod_controls, well_state, deferred_logger,
2417 /*solving_with_zero_rate=*/false);
2418
2419 if (it > this->param_.strict_inner_iter_wells_) {
2420 relax_convergence = true;
2421 this->regularize_ = true;
2422 }
2423
2424 auto report = getWellConvergence(groupStateHelper, Base::B_avg_, deferred_logger, relax_convergence);
2425
2426 converged = report.converged();
2427 if (converged) {
2428 break;
2429 }
2430
2431 ++it;
2432 solveEqAndUpdateWellState(simulator, groupStateHelper, well_state, deferred_logger);
2433
2434 // TODO: when this function is used for well testing purposes, will need to check the controls, so that we will obtain convergence
2435 // under the most restrictive control. Based on this converged results, we can check whether to re-open the well. Either we refactor
2436 // this function or we use different functions for the well testing purposes.
2437 // We don't allow for switching well controls while computing well potentials and testing wells
2438 // updateWellControl(simulator, well_state, deferred_logger);
2439 } while (it < max_iter);
2440
2441 if (converged) {
2442 std::ostringstream sstr;
2443 sstr << " Well " << this->name() << " converged in " << it << " inner iterations.";
2444 if (relax_convergence)
2445 sstr << " (A relaxed tolerance was used after "<< this->param_.strict_inner_iter_wells_ << " iterations)";
2446
2447 // Output "converged in 0 inner iterations" messages only at
2448 // elevated verbosity levels.
2449 deferred_logger.debug(sstr.str(), OpmLog::defaultDebugVerbosityLevel + (it == 0));
2450 } else {
2451 std::ostringstream sstr;
2452 sstr << " Well " << this->name() << " did not converge in " << it << " inner iterations.";
2453 deferred_logger.debug(sstr.str());
2454 }
2455
2456 return converged;
2457 }
2458
2459
2460 template<typename TypeTag>
2461 bool
2463 iterateWellEqWithSwitching(const Simulator& simulator,
2464 const double dt,
2465 const Well::InjectionControls& inj_controls,
2466 const Well::ProductionControls& prod_controls,
2467 const GroupStateHelperType& groupStateHelper,
2468 WellStateType& well_state,
2469 DeferredLogger& deferred_logger,
2470 const bool fixed_control /*false*/,
2471 const bool fixed_status /*false*/,
2472 const bool solving_with_zero_rate /*false*/)
2473 {
2474 updatePrimaryVariables(groupStateHelper, deferred_logger);
2475
2476 const int max_iter = this->param_.max_inner_iter_wells_;
2477 int it = 0;
2478 bool converged = false;
2479 bool relax_convergence = false;
2480 this->regularize_ = false;
2481 const auto& summary_state = groupStateHelper.summaryState();
2482
2483 // Always take a few (more than one) iterations after a switch before allowing a new switch
2484 // The optimal number here is subject to further investigation, but it has been observerved
2485 // that unless this number is >1, we may get stuck in a cycle
2486 constexpr int min_its_after_switch = 4;
2487 // We also want to restrict the number of status switches to avoid oscillation between STOP<->OPEN
2488 const int max_status_switch = this->param_.max_well_status_switch_inner_iter_;
2489 int its_since_last_switch = min_its_after_switch;
2490 int switch_count= 0;
2491 // if we fail to solve eqs, we reset status/operability before leaving
2492 const auto well_status_orig = this->wellStatus_;
2493 const auto operability_orig = this->operability_status_;
2494 auto well_status_cur = well_status_orig;
2495 int status_switch_count = 0;
2496 // don't allow opening wells that has a stopped well status
2497 const bool allow_open = well_state.well(this->index_of_well_).status == WellStatus::OPEN;
2498 // don't allow switcing for wells under zero rate target or requested fixed status and control
2499 const bool allow_switching =
2500 !this->wellUnderZeroRateTarget(groupStateHelper, deferred_logger) &&
2501 (!fixed_control || !fixed_status) && allow_open;
2502
2503 bool changed = false;
2504 bool final_check = false;
2505 // well needs to be set operable or else solving/updating of re-opened wells is skipped
2506 this->operability_status_.resetOperability();
2507 this->operability_status_.solvable = true;
2508 do {
2509 its_since_last_switch++;
2510 if (allow_switching && its_since_last_switch >= min_its_after_switch && status_switch_count < max_status_switch){
2511 const Scalar wqTotal = this->primary_variables_.eval(WQTotal).value();
2512 changed = this->updateWellControlAndStatusLocalIteration(
2513 simulator, groupStateHelper, inj_controls, prod_controls, wqTotal,
2514 well_state, deferred_logger, fixed_control, fixed_status,
2515 solving_with_zero_rate
2516 );
2517 if (changed){
2518 its_since_last_switch = 0;
2519 switch_count++;
2520 if (well_status_cur != this->wellStatus_) {
2521 well_status_cur = this->wellStatus_;
2522 status_switch_count++;
2523 }
2524 }
2525 if (!changed && final_check) {
2526 break;
2527 } else {
2528 final_check = false;
2529 }
2530 if (status_switch_count == max_status_switch) {
2531 this->wellStatus_ = well_status_orig;
2532 }
2533 }
2534
2535 assembleWellEqWithoutIteration(simulator, groupStateHelper, dt, inj_controls, prod_controls, well_state, deferred_logger, solving_with_zero_rate);
2536
2537 if (it > this->param_.strict_inner_iter_wells_) {
2538 relax_convergence = true;
2539 this->regularize_ = true;
2540 }
2541
2542 auto report = getWellConvergence(groupStateHelper, Base::B_avg_, deferred_logger, relax_convergence);
2543
2544 converged = report.converged();
2545 if (converged) {
2546 // if equations are sufficiently linear they might converge in less than min_its_after_switch
2547 // in this case, make sure all constraints are satisfied before returning
2548 if (switch_count > 0 && its_since_last_switch < min_its_after_switch) {
2549 final_check = true;
2550 its_since_last_switch = min_its_after_switch;
2551 } else {
2552 break;
2553 }
2554 }
2555
2556 ++it;
2557 solveEqAndUpdateWellState(simulator, groupStateHelper, well_state, deferred_logger);
2558
2559 } while (it < max_iter);
2560
2561 if (converged) {
2562 if (allow_switching){
2563 // update operability if status change
2564 const bool is_stopped = this->wellIsStopped();
2565 if (this->wellHasTHPConstraints(summary_state)){
2566 this->operability_status_.can_obtain_bhp_with_thp_limit = !is_stopped;
2567 this->operability_status_.obey_thp_limit_under_bhp_limit = !is_stopped;
2568 } else {
2569 this->operability_status_.operable_under_only_bhp_limit = !is_stopped;
2570 }
2571 }
2572 std::string message = fmt::format(" Well {} converged in {} inner iterations ("
2573 "{} control/status switches).", this->name(), it, switch_count);
2574 if (relax_convergence) {
2575 message.append(fmt::format(" (A relaxed tolerance was used after {} iterations)",
2576 this->param_.strict_inner_iter_wells_));
2577 }
2578 deferred_logger.debug(message, OpmLog::defaultDebugVerbosityLevel + ((it == 0) && (switch_count == 0)));
2579
2580 } else {
2581 this->wellStatus_ = well_status_orig;
2582 this->operability_status_ = operability_orig;
2583 const std::string message = fmt::format(" Well {} did not converge in {} inner iterations ("
2584 "{} switches, {} status changes).", this->name(), it, switch_count, status_switch_count);
2585 deferred_logger.debug(message);
2586 // add operability here as well ?
2587 }
2588 return converged;
2589 }
2590
2591 template<typename TypeTag>
2592 std::vector<typename StandardWell<TypeTag>::Scalar>
2594 computeCurrentWellRates(const Simulator& simulator,
2595 DeferredLogger& deferred_logger) const
2596 {
2597 // Calculate the rates that follow from the current primary variables.
2598 std::vector<Scalar> well_q_s(this->num_conservation_quantities_, 0.);
2599 const EvalWell& bhp = this->primary_variables_.eval(Bhp);
2600 const bool allow_cf = this->getAllowCrossFlow() || openCrossFlowAvoidSingularity(simulator);
2601 for (int perf = 0; perf < this->number_of_local_perforations_; ++perf) {
2602 const int cell_idx = this->well_cells_[perf];
2603 const auto& intQuants = simulator.model().intensiveQuantities(cell_idx, /*timeIdx=*/ 0);
2604 std::vector<Scalar> mob(this->num_conservation_quantities_, 0.);
2605 getMobility(simulator, perf, mob, deferred_logger);
2606 std::vector<Scalar> cq_s(this->num_conservation_quantities_, 0.);
2607 Scalar trans_mult(0.0);
2608 getTransMult(trans_mult, simulator, cell_idx);
2609 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
2610 std::vector<Scalar> Tw(this->num_conservation_quantities_, this->well_index_[perf] * trans_mult);
2611 this->getTw(Tw, perf, intQuants, trans_mult, wellstate_nupcol);
2612 PerforationRates<Scalar> perf_rates;
2613 computePerfRate(intQuants, mob, bhp.value(), Tw, perf, allow_cf,
2614 cq_s, perf_rates, deferred_logger);
2615 for (int comp = 0; comp < this->num_conservation_quantities_; ++comp) {
2616 well_q_s[comp] += cq_s[comp];
2617 }
2618 }
2619 const auto& comm = this->parallel_well_info_.communication();
2620 if (comm.size() > 1)
2621 {
2622 comm.sum(well_q_s.data(), well_q_s.size());
2623 }
2624 return well_q_s;
2625 }
2626
2627
2628
2629 template <typename TypeTag>
2630 std::vector<typename StandardWell<TypeTag>::Scalar>
2632 getPrimaryVars() const
2633 {
2634 const int num_pri_vars = this->primary_variables_.numWellEq();
2635 std::vector<Scalar> retval(num_pri_vars);
2636 for (int ii = 0; ii < num_pri_vars; ++ii) {
2637 retval[ii] = this->primary_variables_.value(ii);
2638 }
2639 return retval;
2640 }
2641
2642
2643
2644
2645
2646 template <typename TypeTag>
2647 int
2649 setPrimaryVars(typename std::vector<Scalar>::const_iterator it)
2650 {
2651 const int num_pri_vars = this->primary_variables_.numWellEq();
2652 for (int ii = 0; ii < num_pri_vars; ++ii) {
2653 this->primary_variables_.setValue(ii, it[ii]);
2654 }
2655 return num_pri_vars;
2656 }
2657
2658
2659 template <typename TypeTag>
2662 connectionRateEnergy(const std::vector<EvalWell>& cq_s,
2663 const IntensiveQuantities& intQuants,
2664 DeferredLogger& deferred_logger) const
2665 {
2666 auto fs = intQuants.fluidState();
2667 Eval result = 0;
2668 for (unsigned phaseIdx = 0; phaseIdx < FluidSystem::numPhases; ++phaseIdx) {
2669 if (!FluidSystem::phaseIsActive(phaseIdx)) {
2670 continue;
2671 }
2672
2673 // convert to reservoir conditions
2674 EvalWell cq_r_thermal{0.};
2675 const unsigned activeCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::solventComponentIndex(phaseIdx));
2676 const bool both_oil_gas = FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) && FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx);
2677 if (!both_oil_gas || FluidSystem::waterPhaseIdx == phaseIdx) {
2678 cq_r_thermal = cq_s[activeCompIdx] / this->extendEval(fs.invB(phaseIdx));
2679 } else {
2680 // remove dissolved gas and vapporized oil
2681 const unsigned oilCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx);
2682 const unsigned gasCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
2683 // q_os = q_or * b_o + rv * q_gr * b_g
2684 // q_gs = q_gr * g_g + rs * q_or * b_o
2685 // q_gr = 1 / (b_g * d) * (q_gs - rs * q_os)
2686 // d = 1.0 - rs * rv
2687 const EvalWell d = this->extendEval(1.0 - fs.Rv() * fs.Rs());
2688 if (d <= 0.0) {
2689 deferred_logger.debug(
2690 fmt::format("Problematic d value {} obtained for well {}"
2691 " during calculateSinglePerf with rs {}"
2692 ", rv {}. Continue as if no dissolution (rs = 0) and"
2693 " vaporization (rv = 0) for this connection.",
2694 d, this->name(), fs.Rs(), fs.Rv()));
2695 cq_r_thermal = cq_s[activeCompIdx] / this->extendEval(fs.invB(phaseIdx));
2696 } else {
2697 if (FluidSystem::gasPhaseIdx == phaseIdx) {
2698 cq_r_thermal = (cq_s[gasCompIdx] -
2699 this->extendEval(fs.Rs()) * cq_s[oilCompIdx]) /
2700 (d * this->extendEval(fs.invB(phaseIdx)) );
2701 } else if (FluidSystem::oilPhaseIdx == phaseIdx) {
2702 // q_or = 1 / (b_o * d) * (q_os - rv * q_gs)
2703 cq_r_thermal = (cq_s[oilCompIdx] - this->extendEval(fs.Rv()) *
2704 cq_s[gasCompIdx]) /
2705 (d * this->extendEval(fs.invB(phaseIdx)) );
2706 }
2707 }
2708 }
2709
2710 // change temperature for injecting fluids
2711 if (this->isInjector() && !this->wellIsStopped() && cq_r_thermal > 0.0){
2712 // only handles single phase injection now
2713 assert(this->well_ecl_.injectorType() != InjectorType::MULTI);
2714 fs.setTemperature(this->well_ecl_.inj_temperature());
2715 typedef typename std::decay<decltype(fs)>::type::Scalar FsScalar;
2716 typename FluidSystem::template ParameterCache<FsScalar> paramCache;
2717 const unsigned pvtRegionIdx = intQuants.pvtRegionIndex();
2718 paramCache.setRegionIndex(pvtRegionIdx);
2719 paramCache.updatePhase(fs, phaseIdx);
2720
2721 const auto& rho = FluidSystem::density(fs, paramCache, phaseIdx);
2722 fs.setDensity(phaseIdx, rho);
2723 const auto& h = FluidSystem::enthalpy(fs, paramCache, phaseIdx);
2724 fs.setEnthalpy(phaseIdx, h);
2725 cq_r_thermal *= this->extendEval(fs.enthalpy(phaseIdx)) * this->extendEval(fs.density(phaseIdx));
2726 result += getValue(cq_r_thermal);
2727 } else if (cq_r_thermal > 0.0) {
2728 cq_r_thermal *= getValue(fs.enthalpy(phaseIdx)) * getValue(fs.density(phaseIdx));
2729 result += Base::restrictEval(cq_r_thermal);
2730 } else {
2731 // compute the thermal flux
2732 cq_r_thermal *= this->extendEval(fs.enthalpy(phaseIdx)) * this->extendEval(fs.density(phaseIdx));
2733 result += Base::restrictEval(cq_r_thermal);
2734 }
2735 }
2736
2737 return result * this->well_efficiency_factor_;
2738 }
2739
2740 template <typename TypeTag>
2743 maxPerfPress(const Simulator& simulator) const {
2744 Scalar max_pressure = 0.0;
2745 for (int perf = 0; perf < this->number_of_local_perforations_; ++perf) {
2746 const int cell_idx = this->well_cells_[perf];
2747 const auto& int_quants = simulator.model().intensiveQuantities(cell_idx, /*timeIdx=*/ 0);
2748 const auto& fs = int_quants.fluidState();
2749 Scalar pressure_cell = this->getPerfCellPressure(fs).value();
2750 max_pressure = std::max(max_pressure, pressure_cell);
2751 }
2752 const auto& comm = this->parallel_well_info_.communication();
2753 if (comm.size() > 1) {
2754 max_pressure = comm.max(max_pressure);
2755 }
2756 return max_pressure;
2757 }
2758
2759} // namespace Opm
2760
2761#endif
#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: GroupStateHelper.hpp:53
GroupState< Scalar > & groupState() const
Definition: GroupStateHelper.hpp:180
const SummaryState & summaryState() const
Definition: GroupStateHelper.hpp:257
const WellState< Scalar, IndexTraits > & wellState() const
Definition: GroupStateHelper.hpp:306
WellStateGuard pushWellState(WellState< Scalar, IndexTraits > &well_state)
Definition: GroupStateHelper.hpp:195
GroupStateGuard pushGroupState(GroupState< Scalar > &group_state)
Definition: GroupStateHelper.hpp:190
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:44
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 updatePrimaryVariables(const GroupStateHelperType &groupStateHelper, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:1877
EvalWell wpolymermw(const Scalar throughput, const EvalWell &water_velocity, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:2080
void updateIPRImplicit(const Simulator &simulator, const GroupStateHelperType &groupStateHelper, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:921
void assembleWellEqWithoutIteration(const Simulator &simulator, const GroupStateHelperType &groupStateHelper, 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 solveEqAndUpdateWellState(const Simulator &simulator, const GroupStateHelperType &groupStateHelper, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:1415
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::optional< Scalar > computeBhpAtThpLimitProdWithAlq(const Simulator &ebos_simulator, const GroupStateHelperType &groupStateHelper, const SummaryState &summary_state, const Scalar alq_value, DeferredLogger &deferred_logger, bool iterate_if_no_solution) const override
Definition: StandardWell_impl.hpp:2288
std::optional< Scalar > computeBhpAtThpLimitInj(const Simulator &simulator, const GroupStateHelperType &groupStateHelper, const SummaryState &summary_state, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:2362
void addWellContributions(SparseMatrixAdapter &mat) const override
Definition: StandardWell_impl.hpp:1977
Scalar computeWellRatesAndBhpWithThpAlqProd(const Simulator &ebos_simulator, const GroupStateHelperType &groupStateHelper, const SummaryState &summary_state, DeferredLogger &deferred_logger, std::vector< Scalar > &potentials, Scalar alq) const
Definition: StandardWell_impl.hpp:1750
std::vector< Scalar > getPrimaryVars() const override
Definition: StandardWell_impl.hpp:2632
virtual ConvergenceReport getWellConvergence(const GroupStateHelperType &groupStateHelper, 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 computeWellRatesWithBhpIterations(const Simulator &ebosSimulator, const Scalar &bhp, const GroupStateHelperType &groupStateHelper, std::vector< Scalar > &well_flux, DeferredLogger &deferred_logger) const override
Definition: StandardWell_impl.hpp:1553
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:1985
void updateWaterMobilityWithPolymer(const Simulator &simulator, const int perf, std::vector< EvalWell > &mob_water, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:1911
void recoverWellSolutionAndUpdateWellState(const Simulator &simulator, const BVector &x, const GroupStateHelperType &groupStateHelper, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:1484
std::vector< Scalar > computeCurrentWellRates(const Simulator &ebosSimulator, DeferredLogger &deferred_logger) const override
Definition: StandardWell_impl.hpp:2594
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:505
void computeWellConnectionDensitesPressures(const Simulator &simulator, const GroupStateHelperType &groupStateHelper, const WellConnectionProps &props, DeferredLogger &deferred_logger)
Definition: StandardWell_impl.hpp:1339
std::vector< Scalar > computeWellPotentialWithTHP(const Simulator &ebosSimulator, const GroupStateHelperType &groupStateHelper, DeferredLogger &deferred_logger, const WellStateType &well_state) const
Definition: StandardWell_impl.hpp:1624
bool computeWellPotentialsImplicit(const Simulator &ebos_simulator, const GroupStateHelperType &groupStateHelper, std::vector< Scalar > &well_potentials, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:1660
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
StandardWell(const Well &well, const ParallelWellInfo< Scalar > &pw_info, const int time_step, const ModelParameters &param, 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:274
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:2229
void computeWellRatesWithBhp(const Simulator &ebosSimulator, const Scalar &bhp, std::vector< Scalar > &well_flux, DeferredLogger &deferred_logger) const override
Definition: StandardWell_impl.hpp:1505
void computeWellConnectionPressures(const Simulator &simulator, const GroupStateHelperType &groupStateHelper, DeferredLogger &deferred_logger)
Definition: StandardWell_impl.hpp:1396
void getMobility(const Simulator &simulator, const int perf, std::vector< Value > &mob, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:703
void getTransMult(Value &trans_mult, const Simulator &simulator, const int cell_indx) const
Definition: StandardWell_impl.hpp:683
void checkOperabilityUnderTHPLimit(const Simulator &simulator, const WellStateType &well_state, const GroupStateHelperType &groupStateHelper, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:1067
void updateIPR(const Simulator &simulator, DeferredLogger &deferred_logger) const override
Definition: StandardWell_impl.hpp:829
void updateWellState(const Simulator &simulator, const BVectorWell &dwells, const GroupStateHelperType &groupStateHelper, WellStateType &well_state, DeferredLogger &deferred_logger)
Definition: StandardWell_impl.hpp:759
void handleInjectivityEquations(const Simulator &simulator, const WellStateType &well_state, const int perf, const EvalWell &water_flux_s, DeferredLogger &deferred_logger)
Definition: StandardWell_impl.hpp:2163
void computeWellPotentials(const Simulator &simulator, const WellStateType &well_state, const GroupStateHelperType &groupStateHelper, std::vector< Scalar > &well_potentials, DeferredLogger &deferred_logger) override
computing the well potentials for group control
Definition: StandardWell_impl.hpp:1799
virtual void apply(const BVector &x, BVector &Ax) const override
Ax = Ax - C D^-1 B x.
Definition: StandardWell_impl.hpp:1452
void checkConvergenceExtraEqs(const std::vector< Scalar > &res, ConvergenceReport &report) const
Definition: StandardWell_impl.hpp:2210
void assembleWellEqWithoutIterationImpl(const Simulator &simulator, const GroupStateHelperType &groupStateHelper, 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
typename StdWellEval::Eval Eval
Definition: StandardWell.hpp:120
bool openCrossFlowAvoidSingularity(const Simulator &simulator) const
Definition: StandardWell_impl.hpp:1159
Scalar maxPerfPress(const Simulator &simulator) const override
Definition: StandardWell_impl.hpp:2743
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:2036
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:2649
void computeWellRatesWithThpAlqProd(const Simulator &ebos_simulator, const GroupStateHelperType &groupStateHelper, const SummaryState &summary_state, DeferredLogger &deferred_logger, std::vector< Scalar > &potentials, Scalar alq) const
Definition: StandardWell_impl.hpp:1780
void updateWaterThroughput(const double dt, WellStateType &well_state) const override
Definition: StandardWell_impl.hpp:2109
void checkOperabilityUnderBHPLimit(const WellStateType &well_state, const Simulator &simulator, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:998
EvalWell pskinwater(const Scalar throughput, const EvalWell &water_velocity, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:2005
bool iterateWellEqWithControl(const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, const GroupStateHelperType &groupStateHelper, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:2400
void calculateExplicitQuantities(const Simulator &simulator, const GroupStateHelperType &groupStateHelper, DeferredLogger &deferred_logger) override
Definition: StandardWell_impl.hpp:1438
void handleInjectivityRate(const Simulator &simulator, const int perf, std::vector< EvalWell > &cq_s) const
Definition: StandardWell_impl.hpp:2140
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:1264
std::optional< Scalar > computeBhpAtThpLimitProd(const WellStateType &well_state, const Simulator &simulator, const GroupStateHelperType &groupStateHelper, const SummaryState &summary_state, DeferredLogger &deferred_logger) const
Definition: StandardWell_impl.hpp:2271
Scalar getRefDensity() const override
Definition: StandardWell_impl.hpp:1900
bool iterateWellEqWithSwitching(const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, const GroupStateHelperType &groupStateHelper, 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:2463
Scalar connectionDensity(const int globalConnIdx, const int openConnIdx) const override
Definition: StandardWell_impl.hpp:1862
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
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
bool solveWellWithOperabilityCheck(const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, const GroupStateHelperType &groupStateHelper, WellStateType &well_state, DeferredLogger &deferred_logger)
Definition: WellInterface_impl.hpp:589
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:2060
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:2073
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
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