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