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