22#ifndef OPM_MULTISEGMENTWELL_IMPL_HEADER_INCLUDED
23#define OPM_MULTISEGMENTWELL_IMPL_HEADER_INCLUDED
25#ifndef OPM_MULTISEGMENTWELL_HEADER_INCLUDED
30#include <opm/common/Exceptions.hpp>
31#include <opm/common/OpmLog/OpmLog.hpp>
33#include <opm/input/eclipse/Schedule/MSW/Segment.hpp>
34#include <opm/input/eclipse/Schedule/MSW/Valve.hpp>
35#include <opm/input/eclipse/Schedule/MSW/WellSegments.hpp>
36#include <opm/input/eclipse/Schedule/Well/Connection.hpp>
37#include <opm/input/eclipse/Schedule/Well/WellConnections.hpp>
39#include <opm/input/eclipse/Units/Units.hpp>
41#include <opm/material/densead/EvaluationFormat.hpp>
52#if COMPILE_GPU_BRIDGE && (HAVE_CUDA || HAVE_OPENCL)
60 template <
typename TypeTag>
67 const int pvtRegionIdx,
68 const int num_conservation_quantities,
70 const int index_of_well,
72 :
Base(well, pw_info, time_step, param, rate_converter, pvtRegionIdx, num_conservation_quantities, num_phases, index_of_well, perf_data)
75 , segment_fluid_initial_(this->numberOfSegments(), std::vector<
Scalar>(this->num_conservation_quantities_, 0.0))
79 OPM_THROW(std::runtime_error,
"solvent is not supported by multisegment well yet");
83 OPM_THROW(std::runtime_error,
"polymer is not supported by multisegment well yet");
87 OPM_THROW(std::runtime_error,
"energy is not supported by multisegment well yet");
91 OPM_THROW(std::runtime_error,
"foam is not supported by multisegment well yet");
95 OPM_THROW(std::runtime_error,
"brine is not supported by multisegment well yet");
99 OPM_THROW(std::runtime_error,
"water evaporation is not supported by multisegment well yet");
103 OPM_THROW(std::runtime_error,
"MICP is not supported by multisegment well yet");
107 OPM_THROW(std::runtime_error,
108 "dissolved gas/ vapporized oil in injected oil/gas not supported by multisegment well yet."
109 " \n See (WCONINJE item 10 / WCONHIST item 8)");
119 template <
typename TypeTag>
122 init(
const std::vector<Scalar>& depth_arg,
124 const std::vector< Scalar >& B_avg,
125 const bool changed_to_open_this_step)
127 Base::init(depth_arg, gravity_arg, B_avg, changed_to_open_this_step);
139 this->initMatrixAndVectors();
142 for (
int local_perf_index = 0; local_perf_index < this->number_of_local_perforations_; ++local_perf_index) {
144 const int cell_idx = this->well_cells_[local_perf_index];
146 this->cell_perforation_depth_diffs_[local_perf_index] = depth_arg[cell_idx] - this->perf_depth_[this->pw_info_.localPerfToActivePerf(local_perf_index)];
154 template <
typename TypeTag>
161 const bool stop_or_zero_rate_target = this->stoppedOrZeroRateTarget(simulator, well_state, deferred_logger);
162 this->primary_variables_.update(well_state, stop_or_zero_rate_target);
170 template <
typename TypeTag>
175 this->scaleSegmentRatesWithWellRates(this->segments_.inlets(),
176 this->segments_.perforations(),
178 this->scaleSegmentPressuresWithBhp(well_state);
181 template <
typename TypeTag>
189 Base::updateWellStateWithTarget(simulator, wgHelper, well_state, deferred_logger);
192 this->scaleSegmentRatesWithWellRates(this->segments_.inlets(),
193 this->segments_.perforations(),
195 this->scaleSegmentPressuresWithBhp(well_state);
201 template <
typename TypeTag>
206 const std::vector<Scalar>& B_avg,
208 const bool relax_tolerance)
const
210 return this->MSWEval::getWellConvergence(well_state,
213 this->param_.max_residual_allowed_,
214 this->param_.tolerance_wells_,
215 this->param_.relaxed_tolerance_flow_well_,
216 this->param_.tolerance_pressure_ms_wells_,
217 this->param_.relaxed_tolerance_pressure_ms_well_,
219 this->wellIsStopped());
227 template <
typename TypeTag>
232 if (!this->isOperableAndSolvable() && !this->wellIsStopped()) {
236 if (this->param_.matrix_add_well_contributions_) {
241 this->linSys_.apply(x, Ax);
248 template <
typename TypeTag>
253 if (!this->isOperableAndSolvable() && !this->wellIsStopped()) {
257 this->linSys_.apply(r);
262 template <
typename TypeTag>
270 if (!this->isOperableAndSolvable() && !this->wellIsStopped()) {
276 this->linSys_.recoverSolutionWell(x, xw);
278 updateWellState(simulator, xw, well_state, deferred_logger);
280 catch (
const NumericalProblem& exp) {
284 deferred_logger.
problem(
"In MultisegmentWell::recoverWellSolutionAndUpdateWellState for well "
285 + this->name() +
": "+exp.what());
294 template <
typename TypeTag>
300 std::vector<Scalar>& well_potentials,
303 const auto [compute_potential, bhp_controlled_well] =
306 if (!compute_potential) {
310 debug_cost_counter_ = 0;
311 bool converged_implicit =
false;
312 if (this->param_.local_well_solver_control_switching_) {
313 converged_implicit = computeWellPotentialsImplicit(simulator, wgHelper, well_potentials, deferred_logger);
314 if (!converged_implicit) {
315 deferred_logger.
debug(
"Implicit potential calculations failed for well "
316 + this->name() +
", reverting to original aproach.");
319 if (!converged_implicit) {
321 const auto& summaryState = simulator.vanguard().summaryState();
322 if (!Base::wellHasTHPConstraints(summaryState) || bhp_controlled_well) {
323 computeWellRatesAtBhpLimit(simulator, wgHelper, well_potentials, deferred_logger);
325 well_potentials = computeWellPotentialWithTHP(
326 well_state, simulator, wgHelper, deferred_logger);
329 deferred_logger.
debug(
"Cost in iterations of finding well potential for well "
332 this->checkNegativeWellPotentials(well_potentials,
333 this->param_.check_well_operability_,
340 template<
typename TypeTag>
345 std::vector<Scalar>& well_flux,
348 if (this->well_ecl_.isInjector()) {
349 const auto controls = this->well_ecl_.injectionControls(simulator.vanguard().summaryState());
350 computeWellRatesWithBhpIterations(simulator, controls.bhp_limit, wgHelper, well_flux, deferred_logger);
352 const auto controls = this->well_ecl_.productionControls(simulator.vanguard().summaryState());
353 computeWellRatesWithBhpIterations(simulator, controls.bhp_limit, wgHelper, well_flux, deferred_logger);
357 template<
typename TypeTag>
362 std::vector<Scalar>& well_flux,
365 const int np = this->number_of_phases_;
367 well_flux.resize(np, 0.0);
368 const bool allow_cf = this->getAllowCrossFlow();
369 const int nseg = this->numberOfSegments();
370 const WellStateType& well_state = simulator.problem().wellModel().wellState();
371 const auto& ws = well_state.
well(this->indexOfWell());
372 auto segments_copy = ws.segments;
373 segments_copy.scale_pressure(bhp);
374 const auto& segment_pressure = segments_copy.pressure;
375 for (
int seg = 0; seg < nseg; ++seg) {
376 for (
const int perf : this->segments_.perforations()[seg]) {
377 const int local_perf_index = this->pw_info_.activePerfToLocalPerf(perf);
378 if (local_perf_index < 0)
380 const int cell_idx = this->well_cells_[local_perf_index];
381 const auto& intQuants = simulator.model().intensiveQuantities(cell_idx, 0);
383 std::vector<Scalar> mob(this->num_conservation_quantities_, 0.);
384 getMobility(simulator, local_perf_index, mob, deferred_logger);
386 getTransMult(trans_mult, simulator, cell_idx);
387 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
388 std::vector<Scalar> Tw(this->num_conservation_quantities_,
389 this->well_index_[local_perf_index] * trans_mult);
390 this->getTw(Tw, local_perf_index, intQuants, trans_mult, wellstate_nupcol);
391 const Scalar seg_pressure = segment_pressure[seg];
392 std::vector<Scalar> cq_s(this->num_conservation_quantities_, 0.);
395 computePerfRate(intQuants, mob, Tw, seg, perf, seg_pressure,
396 allow_cf, cq_s, perf_press, perf_rates, deferred_logger);
398 for(
int p = 0; p < np; ++p) {
399 well_flux[FluidSystem::activeCompToActivePhaseIdx(p)] += cq_s[p];
403 this->parallel_well_info_.communication().sum(well_flux.data(), well_flux.size());
407 template<
typename TypeTag>
413 std::vector<Scalar>& well_flux,
428 auto& ws = well_state_copy.
well(this->index_of_well_);
431 const auto& summary_state = simulator.vanguard().summaryState();
432 auto inj_controls = well_copy.
well_ecl_.isInjector()
433 ? well_copy.
well_ecl_.injectionControls(summary_state)
434 : Well::InjectionControls(0);
435 auto prod_controls = well_copy.
well_ecl_.isProducer()
436 ? well_copy.
well_ecl_.productionControls(summary_state) :
437 Well::ProductionControls(0);
441 inj_controls.bhp_limit = bhp;
442 ws.injection_cmode = Well::InjectorCMode::BHP;
444 prod_controls.bhp_limit = bhp;
445 ws.production_cmode = Well::ProducerCMode::BHP;
451 const int np = this->number_of_phases_;
453 for (
int phase = 0; phase < np; ++phase){
454 trivial = trivial && (ws.well_potentials[phase] == 0.0) ;
458 for (
int phase = 0; phase < np; ++phase) {
459 ws.surface_rates[phase] = sign * ws.well_potentials[phase];
463 this->segments_.perforations(),
467 const double dt = simulator.timeStepSize();
470 well_state_copy, deferred_logger);
474 well_flux.resize(np, 0.0);
475 for (
int compIdx = 0; compIdx < this->num_conservation_quantities_; ++compIdx) {
477 well_flux[FluidSystem::activeCompToActivePhaseIdx(compIdx)] = rate.value();
484 template<
typename TypeTag>
485 std::vector<typename MultisegmentWell<TypeTag>::Scalar>
492 std::vector<Scalar> potentials(this->number_of_phases_, 0.0);
493 const auto& summary_state = simulator.vanguard().summaryState();
495 const auto& well = this->well_ecl_;
496 if (well.isInjector()) {
497 auto bhp_at_thp_limit = computeBhpAtThpLimitInj(simulator, wgHelper, summary_state, deferred_logger);
498 if (bhp_at_thp_limit) {
499 const auto& controls = well.injectionControls(summary_state);
500 const Scalar bhp = std::min(*bhp_at_thp_limit,
501 static_cast<Scalar>(controls.bhp_limit));
502 computeWellRatesWithBhpIterations(simulator, bhp, wgHelper, potentials, deferred_logger);
503 deferred_logger.
debug(
"Converged thp based potential calculation for well "
506 deferred_logger.
warning(
"FAILURE_GETTING_CONVERGED_POTENTIAL",
507 "Failed in getting converged thp based potential calculation for well "
508 + this->name() +
". Instead the bhp based value is used");
509 const auto& controls = well.injectionControls(summary_state);
510 const Scalar bhp = controls.bhp_limit;
511 computeWellRatesWithBhpIterations(simulator, bhp, wgHelper, potentials, deferred_logger);
514 auto bhp_at_thp_limit = computeBhpAtThpLimitProd(
515 well_state, simulator, wgHelper, summary_state, deferred_logger);
516 if (bhp_at_thp_limit) {
517 const auto& controls = well.productionControls(summary_state);
518 const Scalar bhp = std::max(*bhp_at_thp_limit,
519 static_cast<Scalar>(controls.bhp_limit));
520 computeWellRatesWithBhpIterations(simulator, bhp, wgHelper, potentials, deferred_logger);
521 deferred_logger.
debug(
"Converged thp based potential calculation for well "
524 deferred_logger.
warning(
"FAILURE_GETTING_CONVERGED_POTENTIAL",
525 "Failed in getting converged thp based potential calculation for well "
526 + this->name() +
". Instead the bhp based value is used");
527 const auto& controls = well.productionControls(summary_state);
528 const Scalar bhp = controls.bhp_limit;
529 computeWellRatesWithBhpIterations(simulator, bhp, wgHelper, potentials, deferred_logger);
536 template<
typename TypeTag>
541 std::vector<Scalar>& well_potentials,
554 auto& ws = well_state_copy.
well(this->index_of_well_);
557 const auto& summary_state = simulator.vanguard().summaryState();
558 auto inj_controls = well_copy.
well_ecl_.isInjector()
559 ? well_copy.
well_ecl_.injectionControls(summary_state)
560 : Well::InjectionControls(0);
561 auto prod_controls = well_copy.
well_ecl_.isProducer()
562 ? well_copy.
well_ecl_.productionControls(summary_state)
563 : Well::ProductionControls(0);
571 const int np = this->number_of_phases_;
573 for (
int phase = 0; phase < np; ++phase){
574 trivial = trivial && (ws.well_potentials[phase] == 0.0) ;
578 for (
int phase = 0; phase < np; ++phase) {
579 ws.surface_rates[phase] = sign * ws.well_potentials[phase];
583 this->segments_.perforations(),
587 const double dt = simulator.timeStepSize();
589 bool converged =
false;
590 if (this->well_ecl_.isProducer()) {
592 simulator, dt, inj_controls, prod_controls, wgHelper_copy, well_state_copy, deferred_logger
596 simulator, dt, inj_controls, prod_controls, wgHelper_copy, well_state_copy, deferred_logger,
604 well_potentials.clear();
605 well_potentials.resize(np, 0.0);
606 for (
int compIdx = 0; compIdx < this->num_conservation_quantities_; ++compIdx) {
608 well_potentials[FluidSystem::activeCompToActivePhaseIdx(compIdx)] = rate.value();
614 template <
typename TypeTag>
621 if (!this->isOperableAndSolvable() && !this->wellIsStopped())
return;
626 const BVectorWell dx_well = this->linSys_.solve();
627 updateWellState(simulator, dx_well, well_state, deferred_logger);
629 catch(
const NumericalProblem& exp) {
633 deferred_logger.
problem(
"In MultisegmentWell::solveEqAndUpdateWellState for well "
634 + this->name() +
": "+exp.what());
643 template <
typename TypeTag>
650 for (
int local_perf_index = 0; local_perf_index < this->number_of_local_perforations_; ++local_perf_index) {
653 std::vector<Scalar> kr(this->number_of_phases_, 0.0);
654 std::vector<Scalar> density(this->number_of_phases_, 0.0);
656 const int cell_idx = this->well_cells_[local_perf_index];
657 const auto& intQuants = simulator.model().intensiveQuantities(cell_idx, 0);
658 const auto& fs = intQuants.fluidState();
662 if (FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx)) {
663 const int water_pos = FluidSystem::canonicalToActivePhaseIdx(FluidSystem::waterPhaseIdx);
664 kr[water_pos] = intQuants.relativePermeability(FluidSystem::waterPhaseIdx).value();
665 sum_kr += kr[water_pos];
666 density[water_pos] = fs.density(FluidSystem::waterPhaseIdx).value();
669 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx)) {
670 const int oil_pos = FluidSystem::canonicalToActivePhaseIdx(FluidSystem::oilPhaseIdx);
671 kr[oil_pos] = intQuants.relativePermeability(FluidSystem::oilPhaseIdx).value();
672 sum_kr += kr[oil_pos];
673 density[oil_pos] = fs.density(FluidSystem::oilPhaseIdx).value();
676 if (FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx)) {
677 const int gas_pos = FluidSystem::canonicalToActivePhaseIdx(FluidSystem::gasPhaseIdx);
678 kr[gas_pos] = intQuants.relativePermeability(FluidSystem::gasPhaseIdx).value();
679 sum_kr += kr[gas_pos];
680 density[gas_pos] = fs.density(FluidSystem::gasPhaseIdx).value();
683 assert(sum_kr != 0.);
686 Scalar average_density = 0.;
687 for (
int p = 0; p < this->number_of_phases_; ++p) {
688 average_density += kr[p] * density[p];
690 average_density /= sum_kr;
692 this->cell_perforation_pressure_diffs_[local_perf_index] = this->gravity_ * average_density * this->cell_perforation_depth_diffs_[local_perf_index];
700 template <
typename TypeTag>
706 for (
int seg = 0; seg < this->numberOfSegments(); ++seg) {
708 const Scalar surface_volume = getSegmentSurfaceVolume(simulator, seg, deferred_logger).value();
709 for (
int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx) {
710 segment_fluid_initial_[seg][comp_idx] = surface_volume * this->primary_variables_.surfaceVolumeFraction(seg, comp_idx).value();
719 template <
typename TypeTag>
723 const BVectorWell& dwells,
726 const Scalar relaxation_factor)
728 if (!this->isOperableAndSolvable() && !this->wellIsStopped())
return;
730 const Scalar dFLimit = this->param_.dwell_fraction_max_;
731 const Scalar max_pressure_change = this->param_.max_pressure_change_ms_wells_;
732 const bool stop_or_zero_rate_target =
733 this->stoppedOrZeroRateTarget(simulator, well_state, deferred_logger);
734 this->primary_variables_.updateNewton(dwells,
737 stop_or_zero_rate_target,
738 max_pressure_change);
740 const auto& summary_state = simulator.vanguard().summaryState();
741 this->primary_variables_.copyToWellState(*
this, getRefDensity(),
747 auto& ws = well_state.
well(this->index_of_well_);
748 this->segments_.copyPhaseDensities(ws.segments);
751 Base::calculateReservoirRates(simulator.vanguard().eclState().runspec().co2Storage(), well_state.
well(this->index_of_well_));
758 template <
typename TypeTag>
765 updatePrimaryVariables(simulator, well_state, deferred_logger);
766 computePerfCellPressDiffs(simulator);
767 computeInitialSegmentFluids(simulator, deferred_logger);
774 template<
typename TypeTag>
782 auto fluidState = [&simulator,
this](
const int local_perf_index)
784 const auto cell_idx = this->well_cells_[local_perf_index];
785 return simulator.model()
786 .intensiveQuantities(cell_idx, 0).fluidState();
789 const int np = this->number_of_phases_;
790 auto setToZero = [np](
Scalar* x) ->
void
792 std::fill_n(x, np, 0.0);
795 auto addVector = [np](
const Scalar* src,
Scalar* dest) ->
void
797 std::transform(src, src + np, dest, dest, std::plus<>{});
800 auto& ws = well_state.
well(this->index_of_well_);
801 auto& perf_data = ws.perf_data;
802 auto* connPI = perf_data.prod_index.data();
803 auto* wellPI = ws.productivity_index.data();
807 const auto preferred_phase = this->well_ecl_.getPreferredPhase();
808 auto subsetPerfID = 0;
810 for (
const auto& perf : *this->perf_data_){
811 auto allPerfID = perf.ecl_index;
813 auto connPICalc = [&wellPICalc, allPerfID](
const Scalar mobility) ->
Scalar
818 std::vector<Scalar> mob(this->num_conservation_quantities_, 0.0);
823 getMobility(simulator,
static_cast<int>(subsetPerfID), mob, deferred_logger);
825 const auto& fs = fluidState(subsetPerfID);
828 if (this->isInjector()) {
829 this->computeConnLevelInjInd(fs, preferred_phase, connPICalc,
830 mob, connPI, deferred_logger);
833 this->computeConnLevelProdInd(fs, connPICalc, mob, connPI);
836 addVector(connPI, wellPI);
843 const auto& comm = this->parallel_well_info_.communication();
844 if (comm.size() > 1) {
845 comm.sum(wellPI, np);
848 assert (
static_cast<int>(subsetPerfID) == this->number_of_local_perforations_ &&
849 "Internal logic error in processing connections for PI/II");
856 template<
typename TypeTag>
860 [[maybe_unused]]
const int openConnIdx)
const
865 const auto segNum = this->wellEcl()
866 .getConnections()[globalConnIdx].segment();
868 const auto segIdx = this->wellEcl()
869 .getSegments().segmentNumberToIndex(segNum);
871 return this->segments_.density(segIdx).value();
878 template<
typename TypeTag>
883 if (this->number_of_local_perforations_ == 0) {
887 this->linSys_.extract(jacobian);
891 template<
typename TypeTag>
896 const int pressureVarIndex,
897 const bool use_well_weights,
900 if (this->number_of_local_perforations_ == 0) {
905 this->linSys_.extractCPRPressureMatrix(jacobian,
915 template<
typename TypeTag>
916 template<
class Value>
922 const std::vector<Value>& b_perfcells,
923 const std::vector<Value>& mob_perfcells,
924 const std::vector<Value>& Tw,
926 const Value& segment_pressure,
927 const Value& segment_density,
928 const bool& allow_cf,
929 const std::vector<Value>& cmix_s,
930 std::vector<Value>& cq_s,
935 const int local_perf_index = this->pw_info_.activePerfToLocalPerf(perf);
936 if (local_perf_index < 0)
940 const Value perf_seg_press_diff = this->gravity() * segment_density *
941 this->segments_.local_perforation_depth_diff(local_perf_index);
943 const Scalar cell_perf_press_diff = this->cell_perforation_pressure_diffs_[local_perf_index];
947 perf_press = segment_pressure + perf_seg_press_diff;
950 const Value cell_press_at_perf = pressure_cell - cell_perf_press_diff;
953 const Value drawdown = cell_press_at_perf - perf_press;
956 if (drawdown > 0.0) {
958 if (!allow_cf && this->isInjector()) {
963 for (
int comp_idx = 0; comp_idx < this->numConservationQuantities(); ++comp_idx) {
964 const Value cq_p = - Tw[comp_idx] * (mob_perfcells[comp_idx] * drawdown);
965 cq_s[comp_idx] = b_perfcells[comp_idx] * cq_p;
968 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) && FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx)) {
969 const unsigned oilCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx);
970 const unsigned gasCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
971 const Value cq_s_oil = cq_s[oilCompIdx];
972 const Value cq_s_gas = cq_s[gasCompIdx];
973 cq_s[gasCompIdx] += rs * cq_s_oil;
974 cq_s[oilCompIdx] += rv * cq_s_gas;
978 if (!allow_cf && this->isProducer()) {
983 Value total_mob = mob_perfcells[0];
984 for (
int comp_idx = 1; comp_idx < this->numConservationQuantities(); ++comp_idx) {
985 total_mob += mob_perfcells[comp_idx];
989 Value volume_ratio = 0.0;
990 if (FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx)) {
991 const unsigned waterCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx);
992 volume_ratio += cmix_s[waterCompIdx] / b_perfcells[waterCompIdx];
995 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) && FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx)) {
996 const unsigned oilCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx);
997 const unsigned gasCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
1002 const Value d = 1.0 - rv * rs;
1004 if (getValue(d) == 0.0) {
1006 fmt::format(
"Zero d value obtained for well {} "
1007 "during flux calculation with rs {} and rv {}",
1008 this->name(), rs, rv),
1012 const Value tmp_oil = (cmix_s[oilCompIdx] - rv * cmix_s[gasCompIdx]) / d;
1013 volume_ratio += tmp_oil / b_perfcells[oilCompIdx];
1015 const Value tmp_gas = (cmix_s[gasCompIdx] - rs * cmix_s[oilCompIdx]) / d;
1016 volume_ratio += tmp_gas / b_perfcells[gasCompIdx];
1018 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx)) {
1019 const unsigned oilCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx);
1020 volume_ratio += cmix_s[oilCompIdx] / b_perfcells[oilCompIdx];
1022 if (FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx)) {
1023 const unsigned gasCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
1024 volume_ratio += cmix_s[gasCompIdx] / b_perfcells[gasCompIdx];
1028 for (
int componentIdx = 0; componentIdx < this->numConservationQuantities(); ++componentIdx) {
1029 const Value cqt_i = - Tw[componentIdx] * (total_mob * drawdown);
1030 Value cqt_is = cqt_i / volume_ratio;
1031 cq_s[componentIdx] = cmix_s[componentIdx] * cqt_is;
1036 if (this->isProducer()) {
1037 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) && FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx)) {
1038 const unsigned oilCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx);
1039 const unsigned gasCompIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
1048 const Scalar d = 1.0 - getValue(rv) * getValue(rs);
1051 perf_rates.
vap_oil = getValue(rv) * (getValue(cq_s[gasCompIdx]) - getValue(rs) * getValue(cq_s[oilCompIdx])) / d;
1054 perf_rates.
dis_gas = getValue(rs) * (getValue(cq_s[oilCompIdx]) - getValue(rv) * getValue(cq_s[gasCompIdx])) / d;
1059 template <
typename TypeTag>
1060 template<
class Value>
1064 const std::vector<Value>& mob_perfcells,
1065 const std::vector<Value>& Tw,
1068 const Value& segment_pressure,
1069 const bool& allow_cf,
1070 std::vector<Value>& cq_s,
1076 auto obtain = [
this](
const Eval& value)
1078 if constexpr (std::is_same_v<Value, Scalar>) {
1079 static_cast<void>(
this);
1080 return getValue(value);
1082 return this->extendEval(value);
1085 auto obtainN = [](
const auto& value)
1087 if constexpr (std::is_same_v<Value, Scalar>) {
1088 return getValue(value);
1093 const auto& fs = int_quants.fluidState();
1095 const Value pressure_cell = obtain(this->getPerfCellPressure(fs));
1096 const Value rs = obtain(fs.Rs());
1097 const Value rv = obtain(fs.Rv());
1100 std::vector<Value> b_perfcells(this->num_conservation_quantities_, 0.0);
1102 for (
unsigned phaseIdx = 0; phaseIdx < FluidSystem::numPhases; ++phaseIdx) {
1103 if (!FluidSystem::phaseIsActive(phaseIdx)) {
1107 const unsigned compIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::solventComponentIndex(phaseIdx));
1108 b_perfcells[compIdx] = obtain(fs.invB(phaseIdx));
1111 std::vector<Value> cmix_s(this->numConservationQuantities(), 0.0);
1112 for (
int comp_idx = 0; comp_idx < this->numConservationQuantities(); ++comp_idx) {
1113 cmix_s[comp_idx] = obtainN(this->primary_variables_.surfaceVolumeFraction(seg, comp_idx));
1116 this->computePerfRate(pressure_cell,
1124 obtainN(this->segments_.density(seg)),
1133 template <
typename TypeTag>
1153 auto info = this->getFirstPerforationFluidStateInfo(simulator);
1154 temperature.setValue(std::get<0>(info));
1155 saltConcentration = this->extendEval(std::get<1>(info));
1157 this->segments_.computeFluidProperties(temperature,
1159 this->primary_variables_,
1163 template<
typename TypeTag>
1164 template<
class Value>
1169 const int cell_idx)
const
1171 auto obtain = [
this](
const Eval& value)
1173 if constexpr (std::is_same_v<Value, Scalar>) {
1174 static_cast<void>(
this);
1175 return getValue(value);
1177 return this->extendEval(value);
1183 template <
typename TypeTag>
1184 template<
class Value>
1188 const int local_perf_index,
1189 std::vector<Value>& mob,
1192 auto obtain = [
this](
const Eval& value)
1194 if constexpr (std::is_same_v<Value, Scalar>) {
1195 static_cast<void>(
this);
1196 return getValue(value);
1198 return this->extendEval(value);
1205 const auto perf_ecl_index = this->perforationData()[local_perf_index].ecl_index;
1206 const Connection& con = this->well_ecl_.getConnections()[perf_ecl_index];
1207 const int seg = this->segmentNumberToIndex(con.segment());
1211 const Scalar segment_pres = this->primary_variables_.getSegmentPressure(seg).value();
1212 const Scalar perf_seg_press_diff = this->gravity() * this->segments_.density(seg).value()
1213 * this->segments_.local_perforation_depth_diff(local_perf_index);
1214 const Scalar perf_press = segment_pres + perf_seg_press_diff;
1215 const Scalar multiplier = this->getInjMult(local_perf_index, segment_pres, perf_press, deferred_logger);
1216 for (std::size_t i = 0; i < mob.size(); ++i) {
1217 mob[i] *= multiplier;
1224 template<
typename TypeTag>
1229 return this->segments_.getRefDensity();
1232 template<
typename TypeTag>
1239 const auto& summaryState = simulator.vanguard().summaryState();
1243 const bool bhp_limit_not_defaulted = bhp_limit > 1.5 * unit::barsa;
1244 if ( bhp_limit_not_defaulted || !this->wellHasTHPConstraints(summaryState) ) {
1247 Scalar total_ipr_mass_rate = 0.0;
1248 for (
unsigned phaseIdx = 0; phaseIdx < FluidSystem::numPhases; ++phaseIdx)
1250 if (!FluidSystem::phaseIsActive(phaseIdx)) {
1254 const unsigned compIdx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::solventComponentIndex(phaseIdx));
1255 const Scalar ipr_rate = this->ipr_a_[compIdx] - this->ipr_b_[compIdx] * bhp_limit;
1257 const Scalar rho = FluidSystem::referenceDensity( phaseIdx, Base::pvtRegionIdx() );
1258 total_ipr_mass_rate += ipr_rate * rho;
1260 if ( (this->isProducer() && total_ipr_mass_rate < 0.) || (this->isInjector() && total_ipr_mass_rate > 0.) ) {
1261 this->operability_status_.operable_under_only_bhp_limit =
false;
1265 if (this->operability_status_.operable_under_only_bhp_limit && this->wellHasTHPConstraints(summaryState)) {
1269 std::vector<Scalar> well_rates_bhp_limit;
1270 computeWellRatesWithBhp(simulator, bhp_limit, well_rates_bhp_limit, deferred_logger);
1272 const Scalar thp_limit = this->getTHPConstraint(summaryState);
1275 this->getRefDensity(),
1276 this->wellEcl().alq_value(summaryState),
1279 if ( (this->isProducer() && thp < thp_limit) || (this->isInjector() && thp > thp_limit) ) {
1280 this->operability_status_.obey_thp_limit_under_bhp_limit =
false;
1291 this->operability_status_.operable_under_only_bhp_limit =
true;
1292 this->operability_status_.obey_thp_limit_under_bhp_limit =
false;
1298 template<
typename TypeTag>
1306 std::fill(this->ipr_a_.begin(), this->ipr_a_.end(), 0.);
1307 std::fill(this->ipr_b_.begin(), this->ipr_b_.end(), 0.);
1309 const int nseg = this->numberOfSegments();
1310 std::vector<Scalar> seg_dp(nseg, 0.0);
1311 for (
int seg = 0; seg < nseg; ++seg) {
1313 const Scalar dp = this->getSegmentDp(seg,
1314 this->segments_.density(seg).value(),
1317 for (
const int perf : this->segments_.perforations()[seg]) {
1318 const int local_perf_index = this->pw_info_.activePerfToLocalPerf(perf);
1319 if (local_perf_index < 0)
1321 std::vector<Scalar> mob(this->num_conservation_quantities_, 0.0);
1324 getMobility(simulator, local_perf_index, mob, deferred_logger);
1326 const int cell_idx = this->well_cells_[local_perf_index];
1327 const auto& int_quantities = simulator.model().intensiveQuantities(cell_idx, 0);
1328 const auto& fs = int_quantities.fluidState();
1330 const Scalar perf_seg_press_diff = this->segments_.getPressureDiffSegLocalPerf(seg, local_perf_index);
1332 const Scalar cell_perf_press_diff = this->cell_perforation_pressure_diffs_[local_perf_index];
1333 const Scalar pressure_cell = this->getPerfCellPressure(fs).value();
1336 std::vector<Scalar> b_perf(this->num_conservation_quantities_);
1337 for (std::size_t phase = 0; phase < FluidSystem::numPhases; ++phase) {
1338 if (!FluidSystem::phaseIsActive(phase)) {
1341 const unsigned comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::solventComponentIndex(phase));
1342 b_perf[comp_idx] = fs.invB(phase).value();
1346 const Scalar h_perf = cell_perf_press_diff + perf_seg_press_diff + dp;
1347 const Scalar pressure_diff = pressure_cell - h_perf;
1350 if ( (this->isProducer() && pressure_diff < 0.) || (this->isInjector() && pressure_diff > 0.) ) {
1351 deferred_logger.
debug(
"CROSSFLOW_IPR",
1352 "cross flow found when updateIPR for well " + this->name());
1357 getTransMult(trans_mult, simulator, cell_idx);
1358 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
1359 std::vector<Scalar> tw_perf(this->num_conservation_quantities_, this->well_index_[perf] * trans_mult);
1360 this->getTw(tw_perf, local_perf_index, int_quantities, trans_mult, wellstate_nupcol);
1361 std::vector<Scalar> ipr_a_perf(this->ipr_a_.size());
1362 std::vector<Scalar> ipr_b_perf(this->ipr_b_.size());
1363 for (
int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx) {
1364 const Scalar tw_mob = tw_perf[comp_idx] * mob[comp_idx] * b_perf[comp_idx];
1365 ipr_a_perf[comp_idx] += tw_mob * pressure_diff;
1366 ipr_b_perf[comp_idx] += tw_mob;
1370 if (FluidSystem::phaseIsActive(FluidSystem::oilPhaseIdx) && FluidSystem::phaseIsActive(FluidSystem::gasPhaseIdx)) {
1371 const unsigned oil_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::oilCompIdx);
1372 const unsigned gas_comp_idx = FluidSystem::canonicalToActiveCompIdx(FluidSystem::gasCompIdx);
1373 const Scalar rs = (fs.Rs()).value();
1374 const Scalar rv = (fs.Rv()).value();
1376 const Scalar dis_gas_a = rs * ipr_a_perf[oil_comp_idx];
1377 const Scalar vap_oil_a = rv * ipr_a_perf[gas_comp_idx];
1379 ipr_a_perf[gas_comp_idx] += dis_gas_a;
1380 ipr_a_perf[oil_comp_idx] += vap_oil_a;
1382 const Scalar dis_gas_b = rs * ipr_b_perf[oil_comp_idx];
1383 const Scalar vap_oil_b = rv * ipr_b_perf[gas_comp_idx];
1385 ipr_b_perf[gas_comp_idx] += dis_gas_b;
1386 ipr_b_perf[oil_comp_idx] += vap_oil_b;
1389 for (std::size_t comp_idx = 0; comp_idx < ipr_a_perf.size(); ++comp_idx) {
1390 this->ipr_a_[comp_idx] += ipr_a_perf[comp_idx];
1391 this->ipr_b_[comp_idx] += ipr_b_perf[comp_idx];
1395 this->parallel_well_info_.communication().sum(this->ipr_a_.data(), this->ipr_a_.size());
1396 this->parallel_well_info_.communication().sum(this->ipr_b_.data(), this->ipr_b_.size());
1399 template<
typename TypeTag>
1414 auto rates = well_state.
well(this->index_of_well_).surface_rates;
1416 for (std::size_t p = 0; p < rates.size(); ++p) {
1417 zero_rates &= rates[p] == 0.0;
1419 auto& ws = well_state.
well(this->index_of_well_);
1421 const auto msg = fmt::format(
"updateIPRImplicit: Well {} has zero rate, IPRs might be problematic", this->name());
1422 deferred_logger.
debug(msg);
1435 std::fill(ws.implicit_ipr_a.begin(), ws.implicit_ipr_a.end(), 0.);
1436 std::fill(ws.implicit_ipr_b.begin(), ws.implicit_ipr_b.end(), 0.);
1438 auto inj_controls = Well::InjectionControls(0);
1439 auto prod_controls = Well::ProductionControls(0);
1440 prod_controls.addControl(Well::ProducerCMode::BHP);
1441 prod_controls.bhp_limit = well_state.
well(this->index_of_well_).bhp;
1444 const auto cmode = ws.production_cmode;
1445 ws.production_cmode = Well::ProducerCMode::BHP;
1446 const double dt = simulator.timeStepSize();
1447 assembleWellEqWithoutIteration(simulator, wgHelper, dt, inj_controls, prod_controls, well_state, deferred_logger,
1450 BVectorWell rhs(this->numberOfSegments());
1452 rhs[0][SPres] = -1.0;
1454 const BVectorWell x_well = this->linSys_.solve(rhs);
1455 constexpr int num_eq = MSWEval::numWellEq;
1456 for (
int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx){
1457 const EvalWell comp_rate = this->primary_variables_.getQs(comp_idx);
1458 const int idx = FluidSystem::activeCompToActivePhaseIdx(comp_idx);
1459 for (
size_t pvIdx = 0; pvIdx < num_eq; ++pvIdx) {
1461 ws.implicit_ipr_b[idx] -= x_well[0][pvIdx]*comp_rate.derivative(pvIdx+Indices::numEq);
1463 ws.implicit_ipr_a[idx] = ws.implicit_ipr_b[idx]*ws.bhp - comp_rate.value();
1466 ws.production_cmode = cmode;
1469 template<
typename TypeTag>
1477 const auto& summaryState = simulator.vanguard().summaryState();
1478 const auto obtain_bhp = this->isProducer()
1479 ? computeBhpAtThpLimitProd(
1480 well_state, simulator, wgHelper, summaryState, deferred_logger)
1481 : computeBhpAtThpLimitInj(simulator, wgHelper, summaryState, deferred_logger);
1484 this->operability_status_.can_obtain_bhp_with_thp_limit =
true;
1487 this->operability_status_.obey_bhp_limit_with_thp_limit = (*obtain_bhp >= bhp_limit);
1489 const Scalar thp_limit = this->getTHPConstraint(summaryState);
1490 if (this->isProducer() && *obtain_bhp < thp_limit) {
1491 const std::string msg =
" obtained bhp " +
std::to_string(unit::convert::to(*obtain_bhp, unit::barsa))
1492 +
" bars is SMALLER than thp limit "
1494 +
" bars as a producer for well " + this->name();
1495 deferred_logger.
debug(msg);
1497 else if (this->isInjector() && *obtain_bhp > thp_limit) {
1498 const std::string msg =
" obtained bhp " +
std::to_string(unit::convert::to(*obtain_bhp, unit::barsa))
1499 +
" bars is LARGER than thp limit "
1501 +
" bars as a injector for well " + this->name();
1502 deferred_logger.
debug(msg);
1507 this->operability_status_.can_obtain_bhp_with_thp_limit =
false;
1508 this->operability_status_.obey_bhp_limit_with_thp_limit =
false;
1509 if (!this->wellIsStopped()) {
1510 const Scalar thp_limit = this->getTHPConstraint(summaryState);
1511 deferred_logger.
debug(
" could not find bhp value at thp limit "
1513 +
" bar for well " + this->name() +
", the well might need to be closed ");
1522 template<
typename TypeTag>
1527 const Well::InjectionControls& inj_controls,
1528 const Well::ProductionControls& prod_controls,
1533 if (!this->isOperableAndSolvable() && !this->wellIsStopped())
return true;
1535 const int max_iter_number = this->param_.max_inner_iter_ms_wells_;
1539 const auto& [isFinite, residuals] = this->getFiniteWellResiduals(Base::B_avg_, deferred_logger);
1544 updatePrimaryVariables(simulator, well_state, deferred_logger);
1546 std::vector<std::vector<Scalar> > residual_history;
1547 std::vector<Scalar> measure_history;
1550 Scalar relaxation_factor = 1.;
1551 bool converged =
false;
1552 bool relax_convergence =
false;
1553 this->regularize_ =
false;
1554 for (; it < max_iter_number; ++it, ++debug_cost_counter_) {
1556 if (it > this->param_.strict_inner_iter_wells_) {
1557 relax_convergence =
true;
1558 this->regularize_ =
true;
1561 assembleWellEqWithoutIteration(simulator, wgHelper, dt, inj_controls, prod_controls,
1562 well_state, deferred_logger,
1565 const auto report = getWellConvergence(simulator, well_state, Base::B_avg_, deferred_logger, relax_convergence);
1566 if (report.converged()) {
1573 const auto& [isFinite, residuals] = this->getFiniteWellResiduals(Base::B_avg_, deferred_logger);
1577 residual_history.push_back(residuals);
1578 measure_history.push_back(this->getResidualMeasureValue(well_state,
1579 residual_history[it],
1580 this->param_.tolerance_wells_,
1581 this->param_.tolerance_pressure_ms_wells_,
1584 bool min_relaxation_reached = this->update_relaxation_factor(measure_history, relaxation_factor, this->regularize_, deferred_logger);
1585 if (min_relaxation_reached || this->repeatedStagnation(measure_history, this->regularize_, deferred_logger)) {
1587 const auto reportStag = getWellConvergence(simulator, well_state, Base::B_avg_, deferred_logger,
true);
1588 if (reportStag.converged()) {
1590 std::string message = fmt::format(
"Well stagnates/oscillates but {} manages to get converged with relaxed tolerances in {} inner iterations."
1592 deferred_logger.
debug(message);
1599 BVectorWell dx_well;
1601 dx_well = this->linSys_.solve();
1602 updateWellState(simulator, dx_well, well_state, deferred_logger, relaxation_factor);
1604 catch(
const NumericalProblem& exp) {
1608 deferred_logger.
problem(
"In MultisegmentWell::iterateWellEqWithControl for well "
1609 + this->name() +
": "+exp.what());
1616 std::ostringstream sstr;
1617 sstr <<
" Well " << this->name() <<
" converged in " << it <<
" inner iterations.";
1618 if (relax_convergence)
1619 sstr <<
" (A relaxed tolerance was used after "<< this->param_.strict_inner_iter_wells_ <<
" iterations)";
1623 deferred_logger.
debug(sstr.str(), OpmLog::defaultDebugVerbosityLevel + (it == 0));
1625 std::ostringstream sstr;
1626 sstr <<
" Well " << this->name() <<
" did not converge in " << it <<
" inner iterations.";
1627#define EXTRA_DEBUG_MSW 0
1629 sstr <<
"***** Outputting the residual history for well " << this->name() <<
" during inner iterations:";
1630 for (
int i = 0; i < it; ++i) {
1631 const auto& residual = residual_history[i];
1632 sstr <<
" residual at " << i <<
"th iteration ";
1633 for (
const auto& res : residual) {
1636 sstr <<
" " << measure_history[i] <<
" \n";
1639#undef EXTRA_DEBUG_MSW
1640 deferred_logger.
debug(sstr.str());
1647 template<
typename TypeTag>
1652 const Well::InjectionControls& inj_controls,
1653 const Well::ProductionControls& prod_controls,
1657 const bool fixed_control ,
1658 const bool fixed_status ,
1659 const bool solving_with_zero_rate )
1661 const int max_iter_number = this->param_.max_inner_iter_ms_wells_;
1665 const auto& [isFinite, residuals] = this->getFiniteWellResiduals(Base::B_avg_, deferred_logger);
1670 updatePrimaryVariables(simulator, well_state, deferred_logger);
1672 std::vector<std::vector<Scalar> > residual_history;
1673 std::vector<Scalar> measure_history;
1676 Scalar relaxation_factor = 1.;
1677 bool converged =
false;
1678 bool relax_convergence =
false;
1679 this->regularize_ =
false;
1685 const int min_its_after_switch = 3;
1687 const int max_status_switch = this->param_.max_well_status_switch_inner_iter_;
1688 int its_since_last_switch = min_its_after_switch;
1689 int switch_count= 0;
1690 int status_switch_count = 0;
1692 const auto well_status_orig = this->wellStatus_;
1693 const auto operability_orig = this->operability_status_;
1694 auto well_status_cur = well_status_orig;
1696 const bool allow_open = well_state.
well(this->index_of_well_).status == WellStatus::OPEN;
1698 const bool allow_switching = !this->wellUnderZeroRateTarget(simulator, well_state, deferred_logger) &&
1699 (!fixed_control || !fixed_status) && allow_open;
1700 bool final_check =
false;
1702 this->operability_status_.resetOperability();
1703 this->operability_status_.solvable =
true;
1705 for (; it < max_iter_number; ++it, ++debug_cost_counter_) {
1706 ++its_since_last_switch;
1707 if (allow_switching && its_since_last_switch >= min_its_after_switch && status_switch_count < max_status_switch){
1708 const Scalar wqTotal = this->primary_variables_.getWQTotal().value();
1709 bool changed = this->updateWellControlAndStatusLocalIteration(
1710 simulator, wgHelper, inj_controls, prod_controls, wqTotal,
1711 well_state, deferred_logger, fixed_control, fixed_status,
1712 solving_with_zero_rate
1715 its_since_last_switch = 0;
1717 if (well_status_cur != this->wellStatus_) {
1718 well_status_cur = this->wellStatus_;
1719 status_switch_count++;
1722 if (!changed && final_check) {
1725 final_check =
false;
1727 if (status_switch_count == max_status_switch) {
1728 this->wellStatus_ = well_status_orig;
1732 if (it > this->param_.strict_inner_iter_wells_) {
1733 relax_convergence =
true;
1734 this->regularize_ =
true;
1737 assembleWellEqWithoutIteration(simulator, wgHelper, dt, inj_controls, prod_controls,
1738 well_state, deferred_logger, solving_with_zero_rate);
1741 const auto report = getWellConvergence(simulator, well_state, Base::B_avg_, deferred_logger, relax_convergence);
1742 converged = report.converged();
1743 if (this->parallel_well_info_.communication().size() > 1 &&
1744 this->parallel_well_info_.communication().max(converged) != this->parallel_well_info_.communication().min(converged)) {
1745 OPM_THROW(std::runtime_error, fmt::format(
"Misalignment of the parallel simulation run in iterateWellEqWithSwitching - the well calculation for well {} succeeded some ranks but failed on other ranks.", this->name()));
1750 if (switch_count > 0 && its_since_last_switch < min_its_after_switch) {
1752 its_since_last_switch = min_its_after_switch;
1760 const auto& [isFinite, residuals] = this->getFiniteWellResiduals(Base::B_avg_, deferred_logger);
1766 residual_history.push_back(residuals);
1770 measure_history.push_back(this->getResidualMeasureValue(well_state,
1771 residual_history[it],
1772 this->param_.tolerance_wells_,
1773 this->param_.tolerance_pressure_ms_wells_,
1775 bool min_relaxation_reached = this->update_relaxation_factor(measure_history, relaxation_factor, this->regularize_, deferred_logger);
1776 if (min_relaxation_reached || this->repeatedStagnation(measure_history, this->regularize_, deferred_logger)) {
1782 const BVectorWell dx_well = this->linSys_.solve();
1783 updateWellState(simulator, dx_well, well_state, deferred_logger, relaxation_factor);
1785 catch(
const NumericalProblem& exp) {
1789 deferred_logger.
problem(
"In MultisegmentWell::iterateWellEqWithSwitching for well "
1790 + this->name() +
": "+exp.what());
1796 if (allow_switching){
1798 const bool is_stopped = this->wellIsStopped();
1799 if (this->wellHasTHPConstraints(summary_state)){
1800 this->operability_status_.can_obtain_bhp_with_thp_limit = !is_stopped;
1801 this->operability_status_.obey_thp_limit_under_bhp_limit = !is_stopped;
1803 this->operability_status_.operable_under_only_bhp_limit = !is_stopped;
1806 std::string message = fmt::format(
" Well {} converged in {} inner iterations ("
1807 "{} control/status switches).", this->name(), it, switch_count);
1808 if (relax_convergence) {
1809 message.append(fmt::format(
" (A relaxed tolerance was used after {} iterations)",
1810 this->param_.strict_inner_iter_wells_));
1812 deferred_logger.
debug(message, OpmLog::defaultDebugVerbosityLevel + ((it == 0) && (switch_count == 0)));
1814 this->wellStatus_ = well_status_orig;
1815 this->operability_status_ = operability_orig;
1816 const std::string message = fmt::format(
" Well {} did not converge in {} inner iterations ("
1817 "{} switches, {} status changes).", this->name(), it, switch_count, status_switch_count);
1818 deferred_logger.
debug(message);
1819 this->primary_variables_.outputLowLimitPressureSegments(deferred_logger);
1826 template<
typename TypeTag>
1832 const Well::InjectionControls& inj_controls,
1833 const Well::ProductionControls& prod_controls,
1836 const bool solving_with_zero_rate)
1838 if (!this->isOperableAndSolvable() && !this->wellIsStopped())
return;
1842 this->segments_.updateUpwindingSegments(this->primary_variables_);
1845 computeSegmentFluidProperties(simulator, deferred_logger);
1848 this->linSys_.clear();
1850 auto& ws = well_state.
well(this->index_of_well_);
1851 ws.phase_mixing_rates.fill(0.0);
1858 const bool allow_cf = this->getAllowCrossFlow() || openCrossFlowAvoidSingularity(simulator);
1860 const int nseg = this->numberOfSegments();
1862 const Scalar rhow = FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx) ?
1863 FluidSystem::referenceDensity( FluidSystem::waterPhaseIdx, Base::pvtRegionIdx() ) : 0.0;
1864 const unsigned watCompIdx = FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx) ?
1865 FluidSystem::canonicalToActiveCompIdx(FluidSystem::waterCompIdx) : 0;
1867 for (
int seg = 0; seg < nseg; ++seg) {
1869 const EvalWell seg_pressure = this->primary_variables_.getSegmentPressure(seg);
1870 auto& perf_data = ws.perf_data;
1871 auto& perf_rates = perf_data.phase_rates;
1872 auto& perf_press_state = perf_data.pressure;
1873 for (
const int perf : this->segments_.perforations()[seg]) {
1874 const int local_perf_index = this->pw_info_.activePerfToLocalPerf(perf);
1875 if (local_perf_index < 0)
1877 const int cell_idx = this->well_cells_[local_perf_index];
1878 const auto& int_quants = simulator.model().intensiveQuantities(cell_idx, 0);
1879 std::vector<EvalWell> mob(this->num_conservation_quantities_, 0.0);
1880 getMobility(simulator, local_perf_index, mob, deferred_logger);
1882 getTransMult(trans_mult, simulator, cell_idx);
1883 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
1884 std::vector<EvalWell> Tw(this->num_conservation_quantities_, this->well_index_[local_perf_index] * trans_mult);
1885 this->getTw(Tw, local_perf_index, int_quants, trans_mult, wellstate_nupcol);
1886 std::vector<EvalWell> cq_s(this->num_conservation_quantities_, 0.0);
1889 computePerfRate(int_quants, mob, Tw, seg, perf, seg_pressure,
1890 allow_cf, cq_s, perf_press, perfRates, deferred_logger);
1893 if (this->isProducer()) {
1894 ws.phase_mixing_rates[ws.dissolved_gas] += perfRates.
dis_gas;
1895 ws.phase_mixing_rates[ws.vaporized_oil] += perfRates.
vap_oil;
1896 perf_data.phase_mixing_rates[local_perf_index][ws.dissolved_gas] = perfRates.
dis_gas;
1897 perf_data.phase_mixing_rates[local_perf_index][ws.vaporized_oil] = perfRates.
vap_oil;
1901 for (
int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx) {
1902 perf_rates[local_perf_index*this->number_of_phases_ + FluidSystem::activeCompToActivePhaseIdx(comp_idx)] = cq_s[comp_idx].value();
1904 perf_press_state[local_perf_index] = perf_press.value();
1907 if (FluidSystem::phaseIsActive(FluidSystem::waterPhaseIdx)) {
1908 perf_data.wat_mass_rates[local_perf_index] = cq_s[watCompIdx].value() * rhow;
1911 for (
int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx) {
1913 const EvalWell cq_s_effective = cq_s[comp_idx] * this->well_efficiency_factor_;
1915 this->connectionRates_[local_perf_index][comp_idx] = Base::restrictEval(cq_s_effective);
1918 assemblePerforationEq(seg, local_perf_index, comp_idx, cq_s_effective, this->linSys_);
1924 const auto& comm = this->parallel_well_info_.communication();
1925 comm.sum(ws.phase_mixing_rates.data(), ws.phase_mixing_rates.size());
1928 if (this->parallel_well_info_.communication().size() > 1) {
1930 this->linSys_.sumDistributed(this->parallel_well_info_.communication());
1932 for (
int seg = 0; seg < nseg; ++seg) {
1936 const EvalWell segment_surface_volume = getSegmentSurfaceVolume(simulator, seg, deferred_logger);
1941 const Scalar regularization_factor = this->regularize_? this->param_.regularization_factor_wells_ : 1.0;
1943 for (
int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx) {
1944 const EvalWell accumulation_term = regularization_factor * (segment_surface_volume * this->primary_variables_.surfaceVolumeFraction(seg, comp_idx)
1945 - segment_fluid_initial_[seg][comp_idx]) / dt;
1947 assembleAccumulationTerm(seg, comp_idx, accumulation_term, this->linSys_);
1952 const int seg_upwind = this->segments_.upwinding_segment(seg);
1953 for (
int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx) {
1955 this->primary_variables_.getSegmentRateUpwinding(seg,
1958 this->well_efficiency_factor_;
1960 assembleOutflowTerm(seg, seg_upwind, comp_idx, segment_rate, this->linSys_);
1966 for (
const int inlet : this->segments_.inlets()[seg]) {
1967 const int inlet_upwind = this->segments_.upwinding_segment(inlet);
1968 for (
int comp_idx = 0; comp_idx < this->num_conservation_quantities_; ++comp_idx) {
1970 this->primary_variables_.getSegmentRateUpwinding(inlet,
1973 this->well_efficiency_factor_;
1975 assembleInflowTerm(seg, inlet, inlet_upwind, comp_idx, inlet_rate, this->linSys_);
1982 const auto& summaryState = simulator.vanguard().summaryState();
1983 const Schedule& schedule = simulator.vanguard().schedule();
1984 const bool stopped_or_zero_target = this->stoppedOrZeroRateTarget(simulator, well_state, deferred_logger);
1989 const auto& group_state = solving_with_zero_rate
1994 assembleControlEq(well_state,
2001 this->primary_variables_,
2003 stopped_or_zero_target,
2006 const UnitSystem& unit_system = simulator.vanguard().eclState().getDeckUnitSystem();
2007 const auto& summary_state = simulator.vanguard().summaryState();
2008 this->assemblePressureEq(seg, unit_system, well_state, summary_state, this->param_.use_average_density_ms_wells_, deferred_logger);
2012 this->parallel_well_info_.communication().sum(this->ipr_a_.data(), this->ipr_a_.size());
2013 this->linSys_.createSolver();
2019 template<
typename TypeTag>
2024 return !this->getAllowCrossFlow() && allDrawDownWrongDirection(simulator);
2028 template<
typename TypeTag>
2033 bool all_drawdown_wrong_direction =
true;
2034 const int nseg = this->numberOfSegments();
2036 for (
int seg = 0; seg < nseg; ++seg) {
2037 const EvalWell segment_pressure = this->primary_variables_.getSegmentPressure(seg);
2038 for (
const int perf : this->segments_.perforations()[seg]) {
2039 const int local_perf_index = this->pw_info_.activePerfToLocalPerf(perf);
2040 if (local_perf_index < 0)
2043 const int cell_idx = this->well_cells_[local_perf_index];
2044 const auto& intQuants = simulator.model().intensiveQuantities(cell_idx, 0);
2045 const auto& fs = intQuants.fluidState();
2048 const EvalWell perf_seg_press_diff = this->segments_.getPressureDiffSegLocalPerf(seg, local_perf_index);
2050 const Scalar cell_perf_press_diff = this->cell_perforation_pressure_diffs_[local_perf_index];
2052 const Scalar pressure_cell = this->getPerfCellPressure(fs).value();
2053 const Scalar perf_press = pressure_cell - cell_perf_press_diff;
2056 const EvalWell drawdown = perf_press - (segment_pressure + perf_seg_press_diff);
2061 if ( (drawdown < 0. && this->isInjector()) ||
2062 (drawdown > 0. && this->isProducer()) ) {
2063 all_drawdown_wrong_direction =
false;
2068 const auto& comm = this->parallel_well_info_.communication();
2069 if (comm.size() > 1)
2071 all_drawdown_wrong_direction =
2072 (comm.min(all_drawdown_wrong_direction ? 1 : 0) == 1);
2075 return all_drawdown_wrong_direction;
2081 template<
typename TypeTag>
2092 template<
typename TypeTag>
2102 auto info = this->getFirstPerforationFluidStateInfo(simulator);
2103 temperature.setValue(std::get<0>(info));
2104 saltConcentration = this->extendEval(std::get<1>(info));
2106 return this->segments_.getSurfaceVolume(temperature,
2108 this->primary_variables_,
2114 template<
typename TypeTag>
2115 std::optional<typename MultisegmentWell<TypeTag>::Scalar>
2120 const SummaryState& summary_state,
2127 this->getALQ(well_state),
2134 template<
typename TypeTag>
2135 std::optional<typename MultisegmentWell<TypeTag>::Scalar>
2139 const SummaryState& summary_state,
2142 bool iterate_if_no_solution)
const
2146 auto frates = [
this, &simulator, &deferred_logger](
const Scalar bhp) {
2152 std::vector<Scalar> rates(3);
2153 computeWellRatesWithBhp(simulator, bhp, rates, deferred_logger);
2158 computeBhpAtThpLimitProd(frates,
2160 this->maxPerfPress(simulator),
2161 this->getRefDensity(),
2163 this->getTHPConstraint(summary_state),
2169 if (!iterate_if_no_solution)
2170 return std::nullopt;
2172 auto fratesIter = [
this, &simulator, &wgHelper, &deferred_logger](
const Scalar bhp) {
2176 std::vector<Scalar> rates(3);
2177 computeWellRatesWithBhpIterations(simulator, bhp, wgHelper, rates, deferred_logger);
2182 computeBhpAtThpLimitProd(fratesIter,
2184 this->maxPerfPress(simulator),
2185 this->getRefDensity(),
2187 this->getTHPConstraint(summary_state),
2191 template<
typename TypeTag>
2192 std::optional<typename MultisegmentWell<TypeTag>::Scalar>
2196 const SummaryState& summary_state,
2200 auto frates = [
this, &simulator, &deferred_logger](
const Scalar bhp) {
2206 std::vector<Scalar> rates(3);
2207 computeWellRatesWithBhp(simulator, bhp, rates, deferred_logger);
2212 computeBhpAtThpLimitInj(frates,
2214 this->getRefDensity(),
2223 auto fratesIter = [
this, &simulator, &wgHelper, &deferred_logger](
const Scalar bhp) {
2227 std::vector<Scalar> rates(3);
2228 computeWellRatesWithBhpIterations(simulator, bhp, wgHelper, rates, deferred_logger);
2233 computeBhpAtThpLimitInj(fratesIter,
2235 this->getRefDensity(),
2246 template<
typename TypeTag>
2251 Scalar max_pressure = 0.0;
2252 const int nseg = this->numberOfSegments();
2253 for (
int seg = 0; seg < nseg; ++seg) {
2254 for (
const int perf : this->segments_.perforations()[seg]) {
2255 const int local_perf_index = this->pw_info_.activePerfToLocalPerf(perf);
2256 if (local_perf_index < 0)
2259 const int cell_idx = this->well_cells_[local_perf_index];
2260 const auto& int_quants = simulator.model().intensiveQuantities(cell_idx, 0);
2261 const auto& fs = int_quants.fluidState();
2262 Scalar pressure_cell = this->getPerfCellPressure(fs).value();
2263 max_pressure = std::max(max_pressure, pressure_cell);
2266 max_pressure = this->parallel_well_info_.communication().max(max_pressure);
2267 return max_pressure;
2274 template<
typename TypeTag>
2275 std::vector<typename MultisegmentWell<TypeTag>::Scalar>
2281 std::vector<Scalar> well_q_s(this->num_conservation_quantities_, 0.0);
2282 const bool allow_cf = this->getAllowCrossFlow() || openCrossFlowAvoidSingularity(simulator);
2283 const int nseg = this->numberOfSegments();
2284 for (
int seg = 0; seg < nseg; ++seg) {
2286 const Scalar seg_pressure = getValue(this->primary_variables_.getSegmentPressure(seg));
2287 for (
const int perf : this->segments_.perforations()[seg]) {
2288 const int local_perf_index = this->pw_info_.activePerfToLocalPerf(perf);
2289 if (local_perf_index < 0)
2292 const int cell_idx = this->well_cells_[local_perf_index];
2293 const auto& int_quants = simulator.model().intensiveQuantities(cell_idx, 0);
2294 std::vector<Scalar> mob(this->num_conservation_quantities_, 0.0);
2295 getMobility(simulator, local_perf_index, mob, deferred_logger);
2297 getTransMult(trans_mult, simulator, cell_idx);
2298 const auto& wellstate_nupcol = simulator.problem().wellModel().nupcolWellState().well(this->index_of_well_);
2299 std::vector<Scalar> Tw(this->num_conservation_quantities_, this->well_index_[local_perf_index] * trans_mult);
2300 this->getTw(Tw, local_perf_index, int_quants, trans_mult, wellstate_nupcol);
2301 std::vector<Scalar> cq_s(this->num_conservation_quantities_, 0.0);
2304 computePerfRate(int_quants, mob, Tw, seg, perf, seg_pressure,
2305 allow_cf, cq_s, perf_press, perf_rates, deferred_logger);
2306 for (
int comp = 0; comp < this->num_conservation_quantities_; ++comp) {
2307 well_q_s[comp] += cq_s[comp];
2311 const auto& comm = this->parallel_well_info_.communication();
2312 if (comm.size() > 1)
2314 comm.sum(well_q_s.data(), well_q_s.size());
2320 template <
typename TypeTag>
2321 std::vector<typename MultisegmentWell<TypeTag>::Scalar>
2325 const int num_seg = this->numberOfSegments();
2326 constexpr int num_eq = MSWEval::numWellEq;
2327 std::vector<Scalar> retval(num_seg * num_eq);
2328 for (
int ii = 0; ii < num_seg; ++ii) {
2329 const auto& pv = this->primary_variables_.value(ii);
2330 std::copy(pv.begin(), pv.end(), retval.begin() + ii * num_eq);
2338 template <
typename TypeTag>
2343 const int num_seg = this->numberOfSegments();
2344 constexpr int num_eq = MSWEval::numWellEq;
2345 std::array<Scalar, num_eq> tmp;
2346 for (
int ii = 0; ii < num_seg; ++ii) {
2347 const auto start = it + ii * num_eq;
2348 std::copy(start, start + num_eq, tmp.begin());
2349 this->primary_variables_.setValue(ii, tmp);
2351 return num_seg * num_eq;
2354 template <
typename TypeTag>
2359 Scalar fsTemperature = 0.0;
2360 using SaltConcType =
typename std::decay<
decltype(std::declval<
decltype(simulator.model().intensiveQuantities(0, 0).fluidState())>().saltConcentration())>::type;
2361 SaltConcType fsSaltConcentration{};
2364 if (this->well_cells_.size() > 0) {
2367 const int cell_idx = this->well_cells_[0];
2368 const auto& intQuants = simulator.model().intensiveQuantities(cell_idx, 0);
2369 const auto& fs = intQuants.fluidState();
2371 fsTemperature = fs.temperature(FluidSystem::oilPhaseIdx).value();
2372 fsSaltConcentration = fs.saltConcentration();
2375 auto info = std::make_tuple(fsTemperature, fsSaltConcentration);
2379 return this->parallel_well_info_.communication().size() == 1 ? info : this->pw_info_.broadcastFirstPerforationValue(info);
#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 problem(const std::string &tag, const std::string &message)
void debug(const std::string &tag, const std::string &message)
Definition: GroupState.hpp:41
Class handling assemble of the equation system for MultisegmentWell.
Definition: MultisegmentWellAssemble.hpp:44
typename PrimaryVariables::EvalWell EvalWell
Definition: MultisegmentWellEval.hpp:66
PrimaryVariables primary_variables_
The primary variables.
Definition: MultisegmentWellEval.hpp:143
void scaleSegmentRatesWithWellRates(const std::vector< std::vector< int > > &segment_inlets, const std::vector< std::vector< int > > &segment_perforations, WellState< Scalar, IndexTraits > &well_state) const
void scaleSegmentPressuresWithBhp(WellState< Scalar, IndexTraits > &well_state) const
Definition: MultisegmentWell.hpp:38
std::optional< Scalar > computeBhpAtThpLimitProd(const WellStateType &well_state, const Simulator &ebos_simulator, const WellGroupHelperType &wgHelper, const SummaryState &summary_state, DeferredLogger &deferred_logger) const
Definition: MultisegmentWell_impl.hpp:2117
void updateWellState(const Simulator &simulator, const BVectorWell &dwells, WellStateType &well_state, DeferredLogger &deferred_logger, const Scalar relaxation_factor=1.0)
Definition: MultisegmentWell_impl.hpp:722
void updateWaterThroughput(const double dt, WellStateType &well_state) const override
Definition: MultisegmentWell_impl.hpp:2084
void addWellPressureEquations(PressureMatrix &mat, const BVector &x, const int pressureVarIndex, const bool use_well_weights, const WellStateType &well_state) const override
Definition: MultisegmentWell_impl.hpp:894
Scalar connectionDensity(const int globalConnIdx, const int openConnIdx) const override
Definition: MultisegmentWell_impl.hpp:859
void addWellContributions(SparseMatrixAdapter &jacobian) const override
Definition: MultisegmentWell_impl.hpp:881
bool iterateWellEqWithControl(const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, const WellGroupHelperType &wgHelper, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: MultisegmentWell_impl.hpp:1525
void getTransMult(Value &trans_mult, const Simulator &simulator, const int cell_indx) const
Definition: MultisegmentWell_impl.hpp:1167
void solveEqAndUpdateWellState(const Simulator &simulator, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: MultisegmentWell_impl.hpp:617
Scalar getRefDensity() const override
Definition: MultisegmentWell_impl.hpp:1227
std::optional< Scalar > computeBhpAtThpLimitProdWithAlq(const Simulator &simulator, const WellGroupHelperType &wgHelper, const SummaryState &summary_state, const Scalar alq_value, DeferredLogger &deferred_logger, bool iterate_if_no_solution) const override
Definition: MultisegmentWell_impl.hpp:2137
std::vector< Scalar > getPrimaryVars() const override
Definition: MultisegmentWell_impl.hpp:2323
void updateIPRImplicit(const Simulator &simulator, const WellGroupHelperType &wgHelper, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: MultisegmentWell_impl.hpp:1402
void assembleWellEqWithoutIteration(const Simulator &simulator, const WellGroupHelperType &wgHelper, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, WellStateType &well_state, DeferredLogger &deferred_logger, const bool solving_with_zero_rate) override
Definition: MultisegmentWell_impl.hpp:1829
void computeWellRatesWithBhpIterations(const Simulator &simulator, const Scalar &bhp, const WellGroupHelperType &wgHelper, std::vector< Scalar > &well_flux, DeferredLogger &deferred_logger) const override
Definition: MultisegmentWell_impl.hpp:410
bool iterateWellEqWithSwitching(const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, const WellGroupHelperType &wgHelper, WellStateType &well_state, DeferredLogger &deferred_logger, const bool fixed_control, const bool fixed_status, const bool solving_with_zero_rate) override
Definition: MultisegmentWell_impl.hpp:1650
void computeWellPotentials(const Simulator &simulator, const WellStateType &well_state, const WellGroupHelperType &wgHelper, std::vector< Scalar > &well_potentials, DeferredLogger &deferred_logger) override
computing the well potentials for group control
Definition: MultisegmentWell_impl.hpp:297
std::vector< Scalar > computeCurrentWellRates(const Simulator &simulator, DeferredLogger &deferred_logger) const override
Definition: MultisegmentWell_impl.hpp:2277
void apply(const BVector &x, BVector &Ax) const override
Ax = Ax - C D^-1 B x.
Definition: MultisegmentWell_impl.hpp:230
MultisegmentWell(const Well &well, const ParallelWellInfo< Scalar > &pw_info, const int time_step, const ModelParameters ¶m, const RateConverterType &rate_converter, const int pvtRegionIdx, const int num_conservation_quantities, const int num_phases, const int index_of_well, const std::vector< PerforationData< Scalar > > &perf_data)
Definition: MultisegmentWell_impl.hpp:62
GetPropType< TypeTag, Properties::Scalar > Scalar
Definition: WellInterface.hpp:83
void checkOperabilityUnderBHPLimit(const WellStateType &well_state, const Simulator &ebos_simulator, DeferredLogger &deferred_logger) override
Definition: MultisegmentWell_impl.hpp:1235
void getMobility(const Simulator &simulator, const int local_perf_index, std::vector< Value > &mob, DeferredLogger &deferred_logger) const
Definition: MultisegmentWell_impl.hpp:1187
bool openCrossFlowAvoidSingularity(const Simulator &simulator) const
Definition: MultisegmentWell_impl.hpp:2022
void computeSegmentFluidProperties(const Simulator &simulator, DeferredLogger &deferred_logger)
Definition: MultisegmentWell_impl.hpp:1136
bool computeWellPotentialsImplicit(const Simulator &simulator, const WellGroupHelperType &wgHelper, std::vector< Scalar > &well_potentials, DeferredLogger &deferred_logger) const
Definition: MultisegmentWell_impl.hpp:539
int setPrimaryVars(typename std::vector< Scalar >::const_iterator it) override
Definition: MultisegmentWell_impl.hpp:2341
void computeWellRatesWithBhp(const Simulator &simulator, const Scalar &bhp, std::vector< Scalar > &well_flux, DeferredLogger &deferred_logger) const override
Definition: MultisegmentWell_impl.hpp:360
void scaleSegmentRatesAndPressure(WellStateType &well_state) const override
updating the segment pressure and rates based the current bhp and well rates
Definition: MultisegmentWell_impl.hpp:173
bool allDrawDownWrongDirection(const Simulator &simulator) const
Definition: MultisegmentWell_impl.hpp:2031
int debug_cost_counter_
Definition: MultisegmentWell.hpp:183
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: MultisegmentWell_impl.hpp:204
void updateProductivityIndex(const Simulator &simulator, const WellProdIndexCalculator< Scalar > &wellPICalc, WellStateType &well_state, DeferredLogger &deferred_logger) const override
Definition: MultisegmentWell_impl.hpp:777
static constexpr bool has_polymer
Definition: WellInterface.hpp:115
void computePerfRate(const IntensiveQuantities &int_quants, const std::vector< Value > &mob_perfcells, const std::vector< Value > &Tw, const int seg, const int perf, const Value &segment_pressure, const bool &allow_cf, std::vector< Value > &cq_s, Value &perf_press, PerforationRates< Scalar > &perf_rates, DeferredLogger &deferred_logger) const
Definition: MultisegmentWell_impl.hpp:1063
static constexpr bool has_solvent
Definition: WellInterface.hpp:113
std::optional< Scalar > computeBhpAtThpLimitInj(const Simulator &ebos_simulator, const WellGroupHelperType &wgHelper, const SummaryState &summary_state, DeferredLogger &deferred_logger) const
Definition: MultisegmentWell_impl.hpp:2194
void computePerfCellPressDiffs(const Simulator &simulator)
Definition: MultisegmentWell_impl.hpp:646
void computeWellRatesAtBhpLimit(const Simulator &simulator, const WellGroupHelperType &wgHelper, std::vector< Scalar > &well_flux, DeferredLogger &deferred_logger) const
Definition: MultisegmentWell_impl.hpp:343
void recoverWellSolutionAndUpdateWellState(const Simulator &simulator, const BVector &x, WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: MultisegmentWell_impl.hpp:265
std::vector< Scalar > computeWellPotentialWithTHP(const WellStateType &well_state, const Simulator &simulator, const WellGroupHelperType &wgHelper, DeferredLogger &deferred_logger) const
Definition: MultisegmentWell_impl.hpp:487
void updateIPR(const Simulator &ebos_simulator, DeferredLogger &deferred_logger) const override
Definition: MultisegmentWell_impl.hpp:1301
FSInfo getFirstPerforationFluidStateInfo(const Simulator &simulator) const
Definition: MultisegmentWell_impl.hpp:2357
std::tuple< Scalar, typename std::decay< decltype(std::declval< decltype(std::declval< const Simulator & >().model().intensiveQuantities(0, 0).fluidState())>().saltConcentration())>::type > FSInfo
Definition: MultisegmentWell.hpp:74
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: MultisegmentWell_impl.hpp:122
Scalar maxPerfPress(const Simulator &simulator) const
Definition: MultisegmentWell_impl.hpp:2249
void computeInitialSegmentFluids(const Simulator &simulator, DeferredLogger &deferred_logger)
Definition: MultisegmentWell_impl.hpp:703
void checkOperabilityUnderTHPLimit(const Simulator &ebos_simulator, const WellStateType &well_state, const WellGroupHelperType &wgHelper, DeferredLogger &deferred_logger) override
Definition: MultisegmentWell_impl.hpp:1472
void updatePrimaryVariables(const Simulator &simulator, const WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: MultisegmentWell_impl.hpp:157
EvalWell getSegmentSurfaceVolume(const Simulator &simulator, const int seg_idx, DeferredLogger &deferred_logger) const
Definition: MultisegmentWell_impl.hpp:2095
void calculateExplicitQuantities(const Simulator &simulator, const WellStateType &well_state, DeferredLogger &deferred_logger) override
Definition: MultisegmentWell_impl.hpp:761
void updateWellStateWithTarget(const Simulator &simulator, const WellGroupHelperType &wgHelper, WellStateType &well_state, DeferredLogger &deferred_logger) const override
updating the well state based the current control mode
Definition: MultisegmentWell_impl.hpp:184
EvalWell getQs(const int comp_idx) const
Returns scaled rate for a component.
Class encapsulating some information about parallel wells.
Definition: ParallelWellInfo.hpp:198
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.
Scalar mostStrictBhpFromBhpLimits(const SummaryState &summaryState) const
Obtain the most strict BHP from BHP limits.
Definition: WellGroupHelper.hpp:59
const GroupState< Scalar > & groupState() const
Definition: WellGroupHelper.hpp:183
const SummaryState & summaryState() const
Definition: WellGroupHelper.hpp:260
const WellState< Scalar, IndexTraits > & wellState() const
Definition: WellGroupHelper.hpp:312
WellStateGuard pushWellState(WellState< Scalar, IndexTraits > &well_state)
Definition: WellGroupHelper.hpp:198
Well well_ecl_
Definition: WellInterfaceGeneric.hpp:304
void onlyKeepBHPandTHPcontrols(const SummaryState &summary_state, WellStateType &well_state, Well::InjectionControls &inj_controls, Well::ProductionControls &prod_controls) const
FluidSystem::Scalar rsRvInj() const
void resetDampening()
Definition: WellInterfaceGeneric.hpp:247
std::pair< bool, bool > computeWellPotentials(std::vector< Scalar > &well_potentials, const WellStateType &well_state)
Definition: WellInterfaceIndices.hpp:34
Definition: WellInterface.hpp:77
static constexpr bool has_brine
Definition: WellInterface.hpp:122
GetPropType< TypeTag, Properties::Simulator > Simulator
Definition: WellInterface.hpp:82
typename WellInterfaceFluidSystem< FluidSystem >::RateConverterType RateConverterType
Definition: WellInterface.hpp:105
void getTransMult(Value &trans_mult, const Simulator &simulator, const int cell_idx, Callback &extendEval) const
Definition: WellInterface_impl.hpp:2072
Dune::BCRSMatrix< Opm::MatrixBlock< Scalar, 1, 1 > > PressureMatrix
Definition: WellInterface.hpp:98
void getMobility(const Simulator &simulator, const int local_perf_index, std::vector< Value > &mob, Callback &extendEval, DeferredLogger &deferred_logger) const
Definition: WellInterface_impl.hpp:2085
GetPropType< TypeTag, Properties::IntensiveQuantities > IntensiveQuantities
Definition: WellInterface.hpp:87
GetPropType< TypeTag, Properties::Scalar > Scalar
Definition: WellInterface.hpp:83
static constexpr bool has_watVapor
Definition: WellInterface.hpp:123
Dune::BlockVector< VectorBlockType > BVector
Definition: WellInterface.hpp:97
typename Base::ModelParameters ModelParameters
Definition: WellInterface.hpp:111
GetPropType< TypeTag, Properties::FluidSystem > FluidSystem
Definition: WellInterface.hpp:84
static constexpr bool has_foam
Definition: WellInterface.hpp:121
static constexpr bool has_micp
Definition: WellInterface.hpp:127
typename Base::Eval Eval
Definition: WellInterface.hpp:96
static constexpr bool has_energy
Definition: WellInterface.hpp:117
GetPropType< TypeTag, Properties::Indices > Indices
Definition: WellInterface.hpp:86
bool solveWellWithOperabilityCheck(const Simulator &simulator, const double dt, const Well::InjectionControls &inj_controls, const Well::ProductionControls &prod_controls, const WellGroupHelperType &wgHelper, WellStateType &well_state, DeferredLogger &deferred_logger)
Definition: WellInterface_impl.hpp:589
bool thp_update_iterations
Definition: WellInterface.hpp:379
GetPropType< TypeTag, Properties::SparseMatrixAdapter > SparseMatrixAdapter
Definition: WellInterface.hpp:89
Definition: WellProdIndexCalculator.hpp:37
Scalar connectionProdIndStandard(const std::size_t connIdx, const Scalar connMobility) const
Definition: WellState.hpp:66
const SingleWellState< Scalar, IndexTraits > & well(std::size_t well_index) const
Definition: WellState.hpp:290
@ 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_oil
Definition: PerforationData.hpp:44