diff --git a/dumux/boxmodels/1p/1plocalresidual.hh b/dumux/boxmodels/1p/1plocalresidual.hh index 88e6bd1537e7e193d6739e0eda2922ecb117c7bb..4fde788a6d20fee3c634881c3858b55fa85766a7 100644 --- a/dumux/boxmodels/1p/1plocalresidual.hh +++ b/dumux/boxmodels/1p/1plocalresidual.hh @@ -134,7 +134,7 @@ public: const VolumeVariables &dn = this->curVolVars_(fluxVars.downstreamIdx(normalFlux)); flux[pressureIdx] = (( upwindWeight)*(up.density()/up.viscosity()) - + + (1 - upwindWeight)*(dn.density()/dn.viscosity())) * normalFlux; diff --git a/dumux/boxmodels/1p2c/1p2cfluidstate.hh b/dumux/boxmodels/1p2c/1p2cfluidstate.hh index adbc04b6546462e825c1255d97706c3f0d60a851..3833f2b3865698f58129050de1719ceee15a239f 100644 --- a/dumux/boxmodels/1p2c/1p2cfluidstate.hh +++ b/dumux/boxmodels/1p2c/1p2cfluidstate.hh @@ -78,7 +78,7 @@ public: phasePressure_ = primaryVars[pressureIdx]; x1_ = primaryVars[x1Idx]; meanMolarMass_ = - (1 - x1_)*FluidSystem::molarMass(comp1Index) + + (1 - x1_)*FluidSystem::molarMass(comp1Index) (x1_ )*FluidSystem::molarMass(comp2Index); density_ = FluidSystem::phaseDensity(phaseIndex, temperature_, phasePressure_, *this); diff --git a/dumux/boxmodels/1p2c/1p2cfluxvariables.hh b/dumux/boxmodels/1p2c/1p2cfluxvariables.hh index da3be2c3348c43d795f7f5df9a2a9f238130e7b6..2a4149aa8b370f16b4e2336df1af81e095fad71d 100644 --- a/dumux/boxmodels/1p2c/1p2cfluxvariables.hh +++ b/dumux/boxmodels/1p2c/1p2cfluxvariables.hh @@ -267,7 +267,7 @@ protected: // Diffusion coefficient in the porous medium diffCoeffPM_ - = 1./2*(vDat_i.porosity() * vDat_i.tortuosity() * vDat_i.diffCoeff() + + = 1./2*(vDat_i.porosity() * vDat_i.tortuosity() * vDat_i.diffCoeff() vDat_j.porosity() * vDat_j.tortuosity() * vDat_j.diffCoeff()); } diff --git a/dumux/boxmodels/1p2c/1p2clocalresidual.hh b/dumux/boxmodels/1p2c/1p2clocalresidual.hh index 6828633cb23cc59e7adad521658c3d45a2198677..d3bda47b14eafd8af77d5ad2afbe9b9447028480 100644 --- a/dumux/boxmodels/1p2c/1p2clocalresidual.hh +++ b/dumux/boxmodels/1p2c/1p2clocalresidual.hh @@ -148,14 +148,14 @@ public: flux[contiEqIdx] = normalFlux * (( upwindAlpha)*up.density()/up.viscosity() - + + ((1 - upwindAlpha)*dn.density()/dn.viscosity())); // advective flux of the second component flux[transEqIdx] += normalFlux * (( upwindAlpha)*up.concentration(1)/up.viscosity() - + + (1 - upwindAlpha)*dn.concentration(1)/dn.viscosity()); // diffusive flux of second component diff --git a/dumux/boxmodels/2p/2plocalresidual.hh b/dumux/boxmodels/2p/2plocalresidual.hh index 265749198729dc562b481f31e3c1eb33c52aaaaa..fecb9a7b9e9a9bdef5e986b202273cb3f8d8e3f2 100644 --- a/dumux/boxmodels/2p/2plocalresidual.hh +++ b/dumux/boxmodels/2p/2plocalresidual.hh @@ -178,7 +178,7 @@ public: normalFlux * (( mobilityUpwindAlpha)*up.density(phaseIdx)*up.mobility(phaseIdx) - + + (1 - mobilityUpwindAlpha)*dn.density(phaseIdx)*dn.mobility(phaseIdx)); } } diff --git a/dumux/boxmodels/2p/2pvolumevariables.hh b/dumux/boxmodels/2p/2pvolumevariables.hh index 085fbc80d54352fafd3887aa7091d110b2161f8d..328ab223975d2b986366a6c39cb87e4ce09a6f86 100644 --- a/dumux/boxmodels/2p/2pvolumevariables.hh +++ b/dumux/boxmodels/2p/2pvolumevariables.hh @@ -119,7 +119,7 @@ public: Sn = priVars[saturationIdx]; p[wPhaseIdx] = priVars[pressureIdx]; p[nPhaseIdx] = - p[wPhaseIdx] + + p[wPhaseIdx] MaterialLaw::pC(materialParams, 1 - Sn); } else if (int(formulation) == pnSw) { diff --git a/dumux/boxmodels/2p2c/2p2cfluxvariables.hh b/dumux/boxmodels/2p2c/2p2cfluxvariables.hh index c48f64207ad25ae0c889f327baea85cb2122b0ad..876bdf5ddb64418f4aad8fc05424af8aaeef6eb2 100644 --- a/dumux/boxmodels/2p2c/2p2cfluxvariables.hh +++ b/dumux/boxmodels/2p2c/2p2cfluxvariables.hh @@ -171,14 +171,14 @@ private: fI = fJ = 0.5; // doesn't matter because no phase is // present in both cells! densityAtIP_[phaseIdx] = - (fI*elemDat[i].density(phaseIdx) + + (fI*elemDat[i].density(phaseIdx) fJ*elemDat[j].density(phaseIdx)) / (fI + fJ); // phase density molarDensityAtIP_[phaseIdx] = - (fI*elemDat[i].molarDensity(phaseIdx) + + (fI*elemDat[i].molarDensity(phaseIdx) fJ*elemDat[j].molarDensity(phaseIdx)) / (fI + fJ); diff --git a/dumux/boxmodels/2p2cni/2p2cnilocalresidual.hh b/dumux/boxmodels/2p2cni/2p2cnilocalresidual.hh index e9abac3a8a5eb63af8c11a40827322e833f9ae46..d2164fac0c10d9cddeb4452dd53c236f0dd1c534 100644 --- a/dumux/boxmodels/2p2cni/2p2cnilocalresidual.hh +++ b/dumux/boxmodels/2p2cni/2p2cnilocalresidual.hh @@ -115,12 +115,12 @@ public: vertDat.internalEnergy(lPhaseIdx) * //vertDat.enthalpy(lPhaseIdx) * vertDat.saturation(lPhaseIdx) - + + vertDat.density(gPhaseIdx) * vertDat.internalEnergy(gPhaseIdx) * //vertDat.enthalpy(gPhaseIdx) * vertDat.saturation(gPhaseIdx)) - + + vertDat.temperature()*vertDat.heatCapacity(); } @@ -153,7 +153,7 @@ public: ( up.density(phase) * up.mobility(phase) * up.enthalpy(phase)) - + + (1-mobilityUpwindAlpha) * // downstream vertex ( dn.density(phase) * dn.mobility(phase) * diff --git a/dumux/boxmodels/2pni/2pnilocalresidual.hh b/dumux/boxmodels/2pni/2pnilocalresidual.hh index 8539266b9a384a3d6256e2ca72b3c3a32f5972d8..ebe60708195b7ebeb73d6ca798aec1289222f463 100644 --- a/dumux/boxmodels/2pni/2pnilocalresidual.hh +++ b/dumux/boxmodels/2pni/2pnilocalresidual.hh @@ -113,7 +113,7 @@ public: vertDat.porosity()*(vertDat.density(wPhaseIdx) * vertDat.internalEnergy(wPhaseIdx) * vertDat.saturation(wPhaseIdx) - + + vertDat.density(nPhaseIdx) * vertDat.internalEnergy(nPhaseIdx) * vertDat.saturation(nPhaseIdx)) @@ -160,7 +160,7 @@ public: up.density(phaseIdx)* up.mobility(phaseIdx)* up.enthalpy(phaseIdx) - + + (1 - mobilityUpwindAlpha)* dn.density(phaseIdx)* dn.mobility(phaseIdx)* diff --git a/dumux/boxmodels/richards/richardslocalresidual.hh b/dumux/boxmodels/richards/richardslocalresidual.hh index b38e8ac3d9f5eb00ff94f5b5f8eee67ef0a11f8d..e1bf185cb3445e7d0eef23831025c51fed0c60fe 100644 --- a/dumux/boxmodels/richards/richardslocalresidual.hh +++ b/dumux/boxmodels/richards/richardslocalresidual.hh @@ -134,7 +134,7 @@ public: normalFlux * (( mobilityUpwindAlpha)*up.density(wPhaseIdx)*up.mobility(wPhaseIdx) - + + (1 - mobilityUpwindAlpha)*dn.density(wPhaseIdx)*dn.mobility(wPhaseIdx)); } diff --git a/dumux/common/splinecommon_.hh b/dumux/common/splinecommon_.hh index c67f8c90bd272c6bbd88f98c9a5d8f3f232ded5e..37a74809a55bd276fc3bf4b95861d161c11594aa 100644 --- a/dumux/common/splinecommon_.hh +++ b/dumux/common/splinecommon_.hh @@ -149,11 +149,11 @@ public: return moment_(i)* x_i1*x_i1*x_i1 / (6 * h_i1) - + + moment_(i + 1)* x_i*x_i*x_i / (6 * h_i1) - + + A_i*x_i - + + B_i; } @@ -180,9 +180,9 @@ public: return -moment_(i) * x_i1*x_i1 / (2 * h_i1) - + + moment_(i + 1) * x_i*x_i / (2 * h_i1) - + + A_i; } diff --git a/dumux/material/binarycoefficients/henryiapws.hh b/dumux/material/binarycoefficients/henryiapws.hh index 2f14fd6f79c9b9403ff87027fde0617cb749d075..bbd43ee7e5b66aef8746a0d48b63006f99326006 100644 --- a/dumux/material/binarycoefficients/henryiapws.hh +++ b/dumux/material/binarycoefficients/henryiapws.hh @@ -70,10 +70,10 @@ inline Scalar henryIAPWS(Scalar E, } Scalar exponent = - q*F + - E/temperature*f + - (F + - G*pow(tau, 2.0/3) + + q*F + E/temperature*f + (F + G*pow(tau, 2.0/3) H*tau)* exp((H2O::tripleTemperature() - temperature)/100); // CAUTION: K_D is formulated in mole fractions. We have to diff --git a/dumux/material/components/brine.hh b/dumux/material/components/brine.hh index af165772eee1c954b0d488e62052dcdf5679dea2..4d33b5412ee0dfd4650a9b3e3fae1b493b9f1728 100644 --- a/dumux/material/components/brine.hh +++ b/dumux/material/components/brine.hh @@ -234,18 +234,18 @@ public: Scalar rhow = H2O::liquidDensity(temperature, pressure); return - rhow + + rhow 1000*salinity*( - 0.668 + - 0.44*salinity + + 0.668 + 0.44*salinity 1.0E-6*( 300*pMPa - - 2400*pMPa*salinity + + 2400*pMPa*salinity TempC*( 80.0 - 3*TempC - 3300*salinity - - 13*pMPa + + 13*pMPa 47*pMPa*salinity))); } diff --git a/dumux/material/components/ch4.hh b/dumux/material/components/ch4.hh index d03bea285440b9e90f934a93353a598d514822c3..1c6e066350679172bf3ff991cee4a29905480258 100644 --- a/dumux/material/components/ch4.hh +++ b/dumux/material/components/ch4.hh @@ -229,8 +229,8 @@ public: Scalar Fc = 1 - 0.2756*omega + 0.059035*mu_r4; Scalar Tstar = 1.2593 * temperature/Tc; Scalar Omega_v = - 1.16145*std::pow(Tstar, -0.14874) + - 0.52487*std::exp(- 0.77320*Tstar) + + 1.16145*std::pow(Tstar, -0.14874) + 0.52487*std::exp(- 0.77320*Tstar) 2.16178*std::exp(- 2.43787*Tstar); Scalar mu = 40.785*Fc*std::sqrt(M*temperature)/(std::pow(Vc, 2./3)*Omega_v); diff --git a/dumux/material/components/h2.hh b/dumux/material/components/h2.hh index b04440db9924d8922e739e09273ad602b94a51f9..414abeb241528f8549e26a3ecdb0c1c9b613d174 100644 --- a/dumux/material/components/h2.hh +++ b/dumux/material/components/h2.hh @@ -224,8 +224,8 @@ public: Scalar Fc = 1 - 0.2756*omega + 0.059035*mu_r4; Scalar Tstar = 1.2593 * temperature/Tc; Scalar Omega_v = - 1.16145*std::pow(Tstar, -0.14874) + - 0.52487*std::exp(- 0.77320*Tstar) + + 1.16145*std::pow(Tstar, -0.14874) + 0.52487*std::exp(- 0.77320*Tstar) 2.16178*std::exp(- 2.43787*Tstar); Scalar mu = 40.785*Fc*std::sqrt(M*temperature)/(std::pow(Vc, 2./3)*Omega_v); diff --git a/dumux/material/components/h2o.hh b/dumux/material/components/h2o.hh index e5c38141bb4a7d879189660015091149b84c7e2c..cf034e19ce24b0cdc79e2999e83015e364b493e5 100644 --- a/dumux/material/components/h2o.hh +++ b/dumux/material/components/h2o.hh @@ -182,7 +182,7 @@ public: Region2::ddgamma_dtaudpi(temperature, pv); return - enthalpyRegion2_(temperature, pv) + + enthalpyRegion2_(temperature, pv) (pressure - pv)*dh_dp; }; @@ -223,7 +223,7 @@ public: Region1::ddgamma_dtaudpi(temperature, pv); return - enthalpyRegion1_(temperature, pv) + + enthalpyRegion1_(temperature, pv) (pressure - pv)*dh_dp; }; @@ -787,7 +787,7 @@ private: return - pow(tau, 2 ) * - Region1::ddgamma_ddtau(temperature, pressure) * R + + Region1::ddgamma_ddtau(temperature, pressure) * R diff; }; diff --git a/dumux/material/components/n2.hh b/dumux/material/components/n2.hh index 11313fee2ab2a3647c4e5bb5fe3076cb6181d27d..73433eb605263435f10f707bf5d32fe2007f21e1 100644 --- a/dumux/material/components/n2.hh +++ b/dumux/material/components/n2.hh @@ -119,9 +119,9 @@ public: return criticalPressure() * std::exp(criticalTemperature()/T* - (sigma*(N1 + - sqrtSigma*N2 + - sigma*(sqrtSigma*N3 + + (sigma*(N1 + sqrtSigma*N2 + sigma*(sqrtSigma*N3 sigma*sigma*sigma*N4)))); } @@ -258,8 +258,8 @@ public: Scalar Fc = 1 - 0.2756*omega + 0.059035*mu_r4; Scalar Tstar = 1.2593 * temperature/Tc; Scalar Omega_v = - 1.16145*std::pow(Tstar, -0.14874) + - 0.52487*std::exp(- 0.77320*Tstar) + + 1.16145*std::pow(Tstar, -0.14874) + 0.52487*std::exp(- 0.77320*Tstar) 2.16178*std::exp(- 2.43787*Tstar); Scalar mu = 40.785*Fc*std::sqrt(M*temperature)/(std::pow(Vc, 2./3)*Omega_v); diff --git a/dumux/material/components/o2.hh b/dumux/material/components/o2.hh index 8679cde32aa7228594ed947ab30a126a47df51b1..a7e1c15f45929bd1ef3e214b0335e3fdba0f861b 100644 --- a/dumux/material/components/o2.hh +++ b/dumux/material/components/o2.hh @@ -117,8 +117,8 @@ public: return triplePressure()* - std::exp(X*(A + - X*(B + C*X) + + std::exp(X*(A + X*(B + C*X) D*std::pow(1 - X, epsilon))); } @@ -234,8 +234,8 @@ public: Scalar Fc = 1 - 0.2756*omega + 0.059035*mu_r4; Scalar Tstar = 1.2593 * temperature/Tc; Scalar Omega_v = - 1.16145*std::pow(Tstar, -0.14874) + - 0.52487*std::exp(- 0.77320*Tstar) + + 1.16145*std::pow(Tstar, -0.14874) + 0.52487*std::exp(- 0.77320*Tstar) 2.16178*std::exp(- 2.43787*Tstar); Scalar mu = 40.785*Fc*std::sqrt(M*temperature)/(std::pow(Vc, 2./3)*Omega_v); diff --git a/dumux/material/components/simpleco2.hh b/dumux/material/components/simpleco2.hh index a045f54c4b021da08e00377e7d65c4dad3ecd98e..58cd0950c6257df76c5b932af3d37a4c02de0964 100644 --- a/dumux/material/components/simpleco2.hh +++ b/dumux/material/components/simpleco2.hh @@ -207,8 +207,8 @@ public: Scalar Fc = 1 - 0.2756*omega + 0.059035*mu_r4; Scalar Tstar = 1.2593 * temperature/Tc; Scalar Omega_v = - 1.16145*std::pow(Tstar, -0.14874) + - 0.52487*std::exp(- 0.77320*Tstar) + + 1.16145*std::pow(Tstar, -0.14874) + 0.52487*std::exp(- 0.77320*Tstar) 2.16178*std::exp(- 2.43787*Tstar); Scalar mu = 40.785*Fc*std::sqrt(M*temperature)/(std::pow(Vc, 2./3)*Omega_v); diff --git a/dumux/material/components/tabulatedcomponent.hh b/dumux/material/components/tabulatedcomponent.hh index 149f76a5bb640a7ad4c13875be976c178c249328..e37aed4d4da3c4e62f3f02f13278f51d6a1c074a 100644 --- a/dumux/material/components/tabulatedcomponent.hh +++ b/dumux/material/components/tabulatedcomponent.hh @@ -166,7 +166,7 @@ public: Scalar density = Scalar(iRho)/(nDensity_ - 1) * (maxGasDensity__[iT] - minGasDensity__[iT]) - + + minGasDensity__[iT]; unsigned i = iT + iRho*nTemp_; @@ -188,7 +188,7 @@ public: Scalar density = Scalar(iRho)/(nDensity_ - 1) * (maxLiquidDensity__[iT] - minLiquidDensity__[iT]) - + + minLiquidDensity__[iT]; unsigned i = iT + iRho*nTemp_; @@ -455,7 +455,7 @@ private: alphaT -= iT; return - values[iT ]*(1 - alphaT) + + values[iT ]*(1 - alphaT) values[iT + 1]*( alphaT); } @@ -480,9 +480,9 @@ private: alphaP2 -= iP2; return - values[(iT ) + (iP1 )*nTemp_]*(1 - alphaT)*(1 - alphaP1) + - values[(iT ) + (iP1 + 1)*nTemp_]*(1 - alphaT)*( alphaP1) + - values[(iT + 1) + (iP2 )*nTemp_]*( alphaT)*(1 - alphaP2) + + values[(iT ) + (iP1 )*nTemp_]*(1 - alphaT)*(1 - alphaP1) + values[(iT ) + (iP1 + 1)*nTemp_]*(1 - alphaT)*( alphaP1) + values[(iT + 1) + (iP2 )*nTemp_]*( alphaT)*(1 - alphaP2) values[(iT + 1) + (iP2 + 1)*nTemp_]*( alphaT)*( alphaP2); } @@ -507,9 +507,9 @@ private: alphaP2 -= iP2; return - values[(iT ) + (iP1 )*nTemp_]*(1 - alphaT)*(1 - alphaP1) + - values[(iT ) + (iP1 + 1)*nTemp_]*(1 - alphaT)*( alphaP1) + - values[(iT + 1) + (iP2 )*nTemp_]*( alphaT)*(1 - alphaP2) + + values[(iT ) + (iP1 )*nTemp_]*(1 - alphaT)*(1 - alphaP1) + values[(iT ) + (iP1 + 1)*nTemp_]*(1 - alphaT)*( alphaP1) + values[(iT + 1) + (iP2 )*nTemp_]*( alphaT)*(1 - alphaP2) values[(iT + 1) + (iP2 + 1)*nTemp_]*( alphaT)*( alphaP2); } @@ -529,9 +529,9 @@ private: alphaP2 -= iP2; return - values[(iT ) + (iP1 )*nTemp_]*(1 - alphaT)*(1 - alphaP1) + - values[(iT ) + (iP1 + 1)*nTemp_]*(1 - alphaT)*( alphaP1) + - values[(iT + 1) + (iP2 )*nTemp_]*( alphaT)*(1 - alphaP2) + + values[(iT ) + (iP1 )*nTemp_]*(1 - alphaT)*(1 - alphaP1) + values[(iT ) + (iP1 + 1)*nTemp_]*(1 - alphaT)*( alphaP1) + values[(iT + 1) + (iP2 )*nTemp_]*( alphaT)*(1 - alphaP2) values[(iT + 1) + (iP2 + 1)*nTemp_]*( alphaT)*( alphaP2); } @@ -551,9 +551,9 @@ private: alphaP2 -= iP2; return - values[(iT ) + (iP1 )*nTemp_]*(1 - alphaT)*(1 - alphaP1) + - values[(iT ) + (iP1 + 1)*nTemp_]*(1 - alphaT)*( alphaP1) + - values[(iT + 1) + (iP2 )*nTemp_]*( alphaT)*(1 - alphaP2) + + values[(iT ) + (iP1 )*nTemp_]*(1 - alphaT)*(1 - alphaP1) + values[(iT ) + (iP1 + 1)*nTemp_]*(1 - alphaT)*( alphaP1) + values[(iT + 1) + (iP2 )*nTemp_]*( alphaT)*(1 - alphaP2) values[(iT + 1) + (iP2 + 1)*nTemp_]*( alphaT)*( alphaP2); } diff --git a/dumux/material/fluidmatrixinteractions/2p/brookscorey.hh b/dumux/material/fluidmatrixinteractions/2p/brookscorey.hh index 32398353069f03287f53d932b3dbd1953424598e..372befb4c9b7ecb6f14c0c86b3e784f7caea84e7 100644 --- a/dumux/material/fluidmatrixinteractions/2p/brookscorey.hh +++ b/dumux/material/fluidmatrixinteractions/2p/brookscorey.hh @@ -212,7 +212,7 @@ public: return 2.0*(Swe - 1)*( - 1 + + 1 pow(Swe, 2.0/params.alpha())*( 1.0/params.alpha() + 1.0/2 - Swe*(1.0/params.alpha() + 1.0/2) diff --git a/dumux/material/fluidsystems/h2o_n2_system.hh b/dumux/material/fluidsystems/h2o_n2_system.hh index c07790dd836419bb85b95f048f1f99899f79d665..0824c1321471d80da5c24ccec747950a84400e90 100644 --- a/dumux/material/fluidsystems/h2o_n2_system.hh +++ b/dumux/material/fluidsystems/h2o_n2_system.hh @@ -151,7 +151,7 @@ public: // water molecule in the liquid return clH2O*(H2O::molarMass()*fluidState.moleFrac(lPhaseIdx, H2OIdx) - + + N2::molarMass()*fluidState.moleFrac(lPhaseIdx, N2Idx)); } else if (phaseIdx == gPhaseIdx) { @@ -162,7 +162,7 @@ public: fluidState.moleFrac(gPhaseIdx, N2Idx) * fluidState.phasePressure(gPhaseIdx); return - H2O::gasDensity(temperature, fugH2O) + + H2O::gasDensity(temperature, fugH2O) N2::gasDensity(temperature, fugN2); } DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx); @@ -452,7 +452,7 @@ public: return fluidState.massFrac(lPhaseIdx, H2OIdx)* H2O::liquidEnthalpy(temperature, pressure) - + + fluidState.massFrac(lPhaseIdx, N2Idx)* N2::gasEnthalpy(temperature, pN2); } @@ -502,7 +502,7 @@ private: // water molecule in the liquid return clH2O*(xlH2O*H2O::molarMass() - + + xlN2*N2::molarMass()); } diff --git a/dumux/material/spatialparameters/boxspatialparameters.hh b/dumux/material/spatialparameters/boxspatialparameters.hh index 52c627e6b206cfc96707ded63c0eccf5d7ecf0d7..24bbcb9a3a94c20c3d9ab2059c17b70c80a09773 100644 --- a/dumux/material/spatialparameters/boxspatialparameters.hh +++ b/dumux/material/spatialparameters/boxspatialparameters.hh @@ -113,7 +113,7 @@ public: (asImp_().extrusionFactorScv(element, fvElemGeom, fvElemGeom.subContVolFace[scvfIdx].i) - + + asImp_().extrusionFactorScv(element, fvElemGeom, fvElemGeom.subContVolFace[scvfIdx].j)); diff --git a/test/boxmodels/2p2c/injectionspatialparameters.hh b/test/boxmodels/2p2c/injectionspatialparameters.hh index 79e7a23c94bdd48fa0230a0c2da9bed508f11b01..5687efdee5b702c0c4fa42b1b8e1073c3f52d77f 100644 --- a/test/boxmodels/2p2c/injectionspatialparameters.hh +++ b/test/boxmodels/2p2c/injectionspatialparameters.hh @@ -230,9 +230,9 @@ public: // arithmetic mean of the liquid saturation and the porosity const int i = fvElemGeom.subContVolFace[scvfIdx].i; const int j = fvElemGeom.subContVolFace[scvfIdx].j; - Scalar Sl = std::max(0.0, (vDat[i].saturation(lPhaseIdx) + + Scalar Sl = std::max(0.0, (vDat[i].saturation(lPhaseIdx) vDat[j].saturation(lPhaseIdx)) / 2); - Scalar poro = (porosity(element, fvElemGeom, i) + + Scalar poro = (porosity(element, fvElemGeom, i) porosity(element, fvElemGeom, j)) / 2; Scalar lsat = pow(lGranite, (1-poro)) * pow(lWater, poro); diff --git a/test/boxmodels/2p2cni/waterairspatialparameters.hh b/test/boxmodels/2p2cni/waterairspatialparameters.hh index b525b1e63902ef477f323752b42f816eabf22833..83a94b96c68a7dffffb4ae0b290f9d50e4a054ac 100644 --- a/test/boxmodels/2p2cni/waterairspatialparameters.hh +++ b/test/boxmodels/2p2cni/waterairspatialparameters.hh @@ -231,9 +231,9 @@ public: // arithmetic mean of the liquid saturation and the porosity const int i = fvElemGeom.subContVolFace[scvfIdx].i; const int j = fvElemGeom.subContVolFace[scvfIdx].j; - Scalar Sl = std::max(0.0, (vDat[i].saturation(lPhaseIdx) + + Scalar Sl = std::max(0.0, (vDat[i].saturation(lPhaseIdx) vDat[j].saturation(lPhaseIdx)) / 2); - Scalar poro = (porosity(element, fvElemGeom, i) + + Scalar poro = (porosity(element, fvElemGeom, i) porosity(element, fvElemGeom, j)) / 2; Scalar lsat = pow(lGranite, (1-poro)) * pow(lWater, poro);