From 7748418c086a5b9ef18c8941dce116c2b7229e05 Mon Sep 17 00:00:00 2001 From: Timo Koch <timo.koch@iws.uni-stuttgart.de> Date: Mon, 13 Apr 2020 19:32:12 +0200 Subject: [PATCH] [cleaup] Remove diffusioncoefficient deprecation helpers --- dumux/common/deprecated.hh | 78 ------------------- dumux/flux/box/fickslaw.hh | 11 +-- dumux/flux/box/maxwellstefanslaw.hh | 11 +-- dumux/flux/cctpfa/fickslaw.hh | 6 +- dumux/flux/cctpfa/maxwellstefanslaw.hh | 7 +- dumux/flux/staggered/freeflow/fickslaw.hh | 12 +-- .../staggered/freeflow/maxwellstefanslaw.hh | 10 +-- dumux/freeflow/compositional/iofields.hh | 12 +-- .../diffusivityconstanttortuosity.hh | 16 ---- .../diffusivitymillingtonquirk.hh | 20 ----- .../boundary/stokesdarcy/couplingdata.hh | 15 ++-- .../fluxvariablescachefiller.hh | 6 +- 12 files changed, 24 insertions(+), 180 deletions(-) diff --git a/dumux/common/deprecated.hh b/dumux/common/deprecated.hh index efffe14959..3e191a6891 100644 --- a/dumux/common/deprecated.hh +++ b/dumux/common/deprecated.hh @@ -25,12 +25,8 @@ #ifndef DUMUX_COMMON_DEPRECATED_HH #define DUMUX_COMMON_DEPRECATED_HH -#include <type_traits> - #include <dune/common/deprecated.hh> -#include <dumux/common/typetraits/isvalid.hh> - namespace Dumux { #ifndef DOXYGEN // hide from doxygen @@ -49,83 +45,9 @@ namespace Deprecated { /////////////////////////////////////////////////////////////// // Deprecation warnings for effective diffusion coefficients // /////////////////////////////////////////////////////////////// -constexpr auto hasEffDiffCoeffImpl = Dumux::isValid([](auto&& v) -> decltype(v.effectiveDiffusionCoefficient(0,0,0)){return 0;}); -template<class VolumeVariables> constexpr bool hasEffDiffCoeff = decltype(hasEffDiffCoeffImpl(std::declval<VolumeVariables>())){}; - -template<class EDL, class VV, - typename std::enable_if_t<!hasEffDiffCoeff<VV>, int> = 0> -[[deprecated("The volume variables class used does not have an effectiveDiffusionCoefficient(phaseIdx, compIIdx, compJIdx) function. " - "This will become mandatory after the 3.2 release! See e.g. the files /dumux/porousmediumflow/2p2c/volumevariables.hh " - "and /dumux/porousmediumflow/2p2c/properties.hh to see how this can be realized.")]] -decltype(EDL::effectiveDiffusionCoefficient(std::declval<VV>(), int(), int(), int())) -effectiveDiffusionCoefficient(const VV& volVars, int phaseIdx, int compIIdx, int compJIdx) -{ - return EDL::effectiveDiffusionCoefficient(volVars, phaseIdx, compIIdx, compJIdx); -} - -template<class EDL, class VV, - typename std::enable_if_t<hasEffDiffCoeff<VV>, int> = 0> -auto effectiveDiffusionCoefficient(const VV& volVars, int phaseIdx, int compIIdx, int compJIdx) -{ return volVars.effectiveDiffusionCoefficient(phaseIdx, compIIdx, compJIdx); } - - //////////////////// - // Maxwell Stefan // - //////////////////// - -template<class EDL, class FS, class VV, class P, class E, class SCV, - typename std::enable_if_t<hasEffDiffCoeff<VV>, int> = 0> -auto effectiveMSDiffusionCoefficient(const VV& volVars, - const int phaseIdx, - const int compIIdx, - const int compJIdx, - const P& problem, - const E& element, - const SCV& scv) -{ return volVars.effectiveDiffusionCoefficient(phaseIdx, compIIdx, compJIdx); } - -template<class EDL, class FS, class VV, class P, class E, class SCV, - typename std::enable_if_t<!hasEffDiffCoeff<VV>, int> = 0> -[[deprecated("The volume variables class used does not have an effectiveDiffusionCoefficient(phaseIdx, compIIdx, compJIdx) function. " - "This will become mandatory after the 3.2 release! See e.g. the files /dumux/porousmediumflow/2p2c/volumevariables.hh " - "and /dumux/porousmediumflow/2p2c/properties.hh to see how this can be realized.")]] -auto effectiveMSDiffusionCoefficient(const VV& volVars, - const int phaseIdx, - const int compIIdx, - const int compJIdx, - const P& problem, - const E& element, - const SCV& scv) -{ - auto tinInside = 0.0; - if constexpr (FS::isTracerFluidSystem()) - { - tinInside = FS::binaryDiffusionCoefficient(compIIdx, - compJIdx, - problem, - element, - scv); - } - else - { - auto fluidState = volVars.fluidState(); - typename FS::ParameterCache paramCache; - paramCache.updateAll(fluidState); - tinInside = FS::binaryDiffusionCoefficient(fluidState, - paramCache, - phaseIdx, - compIIdx, - compJIdx); - } - - return EDL::effectiveDiffusivity(volVars.porosity(), volVars.saturation(phaseIdx), tinInside); -} - -//////////////////////////////////////////////////////// -//////////////////////////////////////////////////////// } // end namespace Deprecated #endif } // end namespace Dumux - #endif diff --git a/dumux/flux/box/fickslaw.hh b/dumux/flux/box/fickslaw.hh index 0c0d46143c..6ff46447c4 100644 --- a/dumux/flux/box/fickslaw.hh +++ b/dumux/flux/box/fickslaw.hh @@ -30,7 +30,6 @@ #include <dumux/common/math.hh> #include <dumux/common/properties.hh> -#include <dumux/common/deprecated.hh> #include <dumux/discretization/method.hh> #include <dumux/flux/fickiandiffusioncoefficients.hh> @@ -181,17 +180,15 @@ private: { if constexpr (!FluidSystem::isTracerFluidSystem()) { - using EffDiffModel = GetPropType<TypeTag, Properties::EffectiveDiffusivityModel>; const auto mainCompIdx = FluidSystem::getMainComponent(phaseIdx); - const auto insideD = Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(insideVV, phaseIdx, mainCompIdx, compIdx); - const auto outsideD = Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(outsideVV, phaseIdx, mainCompIdx, compIdx); + const auto insideD = insideVV.effectiveDiffusionCoefficient(phaseIdx, mainCompIdx, compIdx); + const auto outsideD = outsideVV.effectiveDiffusionCoefficient(phaseIdx, mainCompIdx, compIdx); return { std::move(insideD), std::move(outsideD) }; } else { - using EffDiffModel = GetPropType<TypeTag, Properties::EffectiveDiffusivityModel>; - const auto insideD = Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(insideVV, 0, 0, compIdx); - const auto outsideD = Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(outsideVV, 0, 0, compIdx); + const auto insideD = insideVV.effectiveDiffusionCoefficient(0, 0, compIdx); + const auto outsideD = outsideVV.effectiveDiffusionCoefficient(0, 0, compIdx); return { std::move(insideD), std::move(outsideD) }; } } diff --git a/dumux/flux/box/maxwellstefanslaw.hh b/dumux/flux/box/maxwellstefanslaw.hh index 854a1222a1..c787c12b9b 100644 --- a/dumux/flux/box/maxwellstefanslaw.hh +++ b/dumux/flux/box/maxwellstefanslaw.hh @@ -28,7 +28,6 @@ #include <dune/common/float_cmp.hh> #include <dune/common/fmatrix.hh> -#include <dumux/common/deprecated.hh> #include <dumux/common/properties.hh> #include <dumux/common/parameters.hh> #include <dumux/discretization/method.hh> @@ -151,7 +150,6 @@ private: const ComponentFluxVector moleFrac, const Scalar avgMolarMass) { - using EffDiffModel = GetPropType<TypeTag, Properties::EffectiveDiffusivityModel>; ReducedComponentMatrix reducedDiffusionMatrix(0.0); const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; @@ -169,8 +167,8 @@ private: const auto xi = moleFrac[compIIdx]; const auto Mn = FluidSystem::molarMass(numComponents-1); - auto tinInside = Deprecated::template effectiveMSDiffusionCoefficient<EffDiffModel, FluidSystem>(insideVolVars, phaseIdx, compIIdx, numComponents-1, problem, element, fvGeometry.scv(insideScvIdx)); - auto tinOutside = Deprecated::template effectiveMSDiffusionCoefficient<EffDiffModel, FluidSystem>(outsideVolVars, phaseIdx, compIIdx, numComponents-1, problem, element, fvGeometry.scv(outsideScvIdx)); + auto tinInside = insideVolVars.effectiveDiffusionCoefficient(phaseIdx, compIIdx, numComponents-1); + auto tinOutside = outsideVolVars.effectiveDiffusionCoefficient(phaseIdx, compIIdx, numComponents-1); // scale by extrusion factor tinInside *= insideVolVars.extrusionFactor(); @@ -195,9 +193,8 @@ private: const auto Mj = FluidSystem::molarMass(compJIdx); // effective diffusion tensors - auto tijInside = Deprecated::template effectiveMSDiffusionCoefficient<EffDiffModel, FluidSystem>(insideVolVars, phaseIdx, compIIdx, compJIdx, problem, element, fvGeometry.scv(insideScvIdx)); - - auto tijOutside = Deprecated::template effectiveMSDiffusionCoefficient<EffDiffModel, FluidSystem>(outsideVolVars, phaseIdx, compIIdx, compJIdx, problem, element, fvGeometry.scv(outsideScvIdx)); + auto tijInside = insideVolVars.effectiveDiffusionCoefficient(phaseIdx, compIIdx, compJIdx); + auto tijOutside = outsideVolVars.effectiveDiffusionCoefficient(phaseIdx, compIIdx, compJIdx); // scale by extrusion factor tijInside *= insideVolVars.extrusionFactor(); diff --git a/dumux/flux/cctpfa/fickslaw.hh b/dumux/flux/cctpfa/fickslaw.hh index b1b13d12f6..853cf73f18 100644 --- a/dumux/flux/cctpfa/fickslaw.hh +++ b/dumux/flux/cctpfa/fickslaw.hh @@ -28,7 +28,6 @@ #include <dumux/common/parameters.hh> #include <dumux/common/properties.hh> -#include <dumux/common/deprecated.hh> #include <dumux/discretization/method.hh> #include <dumux/discretization/cellcentered/tpfa/computetransmissibility.hh> @@ -186,11 +185,10 @@ public: const auto& insideVolVars = elemVolVars[insideScvIdx]; const auto getDiffCoeff = [&](const auto& vv) { - using EffDiffModel = GetPropType<TypeTag, Properties::EffectiveDiffusivityModel>; if constexpr (FluidSystem::isTracerFluidSystem()) - return Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(vv, 0, 0, compIdx); + return vv.effectiveDiffusionCoefficient(0, 0, compIdx); else - return Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(vv, phaseIdx, FluidSystem::getMainComponent(phaseIdx), compIdx); + return vv.effectiveDiffusionCoefficient(phaseIdx, FluidSystem::getMainComponent(phaseIdx), compIdx); }; const auto insideD = getDiffCoeff(insideVolVars); diff --git a/dumux/flux/cctpfa/maxwellstefanslaw.hh b/dumux/flux/cctpfa/maxwellstefanslaw.hh index 47aa4f1026..58acfa43fd 100644 --- a/dumux/flux/cctpfa/maxwellstefanslaw.hh +++ b/dumux/flux/cctpfa/maxwellstefanslaw.hh @@ -28,7 +28,6 @@ #include <dune/common/fmatrix.hh> #include <dune/common/float_cmp.hh> -#include <dumux/common/deprecated.hh> #include <dumux/common/properties.hh> #include <dumux/common/parameters.hh> @@ -52,7 +51,6 @@ class MaxwellStefansLawImplementation<TypeTag, DiscretizationMethod::cctpfa, ref { using Scalar = GetPropType<TypeTag, Properties::Scalar>; using Problem = GetPropType<TypeTag, Properties::Problem>; - using EffDiffModel = GetPropType<TypeTag, Properties::EffectiveDiffusivityModel>; using FVElementGeometry = typename GetPropType<TypeTag, Properties::GridGeometry>::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; @@ -218,7 +216,6 @@ private: const SubControlVolume& scv, const int phaseIdx) { - using EffDiffModel = GetPropType<TypeTag, Properties::EffectiveDiffusivityModel>; ReducedComponentMatrix reducedDiffusionMatrix(0.0); //this is to not devide by 0 if the saturation in 0 and the effectiveDiffusionCoefficient becomes zero due to that @@ -232,7 +229,7 @@ private: const auto xi = volVars.moleFraction(phaseIdx, compIIdx); const auto Mn = FluidSystem::molarMass(numComponents-1); - Scalar tin = Deprecated::template effectiveMSDiffusionCoefficient<EffDiffModel, FluidSystem>(volVars, phaseIdx, compIIdx, numComponents-1, problem, element, scv); + Scalar tin = volVars.effectiveDiffusionCoefficient(phaseIdx, compIIdx, numComponents-1); // set the entries of the diffusion matrix of the diagonal reducedDiffusionMatrix[compIIdx][compIIdx] += xi*avgMolarMass/(tin*Mn); @@ -247,7 +244,7 @@ private: const auto xj = volVars.moleFraction(phaseIdx, compJIdx); const auto Mi = FluidSystem::molarMass(compIIdx); const auto Mj = FluidSystem::molarMass(compJIdx); - Scalar tij = Deprecated::template effectiveMSDiffusionCoefficient<EffDiffModel, FluidSystem>(volVars, phaseIdx, compIIdx, compJIdx, problem, element, scv); + Scalar tij = volVars.effectiveDiffusionCoefficient(phaseIdx, compIIdx, compJIdx); reducedDiffusionMatrix[compIIdx][compIIdx] += xj*avgMolarMass/(tij*Mi); if (compJIdx < numComponents-1) diff --git a/dumux/flux/staggered/freeflow/fickslaw.hh b/dumux/flux/staggered/freeflow/fickslaw.hh index 0e9ce6afc8..7e624db4d1 100644 --- a/dumux/flux/staggered/freeflow/fickslaw.hh +++ b/dumux/flux/staggered/freeflow/fickslaw.hh @@ -28,7 +28,6 @@ #include <numeric> #include <dune/common/fvector.hh> -#include <dumux/common/deprecated.hh> #include <dumux/common/properties.hh> #include <dumux/common/parameters.hh> #include <dumux/common/math.hh> @@ -149,16 +148,9 @@ public: private: static Scalar getEffectiveDiffusionCoefficient_(const VolumeVariables& volVars, const int phaseIdx, const int compIdx) { - if constexpr (Dumux::Deprecated::hasEffDiffCoeff<VolumeVariables>) - return volVars.effectiveDiffusionCoefficient(phaseIdx, - VolumeVariables::FluidSystem::getMainComponent(phaseIdx), compIdx); - else - { - // TODO: remove this else clause after release 3.2! - return volVars.effectiveDiffusivity(phaseIdx, compIdx); - } + return volVars.effectiveDiffusionCoefficient(phaseIdx, FluidSystem::getMainComponent(phaseIdx), compIdx); } }; -} // end namespace +} // end namespace Dumux #endif diff --git a/dumux/flux/staggered/freeflow/maxwellstefanslaw.hh b/dumux/flux/staggered/freeflow/maxwellstefanslaw.hh index e901f96965..88995660df 100644 --- a/dumux/flux/staggered/freeflow/maxwellstefanslaw.hh +++ b/dumux/flux/staggered/freeflow/maxwellstefanslaw.hh @@ -26,7 +26,6 @@ #include <dune/common/fmatrix.hh> -#include <dumux/common/deprecated.hh> #include <dumux/common/properties.hh> #include <dumux/common/parameters.hh> #include <dumux/discretization/method.hh> @@ -246,14 +245,7 @@ private: static Scalar getEffectiveDiffusionCoefficient_(const VolumeVariables& volVars, const int phaseIdx, const int compIdx) { - if constexpr (Dumux::Deprecated::hasEffDiffCoeff<VolumeVariables>) - return volVars.effectiveDiffusionCoefficient(phaseIdx, - VolumeVariables::FluidSystem::getMainComponent(phaseIdx), compIdx); - else - { - // TODO: remove this else clause after release 3.2! - return volVars.effectiveDiffusivity(phaseIdx, compIdx); - } + return volVars.effectiveDiffusionCoefficient(phaseIdx, FluidSystem::getMainComponent(phaseIdx), compIdx); } }; } // end namespace diff --git a/dumux/freeflow/compositional/iofields.hh b/dumux/freeflow/compositional/iofields.hh index da2552d313..631a8055dd 100644 --- a/dumux/freeflow/compositional/iofields.hh +++ b/dumux/freeflow/compositional/iofields.hh @@ -25,7 +25,6 @@ #define DUMUX_FREEFLOW_NC_IO_FIELDS_HH #include <dumux/io/name.hh> -#include <dumux/common/deprecated.hh> #include <dumux/freeflow/navierstokes/iofields.hh> namespace Dumux { @@ -79,17 +78,8 @@ struct FreeflowNCIOFields template<class VolumeVariables> static double getEffectiveDiffusionCoefficient_(const VolumeVariables& volVars, const int phaseIdx, const int compIdx) { - if constexpr (Dumux::Deprecated::hasEffDiffCoeff<VolumeVariables>) - return volVars.effectiveDiffusionCoefficient(phaseIdx, - VolumeVariables::FluidSystem::getMainComponent(phaseIdx), compIdx); - else - { - // TODO: remove this else clause after release 3.2! - return volVars.effectiveDiffusivity(phaseIdx, compIdx); - } + return volVars.effectiveDiffusionCoefficient(phaseIdx, VolumeVariables::FluidSystem::getMainComponent(phaseIdx), compIdx); } - - }; } // end namespace Dumux diff --git a/dumux/material/fluidmatrixinteractions/diffusivityconstanttortuosity.hh b/dumux/material/fluidmatrixinteractions/diffusivityconstanttortuosity.hh index 292bee588b..df2b9c7085 100644 --- a/dumux/material/fluidmatrixinteractions/diffusivityconstanttortuosity.hh +++ b/dumux/material/fluidmatrixinteractions/diffusivityconstanttortuosity.hh @@ -48,22 +48,6 @@ template<class Scalar> class DiffusivityConstantTortuosity { public: - /*! - * \brief Returns the effective diffusion coefficient \f$\mathrm{[m^2/s]}\f$ based - * on a constant tortuosity value - * \param porosity The porosity - * \param saturation The saturation of the wetting phase - * \param diffCoeff The diffusion coefficient of the phase in \f$\mathrm{[m^2/s]}\f$ - */ - [[deprecated("Signature deprecated. Use effectiveDiffusionCoefficient(volvars, phaseIdx, comp1dxI, compIdxJ)!")]] - static Scalar effectiveDiffusivity(const Scalar porosity, - const Scalar saturation, - const Scalar diffCoeff) - { - static const Scalar tau = getParam<Scalar>("SpatialParams.Tortuosity", 0.5); - return porosity * saturation * tau * diffCoeff; - } - /*! * \brief Returns the effective diffusion coefficient \f$\mathrm{[m^2/s]}\f$ based * on a constant tortuosity value diff --git a/dumux/material/fluidmatrixinteractions/diffusivitymillingtonquirk.hh b/dumux/material/fluidmatrixinteractions/diffusivitymillingtonquirk.hh index 3255db5353..586d42ee7f 100644 --- a/dumux/material/fluidmatrixinteractions/diffusivitymillingtonquirk.hh +++ b/dumux/material/fluidmatrixinteractions/diffusivitymillingtonquirk.hh @@ -50,26 +50,6 @@ template<class Scalar> class DiffusivityMillingtonQuirk { public: - /*! - * \brief Returns the effective diffusion coefficient \f$\mathrm{[m^2/s]}\f$ after Millington Quirk. - * - * \param porosity The porosity - * \param saturation The saturation of the phase - * \param diffCoeff The diffusion coefficient of the phase \f$\mathrm{[m^2/s]}\f$ - */ - [[deprecated("Signature deprecated. Use effectiveDiffusionCoefficient(volvars, phaseIdx, comp1dxI, compIdxJ)!")]] - static Scalar effectiveDiffusivity(const Scalar porosity, - const Scalar saturation, - const Scalar diffCoeff) - { - // instead of D_eff,pm = phi * Sw * 1/phi^2 * (phi * Sw)^(7/3) * D - // we calculate the more efficient - // D_eff,pm = phi * Sw^3 * cubicroot(phi * Sw) * D - - using std::cbrt; - return porosity * (saturation*saturation*saturation) * cbrt(porosity * saturation) * diffCoeff; - } - /*! * \brief Returns the effective diffusion coefficient \f$\mathrm{[m^2/s]}\f$ after Millington Quirk. * diff --git a/dumux/multidomain/boundary/stokesdarcy/couplingdata.hh b/dumux/multidomain/boundary/stokesdarcy/couplingdata.hh index ac5faf111f..bad04682ea 100644 --- a/dumux/multidomain/boundary/stokesdarcy/couplingdata.hh +++ b/dumux/multidomain/boundary/stokesdarcy/couplingdata.hh @@ -33,7 +33,6 @@ #include <dumux/discretization/cellcentered/tpfa/computetransmissibility.hh> #include <dumux/flux/referencesystemformulation.hh> #include <dumux/multidomain/couplingmanager.hh> -#include <dumux/common/deprecated.hh> namespace Dumux { @@ -911,7 +910,6 @@ protected: const VolumeVariables<i>& volVarsI, const VolumeVariables<j>& volVarsJ) const { - using EffDiffModel = GetPropType<SubDomainTypeTag<darcyIdx>, Properties::EffectiveDiffusivityModel>; NumEqVector diffusiveFlux(0.0); const Scalar insideDistance = this->getDistance_(scvI, scvfI); @@ -950,7 +948,7 @@ protected: const Scalar xk = volVarsI.moleFraction(couplingPhaseIdx(domainI), domainICompKIdx); const Scalar avgMolarMass = volVarsI.averageMolarMass(couplingPhaseIdx(domainI)); const Scalar Mn = FluidSystem<i>::molarMass(numComponents-1); - const Scalar tkn = Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(volVarsI, couplingPhaseIdx(domainI), domainICompKIdx, couplingCompIdx(domainI, numComponents-1)); + const Scalar tkn = volVarsI.effectiveDiffusionCoefficient(couplingPhaseIdx(domainI), domainICompKIdx, couplingCompIdx(domainI, numComponents-1)); // set the entries of the diffusion matrix of the diagonal reducedDiffusionMatrixInside[domainICompKIdx][domainICompKIdx] += xk*avgMolarMass/(tkn*Mn); @@ -966,7 +964,7 @@ protected: const Scalar xl = volVarsI.moleFraction(couplingPhaseIdx(domainI), domainICompLIdx); const Scalar Mk = FluidSystem<i>::molarMass(domainICompKIdx); const Scalar Ml = FluidSystem<i>::molarMass(domainICompLIdx); - const Scalar tkl = Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(volVarsI, couplingPhaseIdx(domainI), domainICompKIdx, domainICompLIdx); + const Scalar tkl = volVarsI.effectiveDiffusionCoefficient(couplingPhaseIdx(domainI), domainICompKIdx, domainICompLIdx); reducedDiffusionMatrixInside[domainICompKIdx][domainICompKIdx] += xl*avgMolarMass/(tkl*Mk); reducedDiffusionMatrixInside[domainICompKIdx][domainICompLIdx] += xk*(avgMolarMass/(tkn*Mn) - avgMolarMass/(tkl*Ml)); } @@ -980,7 +978,7 @@ protected: const Scalar xk = volVarsJ.moleFraction(couplingPhaseIdx(domainJ), domainJCompKIdx); const Scalar avgMolarMass = volVarsJ.averageMolarMass(couplingPhaseIdx(domainJ)); const Scalar Mn = FluidSystem<j>::molarMass(numComponents-1); - const Scalar tkn = Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(volVarsJ, couplingPhaseIdx(domainJ), domainJCompKIdx, couplingCompIdx(domainJ, numComponents-1)); + const Scalar tkn = volVarsJ.effectiveDiffusionCoefficient(couplingPhaseIdx(domainJ), domainJCompKIdx, couplingCompIdx(domainJ, numComponents-1)); // set the entries of the diffusion matrix of the diagonal reducedDiffusionMatrixOutside[domainICompKIdx][domainICompKIdx] += xk*avgMolarMass/(tkn*Mn); @@ -997,7 +995,7 @@ protected: const Scalar xl = volVarsJ.moleFraction(couplingPhaseIdx(domainJ), domainJCompLIdx); const Scalar Mk = FluidSystem<j>::molarMass(domainJCompKIdx); const Scalar Ml = FluidSystem<j>::molarMass(domainJCompLIdx); - const Scalar tkl = Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(volVarsJ, couplingPhaseIdx(domainJ), domainJCompKIdx, domainJCompLIdx); + const Scalar tkl = volVarsJ.effectiveDiffusionCoefficient(couplingPhaseIdx(domainJ), domainJCompKIdx, domainJCompLIdx); reducedDiffusionMatrixOutside[domainICompKIdx][domainICompKIdx] += xl*avgMolarMass/(tkl*Mk); reducedDiffusionMatrixOutside[domainICompKIdx][domainICompLIdx] += xk*(avgMolarMass/(tkn*Mn) - avgMolarMass/(tkl*Ml)); } @@ -1051,7 +1049,6 @@ protected: const VolumeVariables<j>& volVarsJ, const DiffusionCoefficientAveragingType diffCoeffAvgType) const { - using EffDiffModel = GetPropType<SubDomainTypeTag<darcyIdx>, Properties::EffectiveDiffusivityModel>; NumEqVector diffusiveFlux(0.0); const Scalar rhoInside = massOrMolarDensity(volVarsI, referenceSystemFormulation, couplingPhaseIdx(domainI)); @@ -1078,8 +1075,8 @@ protected: domainJ, insideDistance, outsideDistance, - Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(volVarsI, couplingPhaseIdx(domainI), domainIMainCompIdx, domainICompIdx), - Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(volVarsJ, couplingPhaseIdx(domainJ), domainJMainCompIdx, domainJCompIdx), + volVarsI.effectiveDiffusionCoefficient(couplingPhaseIdx(domainI), domainIMainCompIdx, domainICompIdx), + volVarsJ.effectiveDiffusionCoefficient(couplingPhaseIdx(domainJ), domainJMainCompIdx, domainJCompIdx), diffCoeffAvgType); diffusiveFlux[domainICompIdx] += -avgDensity * tij * deltaMassOrMoleFrac; } diff --git a/dumux/porousmediumflow/fluxvariablescachefiller.hh b/dumux/porousmediumflow/fluxvariablescachefiller.hh index 5afe55fbc5..336dabc582 100644 --- a/dumux/porousmediumflow/fluxvariablescachefiller.hh +++ b/dumux/porousmediumflow/fluxvariablescachefiller.hh @@ -26,7 +26,6 @@ #include <dumux/common/properties.hh> #include <dumux/common/parameters.hh> -#include <dumux/common/deprecated.hh> #include <dumux/discretization/method.hh> #include <dumux/flux/referencesystemformulation.hh> @@ -607,7 +606,6 @@ private: handle.diffusionHandle().setComponentIndex(compIdx); using DiffusionType = GetPropType<TypeTag, Properties::MolecularDiffusionType>; - using EffDiffModel = GetPropType<TypeTag, Properties::EffectiveDiffusivityModel>; // get instance of the interaction volume-local assembler using Traits = typename InteractionVolume::Traits; @@ -621,9 +619,9 @@ private: const auto getD = [phaseIdx, compIdx] (const auto& volVars) { if constexpr (FluidSystem::isTracerFluidSystem()) - return Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(volVars, 0, 0, compIdx); + return volVars.effectiveDiffusionCoefficient(0, 0, compIdx); else - return Deprecated::template effectiveDiffusionCoefficient<EffDiffModel>(volVars, phaseIdx, FluidSystem::getMainComponent(phaseIdx), compIdx); + return volVars.effectiveDiffusionCoefficient(phaseIdx, FluidSystem::getMainComponent(phaseIdx), compIdx); }; // Effective diffusion coefficients might get zero if saturation = 0. -- GitLab