From 28762dc468d0680c2108b165c6ffbb2ac4a0bbe9 Mon Sep 17 00:00:00 2001
From: Henry <Henry>
Date: Thu, 19 Apr 2012 14:17:30 +0100
Subject: [PATCH] Removed trailing whitespace

---
 applications/solvers/DNS/dnsFoam/dnsFoam.C    |  4 +-
 .../solvers/combustion/fireFoam/pEqn.H        |  2 +-
 .../buoyantBoussinesqPimpleFoam/pEqn.H        |  2 +-
 .../buoyantBoussinesqSimpleFoam/pEqn.H        |  2 +-
 .../heatTransfer/buoyantPimpleFoam/pEqn.H     |  2 +-
 .../heatTransfer/buoyantSimpleFoam/pEqn.H     |  2 +-
 .../chtMultiRegionSimpleFoam/fluid/pEqn.H     |  8 ++--
 .../chtMultiRegionFoam/fluid/pEqn.H           |  2 +-
 .../potentialFreeSurfaceFoam/pEqn.H           |  2 +-
 .../lagrangian/reactingParcelFilmFoam/pEqn.H  |  2 +-
 .../solvers/multiphase/bubbleFoam/pEqn.H      | 46 ++++++++++++-------
 .../solvers/multiphase/cavitatingFoam/pEqn.H  |  2 +-
 .../DNS/dnsFoam/boxTurb16/system/fvSchemes    |  2 +-
 .../constant/thermophysicalProperties         |  1 +
 .../constant/thermophysicalProperties         |  3 +-
 .../hotRoom/system/fvSchemes                  |  2 +-
 .../hotRoom/system/fvSchemes                  |  2 +-
 .../iglooWithFridges/system/fvSchemes         |  2 +-
 .../hotRoom/system/fvSchemes                  |  2 +-
 .../buoyantCavity/system/fvSchemes            |  2 +-
 .../circuitBoardCooling/system/fvSchemes      |  2 +-
 .../hotRoom/system/fvSchemes                  |  2 +-
 .../hotRadiationRoom/system/fvSchemes         |  2 +-
 .../hotRadiationRoomFvDOM/system/fvSchemes    |  2 +-
 .../system/bottomAir/fvSchemes                |  2 +-
 .../multiRegionHeater/system/topAir/fvSchemes |  2 +-
 .../system/bottomWater/fvSchemes              |  2 +-
 .../system/topAir/fvSchemes                   |  2 +-
 .../system/bottomAir/fvSchemes                |  2 +-
 .../system/topAir/fvSchemes                   |  2 +-
 .../system/bottomAir/fvSchemes                |  2 +-
 .../multiRegionHeater/system/topAir/fvSchemes |  2 +-
 .../system/bottomAir/fvSchemes                |  2 +-
 .../system/topAir/fvSchemes                   |  2 +-
 .../pimpleFoam/TJunctionFan/0/epsilon         | 14 +++---
 .../pimpleFoam/TJunctionFan/0/k               | 14 +++---
 .../pimpleFoam/TJunctionFan/0/p               | 21 ++++++---
 .../elipsekkLOmega/constant/polyMesh/boundary | 16 +++++--
 .../bubbleFoam/bubbleColumn/0.org/p           |  5 +-
 .../multiphase/bubbleFoam/bubbleColumn/0/p    |  5 +-
 .../bubbleFoam/bubbleColumn/system/fvSchemes  |  2 +-
 .../les/throttle/system/fvSchemes             |  2 +-
 .../les/throttle3D/system/fvSchemes           |  2 +-
 .../ras/throttle/system/fvSchemes             |  2 +-
 44 files changed, 116 insertions(+), 87 deletions(-)

diff --git a/applications/solvers/DNS/dnsFoam/dnsFoam.C b/applications/solvers/DNS/dnsFoam/dnsFoam.C
index 0733802b086..08073398a76 100644
--- a/applications/solvers/DNS/dnsFoam/dnsFoam.C
+++ b/applications/solvers/DNS/dnsFoam/dnsFoam.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -85,7 +85,7 @@ int main(int argc, char *argv[])
 
         for (int corr=1; corr<=1; corr++)
         {
-            volScalarField rAU(1.0/UEqn.A());
+            volScalarField rAU("Dp", 1.0/UEqn.A());
             volVectorField HbyA("HbyA", U);
             HbyA = rAU*UEqn.H();
 
diff --git a/applications/solvers/combustion/fireFoam/pEqn.H b/applications/solvers/combustion/fireFoam/pEqn.H
index b6f5ef47b10..3f4f485cf6b 100644
--- a/applications/solvers/combustion/fireFoam/pEqn.H
+++ b/applications/solvers/combustion/fireFoam/pEqn.H
@@ -1,7 +1,7 @@
 rho = thermo.rho();
 
 volScalarField rAU(1.0/UEqn.A());
-surfaceScalarField rhorAUf(rAU.name() + 'f', fvc::interpolate(rho*rAU));
+surfaceScalarField rhorAUf("Dp", fvc::interpolate(rho*rAU));
 volVectorField HbyA("HbyA", U);
 HbyA = rAU*UEqn.H();
 
diff --git a/applications/solvers/heatTransfer/buoyantBoussinesqPimpleFoam/pEqn.H b/applications/solvers/heatTransfer/buoyantBoussinesqPimpleFoam/pEqn.H
index ce822ff21b7..06997e52ecd 100644
--- a/applications/solvers/heatTransfer/buoyantBoussinesqPimpleFoam/pEqn.H
+++ b/applications/solvers/heatTransfer/buoyantBoussinesqPimpleFoam/pEqn.H
@@ -1,6 +1,6 @@
 {
     volScalarField rAU("rAU", 1.0/UEqn.A());
-    surfaceScalarField rAUf("(1|A(U))", fvc::interpolate(rAU));
+    surfaceScalarField rAUf("Dp", fvc::interpolate(rAU));
 
     volVectorField HbyA("HbyA", U);
     HbyA = rAU*UEqn.H();
diff --git a/applications/solvers/heatTransfer/buoyantBoussinesqSimpleFoam/pEqn.H b/applications/solvers/heatTransfer/buoyantBoussinesqSimpleFoam/pEqn.H
index 32076b4dd10..c07a344017a 100644
--- a/applications/solvers/heatTransfer/buoyantBoussinesqSimpleFoam/pEqn.H
+++ b/applications/solvers/heatTransfer/buoyantBoussinesqSimpleFoam/pEqn.H
@@ -1,6 +1,6 @@
 {
     volScalarField rAU("rAU", 1.0/UEqn().A());
-    surfaceScalarField rAUf("(1|A(U))", fvc::interpolate(rAU));
+    surfaceScalarField rAUf("Dp", fvc::interpolate(rAU));
 
     volVectorField HbyA("HbyA", U);
     HbyA = rAU*UEqn().H();
diff --git a/applications/solvers/heatTransfer/buoyantPimpleFoam/pEqn.H b/applications/solvers/heatTransfer/buoyantPimpleFoam/pEqn.H
index 462b96b17da..96389fee7b7 100644
--- a/applications/solvers/heatTransfer/buoyantPimpleFoam/pEqn.H
+++ b/applications/solvers/heatTransfer/buoyantPimpleFoam/pEqn.H
@@ -6,7 +6,7 @@
     thermo.rho() -= psi*p_rgh;
 
     volScalarField rAU(1.0/UEqn.A());
-    surfaceScalarField rhorAUf("(rho*(1|A(U)))", fvc::interpolate(rho*rAU));
+    surfaceScalarField rhorAUf("Dp", fvc::interpolate(rho*rAU));
 
     volVectorField HbyA("HbyA", U);
     HbyA = rAU*UEqn.H();
diff --git a/applications/solvers/heatTransfer/buoyantSimpleFoam/pEqn.H b/applications/solvers/heatTransfer/buoyantSimpleFoam/pEqn.H
index a7f873c2f17..f63e12f3637 100644
--- a/applications/solvers/heatTransfer/buoyantSimpleFoam/pEqn.H
+++ b/applications/solvers/heatTransfer/buoyantSimpleFoam/pEqn.H
@@ -3,7 +3,7 @@
     rho.relax();
 
     volScalarField rAU(1.0/UEqn().A());
-    surfaceScalarField rhorAUf("(rho*(1|A(U)))", fvc::interpolate(rho*rAU));
+    surfaceScalarField rhorAUf("Dp", fvc::interpolate(rho*rAU));
 
     volVectorField HbyA("HbyA", U);
     HbyA = rAU*UEqn().H();
diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/pEqn.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/pEqn.H
index 73b72af316a..d23390edeb0 100644
--- a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/pEqn.H
+++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/pEqn.H
@@ -5,7 +5,7 @@
     rho.relax();
 
     volScalarField rAU(1.0/UEqn().A());
-    surfaceScalarField rhorAUf("(rho*(1|A(U)))", fvc::interpolate(rho*rAU));
+    surfaceScalarField rhorAUf("Dp", fvc::interpolate(rho*rAU));
 
     U = rAU*UEqn().H();
     UEqn.clear();
@@ -15,8 +15,8 @@
     dimensionedScalar compressibility = fvc::domainIntegrate(psi);
     bool compressible = (compressibility.value() > SMALL);
 
-    surfaceScalarField buoyancyPhi(rhorAUf*ghf*fvc::snGrad(rho)*mesh.magSf());
-    phi -= buoyancyPhi;
+    surfaceScalarField phig(-rhorAUf*ghf*fvc::snGrad(rho)*mesh.magSf());
+    phi += phig;
 
     // Solve pressure
     for (int nonOrth=0; nonOrth<=nNonOrthCorr; nonOrth++)
@@ -44,7 +44,7 @@
 
             // Correct the momentum source with the pressure gradient flux
             // calculated from the relaxed pressure
-            U -= rAU*fvc::reconstruct((buoyancyPhi + p_rghEqn.flux())/rhorAUf);
+            U += rAU*fvc::reconstruct((phig - p_rghEqn.flux())/rhorAUf);
             U.correctBoundaryConditions();
         }
     }
diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/pEqn.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/pEqn.H
index 76f6f8e30e1..f260acc514d 100644
--- a/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/pEqn.H
+++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/pEqn.H
@@ -6,7 +6,7 @@
     rho = thermo.rho();
 
     volScalarField rAU(1.0/UEqn().A());
-    surfaceScalarField rhorAUf("(rho*(1|A(U)))", fvc::interpolate(rho*rAU));
+    surfaceScalarField rhorAUf("Dp", fvc::interpolate(rho*rAU));
 
     volVectorField HbyA("HbyA", U);
     HbyA = rAU*UEqn().H();
diff --git a/applications/solvers/incompressible/potentialFreeSurfaceFoam/pEqn.H b/applications/solvers/incompressible/potentialFreeSurfaceFoam/pEqn.H
index 2271e85d9b5..5a521a04fff 100644
--- a/applications/solvers/incompressible/potentialFreeSurfaceFoam/pEqn.H
+++ b/applications/solvers/incompressible/potentialFreeSurfaceFoam/pEqn.H
@@ -1,5 +1,5 @@
 volScalarField rAU(1.0/UEqn().A());
-surfaceScalarField rAUf(rAU.name() + 'f', fvc::interpolate(rAU));
+surfaceScalarField rAUf("Dp", fvc::interpolate(rAU));
 
 volVectorField HbyA("HbyA", U);
 HbyA = rAU*(UEqn() == sources(U))().H();
diff --git a/applications/solvers/lagrangian/reactingParcelFilmFoam/pEqn.H b/applications/solvers/lagrangian/reactingParcelFilmFoam/pEqn.H
index b6f5ef47b10..3f4f485cf6b 100644
--- a/applications/solvers/lagrangian/reactingParcelFilmFoam/pEqn.H
+++ b/applications/solvers/lagrangian/reactingParcelFilmFoam/pEqn.H
@@ -1,7 +1,7 @@
 rho = thermo.rho();
 
 volScalarField rAU(1.0/UEqn.A());
-surfaceScalarField rhorAUf(rAU.name() + 'f', fvc::interpolate(rho*rAU));
+surfaceScalarField rhorAUf("Dp", fvc::interpolate(rho*rAU));
 volVectorField HbyA("HbyA", U);
 HbyA = rAU*UEqn.H();
 
diff --git a/applications/solvers/multiphase/bubbleFoam/pEqn.H b/applications/solvers/multiphase/bubbleFoam/pEqn.H
index 5f868f3da9d..631c9cbba64 100644
--- a/applications/solvers/multiphase/bubbleFoam/pEqn.H
+++ b/applications/solvers/multiphase/bubbleFoam/pEqn.H
@@ -8,16 +8,21 @@
     surfaceScalarField rAU1f(fvc::interpolate(rAU1));
     surfaceScalarField rAU2f(fvc::interpolate(rAU2));
 
-    U1 = rAU1*U1Eqn.H();
-    U2 = rAU2*U2Eqn.H();
+    volVectorField HbyA1("HbyA1", U1);
+    HbyA1 = rAU1*U1Eqn.H();
+
+    volVectorField HbyA2("HbyA2", U2);
+    HbyA2 = rAU2*U2Eqn.H();
 
     surfaceScalarField phiDrag1
     (
-        fvc::interpolate(alpha2/rho1*dragCoef*rAU1)*phi2 + rAU1f*(g & mesh.Sf())
+        fvc::interpolate(alpha2/rho1*dragCoef*rAU1)*phi2
+      + rAU1f*(g & mesh.Sf())
     );
     surfaceScalarField phiDrag2
     (
-        fvc::interpolate(alpha1/rho2*dragCoef*rAU2)*phi1 + rAU2f*(g & mesh.Sf())
+        fvc::interpolate(alpha1/rho2*dragCoef*rAU2)*phi1
+      + rAU2f*(g & mesh.Sf())
     );
 
     forAll(p.boundaryField(), patchi)
@@ -29,16 +34,25 @@
         }
     }
 
-    phi1 = (fvc::interpolate(U1) & mesh.Sf()) + fvc::ddtPhiCorr(rAU1, U1, phi1)
-        + phiDrag1;
-    phi2 = (fvc::interpolate(U2) & mesh.Sf()) + fvc::ddtPhiCorr(rAU2, U2, phi2)
-        + phiDrag2;
+    surfaceScalarField phiHbyA1
+    (
+        (fvc::interpolate(HbyA1) & mesh.Sf())
+      + fvc::ddtPhiCorr(rAU1, U1, phi1)
+      + phiDrag1
+    );
+
+    surfaceScalarField phiHbyA2
+    (
+        (fvc::interpolate(HbyA2) & mesh.Sf())
+      + fvc::ddtPhiCorr(rAU2, U2, phi2)
+      + phiDrag2
+    );
 
-    phi = alpha1f*phi1 + alpha2f*phi2;
+    surfaceScalarField phiHbyA("phiHbyA", alpha1f*phiHbyA1 + alpha2f*phiHbyA2);
 
     surfaceScalarField Dp
     (
-        "(rho*(1|A(U)))",
+        "Dp",
         alpha1f*rAU1f/rho1 + alpha2f*rAU2f/rho2
     );
 
@@ -46,7 +60,7 @@
     {
         fvScalarMatrix pEqn
         (
-            fvm::laplacian(Dp, p) == fvc::div(phi)
+            fvm::laplacian(Dp, p) == fvc::div(phiHbyA)
         );
 
         pEqn.setReference(pRefCell, pRefValue);
@@ -57,19 +71,17 @@
         {
             surfaceScalarField SfGradp(pEqn.flux()/Dp);
 
-            phi1 -= rAU1f*SfGradp/rho1;
-            phi2 -= rAU2f*SfGradp/rho2;
+            phi1 = phiHbyA1 - rAU1f*SfGradp/rho1;
+            phi2 = phiHbyA2 - rAU2f*SfGradp/rho2;
             phi = alpha1f*phi1 + alpha2f*phi2;
 
             p.relax();
             SfGradp = pEqn.flux()/Dp;
 
-            U1 += (fvc::reconstruct(phiDrag1 - rAU1f*SfGradp/rho1));
-            //U1 += rAU1*(fvc::reconstruct(phiDrag1/rAU1f - SfGradp/rho1));
+            U1 = HbyA1 + (fvc::reconstruct(phiDrag1 - rAU1f*SfGradp/rho1));
             U1.correctBoundaryConditions();
 
-            U2 += (fvc::reconstruct(phiDrag2 - rAU2f*SfGradp/rho2));
-            //U2 += rAU2*(fvc::reconstruct(phiDrag2/rAU2f - SfGradp/rho2));
+            U2 = HbyA2 + (fvc::reconstruct(phiDrag2 - rAU2f*SfGradp/rho2));
             U2.correctBoundaryConditions();
 
             U = alpha1*U1 + alpha2*U2;
diff --git a/applications/solvers/multiphase/cavitatingFoam/pEqn.H b/applications/solvers/multiphase/cavitatingFoam/pEqn.H
index 34898172cea..ea35f79fa14 100644
--- a/applications/solvers/multiphase/cavitatingFoam/pEqn.H
+++ b/applications/solvers/multiphase/cavitatingFoam/pEqn.H
@@ -12,7 +12,7 @@
     surfaceScalarField rhof("rhof", fvc::interpolate(rho));
 
     volScalarField rAU(1.0/UEqn.A());
-    surfaceScalarField rAUf("rAUf", rhof*fvc::interpolate(rAU));
+    surfaceScalarField rAUf("Dp", rhof*fvc::interpolate(rAU));
 
     volVectorField HbyA("HbyA", U);
     HbyA = rAU*UEqn.H();
diff --git a/tutorials/DNS/dnsFoam/boxTurb16/system/fvSchemes b/tutorials/DNS/dnsFoam/boxTurb16/system/fvSchemes
index 1f665c977f9..21be868783e 100644
--- a/tutorials/DNS/dnsFoam/boxTurb16/system/fvSchemes
+++ b/tutorials/DNS/dnsFoam/boxTurb16/system/fvSchemes
@@ -37,7 +37,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(nu,U) Gauss linear corrected;
-    laplacian((1|A(U)),p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
 }
 
 interpolationSchemes
diff --git a/tutorials/compressible/rhoCentralFoam/LadenburgJet60psi/constant/thermophysicalProperties b/tutorials/compressible/rhoCentralFoam/LadenburgJet60psi/constant/thermophysicalProperties
index e6838dcf7a7..2ff1fabbda2 100644
--- a/tutorials/compressible/rhoCentralFoam/LadenburgJet60psi/constant/thermophysicalProperties
+++ b/tutorials/compressible/rhoCentralFoam/LadenburgJet60psi/constant/thermophysicalProperties
@@ -33,6 +33,7 @@ mixture
     {
         As              1.458e-06;
         Ts              110.4;
+        Pr              1;
     }
 }
 
diff --git a/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/constant/thermophysicalProperties b/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/constant/thermophysicalProperties
index a3c1437dc02..1e8492f320f 100644
--- a/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/constant/thermophysicalProperties
+++ b/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/constant/thermophysicalProperties
@@ -15,8 +15,6 @@ FoamFile
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-Pr              0.72;
-
 thermoType      ePsiThermo<pureMixture<sutherlandTransport<specieThermo<janafThermo<perfectGas>>>>>;
 
 mixture
@@ -38,6 +36,7 @@ mixture
     {
         As              1.458e-06;
         Ts              110;
+        Pr              0.72;
     }
 }
 
diff --git a/tutorials/heatTransfer/buoyantBoussinesqPimpleFoam/hotRoom/system/fvSchemes b/tutorials/heatTransfer/buoyantBoussinesqPimpleFoam/hotRoom/system/fvSchemes
index ceb6aa0497d..b7ff9739c17 100644
--- a/tutorials/heatTransfer/buoyantBoussinesqPimpleFoam/hotRoom/system/fvSchemes
+++ b/tutorials/heatTransfer/buoyantBoussinesqPimpleFoam/hotRoom/system/fvSchemes
@@ -41,7 +41,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(nuEff,U) Gauss linear uncorrected;
-    laplacian((1|A(U)),p_rgh) Gauss linear uncorrected;
+    laplacian(Dp,p_rgh) Gauss linear uncorrected;
     laplacian(kappaEff,T) Gauss linear uncorrected;
     laplacian(DkEff,k) Gauss linear uncorrected;
     laplacian(DepsilonEff,epsilon) Gauss linear uncorrected;
diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/system/fvSchemes b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/system/fvSchemes
index 3fa205e5e36..6fc42b1ca74 100644
--- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/system/fvSchemes
+++ b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/system/fvSchemes
@@ -39,7 +39,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(nuEff,U) Gauss linear corrected;
-    laplacian((1|A(U)),p_rgh) Gauss linear corrected;
+    laplacian(Dp,p_rgh) Gauss linear corrected;
     laplacian(kappaEff,T) Gauss linear corrected;
     laplacian(DkEff,k) Gauss linear corrected;
     laplacian(DepsilonEff,epsilon) Gauss linear corrected;
diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/fvSchemes b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/fvSchemes
index 364987d87f0..b36bd5f8fcb 100644
--- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/fvSchemes
+++ b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/fvSchemes
@@ -41,7 +41,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(nuEff,U) Gauss linear limited 0.333;
-    laplacian((1|A(U)),p_rgh) Gauss linear limited 0.333;
+    laplacian(Dp,p_rgh) Gauss linear limited 0.333;
     laplacian(kappaEff,T) Gauss linear limited 0.333;
     laplacian(DkEff,k) Gauss linear limited 0.333;
     laplacian(DepsilonEff,epsilon) Gauss linear limited 0.333;
diff --git a/tutorials/heatTransfer/buoyantPimpleFoam/hotRoom/system/fvSchemes b/tutorials/heatTransfer/buoyantPimpleFoam/hotRoom/system/fvSchemes
index 3a7b6154e54..a6897b72d52 100644
--- a/tutorials/heatTransfer/buoyantPimpleFoam/hotRoom/system/fvSchemes
+++ b/tutorials/heatTransfer/buoyantPimpleFoam/hotRoom/system/fvSchemes
@@ -42,7 +42,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear corrected;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear corrected;
+    laplacian(Dp,p_rgh) Gauss linear corrected;
     laplacian(alphaEff,h) Gauss linear corrected;
     laplacian(DkEff,k) Gauss linear corrected;
     laplacian(DepsilonEff,epsilon) Gauss linear corrected;
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/buoyantCavity/system/fvSchemes b/tutorials/heatTransfer/buoyantSimpleFoam/buoyantCavity/system/fvSchemes
index cdaadf4c303..599b1530bc8 100644
--- a/tutorials/heatTransfer/buoyantSimpleFoam/buoyantCavity/system/fvSchemes
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/buoyantCavity/system/fvSchemes
@@ -40,7 +40,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear orthogonal;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear orthogonal;
+    laplacian(Dp,p_rgh) Gauss linear orthogonal;
     laplacian(alphaEff,h) Gauss linear orthogonal;
     laplacian(DkEff,k) Gauss linear orthogonal;
     laplacian(DepsilonEff,epsilon) Gauss linear orthogonal;
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSchemes b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSchemes
index 02edc9816b9..46f978cc82b 100644
--- a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSchemes
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSchemes
@@ -40,7 +40,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear uncorrected;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear uncorrected;
+    laplacian(Dp,p_rgh) Gauss linear uncorrected;
     laplacian(alphaEff,h) Gauss linear uncorrected;
     laplacian(DkEff,k) Gauss linear uncorrected;
     laplacian(DepsilonEff,epsilon) Gauss linear uncorrected;
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/fvSchemes b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/fvSchemes
index f0019f66909..991a5277f6e 100644
--- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/fvSchemes
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/fvSchemes
@@ -42,7 +42,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear uncorrected;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear uncorrected;
+    laplacian(Dp,p_rgh) Gauss linear uncorrected;
     laplacian(alphaEff,h) Gauss linear uncorrected;
     laplacian(DkEff,k) Gauss linear uncorrected;
     laplacian(DepsilonEff,epsilon) Gauss linear uncorrected;
diff --git a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/system/fvSchemes b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/system/fvSchemes
index 572a6207d22..3b6deefb697 100644
--- a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/system/fvSchemes
+++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/system/fvSchemes
@@ -42,7 +42,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear corrected;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear corrected;
+    laplacian(Dp,p_rgh) Gauss linear corrected;
     laplacian(alphaEff,h) Gauss linear corrected;
     laplacian(DkEff,k) Gauss linear corrected;
     laplacian(DepsilonEff,epsilon) Gauss linear corrected;
diff --git a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/system/fvSchemes b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/system/fvSchemes
index 3cbd1184088..817fe7274b4 100644
--- a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/system/fvSchemes
+++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/system/fvSchemes
@@ -43,7 +43,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear corrected;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear corrected;
+    laplacian(Dp,p_rgh) Gauss linear corrected;
     laplacian(alphaEff,h) Gauss linear corrected;
     laplacian(DkEff,k) Gauss linear corrected;
     laplacian(DepsilonEff,epsilon) Gauss linear corrected;
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSchemes
index e4be18c50c4..148fdb45eb9 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSchemes
@@ -41,7 +41,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear limited 0.333;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear limited 0.333;
+    laplacian(Dp,p_rgh) Gauss linear limited 0.333;
     laplacian(alphaEff,h) Gauss linear limited 0.333;
     laplacian(DkEff,k) Gauss linear limited 0.333;
     laplacian(DepsilonEff,epsilon) Gauss linear limited 0.333;
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSchemes
index 865dfd9f993..5694ac1f59b 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSchemes
@@ -41,7 +41,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear limited 0.333;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear limited 0.333;
+    laplacian(Dp,p_rgh) Gauss linear limited 0.333;
     laplacian(alphaEff,h) Gauss linear limited 0.333;
     laplacian(DkEff,k) Gauss linear limited 0.333;
     laplacian(DepsilonEff,epsilon) Gauss linear limited 0.333;
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/fvSchemes
index 865dfd9f993..5694ac1f59b 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/fvSchemes
@@ -41,7 +41,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear limited 0.333;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear limited 0.333;
+    laplacian(Dp,p_rgh) Gauss linear limited 0.333;
     laplacian(alphaEff,h) Gauss linear limited 0.333;
     laplacian(DkEff,k) Gauss linear limited 0.333;
     laplacian(DepsilonEff,epsilon) Gauss linear limited 0.333;
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/fvSchemes
index 865dfd9f993..5694ac1f59b 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/fvSchemes
@@ -41,7 +41,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear limited 0.333;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear limited 0.333;
+    laplacian(Dp,p_rgh) Gauss linear limited 0.333;
     laplacian(alphaEff,h) Gauss linear limited 0.333;
     laplacian(DkEff,k) Gauss linear limited 0.333;
     laplacian(DepsilonEff,epsilon) Gauss linear limited 0.333;
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSchemes
index 865dfd9f993..5694ac1f59b 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSchemes
@@ -41,7 +41,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear limited 0.333;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear limited 0.333;
+    laplacian(Dp,p_rgh) Gauss linear limited 0.333;
     laplacian(alphaEff,h) Gauss linear limited 0.333;
     laplacian(DkEff,k) Gauss linear limited 0.333;
     laplacian(DepsilonEff,epsilon) Gauss linear limited 0.333;
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes
index 865dfd9f993..5694ac1f59b 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes
@@ -41,7 +41,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear limited 0.333;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear limited 0.333;
+    laplacian(Dp,p_rgh) Gauss linear limited 0.333;
     laplacian(alphaEff,h) Gauss linear limited 0.333;
     laplacian(DkEff,k) Gauss linear limited 0.333;
     laplacian(DepsilonEff,epsilon) Gauss linear limited 0.333;
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/fvSchemes
index 17ab97ec96f..09a66a2658b 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/fvSchemes
@@ -42,7 +42,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear uncorrected;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear uncorrected;
+    laplacian(Dp,p_rgh) Gauss linear uncorrected;
     laplacian(alphaEff,h) Gauss linear uncorrected;
     laplacian(DkEff,k) Gauss linear uncorrected;
     laplacian(DepsilonEff,epsilon) Gauss linear uncorrected;
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/fvSchemes
index cf4192a4ded..9b8eac50b50 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/fvSchemes
@@ -42,7 +42,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear uncorrected;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear uncorrected;
+    laplacian(Dp,p_rgh) Gauss linear uncorrected;
     laplacian(alphaEff,h) Gauss linear uncorrected;
     laplacian(DkEff,k) Gauss linear uncorrected;
     laplacian(DepsilonEff,epsilon) Gauss linear uncorrected;
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSchemes
index 7f3767d1793..ca25b1d27ca 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSchemes
@@ -43,7 +43,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear uncorrected;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear uncorrected;
+    laplacian(Dp,p_rgh) Gauss linear uncorrected;
     laplacian(alphaEff,h) Gauss linear uncorrected;
     laplacian(DkEff,k) Gauss linear uncorrected;
     laplacian(DepsilonEff,epsilon) Gauss linear uncorrected;
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSchemes
index 7f3767d1793..ca25b1d27ca 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSchemes
@@ -43,7 +43,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear uncorrected;
-    laplacian((rho*(1|A(U))),p_rgh) Gauss linear uncorrected;
+    laplacian(Dp,p_rgh) Gauss linear uncorrected;
     laplacian(alphaEff,h) Gauss linear uncorrected;
     laplacian(DkEff,k) Gauss linear uncorrected;
     laplacian(DepsilonEff,epsilon) Gauss linear uncorrected;
diff --git a/tutorials/incompressible/pimpleFoam/TJunctionFan/0/epsilon b/tutorials/incompressible/pimpleFoam/TJunctionFan/0/epsilon
index 7448f8e5445..b972d9f1d29 100644
--- a/tutorials/incompressible/pimpleFoam/TJunctionFan/0/epsilon
+++ b/tutorials/incompressible/pimpleFoam/TJunctionFan/0/epsilon
@@ -27,19 +27,19 @@ boundaryField
         mixingLength    0.01;
         phi             phi;
         k               k;
-        value           $internalField;
+        value           uniform 200;
     }
     outlet1
     {
         type            inletOutlet;
-        inletValue      $internalField;
-        value           $internalField;
+        inletValue      uniform 200;
+        value           uniform 200;
     }
     outlet2
     {
         type            inletOutlet;
-        inletValue      $internalField;
-        value           $internalField;
+        inletValue      uniform 200;
+        value           uniform 200;
     }
     baffles
     {
@@ -47,7 +47,7 @@ boundaryField
         Cmu             0.09;
         kappa           0.41;
         E               9.8;
-        value           $internalField;
+        value           uniform 0;
     }
     fan_half0
     {
@@ -63,7 +63,7 @@ boundaryField
         Cmu             0.09;
         kappa           0.41;
         E               9.8;
-        value           $internalField;
+        value           uniform 200;
     }
 }
 
diff --git a/tutorials/incompressible/pimpleFoam/TJunctionFan/0/k b/tutorials/incompressible/pimpleFoam/TJunctionFan/0/k
index 9684d73a558..a58acefeab7 100644
--- a/tutorials/incompressible/pimpleFoam/TJunctionFan/0/k
+++ b/tutorials/incompressible/pimpleFoam/TJunctionFan/0/k
@@ -27,24 +27,24 @@ boundaryField
         intensity       0.05;
         U               U;
         phi             phi;
-        value           $internalField;
+        value           uniform 0.375;
     }
     outlet1
     {
         type            inletOutlet;
-        inletValue      $internalField;
-        value           $internalField;
+        inletValue      uniform 0.375;
+        value           uniform 0.375;
     }
     outlet2
     {
         type            inletOutlet;
-        inletValue      $internalField;
-        value           $internalField;
+        inletValue      uniform 0.375;
+        value           uniform 0.375;
     }
     baffles
     {
         type            kqRWallFunction;
-        value           $internalField;
+        value           uniform 0;
     }
     fan_half0
     {
@@ -57,7 +57,7 @@ boundaryField
     defaultFaces
     {
         type            kqRWallFunction;
-        value           $internalField;
+        value           uniform 0.375;
     }
 }
 
diff --git a/tutorials/incompressible/pimpleFoam/TJunctionFan/0/p b/tutorials/incompressible/pimpleFoam/TJunctionFan/0/p
index dd968b84c5f..16a8bb50edd 100644
--- a/tutorials/incompressible/pimpleFoam/TJunctionFan/0/p
+++ b/tutorials/incompressible/pimpleFoam/TJunctionFan/0/p
@@ -29,10 +29,13 @@ boundaryField
         gamma           1;
         p0              40;
         pressure        table
-        (
-            (0 10)
-            (1 40)
-        );
+
+2
+(
+(0 10)
+(1 40)
+)
+;
         value           uniform 40;
     }
     outlet1
@@ -54,7 +57,14 @@ boundaryField
         type            fan;
         patchType       cyclic;
         jump            uniform 0;
-        f               2(100 -0.1);
+        jumpTable       polynomial
+
+2
+(
+(100 0)
+(-0.1 1)
+)
+;
         value           uniform 0;
     }
     fan_half1
@@ -62,7 +72,6 @@ boundaryField
         type            fan;
         patchType       cyclic;
         jump            uniform 0;
-        f               2(100 -0.1);
         value           uniform 0;
     }
     defaultFaces
diff --git a/tutorials/incompressible/pimpleFoam/elipsekkLOmega/constant/polyMesh/boundary b/tutorials/incompressible/pimpleFoam/elipsekkLOmega/constant/polyMesh/boundary
index ff3254a0cb6..5370728b893 100644
--- a/tutorials/incompressible/pimpleFoam/elipsekkLOmega/constant/polyMesh/boundary
+++ b/tutorials/incompressible/pimpleFoam/elipsekkLOmega/constant/polyMesh/boundary
@@ -15,31 +15,37 @@ FoamFile
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-4
+5
 (
+    left
+    {
+        type            symmetryPlane;
+        nFaces          320;
+        startFace       99210;
+    }
     outlet
     {
         type            patch;
         nFaces          320;
-        startFace       99370;
+        startFace       99530;
     }
     up
     {
         type            symmetryPlane;
         nFaces          380;
-        startFace       99690;
+        startFace       99850;
     }
     hole
     {
         type            wall;
         nFaces          560;
-        startFace       100070;
+        startFace       100230;
     }
     frontAndBack
     {
         type            empty;
         nFaces          100000;
-        startFace       100630;
+        startFace       100790;
     }
 )
 
diff --git a/tutorials/multiphase/bubbleFoam/bubbleColumn/0.org/p b/tutorials/multiphase/bubbleFoam/bubbleColumn/0.org/p
index 07744fc101c..536747ce3f1 100644
--- a/tutorials/multiphase/bubbleFoam/bubbleColumn/0.org/p
+++ b/tutorials/multiphase/bubbleFoam/bubbleColumn/0.org/p
@@ -22,7 +22,8 @@ boundaryField
 {
     inlet
     {
-        type            zeroGradient;
+        type            fixedFluxPressure;
+        value           uniform 0;
     }
 
     outlet
@@ -33,7 +34,7 @@ boundaryField
 
     walls
     {
-        type            buoyantPressure;
+        type            fixedFluxPressure;
         value           uniform 0;
     }
 
diff --git a/tutorials/multiphase/bubbleFoam/bubbleColumn/0/p b/tutorials/multiphase/bubbleFoam/bubbleColumn/0/p
index 709bf07cefe..5fffa73a19c 100644
--- a/tutorials/multiphase/bubbleFoam/bubbleColumn/0/p
+++ b/tutorials/multiphase/bubbleFoam/bubbleColumn/0/p
@@ -1901,7 +1901,8 @@ boundaryField
 {
     inlet
     {
-        type            zeroGradient;
+        type            fixedFluxPressure;
+        value           uniform 0;
     }
 
     outlet
@@ -1912,7 +1913,7 @@ boundaryField
 
     walls
     {
-        type            buoyantPressure;
+        type            fixedFluxPressure;
         value           uniform 0;
     }
 
diff --git a/tutorials/multiphase/bubbleFoam/bubbleColumn/system/fvSchemes b/tutorials/multiphase/bubbleFoam/bubbleColumn/system/fvSchemes
index 9e465b42626..0779f1ea221 100644
--- a/tutorials/multiphase/bubbleFoam/bubbleColumn/system/fvSchemes
+++ b/tutorials/multiphase/bubbleFoam/bubbleColumn/system/fvSchemes
@@ -42,7 +42,7 @@ laplacianSchemes
     default         none;
     laplacian(nuEff1,U1) Gauss linear corrected;
     laplacian(nuEff2,U2) Gauss linear corrected;
-    laplacian((rho*(1|A(U))),p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
 }
 
 interpolationSchemes
diff --git a/tutorials/multiphase/cavitatingFoam/les/throttle/system/fvSchemes b/tutorials/multiphase/cavitatingFoam/les/throttle/system/fvSchemes
index 4dd3e2bcc88..0c8bf54bb51 100644
--- a/tutorials/multiphase/cavitatingFoam/les/throttle/system/fvSchemes
+++ b/tutorials/multiphase/cavitatingFoam/les/throttle/system/fvSchemes
@@ -43,7 +43,7 @@ laplacianSchemes
     default         none;
     laplacian(nuf,rhoU) Gauss linear corrected;
     laplacian(muEff,U) Gauss linear corrected;
-    laplacian(rAUf,p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
     laplacian(DkEff,k) Gauss linear corrected;
     laplacian(1,p)  Gauss linear corrected;
 }
diff --git a/tutorials/multiphase/cavitatingFoam/les/throttle3D/system/fvSchemes b/tutorials/multiphase/cavitatingFoam/les/throttle3D/system/fvSchemes
index 4dd3e2bcc88..0c8bf54bb51 100644
--- a/tutorials/multiphase/cavitatingFoam/les/throttle3D/system/fvSchemes
+++ b/tutorials/multiphase/cavitatingFoam/les/throttle3D/system/fvSchemes
@@ -43,7 +43,7 @@ laplacianSchemes
     default         none;
     laplacian(nuf,rhoU) Gauss linear corrected;
     laplacian(muEff,U) Gauss linear corrected;
-    laplacian(rAUf,p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
     laplacian(DkEff,k) Gauss linear corrected;
     laplacian(1,p)  Gauss linear corrected;
 }
diff --git a/tutorials/multiphase/cavitatingFoam/ras/throttle/system/fvSchemes b/tutorials/multiphase/cavitatingFoam/ras/throttle/system/fvSchemes
index 7134b5cb392..633e4a749e3 100644
--- a/tutorials/multiphase/cavitatingFoam/ras/throttle/system/fvSchemes
+++ b/tutorials/multiphase/cavitatingFoam/ras/throttle/system/fvSchemes
@@ -44,7 +44,7 @@ laplacianSchemes
     default         none;
     laplacian(nuf,rhoU) Gauss linear corrected;
     laplacian(muEff,U) Gauss linear corrected;
-    laplacian(rAUf,p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
     laplacian(DomegaEff,omega) Gauss linear corrected;
     laplacian(DkEff,k) Gauss linear corrected;
     laplacian(1,p)  Gauss linear corrected;
-- 
GitLab