From 01bc7ea01fb013522b09d193574db34a8aa76836 Mon Sep 17 00:00:00 2001 From: Mathis Kelm <mathis.kelm@iws.uni-stuttgart.de> Date: Wed, 28 Oct 2020 11:04:00 +0100 Subject: [PATCH] [cleanup] Consistent spelling of nonwetting/Nonwetting --- .../nonequilibrium/thermal/localresidual.hh | 16 ++--- .../nonequilibrium/volumevariables.hh | 26 +++---- .../porousmediumflow/richards/newtonsolver.hh | 2 +- .../richards/volumevariables.hh | 16 ++--- .../richardsnc/volumevariables.hh | 4 +- .../1d3d/1p2c_richards2c/problem_soil.hh | 4 +- .../embedded/1d3d/1p_richards/problem_soil.hh | 2 +- .../chemicalnonequilibrium/params.input | 6 +- .../chemicalnonequilibrium/spatialparams.hh | 28 ++++---- .../mpnc/implicit/kinetic/params.input | 12 ++-- .../mpnc/implicit/kinetic/spatialparams.hh | 72 +++++++++---------- .../richards/implicit/analytical/problem.hh | 2 +- .../richards/implicit/lens/problem.hh | 4 +- .../nonisothermal/conduction/problem.hh | 2 +- .../nonisothermal/convection/problem.hh | 2 +- .../nonisothermal/evaporation/problem.hh | 2 +- .../richardsnc/implicit/problem.hh | 4 +- 17 files changed, 102 insertions(+), 102 deletions(-) diff --git a/dumux/porousmediumflow/nonequilibrium/thermal/localresidual.hh b/dumux/porousmediumflow/nonequilibrium/thermal/localresidual.hh index 8647db84e4..0921205728 100644 --- a/dumux/porousmediumflow/nonequilibrium/thermal/localresidual.hh +++ b/dumux/porousmediumflow/nonequilibrium/thermal/localresidual.hh @@ -325,12 +325,12 @@ public: const Scalar Ts = volVars.temperatureSolid(); const Scalar lambdaWetting = volVars.fluidThermalConductivity(phase0Idx); - const Scalar lambdaNonWetting = volVars.fluidThermalConductivity(phase1Idx); + const Scalar lambdaNonwetting = volVars.fluidThermalConductivity(phase1Idx); const Scalar lambdaSolid = volVars.solidThermalConductivity(); - const Scalar lambdaWN = harmonicMean(lambdaWetting, lambdaNonWetting); + const Scalar lambdaWN = harmonicMean(lambdaWetting, lambdaNonwetting); const Scalar lambdaWS = harmonicMean(lambdaWetting, lambdaSolid); - const Scalar lambdaNS = harmonicMean(lambdaNonWetting, lambdaSolid); + const Scalar lambdaNS = harmonicMean(lambdaNonwetting, lambdaSolid); const Scalar characteristicLength = volVars.characteristicLength() ; const Scalar factorEnergyTransfer = volVars.factorEnergyTransfer() ; @@ -339,22 +339,22 @@ public: const Scalar nusseltWS = volVars.nusseltNumber(phase0Idx); const Scalar nusseltNS = volVars.nusseltNumber(phase1Idx); - const Scalar wettingToNonWettingEnergyExchange = factorEnergyTransfer * (Tw - Tn) / characteristicLength * awn * lambdaWN * nusseltWN ; + const Scalar wettingToNonwettingEnergyExchange = factorEnergyTransfer * (Tw - Tn) / characteristicLength * awn * lambdaWN * nusseltWN ; const Scalar wettingToSolidEnergyExchange = factorEnergyTransfer * (Tw - Ts) / characteristicLength * aws * lambdaWS * nusseltWS ; - const Scalar nonWettingToSolidEnergyExchange = factorEnergyTransfer * (Tn - Ts) / characteristicLength * ans * lambdaNS * nusseltNS ; + const Scalar nonwettingToSolidEnergyExchange = factorEnergyTransfer * (Tn - Ts) / characteristicLength * ans * lambdaNS * nusseltNS ; for(int phaseIdx = 0; phaseIdx < numEnergyEqFluid+numEnergyEqSolid; ++phaseIdx) { switch (phaseIdx) { case phase0Idx: - source[energyEq0Idx + phaseIdx] += ( - wettingToNonWettingEnergyExchange - wettingToSolidEnergyExchange); + source[energyEq0Idx + phaseIdx] += ( - wettingToNonwettingEnergyExchange - wettingToSolidEnergyExchange); break; case phase1Idx: - source[energyEq0Idx + phaseIdx] += (+ wettingToNonWettingEnergyExchange - nonWettingToSolidEnergyExchange); + source[energyEq0Idx + phaseIdx] += (+ wettingToNonwettingEnergyExchange - nonwettingToSolidEnergyExchange); break; case sPhaseIdx: - source[energyEq0Idx + phaseIdx] += (+ wettingToSolidEnergyExchange + nonWettingToSolidEnergyExchange); + source[energyEq0Idx + phaseIdx] += (+ wettingToSolidEnergyExchange + nonwettingToSolidEnergyExchange); break; default: DUNE_THROW(Dune::NotImplemented, diff --git a/dumux/porousmediumflow/nonequilibrium/volumevariables.hh b/dumux/porousmediumflow/nonequilibrium/volumevariables.hh index 116a5617fa..44efcdcdae 100644 --- a/dumux/porousmediumflow/nonequilibrium/volumevariables.hh +++ b/dumux/porousmediumflow/nonequilibrium/volumevariables.hh @@ -180,20 +180,20 @@ public: const auto& materialParams = problem.spatialParams().materialLawParams(element, scv, elemSol); //obtain parameters for interfacial area constitutive relations - const auto& aWettingNonWettingSurfaceParams = problem.spatialParams().aWettingNonWettingSurfaceParams(element, scv, elemSol); + const auto& aWettingNonwettingSurfaceParams = problem.spatialParams().aWettingNonwettingSurfaceParams(element, scv, elemSol); const Scalar pc = fluidState.pressure(phase1Idx) - fluidState.pressure(phase0Idx); const Scalar Sw = fluidState.saturation(phase0Idx); using AwnSurface = typename Problem::SpatialParams::AwnSurface; - const auto awn = AwnSurface::interfacialArea(aWettingNonWettingSurfaceParams, materialParams, Sw, pc); + const auto awn = AwnSurface::interfacialArea(aWettingNonwettingSurfaceParams, materialParams, Sw, pc); interfacialArea_[phase0Idx][phase1Idx] = awn; interfacialArea_[phase1Idx][phase0Idx] = interfacialArea_[phase0Idx][phase1Idx]; interfacialArea_[phase0Idx][phase0Idx] = 0.; using AnsSurface = typename Problem::SpatialParams::AnsSurface; - const auto& aNonWettingSolidSurfaceParams = problem.spatialParams().aNonWettingSolidSurfaceParams(element, scv, elemSol); - const auto ans = AnsSurface::interfacialArea(aNonWettingSolidSurfaceParams, materialParams, Sw, pc); + const auto& aNonwettingSolidSurfaceParams = problem.spatialParams().aNonwettingSolidSurfaceParams(element, scv, elemSol); + const auto ans = AnsSurface::interfacialArea(aNonwettingSolidSurfaceParams, materialParams, Sw, pc); // Switch for using a a_{wn} relations that has some "maximum capillary pressure" as parameter // That value is obtained by regularization of the pc(Sw) function. @@ -201,8 +201,8 @@ public: if (computeAwsFromAnsAndPcMax) { // I know the solid surface from the pore network. But it is more consistent to use the fit value. - const Scalar pcMax = aWettingNonWettingSurfaceParams.pcMax(); - const auto solidSurface = AnsSurface::interfacialArea(aNonWettingSolidSurfaceParams, materialParams, /*Sw=*/0., pcMax); + const Scalar pcMax = aWettingNonwettingSurfaceParams.pcMax(); + const auto solidSurface = AnsSurface::interfacialArea(aNonwettingSolidSurfaceParams, materialParams, /*Sw=*/0., pcMax); interfacialArea_[phase0Idx][sPhaseIdx] = solidSurface - ans; } else @@ -536,7 +536,7 @@ public: const Scv& scv) { // obtain parameters for awnsurface and material law - const auto& awnSurfaceParams = problem.spatialParams().aWettingNonWettingSurfaceParams(element, scv, elemSol) ; + const auto& awnSurfaceParams = problem.spatialParams().aWettingNonwettingSurfaceParams(element, scv, elemSol) ; const auto& materialParams = problem.spatialParams().materialLawParams(element, scv, elemSol) ; const auto Sw = fluidState.saturation(phase0Idx) ; @@ -724,20 +724,20 @@ public: const auto& materialParams = problem.spatialParams().materialLawParams(element, scv, elemSol); //obtain parameters for interfacial area constitutive relations - const auto& aWettingNonWettingSurfaceParams = problem.spatialParams().aWettingNonWettingSurfaceParams(element, scv, elemSol); + const auto& aWettingNonwettingSurfaceParams = problem.spatialParams().aWettingNonwettingSurfaceParams(element, scv, elemSol); const Scalar pc = fluidState.pressure(phase1Idx) - fluidState.pressure(phase0Idx); const Scalar Sw = fluidState.saturation(phase0Idx); using AwnSurface = typename Problem::SpatialParams::AwnSurface; - const auto awn = AwnSurface::interfacialArea(aWettingNonWettingSurfaceParams, materialParams, Sw, pc); + const auto awn = AwnSurface::interfacialArea(aWettingNonwettingSurfaceParams, materialParams, Sw, pc); interfacialArea_[phase0Idx][phase1Idx] = awn; interfacialArea_[phase1Idx][phase0Idx] = interfacialArea_[phase0Idx][phase1Idx]; interfacialArea_[phase0Idx][phase0Idx] = 0.; using AnsSurface = typename Problem::SpatialParams::AnsSurface; - const auto& aNonWettingSolidSurfaceParams = problem.spatialParams().aNonWettingSolidSurfaceParams(element, scv, elemSol); - const auto ans = AnsSurface::interfacialArea(aNonWettingSolidSurfaceParams, materialParams, Sw, pc); + const auto& aNonwettingSolidSurfaceParams = problem.spatialParams().aNonwettingSolidSurfaceParams(element, scv, elemSol); + const auto ans = AnsSurface::interfacialArea(aNonwettingSolidSurfaceParams, materialParams, Sw, pc); // Switch for using a a_{wn} relations that has some "maximum capillary pressure" as parameter. // That value is obtained by regularization of the pc(Sw) function. @@ -745,8 +745,8 @@ public: if (computeAwsFromAnsAndPcMax) { // I know the solid surface from the pore network. But it is more consistent to use the fit value. - const Scalar pcMax = aWettingNonWettingSurfaceParams.pcMax(); - const auto solidSurface = AnsSurface::interfacialArea(aNonWettingSolidSurfaceParams, materialParams, /*Sw=*/0., pcMax); + const Scalar pcMax = aWettingNonwettingSurfaceParams.pcMax(); + const auto solidSurface = AnsSurface::interfacialArea(aNonwettingSolidSurfaceParams, materialParams, /*Sw=*/0., pcMax); interfacialArea_[phase0Idx][sPhaseIdx] = solidSurface - ans; } else diff --git a/dumux/porousmediumflow/richards/newtonsolver.hh b/dumux/porousmediumflow/richards/newtonsolver.hh index 421f3783d8..fd3e9dbbd5 100644 --- a/dumux/porousmediumflow/richards/newtonsolver.hh +++ b/dumux/porousmediumflow/richards/newtonsolver.hh @@ -90,7 +90,7 @@ private: const Scalar pcMin = MaterialLaw::pc(materialLawParams, 1.0); const Scalar pw = uLastIter[dofIdxGlobal][pressureIdx]; using std::max; - const Scalar pn = max(this->assembler().problem().nonWettingReferencePressure(), pw + pcMin); + const Scalar pn = max(this->assembler().problem().nonwettingReferencePressure(), pw + pcMin); const Scalar pcOld = pn - pw; const Scalar SwOld = max(0.0, MaterialLaw::sw(materialLawParams, pcOld)); diff --git a/dumux/porousmediumflow/richards/volumevariables.hh b/dumux/porousmediumflow/richards/volumevariables.hh index bba813fb30..ae661d9a27 100644 --- a/dumux/porousmediumflow/richards/volumevariables.hh +++ b/dumux/porousmediumflow/richards/volumevariables.hh @@ -141,14 +141,14 @@ public: const Scalar pc = MaterialLaw::pc(materialParams, 0.0); // set the wetting pressure - fluidState_.setPressure(FluidSystem::liquidPhaseIdx, problem.nonWettingReferencePressure() - pc); - fluidState_.setPressure(FluidSystem::gasPhaseIdx, problem.nonWettingReferencePressure()); + fluidState_.setPressure(FluidSystem::liquidPhaseIdx, problem.nonwettingReferencePressure() - pc); + fluidState_.setPressure(FluidSystem::gasPhaseIdx, problem.nonwettingReferencePressure()); // set molar densities if (enableWaterDiffusionInAir()) { molarDensity_[FluidSystem::liquidPhaseIdx] = FluidSystem::H2O::liquidDensity(temperature(), pressure(FluidSystem::liquidPhaseIdx))/FluidSystem::H2O::molarMass(); - molarDensity_[FluidSystem::gasPhaseIdx] = IdealGas<Scalar>::molarDensity(temperature(), problem.nonWettingReferencePressure()); + molarDensity_[FluidSystem::gasPhaseIdx] = IdealGas<Scalar>::molarDensity(temperature(), problem.nonwettingReferencePressure()); } // density and viscosity @@ -176,10 +176,10 @@ public: if (enableWaterDiffusionInAir()) { molarDensity_[FluidSystem::liquidPhaseIdx] = FluidSystem::H2O::liquidDensity(temperature(), pressure(FluidSystem::liquidPhaseIdx))/FluidSystem::H2O::molarMass(); - molarDensity_[FluidSystem::gasPhaseIdx] = IdealGas<Scalar>::molarDensity(temperature(), problem.nonWettingReferencePressure()); + molarDensity_[FluidSystem::gasPhaseIdx] = IdealGas<Scalar>::molarDensity(temperature(), problem.nonwettingReferencePressure()); moleFraction_[FluidSystem::liquidPhaseIdx] = 1.0; - moleFraction_[FluidSystem::gasPhaseIdx] = FluidSystem::H2O::vaporPressure(temperature()) / problem.nonWettingReferencePressure(); + moleFraction_[FluidSystem::gasPhaseIdx] = FluidSystem::H2O::vaporPressure(temperature()) / problem.nonwettingReferencePressure(); const auto averageMolarMassGasPhase = (moleFraction_[FluidSystem::gasPhaseIdx]*FluidSystem::molarMass(FluidSystem::liquidPhaseIdx)) + ((1-moleFraction_[FluidSystem::gasPhaseIdx])*FluidSystem::molarMass(FluidSystem::gasPhaseIdx)); @@ -201,7 +201,7 @@ public: if (enableWaterDiffusionInAir()) { molarDensity_[FluidSystem::liquidPhaseIdx] = FluidSystem::H2O::liquidDensity(temperature(), pressure(FluidSystem::liquidPhaseIdx))/FluidSystem::H2O::molarMass(); - molarDensity_[FluidSystem::gasPhaseIdx] = IdealGas<Scalar>::molarDensity(temperature(), problem.nonWettingReferencePressure()); + molarDensity_[FluidSystem::gasPhaseIdx] = IdealGas<Scalar>::molarDensity(temperature(), problem.nonwettingReferencePressure()); moleFraction_[FluidSystem::liquidPhaseIdx] = 1.0; moleFraction_[FluidSystem::gasPhaseIdx] = 0.0; massFraction_[FluidSystem::liquidPhaseIdx] = 1.0; @@ -254,14 +254,14 @@ public: using MaterialLaw = typename Problem::SpatialParams::MaterialLaw; Scalar minPc = MaterialLaw::pc(materialParams, 1.0); fluidState.setPressure(FluidSystem::liquidPhaseIdx, priVars[Indices::pressureIdx]); - fluidState.setPressure(FluidSystem::gasPhaseIdx, max(problem.nonWettingReferencePressure(), fluidState.pressure(FluidSystem::liquidPhaseIdx) + minPc)); + fluidState.setPressure(FluidSystem::gasPhaseIdx, max(problem.nonwettingReferencePressure(), fluidState.pressure(FluidSystem::liquidPhaseIdx) + minPc)); // compute the capillary pressure to compute the saturation // make sure that we the capillary pressure is not smaller than the minimum pc // this would possibly return unphysical values from regularized material laws using std::max; const Scalar pc = max(MaterialLaw::endPointPc(materialParams), - problem.nonWettingReferencePressure() - fluidState.pressure(FluidSystem::liquidPhaseIdx)); + problem.nonwettingReferencePressure() - fluidState.pressure(FluidSystem::liquidPhaseIdx)); const Scalar sw = MaterialLaw::sw(materialParams, pc); fluidState.setSaturation(FluidSystem::liquidPhaseIdx, sw); fluidState.setSaturation(FluidSystem::gasPhaseIdx, 1.0-sw); diff --git a/dumux/porousmediumflow/richardsnc/volumevariables.hh b/dumux/porousmediumflow/richardsnc/volumevariables.hh index 0463346001..6e08db301a 100644 --- a/dumux/porousmediumflow/richardsnc/volumevariables.hh +++ b/dumux/porousmediumflow/richardsnc/volumevariables.hh @@ -100,7 +100,7 @@ public: // precompute the minimum capillary pressure (entry pressure) // needed to make sure we don't compute unphysical capillary pressures and thus saturations minPc_ = MaterialLaw::endPointPc(materialParams); - pn_ = problem.nonWettingReferencePressure(); + pn_ = problem.nonwettingReferencePressure(); //porosity updateSolidVolumeFractions(elemSol, problem, element, scv, solidState_, ParentType::numFluidComponents()); EnergyVolVars::updateSolidEnergyParams(elemSol, problem, element, scv, solidState_); @@ -162,7 +162,7 @@ public: using std::max; using MaterialLaw = typename Problem::SpatialParams::MaterialLaw; const Scalar pc = max(MaterialLaw::endPointPc(materialParams), - problem.nonWettingReferencePressure() - fluidState.pressure(0)); + problem.nonwettingReferencePressure() - fluidState.pressure(0)); const Scalar sw = MaterialLaw::sw(materialParams, pc); fluidState.setSaturation(0, sw); diff --git a/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_soil.hh b/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_soil.hh index 01bad91ee9..673e8bb025 100644 --- a/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_soil.hh +++ b/test/multidomain/embedded/1d3d/1p2c_richards2c/problem_soil.hh @@ -189,7 +189,7 @@ public: * * This problem assumes a constant reference pressure of 1 bar. */ - Scalar nonWettingReferencePressure() const + Scalar nonwettingReferencePressure() const { return 1.0e5; } @@ -331,7 +331,7 @@ public: PrimaryVariables priVars(0.0); //! Hydrostatic pressure profile - priVars[pressureIdx] = (nonWettingReferencePressure() - pcTop_) + priVars[pressureIdx] = (nonwettingReferencePressure() - pcTop_) -9.81*1000*(globalPos[dimWorld-1] - gg.bBoxMax()[dimWorld-1]); priVars[transportCompIdx] = xTracer; return priVars; diff --git a/test/multidomain/embedded/1d3d/1p_richards/problem_soil.hh b/test/multidomain/embedded/1d3d/1p_richards/problem_soil.hh index 8976cd1845..26f4e86975 100644 --- a/test/multidomain/embedded/1d3d/1p_richards/problem_soil.hh +++ b/test/multidomain/embedded/1d3d/1p_richards/problem_soil.hh @@ -149,7 +149,7 @@ public: * * This problem assumes a constant reference pressure of 1 bar. */ - Scalar nonWettingReferencePressure() const + Scalar nonwettingReferencePressure() const { return 1.0e5; } diff --git a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/params.input b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/params.input index ed68bdc8fe..353c491f26 100644 --- a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/params.input +++ b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/params.input @@ -12,9 +12,9 @@ Name = chemicalnonequilibrium EnableGravity = false [SpatialParams] -WettingNonWettingAreaA1 = -1.603e-01 -WettingNonWettingAreaA2 = 1.429e-05 -WettingNonWettingAreaA3 = 1.915e-01 +WettingNonwettingAreaA1 = -1.603e-01 +WettingNonwettingAreaA2 = 1.429e-05 +WettingNonwettingAreaA3 = 1.915e-01 MeanPoreSize = 5e-4 MassTransferFactor = 0.5 diff --git a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/spatialparams.hh b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/spatialparams.hh index a8fb9a3f61..6e6e7376a9 100644 --- a/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/spatialparams.hh +++ b/test/porousmediumflow/2p2c/implicit/chemicalnonequilibrium/spatialparams.hh @@ -90,18 +90,18 @@ public: coarseMaterialParams_.setPe(1e4); coarseMaterialParams_.setLambda(2.0); - aWettingNonWettingA1_ = getParam<Scalar>("SpatialParams.WettingNonWettingAreaA1"); - aWettingNonWettingA2_ = getParam<Scalar>("SpatialParams.WettingNonWettingAreaA2"); - aWettingNonWettingA3_ = getParam<Scalar>("SpatialParams.WettingNonWettingAreaA3"); + aWettingNonwettingA1_ = getParam<Scalar>("SpatialParams.WettingNonwettingAreaA1"); + aWettingNonwettingA2_ = getParam<Scalar>("SpatialParams.WettingNonwettingAreaA2"); + aWettingNonwettingA3_ = getParam<Scalar>("SpatialParams.WettingNonwettingAreaA3"); // wetting-non wetting: surface which goes to zero on the edges, but is a polynomial - aWettingNonWettingSurfaceParams_.setA1(aWettingNonWettingA1_); - aWettingNonWettingSurfaceParams_.setA2(aWettingNonWettingA2_); - aWettingNonWettingSurfaceParams_.setA3(aWettingNonWettingA3_); + aWettingNonwettingSurfaceParams_.setA1(aWettingNonwettingA1_); + aWettingNonwettingSurfaceParams_.setA2(aWettingNonwettingA2_); + aWettingNonwettingSurfaceParams_.setA3(aWettingNonwettingA3_); // determine maximum capillary pressure for wetting-nonwetting surface using TwoPLaw = EffToAbsLaw<RegularizedBrooksCorey<Scalar>>; pcMax_ = TwoPLaw::pc(coarseMaterialParams_, /*sw = */0.0); - aWettingNonWettingSurfaceParams_.setPcMax(pcMax_); + aWettingNonwettingSurfaceParams_.setPcMax(pcMax_); characteristicLength_ =getParam<Scalar>("SpatialParams.MeanPoreSize"); factorMassTransfer_ = getParam<Scalar>("SpatialParams.MassTransferFactor"); } @@ -147,11 +147,11 @@ public: * \param elemSol The element solution */ template<class ElementSolution> - const AwnSurfaceParams& aWettingNonWettingSurfaceParams(const Element &element, + const AwnSurfaceParams& aWettingNonwettingSurfaceParams(const Element &element, const SubControlVolume &scv, const ElementSolution &elemSol) const { - return aWettingNonWettingSurfaceParams_ ; + return aWettingNonwettingSurfaceParams_ ; } /*!\brief Returns the maximum capillary pressure for the given pc-Sw curve @@ -171,7 +171,7 @@ public: const Scalar pcMax(const Element &element, const SubControlVolume &scv, const ElementSolution &elemSol) const - { return aWettingNonWettingSurfaceParams_.pcMax() ; } + { return aWettingNonwettingSurfaceParams_.pcMax() ; } /*! * \brief Returns the characteristic length for the mass transfer. @@ -206,13 +206,13 @@ private: MaterialLawParams coarseMaterialParams_; static constexpr Scalar eps_ = 1e-6; - AwnSurfaceParams aWettingNonWettingSurfaceParams_; + AwnSurfaceParams aWettingNonwettingSurfaceParams_; Scalar pcMax_ ; // interfacial area parameters - Scalar aWettingNonWettingA1_ ; - Scalar aWettingNonWettingA2_ ; - Scalar aWettingNonWettingA3_ ; + Scalar aWettingNonwettingA1_ ; + Scalar aWettingNonwettingA2_ ; + Scalar aWettingNonwettingA3_ ; Scalar factorMassTransfer_ ; Scalar characteristicLength_ ; diff --git a/test/porousmediumflow/mpnc/implicit/kinetic/params.input b/test/porousmediumflow/mpnc/implicit/kinetic/params.input index 8c7a9bad77..4519ec64e4 100644 --- a/test/porousmediumflow/mpnc/implicit/kinetic/params.input +++ b/test/porousmediumflow/mpnc/implicit/kinetic/params.input @@ -44,16 +44,16 @@ Swr = 0 # Snr = 0 # specificSolidsurface = 4022.994# (1/m) -aWettingNonWettingA1 = -1.603e-01 # -aWettingNonWettingA2 = 1.429e-05 # -aWettingNonWettingA3 = 1.915e-01 # +aWettingNonwettingA1 = -1.603e-01 # +aWettingNonwettingA2 = 1.429e-05 # +aWettingNonwettingA3 = 1.915e-01 # BCPd = 2.290e+03 # BClambda = 2.740e+00 # -aNonWettingSolidA1 = 1.369e+03 # -aNonWettingSolidA2 = -3.782e+00 # -aNonWettingSolidA3 = 1.063e-09 # +aNonwettingSolidA1 = 1.369e+03 # +aNonwettingSolidA2 = -3.782e+00 # +aNonwettingSolidA3 = 1.063e-09 # [SourceSink] heatIntoSolid = 0 # diff --git a/test/porousmediumflow/mpnc/implicit/kinetic/spatialparams.hh b/test/porousmediumflow/mpnc/implicit/kinetic/spatialparams.hh index fda52a9e4d..ced5bb0805 100644 --- a/test/porousmediumflow/mpnc/implicit/kinetic/spatialparams.hh +++ b/test/porousmediumflow/mpnc/implicit/kinetic/spatialparams.hh @@ -93,13 +93,13 @@ public: porosityFF_ = getParam<Scalar>("SpatialParams.FreeFlow.porosity"); intrinsicPermeabilityFF_ = getParam<Scalar>("SpatialParams.FreeFlow.permeability"); - aWettingNonWettingA1_ = getParam<Scalar>("SpatialParams.soil.aWettingNonWettingA1"); - aWettingNonWettingA2_ = getParam<Scalar>("SpatialParams.soil.aWettingNonWettingA2"); - aWettingNonWettingA3_ = getParam<Scalar>("SpatialParams.soil.aWettingNonWettingA3"); + aWettingNonwettingA1_ = getParam<Scalar>("SpatialParams.soil.aWettingNonwettingA1"); + aWettingNonwettingA2_ = getParam<Scalar>("SpatialParams.soil.aWettingNonwettingA2"); + aWettingNonwettingA3_ = getParam<Scalar>("SpatialParams.soil.aWettingNonwettingA3"); - aNonWettingSolidA1_ = getParam<Scalar>("SpatialParams.soil.aNonWettingSolidA1"); - aNonWettingSolidA2_ = getParam<Scalar>("SpatialParams.soil.aNonWettingSolidA2"); - aNonWettingSolidA3_ = getParam<Scalar>("SpatialParams.soil.aNonWettingSolidA3"); + aNonwettingSolidA1_ = getParam<Scalar>("SpatialParams.soil.aNonwettingSolidA1"); + aNonwettingSolidA2_ = getParam<Scalar>("SpatialParams.soil.aNonwettingSolidA2"); + aNonwettingSolidA3_ = getParam<Scalar>("SpatialParams.soil.aNonwettingSolidA3"); BCPd_ = getParam<Scalar>("SpatialParams.soil.BCPd"); BClambda_ = getParam<Scalar>("SpatialParams.soil.BClambda"); @@ -138,28 +138,28 @@ public: */ using TwoPLaw = EffToAbsLaw<RegularizedBrooksCorey<Scalar>>; const auto pcMax = TwoPLaw::pc(materialParamsPM_, /*sw = */0.0); - aWettingNonWettingSurfaceParams_.setPcMax(pcMax); + aWettingNonwettingSurfaceParams_.setPcMax(pcMax); // wetting-non wetting: surface which goes to zero on the edges, but is a polynomial - aWettingNonWettingSurfaceParams_.setA1(aWettingNonWettingA1_); - aWettingNonWettingSurfaceParams_.setA2(aWettingNonWettingA2_); - aWettingNonWettingSurfaceParams_.setA3(aWettingNonWettingA3_); + aWettingNonwettingSurfaceParams_.setA1(aWettingNonwettingA1_); + aWettingNonwettingSurfaceParams_.setA2(aWettingNonwettingA2_); + aWettingNonwettingSurfaceParams_.setA3(aWettingNonwettingA3_); // non-wetting-solid - aNonWettingSolidSurfaceParams_.setA1(aNonWettingSolidA1_); - aNonWettingSolidSurfaceParams_.setA2(aNonWettingSolidA2_); - aNonWettingSolidSurfaceParams_.setA3(aNonWettingSolidA3_); + aNonwettingSolidSurfaceParams_.setA1(aNonwettingSolidA1_); + aNonwettingSolidSurfaceParams_.setA2(aNonwettingSolidA2_); + aNonwettingSolidSurfaceParams_.setA3(aNonwettingSolidA3_); // dummys for free flow: no interface where there is only one phase - aWettingNonWettingSurfaceParamsFreeFlow_.setA1(0.); - aWettingNonWettingSurfaceParamsFreeFlow_.setA2(0.); - aWettingNonWettingSurfaceParamsFreeFlow_.setA3(0.); - aWettingNonWettingSurfaceParamsFreeFlow_.setPcMax(42.); // not needed because it is anyways zero; + aWettingNonwettingSurfaceParamsFreeFlow_.setA1(0.); + aWettingNonwettingSurfaceParamsFreeFlow_.setA2(0.); + aWettingNonwettingSurfaceParamsFreeFlow_.setA3(0.); + aWettingNonwettingSurfaceParamsFreeFlow_.setPcMax(42.); // not needed because it is anyways zero; // dummys for free flow: no interface where there is only one phase - aNonWettingSolidSurfaceParamsFreeFlow_.setA1(0.); - aNonWettingSolidSurfaceParamsFreeFlow_.setA2(0.); - aNonWettingSolidSurfaceParamsFreeFlow_.setA3(0.); + aNonwettingSolidSurfaceParamsFreeFlow_.setA1(0.); + aNonwettingSolidSurfaceParamsFreeFlow_.setA2(0.); + aNonwettingSolidSurfaceParamsFreeFlow_.setA3(0.); } template<class ElementSolution> @@ -226,15 +226,15 @@ public: * \param elemSol The element solution */ template<class ElementSolution> - const AwnSurfaceParams& aWettingNonWettingSurfaceParams(const Element &element, + const AwnSurfaceParams& aWettingNonwettingSurfaceParams(const Element &element, const SubControlVolume &scv, const ElementSolution &elemSol) const { const auto& globalPos = scv.dofPosition(); if (inFF_(globalPos) ) - return aWettingNonWettingSurfaceParamsFreeFlow_ ; + return aWettingNonwettingSurfaceParamsFreeFlow_ ; else if (inPM_(globalPos)) - return aWettingNonWettingSurfaceParams_ ; + return aWettingNonwettingSurfaceParams_ ; else DUNE_THROW(Dune::InvalidStateException, "You should not be here: x=" << globalPos[0] << " y= "<< globalPos[dimWorld-1]); } @@ -248,15 +248,15 @@ public: * \param elemSol The element solution */ template<class ElementSolution> - const AnsSurfaceParams& aNonWettingSolidSurfaceParams(const Element &element, + const AnsSurfaceParams& aNonwettingSolidSurfaceParams(const Element &element, const SubControlVolume &scv, const ElementSolution &elemSol) const { const auto& globalPos = scv.dofPosition(); if (inFF_(globalPos) ) - return aNonWettingSolidSurfaceParamsFreeFlow_ ; + return aNonwettingSolidSurfaceParamsFreeFlow_ ; else if (inPM_(globalPos)) - return aNonWettingSolidSurfaceParams_ ; + return aNonwettingSolidSurfaceParams_ ; else DUNE_THROW(Dune::InvalidStateException, "You should not be here: x=" << globalPos[0] << " y= "<< globalPos[dimWorld-1]); } @@ -368,10 +368,10 @@ private: static constexpr Scalar eps_ = 1e-6; Scalar heightDomain_ ; - AwnSurfaceParams aWettingNonWettingSurfaceParams_; - AnsSurfaceParams aNonWettingSolidSurfaceParams_ ; - AwnSurfaceParams aWettingNonWettingSurfaceParamsFreeFlow_; - AnsSurfaceParams aNonWettingSolidSurfaceParamsFreeFlow_ ; + AwnSurfaceParams aWettingNonwettingSurfaceParams_; + AnsSurfaceParams aNonwettingSolidSurfaceParams_ ; + AwnSurfaceParams aWettingNonwettingSurfaceParamsFreeFlow_; + AnsSurfaceParams aNonwettingSolidSurfaceParamsFreeFlow_ ; // Porous Medium Domain Scalar intrinsicPermeabilityPM_ ; @@ -389,13 +389,13 @@ private: MaterialLawParams materialParamsFF_ ; // interfacial area parameters - Scalar aWettingNonWettingA1_ ; - Scalar aWettingNonWettingA2_ ; - Scalar aWettingNonWettingA3_ ; + Scalar aWettingNonwettingA1_ ; + Scalar aWettingNonwettingA2_ ; + Scalar aWettingNonwettingA3_ ; - Scalar aNonWettingSolidA1_; - Scalar aNonWettingSolidA2_; - Scalar aNonWettingSolidA3_; + Scalar aNonwettingSolidA1_; + Scalar aNonwettingSolidA2_; + Scalar aNonwettingSolidA3_; // capillary pressures parameters Scalar BCPd_ ; diff --git a/test/porousmediumflow/richards/implicit/analytical/problem.hh b/test/porousmediumflow/richards/implicit/analytical/problem.hh index 818e2cd572..c207a05035 100644 --- a/test/porousmediumflow/richards/implicit/analytical/problem.hh +++ b/test/porousmediumflow/richards/implicit/analytical/problem.hh @@ -165,7 +165,7 @@ public: * * This problem assumes a constant reference pressure of 1 bar. */ - Scalar nonWettingReferencePressure() const + Scalar nonwettingReferencePressure() const { return pnRef_; } /*! diff --git a/test/porousmediumflow/richards/implicit/lens/problem.hh b/test/porousmediumflow/richards/implicit/lens/problem.hh index bcf448e218..2974ae969b 100644 --- a/test/porousmediumflow/richards/implicit/lens/problem.hh +++ b/test/porousmediumflow/richards/implicit/lens/problem.hh @@ -170,7 +170,7 @@ public: * * This problem assumes a constant reference pressure of 1 bar. */ - Scalar nonWettingReferencePressure() const + Scalar nonwettingReferencePressure() const { return 1.0e5; }; // \} @@ -249,7 +249,7 @@ private: const Scalar sw = 0.0; using MaterialLaw = typename ParentType::SpatialParams::MaterialLaw; const Scalar pc = MaterialLaw::pc(this->spatialParams().materialLawParamsAtPos(globalPos), sw); - values[pressureIdx] = nonWettingReferencePressure() - pc; + values[pressureIdx] = nonwettingReferencePressure() - pc; values.setState(bothPhases); return values; } diff --git a/test/porousmediumflow/richards/implicit/nonisothermal/conduction/problem.hh b/test/porousmediumflow/richards/implicit/nonisothermal/conduction/problem.hh index d1270c794d..cfc8617b0c 100644 --- a/test/porousmediumflow/richards/implicit/nonisothermal/conduction/problem.hh +++ b/test/porousmediumflow/richards/implicit/nonisothermal/conduction/problem.hh @@ -281,7 +281,7 @@ public: * * This problem assumes a constant reference pressure of 1 bar. */ - Scalar nonWettingReferencePressure() const + Scalar nonwettingReferencePressure() const { return 1e5; }; /*! diff --git a/test/porousmediumflow/richards/implicit/nonisothermal/convection/problem.hh b/test/porousmediumflow/richards/implicit/nonisothermal/convection/problem.hh index 89f8851c8e..4c047fb128 100644 --- a/test/porousmediumflow/richards/implicit/nonisothermal/convection/problem.hh +++ b/test/porousmediumflow/richards/implicit/nonisothermal/convection/problem.hh @@ -301,7 +301,7 @@ public: * * This problem assumes a constant reference pressure of 1 bar. */ - Scalar nonWettingReferencePressure() const + Scalar nonwettingReferencePressure() const { return 1e5; }; /*! diff --git a/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/problem.hh b/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/problem.hh index 1a4f1f2343..fbf620b760 100644 --- a/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/problem.hh +++ b/test/porousmediumflow/richards/implicit/nonisothermal/evaporation/problem.hh @@ -242,7 +242,7 @@ public: * * This problem assumes a constant reference pressure of 1 bar. */ - Scalar nonWettingReferencePressure() const + Scalar nonwettingReferencePressure() const { return 1e5; }; /*! diff --git a/test/porousmediumflow/richardsnc/implicit/problem.hh b/test/porousmediumflow/richardsnc/implicit/problem.hh index 6f10763218..af08a7452e 100644 --- a/test/porousmediumflow/richardsnc/implicit/problem.hh +++ b/test/porousmediumflow/richardsnc/implicit/problem.hh @@ -216,7 +216,7 @@ public: * * This problem assumes a constant reference pressure of 1 bar. */ - Scalar nonWettingReferencePressure() const + Scalar nonwettingReferencePressure() const { return 1.0e5; }; // \} @@ -327,7 +327,7 @@ private: PrimaryVariables values(0.0); //! Hydrostatic pressure profile - values[pressureIdx] = (nonWettingReferencePressure() - pcTop_) + values[pressureIdx] = (nonwettingReferencePressure() - pcTop_) - 9.81*1000*(globalPos[dimWorld-1] - this->gridGeometry().bBoxMax()[dimWorld-1]); values[compIdx] = xTracer; return values; -- GitLab