diff --git a/ReleaseNotes-1.6 b/ReleaseNotes-1.6
index 78a3f045a74338d6449079c3593e8ce4b073b41a..58955d33498c78a72a34d3378dc32163aa6c35b8 100644
--- a/ReleaseNotes-1.6
+++ b/ReleaseNotes-1.6
@@ -180,7 +180,7 @@
            - =mut=: =muWallFunction=
            - =epsilon=: =epsilonWallFunction=
            - =omega=: =omegaWallFunction=
-           - =k=, =Q=, =R=: =kQRWallFunction=
+           - =k=, =q=, =R=: =kqRWallFunction=
          - for temperature:
            - =alphat=: =alphatWallFunction=
        - New =alphaSgsJayatillekeWallFunction= thermal wall function for
diff --git a/applications/solvers/multiphase/bubbleFoam/createRASTurbulence.H b/applications/solvers/multiphase/bubbleFoam/createRASTurbulence.H
index 9eb468f91640b49248c7de8f01af8c397a7eeb1d..f9794a914f65f5dce52d87824cb67cc478a0e1c1 100644
--- a/applications/solvers/multiphase/bubbleFoam/createRASTurbulence.H
+++ b/applications/solvers/multiphase/bubbleFoam/createRASTurbulence.H
@@ -16,52 +16,93 @@
         RASProperties.lookup("turbulence")
     );
 
-    dictionary kEpsilonCoeffs
+    dictionary kEpsilonDict
     (
-        RASProperties.subDict("kEpsilonCoeffs")
+        RASProperties.subDictPtr("kEpsilonCoeffs")
     );
 
-
-    scalar Cmu
+    dimensionedScalar Cmu
     (
-        readScalar(kEpsilonCoeffs.lookup("Cmu"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "Cmu",
+            kEpsilonDict,
+            0.09
+        )
     );
 
-    scalar C1
+    dimensionedScalar C1
     (
-        readScalar(kEpsilonCoeffs.lookup("C1"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "C1",
+            kEpsilonDict,
+            1.44
+        )
     );
 
-    scalar C2
+    dimensionedScalar C2
     (
-        readScalar(kEpsilonCoeffs.lookup("C2"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "C2",
+            kEpsilonDict,
+            1.92
+        )
     );
 
-    scalar alphak
+    dimensionedScalar alphak
     (
-        readScalar(kEpsilonCoeffs.lookup("alphak"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "alphaEps",
+            kEpsilonDict,
+            1.0
+        )
     );
 
-    scalar alphaEps
+    dimensionedScalar alphaEps
     (
-        readScalar(kEpsilonCoeffs.lookup("alphaEps"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "alphaEps",
+            kEpsilonDict,
+            0.76923
+        )
     );
 
-    dictionary wallFunctionCoeffs
+    dictionary wallFunctionDict
     (
-        RASProperties.subDict("wallFunctionCoeffs")
+        RASProperties.subDictPtr("wallFunctionCoeffs")
     );
 
-    scalar kappa
+    dimensionedScalar kappa
     (
-        readScalar(wallFunctionCoeffs.lookup("kappa"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "kappa",
+            wallFunctionDict,
+            0.4187
+        )
     );
 
-    scalar E
+    dimensionedScalar E
     (
-        readScalar(wallFunctionCoeffs.lookup("E"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "E",
+            wallFunctionDict,
+            9.0
+        )
     );
 
+    if (RASProperties.lookupOrDefault<Switch>("printCoeffs", false))
+    {
+        Info<< "kEpsilonCoeffs" << kEpsilonDict << nl
+            << "wallFunctionCoeffs" << wallFunctionDict << endl;
+    }
+
+
     nearWallDist y(mesh);
 
 
diff --git a/applications/solvers/multiphase/bubbleFoam/kEpsilon.H b/applications/solvers/multiphase/bubbleFoam/kEpsilon.H
index b1c8951b04ab389de71cbdf1a5efbc9193c734fb..576e3253abf0b9f1dc592825aab3b6e5852bb853 100644
--- a/applications/solvers/multiphase/bubbleFoam/kEpsilon.H
+++ b/applications/solvers/multiphase/bubbleFoam/kEpsilon.H
@@ -16,7 +16,11 @@ if(turbulence)
     (
         fvm::ddt(beta, epsilon)
       + fvm::div(phib, epsilon)
-      - fvm::laplacian(alphaEps*nuEffb, epsilon)
+      - fvm::laplacian
+        (
+            alphaEps*nuEffb, epsilon,
+            "laplacian(DepsilonEff,epsilon)"
+        )
       ==
          C1*beta*G*epsilon/k
        - fvm::Sp(C2*beta*epsilon/k, epsilon)
@@ -35,7 +39,11 @@ if(turbulence)
     (
         fvm::ddt(beta, k)
       + fvm::div(phib, k)
-      - fvm::laplacian(alphak*nuEffb, k)
+      - fvm::laplacian
+        (
+            alphak*nuEffb, k,
+            "laplacian(DkEff,k)"
+        )
       ==
         beta*G
       - fvm::Sp(beta*epsilon/k, k)
diff --git a/applications/solvers/multiphase/bubbleFoam/wallFunctions.H b/applications/solvers/multiphase/bubbleFoam/wallFunctions.H
index 8650460bc11772ab72ad15e4b089ed5244cfd0ab..38b7297b10b0eb66430b768f66b2b71952913cbd 100644
--- a/applications/solvers/multiphase/bubbleFoam/wallFunctions.H
+++ b/applications/solvers/multiphase/bubbleFoam/wallFunctions.H
@@ -1,8 +1,9 @@
 {
     labelList cellBoundaryFaceCount(epsilon.size(), 0);
 
-    scalar Cmu25 = ::pow(Cmu, 0.25);
-    scalar Cmu75 = ::pow(Cmu, 0.75);
+    scalar Cmu25 = ::pow(Cmu.value(), 0.25);
+    scalar Cmu75 = ::pow(Cmu.value(), 0.75);
+    scalar kappa_ = kappa.value();
 
     const fvPatchList& patches = mesh.boundary();
 
@@ -53,14 +54,14 @@
 
                 epsilon[faceCelli] +=
                      Cmu75*::pow(k[faceCelli], 1.5)
-                    /(kappa*y[patchi][facei]);
+                    /(kappa_*y[patchi][facei]);
 
                 if (yPlus > 11.6)
                 {
                     G[faceCelli] +=
                         nuw[facei]*magFaceGradU[facei]
                         *Cmu25*::sqrt(k[faceCelli])
-                        /(kappa*y[patchi][facei]);
+                        /(kappa_*y[patchi][facei]);
                 }
             }
         }
diff --git a/applications/solvers/multiphase/bubbleFoam/wallViscosity.H b/applications/solvers/multiphase/bubbleFoam/wallViscosity.H
index cd9c005302daa1d899fa13bd09cd7469d06ee372..21ea94d8d7808964dd285c5cb2f0df55ba62d240 100644
--- a/applications/solvers/multiphase/bubbleFoam/wallViscosity.H
+++ b/applications/solvers/multiphase/bubbleFoam/wallViscosity.H
@@ -1,5 +1,8 @@
 {
-    scalar Cmu25 = ::pow(Cmu, 0.25);
+    scalar Cmu25 = ::pow(Cmu.value(), 0.25);
+    scalar kappa_ = kappa.value();
+    scalar E_ = E.value();
+    scalar nub_ = nub.value();
 
     const fvPatchList& patches = mesh.boundary();
 
@@ -19,14 +22,14 @@
                 scalar yPlus =
                     Cmu25*y[patchi][facei]
                    *::sqrt(k[faceCelli])
-                   /nub.value();
+                   /nub_;
 
                 if (yPlus > 11.6)
                 {
                     nutw[facei] =
-                        yPlus*nub.value()*kappa
-                       /::log(E*yPlus)
-                      - nub.value();
+                        yPlus*nub_*kappa_
+                       /::log(E_*yPlus)
+                      - nub_;
                 }
                 else
                 {
diff --git a/applications/solvers/multiphase/settlingFoam/createFields.H b/applications/solvers/multiphase/settlingFoam/createFields.H
index 916acde39ed5264a9f7bc765d3ec445b83519637..9f0ca00596bcb6ceb87117b6d8e82a38e867833b 100644
--- a/applications/solvers/multiphase/settlingFoam/createFields.H
+++ b/applications/solvers/multiphase/settlingFoam/createFields.H
@@ -228,57 +228,103 @@
         RASProperties.lookup("turbulence")
     );
 
-    const dictionary& kEpsilonCoeffs
+    dictionary kEpsilonDict
     (
-        RASProperties.subDict("kEpsilonCoeffs")
+        RASProperties.subDictPtr("kEpsilonCoeffs")
     );
 
-
-    scalar Cmu
+    dimensionedScalar Cmu
     (
-        readScalar(kEpsilonCoeffs.lookup("Cmu"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "Cmu",
+            kEpsilonDict,
+            0.09
+        )
     );
 
-    scalar C1
+    dimensionedScalar C1
     (
-        readScalar(kEpsilonCoeffs.lookup("C1"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "C1",
+            kEpsilonDict,
+            1.44
+        )
     );
 
-    scalar C2
+    dimensionedScalar C2
     (
-        readScalar(kEpsilonCoeffs.lookup("C2"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "C2",
+            kEpsilonDict,
+            1.92
+        )
     );
 
-    scalar C3
+    dimensionedScalar C3
     (
-        readScalar(kEpsilonCoeffs.lookup("C3"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "C3",
+            kEpsilonDict,
+            0.85
+        )
     );
 
-    scalar alphak
+    dimensionedScalar alphak
     (
-        readScalar(kEpsilonCoeffs.lookup("alphak"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "alphaEps",
+            kEpsilonDict,
+            1.0
+        )
     );
 
-    scalar alphaEps
+    dimensionedScalar alphaEps
     (
-        readScalar(kEpsilonCoeffs.lookup("alphaEps"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "alphaEps",
+            kEpsilonDict,
+            0.76923
+        )
     );
 
-    const dictionary& wallFunctionCoeffs
+    dictionary wallFunctionDict
     (
-        RASProperties.subDict("wallFunctionCoeffs")
+        RASProperties.subDictPtr("wallFunctionCoeffs")
     );
 
-    scalar kappa
+    dimensionedScalar kappa
     (
-        readScalar(wallFunctionCoeffs.lookup("kappa"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "kappa",
+            wallFunctionDict,
+            0.4187
+        )
     );
 
-    scalar E
+    dimensionedScalar E
     (
-        readScalar(wallFunctionCoeffs.lookup("E"))
+        dimensionedScalar::lookupOrAddToDict
+        (
+            "E",
+            wallFunctionDict,
+            9.0
+        )
     );
 
+    if (RASProperties.lookupOrDefault<Switch>("printCoeffs", false))
+    {
+        Info<< "kEpsilonCoeffs" << kEpsilonDict << nl
+            << "wallFunctionCoeffs" << wallFunctionDict << endl;
+    }
+
+
     nearWallDist y(mesh);
 
     Info<< "Reading field k\n" << endl;
diff --git a/applications/solvers/multiphase/settlingFoam/kEpsilon.H b/applications/solvers/multiphase/settlingFoam/kEpsilon.H
index 0c0930dd102b8ba39a37c462f1fb0405688e958a..742fcde70859b2bd1b3f2615429e2a384dcfdd72 100644
--- a/applications/solvers/multiphase/settlingFoam/kEpsilon.H
+++ b/applications/solvers/multiphase/settlingFoam/kEpsilon.H
@@ -26,7 +26,7 @@ if(turbulence)
       + fvm::div(phi, epsilon)
       - fvm::laplacian
         (
-            alphaEps*mut + mul, epsilon, 
+            alphaEps*mut + mul, epsilon,
             "laplacian(DepsilonEff,epsilon)"
         )
      ==
@@ -49,7 +49,11 @@ if(turbulence)
     (
         fvm::ddt(rho, k)
       + fvm::div(phi, k)
-      - fvm::laplacian(alphak*mut + mul, k, "laplacian(DkEff,k)")
+      - fvm::laplacian
+        (
+            alphak*mut + mul, k,
+            "laplacian(DkEff,k)"
+        )
      ==
         G
       - fvm::SuSp(Gcoef + 2.0/3.0*rho*divU, k)
diff --git a/applications/solvers/multiphase/settlingFoam/wallFunctions.H b/applications/solvers/multiphase/settlingFoam/wallFunctions.H
index 411a897499268413b93fbb873962584f0e86aae2..ae323691e3ed97820455630546716ff7153d45c3 100644
--- a/applications/solvers/multiphase/settlingFoam/wallFunctions.H
+++ b/applications/solvers/multiphase/settlingFoam/wallFunctions.H
@@ -1,8 +1,9 @@
 {
     labelList cellBoundaryFaceCount(epsilon.size(), 0);
 
-    scalar Cmu25 = ::pow(Cmu, 0.25);
-    scalar Cmu75 = ::pow(Cmu, 0.75);
+    scalar Cmu25 = ::pow(Cmu.value(), 0.25);
+    scalar Cmu75 = ::pow(Cmu.value(), 0.75);
+    scalar kappa_ = kappa.value();
 
     const fvPatchList& patches = mesh.boundary();
 
@@ -55,14 +56,14 @@
 
                 epsilon[faceCelli] +=
                     Cmu75*rho[faceCelli]*::pow(k[faceCelli], 1.5)
-                   /(kappa*y[patchi][facei]);
+                   /(kappa_*y[patchi][facei]);
 
                 if (yPlus > 11.6)
                 {
                     G[faceCelli] +=
                         mutw[facei]*magFaceGradU[facei]
                        *Cmu25*::sqrt(k[faceCelli])
-                       /(kappa*y[patchi][facei]);
+                       /(kappa_*y[patchi][facei]);
                 }
             }
         }
diff --git a/applications/solvers/multiphase/settlingFoam/wallViscosity.H b/applications/solvers/multiphase/settlingFoam/wallViscosity.H
index 665d4bbf74bca783cb38080d2bfc2474a982b511..35d6f9ba8b635db951a3c054daf528e1c4aee7d5 100644
--- a/applications/solvers/multiphase/settlingFoam/wallViscosity.H
+++ b/applications/solvers/multiphase/settlingFoam/wallViscosity.H
@@ -1,5 +1,7 @@
 {
-    scalar Cmu25 = ::pow(Cmu, 0.25);
+    scalar Cmu25 = ::pow(Cmu.value(), 0.25);
+    scalar kappa_ = kappa.value();
+    scalar E_ = E.value();
 
     const fvPatchList& patches = mesh.boundary();
 
@@ -26,7 +28,7 @@
                 {
                     mutw[facei] =
                         muw[facei]
-                       *(yPlus*kappa/::log(E*yPlus) - 1);
+                       *(yPlus*kappa_/::log(E_*yPlus) - 1);
                 }
                 else
                 {
diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/Make/options b/applications/solvers/multiphase/twoPhaseEulerFoam/Make/options
index 3e7b346fe2a295f4b53ed3632b6b521d5261f853..1bf97d106c3075e689f94158c51472d13483f2d4 100644
--- a/applications/solvers/multiphase/twoPhaseEulerFoam/Make/options
+++ b/applications/solvers/multiphase/twoPhaseEulerFoam/Make/options
@@ -1,4 +1,5 @@
 EXE_INC = \
+    -I../bubbleFoam \
     -I$(LIB_SRC)/finiteVolume/lnInclude \
     -I$(LIB_SRC)/transportModels/incompressible/lnInclude \
     -IturbulenceModel \
@@ -6,7 +7,7 @@ EXE_INC = \
     -IinterfacialModels/lnInclude \
     -IphaseModel/lnInclude \
     -Iaveraging
-        
+
 EXE_LIBS = \
     -lEulerianInterfacialModels \
     -lfiniteVolume \
diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H b/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H
index 8a176157152c6b3042870796b53644f7e467aeaf..e422fe845b67041fb3277271559232271ecf2716 100644
--- a/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H
+++ b/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H
@@ -91,34 +91,6 @@
         alpha*Ua + beta*Ub
     );
 
-    Info<< "Reading field k\n" << endl;
-    volScalarField k
-    (
-        IOobject
-        (
-            "k",
-            runTime.timeName(),
-            mesh,
-            IOobject::MUST_READ,
-            IOobject::AUTO_WRITE
-        ),
-        mesh
-    );
-
-    Info<< "Reading field epsilon\n" << endl;
-    volScalarField epsilon
-    (
-        IOobject
-        (
-            "epsilon",
-            runTime.timeName(),
-            mesh,
-            IOobject::MUST_READ,
-            IOobject::AUTO_WRITE
-        ),
-        mesh
-    );
-
     dimensionedScalar Cvm
     (
         transportProperties.lookup("Cvm")
@@ -156,114 +128,7 @@
         alpha*rhoa + beta*rhob
     );
 
-    IOdictionary RASProperties
-    (
-        IOobject
-        (
-            "RASProperties",
-            runTime.constant(),
-            mesh,
-            IOobject::MUST_READ,
-            IOobject::NO_WRITE
-        )
-    );
-
-
-    Switch turbulence
-    (
-        RASProperties.lookup("turbulence")
-    );
-
-    dictionary kEpsilonCoeffs
-    (
-        RASProperties.subDict("kEpsilonCoeffs")
-    );
-
-
-    scalar Cmu
-    (
-        readScalar(kEpsilonCoeffs.lookup("Cmu"))
-    );
-
-    scalar C1
-    (
-        readScalar(kEpsilonCoeffs.lookup("C1"))
-    );
-
-    scalar C2
-    (
-        readScalar(kEpsilonCoeffs.lookup("C2"))
-    );
-
-    scalar alphak
-    (
-        readScalar(kEpsilonCoeffs.lookup("alphak"))
-    );
-
-    scalar alphaEps
-    (
-        readScalar(kEpsilonCoeffs.lookup("alphaEps"))
-    );
-
-    dictionary wallFunctionCoeffs
-    (
-        RASProperties.subDict("wallFunctionCoeffs")
-    );
-
-    scalar kappa
-    (
-        readScalar(wallFunctionCoeffs.lookup("kappa"))
-    );
-
-    scalar E
-    (
-        readScalar(wallFunctionCoeffs.lookup("E"))
-    );
-
-    nearWallDist y(mesh);
-
-    Info<< "Calculating field nutb\n" << endl;
-    volScalarField nutb
-    (
-        IOobject
-        (
-            "nutb",
-            runTime.timeName(),
-            mesh,
-            IOobject::NO_READ,
-            IOobject::AUTO_WRITE
-        ),
-        Cmu*sqr(k)/epsilon
-    );
-
-    Info<< "Calculating field nuEffa\n" << endl;
-    volScalarField nuEffa
-    (
-        IOobject
-        (
-            "nuEffa",
-            runTime.timeName(),
-            mesh,
-            IOobject::NO_READ,
-            IOobject::NO_WRITE
-        ),
-        sqr(Ct)*nutb + nua
-    );
-
-    Info<< "Calculating field nuEffb\n" << endl;
-    volScalarField nuEffb
-    (
-        IOobject
-        (
-            "nuEffb",
-            runTime.timeName(),
-            mesh,
-            IOobject::NO_READ,
-            IOobject::NO_WRITE
-        ),
-        nutb + nub
-    );
-
+    #include "createRASTurbulence.H"
 
     Info<< "Calculating field DDtUa and DDtUb\n" << endl;
 
diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/kEpsilon.H b/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/kEpsilon.H
deleted file mode 100644
index 9479d6a47fcef3e4f2d1fae2622eb305023d401b..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/kEpsilon.H
+++ /dev/null
@@ -1,61 +0,0 @@
-if(turbulence)
-{
-    if (mesh.changing())
-    {
-        y.correct();
-    }
-
-    tmp<volTensorField> tgradUb = fvc::grad(Ub);
-    volScalarField G = 2*nutb*(tgradUb() && dev(symm(tgradUb())));
-    tgradUb.clear();
-
-#   include "wallFunctions.H"
-
-    // Dissipation equation
-    fvScalarMatrix epsEqn
-    (
-        fvm::ddt(beta, epsilon)
-      + fvm::div(phib, epsilon)
-      - fvm::laplacian
-        (
-            alphaEps*nuEffb,
-            epsilon,
-            "laplacian((alphaEps*nuEffb),epsilon)"
-        )
-      ==
-         C1*beta*G*epsilon/k
-       - fvm::Sp(C2*beta*epsilon/k, epsilon)
-    );
-
-#   include "wallDissipation.H"
-
-    epsEqn.relax();
-    epsEqn.solve();
-
-    epsilon.max(dimensionedScalar("zero", epsilon.dimensions(), 1.0e-15));
-
-
-    // Turbulent kinetic energy equation
-    fvScalarMatrix kEqn
-    (
-        fvm::ddt(beta, k)
-      + fvm::div(phib, k)
-      - fvm::laplacian(alphak*nuEffb, k, "laplacian((alphak*nuEffb),k)")
-      ==
-        beta*G
-      - fvm::Sp(beta*epsilon/k, k)
-    );
-    kEqn.relax();
-    kEqn.solve();
-
-    k.max(dimensionedScalar("zero", k.dimensions(), 1.0e-8));
-
-    //- Re-calculate turbulence viscosity
-    nutb = Cmu*sqr(k)/epsilon;
-
-#   include "wallViscosity.H"
-
-}
-
-nuEffa = sqr(Ct)*nutb + nua;
-nuEffb = nutb + nub;
diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/wallDissipation.H b/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/wallDissipation.H
deleted file mode 100644
index 5c84c9e7ac9e492f13d5331dea6f6d0097ae39bf..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/wallDissipation.H
+++ /dev/null
@@ -1,51 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 1991-2009 OpenCFD Ltd.
-     \\/     M anipulation  |
--------------------------------------------------------------------------------
-License
-    This file is part of OpenFOAM.
-
-    OpenFOAM is free software; you can redistribute it and/or modify it
-    under the terms of the GNU General Public License as published by the
-    Free Software Foundation; either version 2 of the License, or (at your
-    option) any later version.
-
-    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
-    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
-    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
-    for more details.
-
-    You should have received a copy of the GNU General Public License
-    along with OpenFOAM; if not, write to the Free Software Foundation,
-    Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
-
-Global
-    wallDissipation
-
-Description
-    Set wall dissipation in the epsilon matrix
-
-\*---------------------------------------------------------------------------*/
-
-{
-    const fvPatchList& patches = mesh.boundary();
-
-    forAll(patches, patchi)
-    {
-        const fvPatch& p = patches[patchi];
-
-        if (isType<wallFvPatch>(p))
-        {
-            epsEqn.setValues
-            (
-                p.faceCells(),
-                epsilon.boundaryField()[patchi].patchInternalField()
-            );
-        }
-    }
-}
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/wallFunctions.H b/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/wallFunctions.H
deleted file mode 100644
index ea7d1a9b14579d25d67cfa53a98168c24f2c00b8..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/wallFunctions.H
+++ /dev/null
@@ -1,86 +0,0 @@
-{
-    labelList cellBoundaryFaceCount(epsilon.size(), 0);
-
-    scalar Cmu25 = ::pow(Cmu, 0.25);
-    scalar Cmu75 = ::pow(Cmu, 0.75);
-
-    const fvPatchList& patches = mesh.boundary();
-
-    //- Initialise the near-wall P field to zero
-    forAll(patches, patchi)
-    {
-        const fvPatch& currPatch = patches[patchi];
-
-        if (isType<wallFvPatch>(currPatch))
-        {
-            forAll(currPatch, facei)
-            {
-                label faceCelli = currPatch.faceCells()[facei];
-
-                epsilon[faceCelli] = 0.0;
-                G[faceCelli] = 0.0;
-            }
-        }
-    }
-
-    //- Accumulate the wall face contributions to epsilon and G
-    //  Increment cellBoundaryFaceCount for each face for averaging
-    forAll(patches, patchi)
-    {
-        const fvPatch& currPatch = patches[patchi];
-
-        if (isType<wallFvPatch>(currPatch))
-        {
-            const scalarField& nuw = nutb.boundaryField()[patchi];
-
-            scalarField magFaceGradU = mag(U.boundaryField()[patchi].snGrad());
-
-            forAll(currPatch, facei)
-            {
-                label faceCelli = currPatch.faceCells()[facei];
-
-                scalar yPlus =
-                    Cmu25*y[patchi][facei]
-                    *::sqrt(k[faceCelli])
-                    /nub.value();
-
-                // For corner cells (with two boundary or more faces),
-                // epsilon and G in the near-wall cell are calculated
-                // as an average
-
-                cellBoundaryFaceCount[faceCelli]++;
-
-                epsilon[faceCelli] +=
-                     Cmu75*::pow(k[faceCelli], 1.5)
-                    /(kappa*y[patchi][facei]);
-
-                if (yPlus > 11.6)
-                {
-                    G[faceCelli] +=
-                        nuw[facei]*magFaceGradU[facei]
-                        *Cmu25*::sqrt(k[faceCelli])
-                        /(kappa*y[patchi][facei]);
-                }
-            }
-        }
-    }
-
-
-    // perform the averaging
-
-    forAll(patches, patchi)
-    {
-        const fvPatch& curPatch = patches[patchi];
-
-        if (isType<wallFvPatch>(curPatch))
-        {
-            forAll(curPatch, facei)
-            {
-                label faceCelli = curPatch.faceCells()[facei];
-
-                epsilon[faceCelli] /= cellBoundaryFaceCount[faceCelli];
-                G[faceCelli] /= cellBoundaryFaceCount[faceCelli];
-            }
-        }
-    }
-}
diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/wallViscosity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/wallViscosity.H
deleted file mode 100644
index cd9c005302daa1d899fa13bd09cd7469d06ee372..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/twoPhaseEulerFoam/turbulenceModel/wallViscosity.H
+++ /dev/null
@@ -1,38 +0,0 @@
-{
-    scalar Cmu25 = ::pow(Cmu, 0.25);
-
-    const fvPatchList& patches = mesh.boundary();
-
-    forAll(patches, patchi)
-    {
-        const fvPatch& currPatch = patches[patchi];
-
-        if (isType<wallFvPatch>(currPatch))
-        {
-            scalarField& nutw = nutb.boundaryField()[patchi];
-
-            forAll(currPatch, facei)
-            {
-                label faceCelli = currPatch.faceCells()[facei];
-
-                // calculate yPlus
-                scalar yPlus =
-                    Cmu25*y[patchi][facei]
-                   *::sqrt(k[faceCelli])
-                   /nub.value();
-
-                if (yPlus > 11.6)
-                {
-                    nutw[facei] =
-                        yPlus*nub.value()*kappa
-                       /::log(E*yPlus)
-                      - nub.value();
-                }
-                else
-                {
-                    nutw[facei] = 0.0;
-                }
-            }
-        }
-    }
-}
diff --git a/applications/utilities/parallelProcessing/redistributeMeshPar/redistributeMeshPar.C b/applications/utilities/parallelProcessing/redistributeMeshPar/redistributeMeshPar.C
index c0859573e0d706fc2c996f66ec00aad434a49d9b..40db19f4b3612302ef972bd74eb6acf1480a8b67 100644
--- a/applications/utilities/parallelProcessing/redistributeMeshPar/redistributeMeshPar.C
+++ b/applications/utilities/parallelProcessing/redistributeMeshPar/redistributeMeshPar.C
@@ -26,7 +26,14 @@ Application
     redistributeMeshPar
 
 Description
-    Parallel redecomposition of mesh.
+    Parallel redecomposition of mesh. Start with maximum number of processors.
+    Balances mesh and writes new mesh to new timedirectory.
+
+    Can also work like decomposePar:
+
+        mkdir processor0
+        cp -r constant processor0
+        mpirun -np ddd redistributeMeshPar -parallel
 
 \*---------------------------------------------------------------------------*/
 
diff --git a/applications/utilities/preProcessing/applyWallFunctionBounaryConditions/applyWallFunctionBounaryConditions.C b/applications/utilities/preProcessing/applyWallFunctionBounaryConditions/applyWallFunctionBounaryConditions.C
index 1cdc3f28abe605beedac2880e0a5c9e2f5942b54..b26c7154fc9a8612ca4fb190caf6f71d04a665da 100644
--- a/applications/utilities/preProcessing/applyWallFunctionBounaryConditions/applyWallFunctionBounaryConditions.C
+++ b/applications/utilities/preProcessing/applyWallFunctionBounaryConditions/applyWallFunctionBounaryConditions.C
@@ -266,9 +266,9 @@ int main(int argc, char *argv[])
 
     replaceBoundaryType(mesh, "epsilon", "epsilonWallFunction", "0");
     replaceBoundaryType(mesh, "omega", "omegaWallFunction", "0");
-    replaceBoundaryType(mesh, "k", "kQRWallFunction", "0");
-    replaceBoundaryType(mesh, "q", "kQRWallFunction", "0");
-    replaceBoundaryType(mesh, "R", "kQRWallFunction", "(0 0 0 0 0 0)");
+    replaceBoundaryType(mesh, "k", "kqRWallFunction", "0");
+    replaceBoundaryType(mesh, "q", "kqRWallFunction", "0");
+    replaceBoundaryType(mesh, "R", "kqRWallFunction", "(0 0 0 0 0 0)");
 
     Info<< "End\n" << endl;
 
diff --git a/etc/apps/paraview3/bashrc b/etc/apps/paraview3/bashrc
index 6536eb32ce6425f2efd66f0e0530b9ae3750dc1c..354687e30a50c46efe739382ff8f0745d8c3bc56 100644
--- a/etc/apps/paraview3/bashrc
+++ b/etc/apps/paraview3/bashrc
@@ -47,7 +47,7 @@ do
 done
 
 paraviewMajor=paraview-3.6
-export ParaView_VERSION=3.6
+export ParaView_VERSION=3.6.1
 
 export ParaView_INST_DIR=$WM_THIRD_PARTY_DIR/paraview-$ParaView_VERSION
 export ParaView_DIR=$ParaView_INST_DIR/platforms/$WM_ARCH$WM_COMPILER
diff --git a/etc/apps/paraview3/cshrc b/etc/apps/paraview3/cshrc
index 66c7e1a54f283c56121c74164e482b7b221d437d..7da38cfaa51b1b210a48e02dde45ae67bcf580fa 100644
--- a/etc/apps/paraview3/cshrc
+++ b/etc/apps/paraview3/cshrc
@@ -44,7 +44,7 @@ foreach cmake ( cmake-2.6.4 cmake-2.6.2 cmake-2.4.6 )
     endif
 end
 
-set paraviewMajor=paraview-3.6
+set paraviewMajor=paraview-3.6.1
 setenv ParaView_VERSION 3.6
 
 setenv ParaView_INST_DIR $WM_THIRD_PARTY_DIR/paraview-$ParaView_VERSION
diff --git a/etc/controlDict b/etc/controlDict
index f06bbbd96123726a277fbb8a18a29ea084bb8d10..a76ef3c335037549ab8bb81220aca0587dc9e1e9 100644
--- a/etc/controlDict
+++ b/etc/controlDict
@@ -520,7 +520,7 @@ DebugSwitches
     kOmega              0;
     kOmegaSST           0;
     kOmegaSSTSAS        0;
-    kQRWallFunction     0;
+    kqRWallFunction     0;
     kinematicCloud      0;
     labelField          0;
     labelList           0;
diff --git a/src/OpenFOAM/db/functionObjects/OutputFilterFunctionObject/OutputFilterFunctionObject.C b/src/OpenFOAM/db/functionObjects/OutputFilterFunctionObject/OutputFilterFunctionObject.C
index 15a32c1e8e3b979d53da4aefac77e0e65afe4682..4e3bf3fad6849ce9daa4d5c6189716b91bd139f8 100644
--- a/src/OpenFOAM/db/functionObjects/OutputFilterFunctionObject/OutputFilterFunctionObject.C
+++ b/src/OpenFOAM/db/functionObjects/OutputFilterFunctionObject/OutputFilterFunctionObject.C
@@ -50,8 +50,7 @@ Foam::OutputFilterFunctionObject<OutputFilter>::OutputFilterFunctionObject
     const dictionary& dict
 )
 :
-    functionObject(),
-    name_(name),
+    functionObject(name),
     time_(t),
     dict_(dict),
     regionName_(polyMesh::defaultRegion),
@@ -92,7 +91,7 @@ bool Foam::OutputFilterFunctionObject<OutputFilter>::start()
             (
                 new IOOutputFilter<OutputFilter>
                 (
-                    name_,
+                    name(),
                     time_.lookupObject<objectRegistry>(regionName_),
                     dictName_
                 )
@@ -104,7 +103,7 @@ bool Foam::OutputFilterFunctionObject<OutputFilter>::start()
             (
                 new OutputFilter
                 (
-                    name_,
+                    name(),
                     time_.lookupObject<objectRegistry>(regionName_),
                     dict_
                 )
diff --git a/src/OpenFOAM/db/functionObjects/OutputFilterFunctionObject/OutputFilterFunctionObject.H b/src/OpenFOAM/db/functionObjects/OutputFilterFunctionObject/OutputFilterFunctionObject.H
index 9ac00bd060f7d650f216ad162595af56ca7a31f6..f6c183e803cb0aadf64d2fe346faa8d975e09d10 100644
--- a/src/OpenFOAM/db/functionObjects/OutputFilterFunctionObject/OutputFilterFunctionObject.H
+++ b/src/OpenFOAM/db/functionObjects/OutputFilterFunctionObject/OutputFilterFunctionObject.H
@@ -63,9 +63,6 @@ class OutputFilterFunctionObject
 {
     // Private data
 
-        //- Output filter name
-        word name_;
-
         //- Reference to the time database
         const Time& time_;
 
@@ -121,12 +118,6 @@ public:
 
         // Access
 
-            //- Return name
-            virtual const word& name() const
-            {
-                return name_;
-            }
-
             //- Return time database
             virtual const Time& time() const
             {
diff --git a/src/OpenFOAM/db/functionObjects/functionObject/functionObject.C b/src/OpenFOAM/db/functionObjects/functionObject/functionObject.C
index a731621ff676fae227b64f15f4387b2a006170dd..3157cea04bb4dfcc8f5ef70dcc0b49fa984af62b 100644
--- a/src/OpenFOAM/db/functionObjects/functionObject/functionObject.C
+++ b/src/OpenFOAM/db/functionObjects/functionObject/functionObject.C
@@ -36,7 +36,9 @@ int Foam::functionObject::debug(Foam::debug::debugSwitch("functionObject", 0));
 
 // * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
 
-Foam::functionObject::functionObject()
+Foam::functionObject::functionObject(const word& name)
+:
+    name_(name)
 {}
 
 
@@ -103,6 +105,12 @@ Foam::functionObject::~functionObject()
 
 // * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
 
+const Foam::word& Foam::functionObject::name() const
+{
+    return name_;
+}
+
+
 bool Foam::functionObject::end()
 {
     return execute();
diff --git a/src/OpenFOAM/db/functionObjects/functionObject/functionObject.H b/src/OpenFOAM/db/functionObjects/functionObject/functionObject.H
index 94a2f7aea4848f65b2279142f4dc0eb8e2c9b642..8757c3adbcc0e5547469458b955e8d7b8fd155ec 100644
--- a/src/OpenFOAM/db/functionObjects/functionObject/functionObject.H
+++ b/src/OpenFOAM/db/functionObjects/functionObject/functionObject.H
@@ -57,6 +57,12 @@ class Time;
 
 class functionObject
 {
+    // Private data
+
+        //- Name
+        const word name_;
+
+
     // Private Member Functions
 
         //- Disallow default bitwise copy construct
@@ -88,8 +94,8 @@ public:
 
     // Constructors
 
-        //- Construct null
-        functionObject();
+        //- Construct from components
+        functionObject(const word& name);
 
         //- Return clone
         autoPtr<functionObject> clone() const
@@ -137,6 +143,9 @@ public:
 
     // Member Functions
 
+        //- Name
+        virtual const word& name() const;
+
         //- Called at the start of the time-loop
         virtual bool start() = 0;
 
diff --git a/src/OpenFOAM/db/functionObjects/functionObjectList/functionObjectList.H b/src/OpenFOAM/db/functionObjects/functionObjectList/functionObjectList.H
index ea2c43adf328e285fcde866a85a9997449ce8353..0b3a0354641d0d90d6833fda92429298fdc3614b 100644
--- a/src/OpenFOAM/db/functionObjects/functionObjectList/functionObjectList.H
+++ b/src/OpenFOAM/db/functionObjects/functionObjectList/functionObjectList.H
@@ -133,6 +133,9 @@ public:
         //- Return true if the List is empty (ie, size() is zero).
         using PtrList<functionObject>::empty;
 
+        //- Access to the functionObjects
+        using PtrList<functionObject>::operator[];
+
         //- Clear the list of function objects
         virtual void clear();
 
diff --git a/src/lagrangian/basic/passiveParticle/passiveParticleCloud.C b/src/lagrangian/basic/passiveParticle/passiveParticleCloud.C
index 18844ffcea9d845c8cbd16c9642ed3a5fd310a15..ebb67d26de9f9b4f31bd0aa010108d3d4bfc30d9 100644
--- a/src/lagrangian/basic/passiveParticle/passiveParticleCloud.C
+++ b/src/lagrangian/basic/passiveParticle/passiveParticleCloud.C
@@ -52,6 +52,17 @@ Foam::passiveParticleCloud::passiveParticleCloud
 }
 
 
+Foam::passiveParticleCloud::passiveParticleCloud
+(
+    const polyMesh& mesh,
+    const word& cloudName,
+    const IDLList<passiveParticle>& particles
+)
+:
+    Cloud<passiveParticle>(mesh, cloudName, particles)
+{}
+
+
 // * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
 
 void Foam::passiveParticleCloud::readFields()
diff --git a/src/lagrangian/basic/passiveParticle/passiveParticleCloud.H b/src/lagrangian/basic/passiveParticle/passiveParticleCloud.H
index b8faac8f439c9bd4754b2c7d5c8189dba7f70268..e3c0266fa3b922157d7ac9605bac8d31e7b3cba0 100644
--- a/src/lagrangian/basic/passiveParticle/passiveParticleCloud.H
+++ b/src/lagrangian/basic/passiveParticle/passiveParticleCloud.H
@@ -63,6 +63,9 @@ class passiveParticleCloud
 
 public:
 
+    //- Type of parcel the cloud was instantiated for
+    typedef passiveParticle parcelType;
+
     // Constructors
 
         //- Construct given mesh
@@ -72,6 +75,14 @@ public:
             const word& cloudName = "defaultCloud"
         );
 
+        //- Construct from mesh, cloud name, and a list of particles
+        passiveParticleCloud
+        (
+            const polyMesh& mesh,
+            const word& cloudName,
+            const IDLList<passiveParticle>& particles
+        );
+
 
     // Member Functions
 
diff --git a/src/sampling/sampledSurface/isoSurface/isoSurfaceTemplates.C b/src/sampling/sampledSurface/isoSurface/isoSurfaceTemplates.C
index d7903551c9c70d4508faacbb0b13fd1b41acdd2d..1a7a68ad4c9908a11e893ef5c5e56485c0e32091 100644
--- a/src/sampling/sampledSurface/isoSurface/isoSurfaceTemplates.C
+++ b/src/sampling/sampledSurface/isoSurface/isoSurfaceTemplates.C
@@ -81,7 +81,11 @@ Foam::isoSurface::adaptPatchFields
     {
         const polyPatch& pp = patches[patchI];
 
-        if (isA<emptyPolyPatch>(pp))
+        if
+        (
+            isA<emptyPolyPatch>(pp)
+         && pp.size() != sliceFld.boundaryField()[patchI].size()
+        )
         {
             // Clear old value. Cannot resize it since is a slice.
             sliceFld.boundaryField().set(patchI, NULL);
@@ -96,11 +100,18 @@ Foam::isoSurface::adaptPatchFields
                     sliceFld
                 )
             );
-            sliceFld.boundaryField()[patchI] ==
-                mesh.boundary()[patchI].patchInternalField
-                (
-                    sliceFld
-                );
+
+            // Note: cannot use patchInternalField since uses emptyFvPatch::size
+            // Do our own internalField instead.
+            const unallocLabelList& faceCells =
+                mesh.boundary()[patchI].patch().faceCells();
+
+            Field<Type>& pfld = sliceFld.boundaryField()[patchI];
+            pfld.setSize(faceCells.size());
+            forAll(faceCells, i)
+            {
+                pfld[i] = sliceFld[faceCells[i]];
+            }
         }
         else if (isA<cyclicPolyPatch>(pp))
         {
diff --git a/src/sampling/sampledSurface/sampledCuttingPlane/sampledCuttingPlane.C b/src/sampling/sampledSurface/sampledCuttingPlane/sampledCuttingPlane.C
index 85dbeca59590d134b6e7fca455dd391229119de2..2bcf3784b6ec83f34120b70032f71e9bf8b4bb9b 100644
--- a/src/sampling/sampledSurface/sampledCuttingPlane/sampledCuttingPlane.C
+++ b/src/sampling/sampledSurface/sampledCuttingPlane/sampledCuttingPlane.C
@@ -37,7 +37,13 @@ License
 namespace Foam
 {
     defineTypeNameAndDebug(sampledCuttingPlane, 0);
-    addNamedToRunTimeSelectionTable(sampledSurface, sampledCuttingPlane, word, cuttingPlane);
+    addNamedToRunTimeSelectionTable
+    (
+        sampledSurface,
+        sampledCuttingPlane,
+        word,
+        cuttingPlane
+    );
 }
 
 // * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
@@ -118,7 +124,7 @@ void Foam::sampledCuttingPlane::createGeometry()
 
     // Internal field
     {
-        const pointField& cc = fvm.C();
+        const pointField& cc = fvm.cellCentres();
         scalarField& fld = cellDistance.internalField();
 
         forAll(cc, i)
@@ -130,14 +136,45 @@ void Foam::sampledCuttingPlane::createGeometry()
 
     // Patch fields
     {
-        forAll(fvm.C().boundaryField(), patchI)
+        forAll(cellDistance.boundaryField(), patchI)
         {
-            const pointField& cc = fvm.C().boundaryField()[patchI];
-            fvPatchScalarField& fld = cellDistance.boundaryField()[patchI];
-
-            forAll(fld, i)
+            if
+            (
+                isA<emptyFvPatchScalarField>
+                (
+                    cellDistance.boundaryField()[patchI]
+                )
+            )
             {
-                fld[i] =  (cc[i] - plane_.refPoint()) & plane_.normal();
+                cellDistance.boundaryField().set
+                (
+                    patchI,
+                    new calculatedFvPatchScalarField
+                    (
+                        fvm.boundary()[patchI],
+                        cellDistance
+                    )
+                );
+
+                const polyPatch& pp = fvm.boundary()[patchI].patch();
+                pointField::subField cc = pp.patchSlice(fvm.faceCentres());
+
+                fvPatchScalarField& fld = cellDistance.boundaryField()[patchI];
+                fld.setSize(pp.size());
+                forAll(fld, i)
+                {
+                    fld[i] = (cc[i] - plane_.refPoint()) & plane_.normal();
+                }
+            }
+            else
+            {
+                const pointField& cc = fvm.C().boundaryField()[patchI];
+                fvPatchScalarField& fld = cellDistance.boundaryField()[patchI];
+
+                forAll(fld, i)
+                {
+                    fld[i] =  (cc[i] - plane_.refPoint()) & plane_.normal();
+                }
             }
         }
     }
diff --git a/src/turbulenceModels/compressible/RAS/Make/files b/src/turbulenceModels/compressible/RAS/Make/files
index 7642142d56d1e82a95537619f96d4d2291b697d4..da455db87f2b263fb678e60978c39bb084b73ba3 100644
--- a/src/turbulenceModels/compressible/RAS/Make/files
+++ b/src/turbulenceModels/compressible/RAS/Make/files
@@ -29,8 +29,8 @@ $(epsilonWallFunctions)/epsilonWallFunction/epsilonWallFunctionFvPatchScalarFiel
 omegaWallFunctions = $(wallFunctions)/omegaWallFunctions
 $(omegaWallFunctions)/omegaWallFunction/omegaWallFunctionFvPatchScalarField.C
 
-kQRWallFunctions = $(wallFunctions)/kQRWallFunctions
-$(kQRWallFunctions)/kQRWallFunction/kQRWallFunctionFvPatchFields.C
+kqRWallFunctions = $(wallFunctions)/kqRWallFunctions
+$(kqRWallFunctions)/kqRWallFunction/kqRWallFunctionFvPatchFields.C
 
 /* Patch fields */
 derivedFvPatchFields/turbulentHeatFluxTemperature/turbulentHeatFluxTemperatureFvPatchScalarField.C
diff --git a/src/turbulenceModels/compressible/RAS/backwardsCompatibility/wallFunctions/backwardsCompatibilityWallFunctions.C b/src/turbulenceModels/compressible/RAS/backwardsCompatibility/wallFunctions/backwardsCompatibilityWallFunctions.C
index 657dfbb48e629f38f435eb7cbd6d19f5fe48432b..4749b46c0725876a76250fd3f63bfe5160aaa0fc 100644
--- a/src/turbulenceModels/compressible/RAS/backwardsCompatibility/wallFunctions/backwardsCompatibilityWallFunctions.C
+++ b/src/turbulenceModels/compressible/RAS/backwardsCompatibility/wallFunctions/backwardsCompatibilityWallFunctions.C
@@ -30,7 +30,7 @@ License
 #include "alphatWallFunctionFvPatchScalarField.H"
 #include "mutWallFunctionFvPatchScalarField.H"
 #include "epsilonWallFunctionFvPatchScalarField.H"
-#include "kQRWallFunctionFvPatchField.H"
+#include "kqRWallFunctionFvPatchField.H"
 #include "omegaWallFunctionFvPatchScalarField.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@@ -230,7 +230,7 @@ tmp<volScalarField> autoCreateK
         autoCreateWallFunctionField
         <
             scalar,
-            RASModels::kQRWallFunctionFvPatchField<scalar>
+            RASModels::kqRWallFunctionFvPatchField<scalar>
         >
         (
             fieldName,
@@ -249,7 +249,7 @@ tmp<volScalarField> autoCreateQ
         autoCreateWallFunctionField
         <
             scalar,
-            RASModels::kQRWallFunctionFvPatchField<scalar>
+            RASModels::kqRWallFunctionFvPatchField<scalar>
         >
         (
             fieldName,
@@ -268,7 +268,7 @@ tmp<volSymmTensorField> autoCreateR
         autoCreateWallFunctionField
         <
             symmTensor,
-            RASModels::kQRWallFunctionFvPatchField<symmTensor>
+            RASModels::kqRWallFunctionFvPatchField<symmTensor>
         >
         (
             fieldName,
diff --git a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentMixingLengthDissipationRateInlet/turbulentMixingLengthDissipationRateInletFvPatchScalarField.C b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentMixingLengthDissipationRateInlet/turbulentMixingLengthDissipationRateInletFvPatchScalarField.C
index 2e44d03c738b06ce84a018e98c9d263a25053c59..d83cd7bfc2557a499c27db1c5dc1b2a52146307d 100644
--- a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentMixingLengthDissipationRateInlet/turbulentMixingLengthDissipationRateInletFvPatchScalarField.C
+++ b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentMixingLengthDissipationRateInlet/turbulentMixingLengthDissipationRateInletFvPatchScalarField.C
@@ -110,7 +110,9 @@ void turbulentMixingLengthDissipationRateInletFvPatchScalarField::updateCoeffs()
     // Lookup Cmu corresponding to the turbulence model selected
     const RASModel& rasModel = db().lookupObject<RASModel>("RASProperties");
 
-    const scalar Cmu = readScalar(rasModel.coeffDict().lookup("Cmu"));
+    const scalar Cmu =
+        rasModel.coeffDict().lookupOrDefault<scalar>("Cmu", 0.09);
+
     const scalar Cmu75 = pow(Cmu, 0.75);
 
     const fvPatchField<scalar>& kp =
diff --git a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentMixingLengthFrequencyInlet/turbulentMixingLengthFrequencyInletFvPatchScalarField.C b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentMixingLengthFrequencyInlet/turbulentMixingLengthFrequencyInletFvPatchScalarField.C
index 60a8e9c9e3da353537e9fba6bca55632c7559a15..5893f2072ebff0ddc2a2fb4476d45ba8897029de 100644
--- a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentMixingLengthFrequencyInlet/turbulentMixingLengthFrequencyInletFvPatchScalarField.C
+++ b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentMixingLengthFrequencyInlet/turbulentMixingLengthFrequencyInletFvPatchScalarField.C
@@ -115,7 +115,9 @@ void turbulentMixingLengthFrequencyInletFvPatchScalarField::updateCoeffs()
     // Lookup Cmu corresponding to the turbulence model selected
     const RASModel& rasModel = db().lookupObject<RASModel>("RASProperties");
 
-    const scalar Cmu = readScalar(rasModel.coeffDict().lookup("Cmu"));
+    const scalar Cmu =
+        rasModel.coeffDict().lookupOrDefault<scalar>("Cmu", 0.09);
+
     const scalar Cmu25 = pow(Cmu, 0.25);
 
     const fvPatchField<scalar>& kp =
diff --git a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.C b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.C
similarity index 80%
rename from src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.C
rename to src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.C
index c0152e545a3fac7830ddbe955ed8cda1cb7e9cd1..16bab379df60bc31f2bd695b4684f1ab816bf1b8 100644
--- a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.C
+++ b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 1991-2009 OpenCFD Ltd.
+    \\  /    A nd           | Copyright (C) 2008-2009 OpenCFD Ltd.
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -24,7 +24,7 @@ License
 
 \*---------------------------------------------------------------------------*/
 
-#include "kQRWallFunctionFvPatchField.H"
+#include "kqRWallFunctionFvPatchField.H"
 #include "fvPatchFieldMapper.H"
 #include "addToRunTimeSelectionTable.H"
 #include "wallFvPatch.H"
@@ -41,11 +41,11 @@ namespace RASModels
 // * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
 
 template<class Type>
-void kQRWallFunctionFvPatchField<Type>::checkType()
+void kqRWallFunctionFvPatchField<Type>::checkType()
 {
     if (!isA<wallFvPatch>(this->patch()))
     {
-        FatalErrorIn("kQRWallFunctionFvPatchField::checkType()")
+        FatalErrorIn("kqRWallFunctionFvPatchField::checkType()")
             << "Invalid wall function specification" << nl
             << "    Patch type for patch " << this->patch().name()
             << " must be wall" << nl
@@ -58,7 +58,7 @@ void kQRWallFunctionFvPatchField<Type>::checkType()
 // * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
 
 template<class Type>
-kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
+kqRWallFunctionFvPatchField<Type>::kqRWallFunctionFvPatchField
 (
     const fvPatch& p,
     const DimensionedField<Type, volMesh>& iF
@@ -71,9 +71,9 @@ kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
 
 
 template<class Type>
-kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
+kqRWallFunctionFvPatchField<Type>::kqRWallFunctionFvPatchField
 (
-    const kQRWallFunctionFvPatchField& ptf,
+    const kqRWallFunctionFvPatchField& ptf,
     const fvPatch& p,
     const DimensionedField<Type, volMesh>& iF,
     const fvPatchFieldMapper& mapper
@@ -86,7 +86,7 @@ kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
 
 
 template<class Type>
-kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
+kqRWallFunctionFvPatchField<Type>::kqRWallFunctionFvPatchField
 (
     const fvPatch& p,
     const DimensionedField<Type, volMesh>& iF,
@@ -100,9 +100,9 @@ kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
 
 
 template<class Type>
-kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
+kqRWallFunctionFvPatchField<Type>::kqRWallFunctionFvPatchField
 (
-    const kQRWallFunctionFvPatchField& tkqrwfpf
+    const kqRWallFunctionFvPatchField& tkqrwfpf
 )
 :
     zeroGradientFvPatchField<Type>(tkqrwfpf)
@@ -112,9 +112,9 @@ kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
 
 
 template<class Type>
-kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
+kqRWallFunctionFvPatchField<Type>::kqRWallFunctionFvPatchField
 (
-    const kQRWallFunctionFvPatchField& tkqrwfpf,
+    const kqRWallFunctionFvPatchField& tkqrwfpf,
     const DimensionedField<Type, volMesh>& iF
 )
 :
@@ -127,7 +127,7 @@ kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
 // * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
 
 template<class Type>
-void kQRWallFunctionFvPatchField<Type>::evaluate
+void kqRWallFunctionFvPatchField<Type>::evaluate
 (
     const Pstream::commsTypes commsType
 )
@@ -137,7 +137,7 @@ void kQRWallFunctionFvPatchField<Type>::evaluate
 
 
 template<class Type>
-void kQRWallFunctionFvPatchField<Type>::write(Ostream& os) const
+void kqRWallFunctionFvPatchField<Type>::write(Ostream& os) const
 {
     zeroGradientFvPatchField<Type>::write(os);
     this->writeEntry("value", os);
diff --git a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.H b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.H
similarity index 82%
rename from src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.H
rename to src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.H
index cacb704e32a1ac2a30c01c859bc507855bc2af15..60baa36ff4b8b95e29c702ca1ae79dcc45dc95b8 100644
--- a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.H
+++ b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.H
@@ -23,19 +23,19 @@ License
     Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
 
 Class
-    Foam::compressible::RASModels::kQRWallFunctionFvPatchField
+    Foam::compressible::RASModels::kqRWallFunctionFvPatchField
 
 Description
     Boundary condition for turbulence k, Q, and R when using wall functions.
     Simply acts as a zero gradient condition.
 
 SourceFiles
-    kQRWallFunctionFvPatchField.C
+    kqRWallFunctionFvPatchField.C
 
 \*---------------------------------------------------------------------------*/
 
-#ifndef kQRWallFunctionFvPatchField_H
-#define kQRWallFunctionFvPatchField_H
+#ifndef kqRWallFunctionFvPatchField_H
+#define kqRWallFunctionFvPatchField_H
 
 #include "zeroGradientFvPatchField.H"
 
@@ -49,11 +49,11 @@ namespace RASModels
 {
 
 /*---------------------------------------------------------------------------*\
-                Class kQRWallFunctionFvPatchField Declaration
+                Class kqRWallFunctionFvPatchField Declaration
 \*---------------------------------------------------------------------------*/
 
 template<class Type>
-class kQRWallFunctionFvPatchField
+class kqRWallFunctionFvPatchField
 :
     public zeroGradientFvPatchField<Type>
 {
@@ -67,20 +67,20 @@ class kQRWallFunctionFvPatchField
 public:
 
     //- Runtime type information
-    TypeName("compressible::kQRWallFunction");
+    TypeName("compressible::kqRWallFunction");
 
 
     // Constructors
 
         //- Construct from patch and internal field
-        kQRWallFunctionFvPatchField
+        kqRWallFunctionFvPatchField
         (
             const fvPatch&,
             const DimensionedField<Type, volMesh>&
         );
 
         //- Construct from patch, internal field and dictionary
-        kQRWallFunctionFvPatchField
+        kqRWallFunctionFvPatchField
         (
             const fvPatch&,
             const DimensionedField<Type, volMesh>&,
@@ -88,20 +88,20 @@ public:
         );
 
         //- Construct by mapping given
-        // kQRWallFunctionFvPatchField
+        // kqRWallFunctionFvPatchField
         //  onto a new patch
-        kQRWallFunctionFvPatchField
+        kqRWallFunctionFvPatchField
         (
-            const kQRWallFunctionFvPatchField&,
+            const kqRWallFunctionFvPatchField&,
             const fvPatch&,
             const DimensionedField<Type, volMesh>&,
             const fvPatchFieldMapper&
         );
 
         //- Construct as copy
-        kQRWallFunctionFvPatchField
+        kqRWallFunctionFvPatchField
         (
-            const kQRWallFunctionFvPatchField&
+            const kqRWallFunctionFvPatchField&
         );
 
         //- Construct and return a clone
@@ -109,14 +109,14 @@ public:
         {
             return tmp<fvPatchField<Type> >
             (
-                new kQRWallFunctionFvPatchField(*this)
+                new kqRWallFunctionFvPatchField(*this)
             );
         }
 
         //- Construct as copy setting internal field reference
-        kQRWallFunctionFvPatchField
+        kqRWallFunctionFvPatchField
         (
-            const kQRWallFunctionFvPatchField&,
+            const kqRWallFunctionFvPatchField&,
             const DimensionedField<Type, volMesh>&
         );
 
@@ -128,7 +128,7 @@ public:
         {
             return tmp<fvPatchField<Type> >
             (
-                new kQRWallFunctionFvPatchField(*this, iF)
+                new kqRWallFunctionFvPatchField(*this, iF)
             );
         }
 
@@ -160,7 +160,7 @@ public:
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
 #ifdef NoRepository
-#   include "kQRWallFunctionFvPatchField.C"
+#   include "kqRWallFunctionFvPatchField.C"
 #endif
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
diff --git a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.C b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.C
similarity index 95%
rename from src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.C
rename to src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.C
index 684b60c05cd094c607a719db12791f6f3761158e..e25b7ff0232e6091a6a0219a870870a96321d0ff 100644
--- a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.C
+++ b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.C
@@ -24,7 +24,7 @@ License
 
 \*---------------------------------------------------------------------------*/
 
-#include "kQRWallFunctionFvPatchFields.H"
+#include "kqRWallFunctionFvPatchFields.H"
 #include "fvPatchFields.H"
 #include "addToRunTimeSelectionTable.H"
 #include "volFields.H"
@@ -40,7 +40,7 @@ namespace RASModels
 
 // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
 
-makePatchFields(kQRWallFunction);
+makePatchFields(kqRWallFunction);
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
diff --git a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.H b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.H
similarity index 91%
rename from src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.H
rename to src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.H
index 5f9bd57445e1fec8d77687a90b7ca5558d981766..bd72c6a7321863ac4300cfd5b6b60561a9ff9e3a 100644
--- a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.H
+++ b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.H
@@ -24,10 +24,10 @@ License
 
 \*---------------------------------------------------------------------------*/
 
-#ifndef kQRWallFunctionFvPatchFields_H
-#define kQRWallFunctionFvPatchFields_H
+#ifndef kqRWallFunctionFvPatchFields_H
+#define kqRWallFunctionFvPatchFields_H
 
-#include "kQRWallFunctionFvPatchField.H"
+#include "kqRWallFunctionFvPatchField.H"
 #include "fieldTypes.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@@ -41,7 +41,7 @@ namespace RASModels
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-makePatchTypeFieldTypedefs(kQRWallFunction)
+makePatchTypeFieldTypedefs(kqRWallFunction)
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
diff --git a/src/turbulenceModels/incompressible/RAS/Make/files b/src/turbulenceModels/incompressible/RAS/Make/files
index 95322d4f68c38c6f66ecd763e58fbb6cfeecb1b5..e7ac20e59ede919f4508677cec7dd08411b9ce13 100644
--- a/src/turbulenceModels/incompressible/RAS/Make/files
+++ b/src/turbulenceModels/incompressible/RAS/Make/files
@@ -10,7 +10,7 @@ SpalartAllmaras/SpalartAllmaras.C
 LRR/LRR.C
 LaunderGibsonRSTM/LaunderGibsonRSTM.C
 LaunderSharmaKE/LaunderSharmaKE.C
-QZeta/QZeta.C
+qZeta/qZeta.C
 LienCubicKE/LienCubicKE.C
 LienCubicKELowRe/LienCubicKELowRe.C
 NonlinearKEShih/NonlinearKEShih.C
@@ -33,8 +33,8 @@ $(epsilonWallFunctions)/epsilonWallFunction/epsilonWallFunctionFvPatchScalarFiel
 omegaWallFunctions = $(wallFunctions)/omegaWallFunctions
 $(omegaWallFunctions)/omegaWallFunction/omegaWallFunctionFvPatchScalarField.C
 
-kQRWallFunctions = $(wallFunctions)/kQRWallFunctions
-$(kQRWallFunctions)/kQRWallFunction/kQRWallFunctionFvPatchFields.C
+kqRWallFunctions = $(wallFunctions)/kqRWallFunctions
+$(kqRWallFunctions)/kqRWallFunction/kqRWallFunctionFvPatchFields.C
 
 
 /* Patch fields */
diff --git a/src/turbulenceModels/incompressible/RAS/backwardsCompatibility/wallFunctions/backwardsCompatibilityWallFunctions.C b/src/turbulenceModels/incompressible/RAS/backwardsCompatibility/wallFunctions/backwardsCompatibilityWallFunctions.C
index f7b144a03b4bdce4890b2d06eaeb83a278a3b402..900cd1a24eac096fa57d6c1bfac52379a36b526e 100644
--- a/src/turbulenceModels/incompressible/RAS/backwardsCompatibility/wallFunctions/backwardsCompatibilityWallFunctions.C
+++ b/src/turbulenceModels/incompressible/RAS/backwardsCompatibility/wallFunctions/backwardsCompatibilityWallFunctions.C
@@ -29,7 +29,7 @@ License
 #include "calculatedFvPatchField.H"
 #include "nutWallFunctionFvPatchScalarField.H"
 #include "epsilonWallFunctionFvPatchScalarField.H"
-#include "kQRWallFunctionFvPatchField.H"
+#include "kqRWallFunctionFvPatchField.H"
 #include "omegaWallFunctionFvPatchScalarField.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@@ -159,7 +159,7 @@ tmp<volScalarField> autoCreateK
         autoCreateWallFunctionField
         <
             scalar,
-            RASModels::kQRWallFunctionFvPatchField<scalar>
+            RASModels::kqRWallFunctionFvPatchField<scalar>
         >
         (
             fieldName,
@@ -178,7 +178,7 @@ tmp<volScalarField> autoCreateQ
         autoCreateWallFunctionField
         <
             scalar,
-            RASModels::kQRWallFunctionFvPatchField<scalar>
+            RASModels::kqRWallFunctionFvPatchField<scalar>
         >
         (
             fieldName,
@@ -197,7 +197,7 @@ tmp<volSymmTensorField> autoCreateR
         autoCreateWallFunctionField
         <
             symmTensor,
-            RASModels::kQRWallFunctionFvPatchField<symmTensor>
+            RASModels::kqRWallFunctionFvPatchField<symmTensor>
         >
         (
             fieldName,
diff --git a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/turbulentMixingLengthDissipationRateInlet/turbulentMixingLengthDissipationRateInletFvPatchScalarField.C b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/turbulentMixingLengthDissipationRateInlet/turbulentMixingLengthDissipationRateInletFvPatchScalarField.C
index 3c880b108ffa5f8f658d8c1d70f3848bcb72ad71..cab3484017c2d48afc8df8a8a6c6439fe8c82bdd 100644
--- a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/turbulentMixingLengthDissipationRateInlet/turbulentMixingLengthDissipationRateInletFvPatchScalarField.C
+++ b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/turbulentMixingLengthDissipationRateInlet/turbulentMixingLengthDissipationRateInletFvPatchScalarField.C
@@ -110,7 +110,9 @@ void turbulentMixingLengthDissipationRateInletFvPatchScalarField::updateCoeffs()
     // Lookup Cmu corresponding to the turbulence model selected
     const RASModel& rasModel = db().lookupObject<RASModel>("RASProperties");
 
-    const scalar Cmu = readScalar(rasModel.coeffDict().lookup("Cmu"));
+    const scalar Cmu =
+        rasModel.coeffDict().lookupOrDefault<scalar>("Cmu", 0.09);
+
     const scalar Cmu75 = pow(Cmu, 0.75);
 
     const fvPatchField<scalar>& kp =
diff --git a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/turbulentMixingLengthFrequencyInlet/turbulentMixingLengthFrequencyInletFvPatchScalarField.C b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/turbulentMixingLengthFrequencyInlet/turbulentMixingLengthFrequencyInletFvPatchScalarField.C
index acff657d959025afeb79a96e9d62d75deac9cdda..dac5ccb0f16498e57b9541d9149d6c0310a48104 100644
--- a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/turbulentMixingLengthFrequencyInlet/turbulentMixingLengthFrequencyInletFvPatchScalarField.C
+++ b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/turbulentMixingLengthFrequencyInlet/turbulentMixingLengthFrequencyInletFvPatchScalarField.C
@@ -115,7 +115,9 @@ void turbulentMixingLengthFrequencyInletFvPatchScalarField::updateCoeffs()
     // Lookup Cmu corresponding to the turbulence model selected
     const RASModel& rasModel = db().lookupObject<RASModel>("RASProperties");
 
-    const scalar Cmu = readScalar(rasModel.coeffDict().lookup("Cmu"));
+    const scalar Cmu =
+        rasModel.coeffDict().lookupOrDefault<scalar>("Cmu", 0.09);
+
     const scalar Cmu25 = pow(Cmu, 0.25);
 
     const fvPatchField<scalar>& kp =
diff --git a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.C b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.C
similarity index 81%
rename from src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.C
rename to src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.C
index 7e503b29c94ab237b97ec4866967d228aa9d67c9..c11ace45b00cf8725d6b3bb7d71b83aeb8603ef6 100644
--- a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.C
+++ b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 1991-2009 OpenCFD Ltd.
+    \\  /    A nd           | Copyright (C) 2008-2009 OpenCFD Ltd.
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -41,11 +41,11 @@ namespace RASModels
 // * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
 
 template<class Type>
-void kQRWallFunctionFvPatchField<Type>::checkType()
+void kqRWallFunctionFvPatchField<Type>::checkType()
 {
     if (!isA<wallFvPatch>(this->patch()))
     {
-        FatalErrorIn("kQRWallFunctionFvPatchField::checkType()")
+        FatalErrorIn("kqRWallFunctionFvPatchField::checkType()")
             << "Invalid wall function specification" << nl
             << "    Patch type for patch " << this->patch().name()
             << " must be wall" << nl
@@ -58,7 +58,7 @@ void kQRWallFunctionFvPatchField<Type>::checkType()
 // * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
 
 template<class Type>
-kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
+kqRWallFunctionFvPatchField<Type>::kqRWallFunctionFvPatchField
 (
     const fvPatch& p,
     const DimensionedField<Type, volMesh>& iF
@@ -71,9 +71,9 @@ kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
 
 
 template<class Type>
-kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
+kqRWallFunctionFvPatchField<Type>::kqRWallFunctionFvPatchField
 (
-    const kQRWallFunctionFvPatchField& ptf,
+    const kqRWallFunctionFvPatchField& ptf,
     const fvPatch& p,
     const DimensionedField<Type, volMesh>& iF,
     const fvPatchFieldMapper& mapper
@@ -86,7 +86,7 @@ kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
 
 
 template<class Type>
-kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
+kqRWallFunctionFvPatchField<Type>::kqRWallFunctionFvPatchField
 (
     const fvPatch& p,
     const DimensionedField<Type, volMesh>& iF,
@@ -100,9 +100,9 @@ kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
 
 
 template<class Type>
-kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
+kqRWallFunctionFvPatchField<Type>::kqRWallFunctionFvPatchField
 (
-    const kQRWallFunctionFvPatchField& tkqrwfpf
+    const kqRWallFunctionFvPatchField& tkqrwfpf
 )
 :
     zeroGradientFvPatchField<Type>(tkqrwfpf)
@@ -112,9 +112,9 @@ kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
 
 
 template<class Type>
-kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
+kqRWallFunctionFvPatchField<Type>::kqRWallFunctionFvPatchField
 (
-    const kQRWallFunctionFvPatchField& tkqrwfpf,
+    const kqRWallFunctionFvPatchField& tkqrwfpf,
     const DimensionedField<Type, volMesh>& iF
 )
 :
@@ -127,7 +127,7 @@ kQRWallFunctionFvPatchField<Type>::kQRWallFunctionFvPatchField
 // * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
 
 template<class Type>
-void kQRWallFunctionFvPatchField<Type>::evaluate
+void kqRWallFunctionFvPatchField<Type>::evaluate
 (
     const Pstream::commsTypes commsType
 )
@@ -137,7 +137,7 @@ void kQRWallFunctionFvPatchField<Type>::evaluate
 
 
 template<class Type>
-void kQRWallFunctionFvPatchField<Type>::write(Ostream& os) const
+void kqRWallFunctionFvPatchField<Type>::write(Ostream& os) const
 {
     zeroGradientFvPatchField<Type>::write(os);
     this->writeEntry("value", os);
diff --git a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.H b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.H
similarity index 82%
rename from src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.H
rename to src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.H
index 1a6c6df19438b53eaf94520b2967478b6a7359cc..b97a56239e915ddb6aefdf82b14201f7513ad1ed 100644
--- a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchField.H
+++ b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.H
@@ -23,19 +23,19 @@ License
     Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
 
 Class
-    Foam::incompressible::RASModels::kQRWallFunctionFvPatchField
+    Foam::incompressible::RASModels::kqRWallFunctionFvPatchField
 
 Description
     Boundary condition for turbulence k, Q, and R when using wall functions.
     Simply acts as a zero gradient condition.
 
 SourceFiles
-    kQRWallFunctionFvPatchField.C
+    kqRWallFunctionFvPatchField.C
 
 \*---------------------------------------------------------------------------*/
 
-#ifndef kQRWallFunctionFvPatchField_H
-#define kQRWallFunctionFvPatchField_H
+#ifndef kqRWallFunctionFvPatchField_H
+#define kqRWallFunctionFvPatchField_H
 
 #include "zeroGradientFvPatchField.H"
 
@@ -49,11 +49,11 @@ namespace RASModels
 {
 
 /*---------------------------------------------------------------------------*\
-                Class kQRWallFunctionFvPatchField Declaration
+                Class kqRWallFunctionFvPatchField Declaration
 \*---------------------------------------------------------------------------*/
 
 template<class Type>
-class kQRWallFunctionFvPatchField
+class kqRWallFunctionFvPatchField
 :
     public zeroGradientFvPatchField<Type>
 {
@@ -67,20 +67,20 @@ class kQRWallFunctionFvPatchField
 public:
 
     //- Runtime type information
-    TypeName("kQRWallFunction");
+    TypeName("kqRWallFunction");
 
 
     // Constructors
 
         //- Construct from patch and internal field
-        kQRWallFunctionFvPatchField
+        kqRWallFunctionFvPatchField
         (
             const fvPatch&,
             const DimensionedField<Type, volMesh>&
         );
 
         //- Construct from patch, internal field and dictionary
-        kQRWallFunctionFvPatchField
+        kqRWallFunctionFvPatchField
         (
             const fvPatch&,
             const DimensionedField<Type, volMesh>&,
@@ -88,20 +88,20 @@ public:
         );
 
         //- Construct by mapping given
-        // kQRWallFunctionFvPatchField
+        // kqRWallFunctionFvPatchField
         //  onto a new patch
-        kQRWallFunctionFvPatchField
+        kqRWallFunctionFvPatchField
         (
-            const kQRWallFunctionFvPatchField&,
+            const kqRWallFunctionFvPatchField&,
             const fvPatch&,
             const DimensionedField<Type, volMesh>&,
             const fvPatchFieldMapper&
         );
 
         //- Construct as copy
-        kQRWallFunctionFvPatchField
+        kqRWallFunctionFvPatchField
         (
-            const kQRWallFunctionFvPatchField&
+            const kqRWallFunctionFvPatchField&
         );
 
         //- Construct and return a clone
@@ -109,14 +109,14 @@ public:
         {
             return tmp<fvPatchField<Type> >
             (
-                new kQRWallFunctionFvPatchField(*this)
+                new kqRWallFunctionFvPatchField(*this)
             );
         }
 
         //- Construct as copy setting internal field reference
-        kQRWallFunctionFvPatchField
+        kqRWallFunctionFvPatchField
         (
-            const kQRWallFunctionFvPatchField&,
+            const kqRWallFunctionFvPatchField&,
             const DimensionedField<Type, volMesh>&
         );
 
@@ -128,7 +128,7 @@ public:
         {
             return tmp<fvPatchField<Type> >
             (
-                new kQRWallFunctionFvPatchField(*this, iF)
+                new kqRWallFunctionFvPatchField(*this, iF)
             );
         }
 
@@ -160,7 +160,7 @@ public:
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
 #ifdef NoRepository
-#   include "kQRWallFunctionFvPatchField.C"
+#   include "kqRWallFunctionFvPatchField.C"
 #endif
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
diff --git a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.C b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.C
similarity index 95%
rename from src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.C
rename to src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.C
index ae99aa59fde01e6b515923441f7bb6da010dcbea..903f35dc43fee3d5e0e8f12381baf724e997cf40 100644
--- a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.C
+++ b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.C
@@ -24,7 +24,7 @@ License
 
 \*---------------------------------------------------------------------------*/
 
-#include "kQRWallFunctionFvPatchFields.H"
+#include "kqRWallFunctionFvPatchFields.H"
 #include "fvPatchFields.H"
 #include "addToRunTimeSelectionTable.H"
 #include "volFields.H"
@@ -40,7 +40,7 @@ namespace RASModels
 
 // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
 
-makePatchFields(kQRWallFunction);
+makePatchFields(kqRWallFunction);
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
diff --git a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.H b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.H
similarity index 91%
rename from src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.H
rename to src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.H
index 989bec841860ba1133422d3b91ecb27e813cff07..39cc173c3399fbbb1dcfe448785e80c6eafa027f 100644
--- a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kQRWallFunctions/kQRWallFunction/kQRWallFunctionFvPatchFields.H
+++ b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchFields.H
@@ -24,10 +24,10 @@ License
 
 \*---------------------------------------------------------------------------*/
 
-#ifndef kQRWallFunctionFvPatchFields_H
-#define kQRWallFunctionFvPatchFields_H
+#ifndef kqRWallFunctionFvPatchFields_H
+#define kqRWallFunctionFvPatchFields_H
 
-#include "kQRWallFunctionFvPatchField.H"
+#include "kqRWallFunctionFvPatchField.H"
 #include "fieldTypes.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@@ -41,7 +41,7 @@ namespace RASModels
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-makePatchTypeFieldTypedefs(kQRWallFunction)
+makePatchTypeFieldTypedefs(kqRWallFunction)
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
diff --git a/src/turbulenceModels/incompressible/RAS/QZeta/QZeta.C b/src/turbulenceModels/incompressible/RAS/qZeta/qZeta.C
similarity index 94%
rename from src/turbulenceModels/incompressible/RAS/QZeta/QZeta.C
rename to src/turbulenceModels/incompressible/RAS/qZeta/qZeta.C
index 440b3d8374690321c0c22e64a04a43fa89b609b5..9b16f1c621076a051cd969a5e126147bd418a9d1 100644
--- a/src/turbulenceModels/incompressible/RAS/QZeta/QZeta.C
+++ b/src/turbulenceModels/incompressible/RAS/qZeta/qZeta.C
@@ -24,7 +24,7 @@ License
 
 \*---------------------------------------------------------------------------*/
 
-#include "QZeta.H"
+#include "qZeta.H"
 #include "addToRunTimeSelectionTable.H"
 
 #include "backwardsCompatibilityWallFunctions.H"
@@ -40,12 +40,12 @@ namespace RASModels
 
 // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
 
-defineTypeNameAndDebug(QZeta, 0);
-addToRunTimeSelectionTable(RASModel, QZeta, dictionary);
+defineTypeNameAndDebug(qZeta, 0);
+addToRunTimeSelectionTable(RASModel, qZeta, dictionary);
 
 // * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * * //
 
-tmp<volScalarField> QZeta::fMu() const
+tmp<volScalarField> qZeta::fMu() const
 {
     volScalarField Rt = q_*k_/(2.0*nu()*zeta_);
 
@@ -62,7 +62,7 @@ tmp<volScalarField> QZeta::fMu() const
 }
 
 
-tmp<volScalarField> QZeta::f2() const
+tmp<volScalarField> qZeta::f2() const
 {
     volScalarField Rt = q_*k_/(2.0*nu()*zeta_);
     return scalar(1) - 0.3*exp(-sqr(Rt));
@@ -71,7 +71,7 @@ tmp<volScalarField> QZeta::f2() const
 
 // * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
 
-QZeta::QZeta
+qZeta::qZeta
 (
     const volVectorField& U,
     const surfaceScalarField& phi,
@@ -202,7 +202,7 @@ QZeta::QZeta
 
 // * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
 
-tmp<volSymmTensorField> QZeta::R() const
+tmp<volSymmTensorField> qZeta::R() const
 {
     return tmp<volSymmTensorField>
     (
@@ -223,7 +223,7 @@ tmp<volSymmTensorField> QZeta::R() const
 }
 
 
-tmp<volSymmTensorField> QZeta::devReff() const
+tmp<volSymmTensorField> qZeta::devReff() const
 {
     return tmp<volSymmTensorField>
     (
@@ -243,7 +243,7 @@ tmp<volSymmTensorField> QZeta::devReff() const
 }
 
 
-tmp<fvVectorMatrix> QZeta::divDevReff(volVectorField& U) const
+tmp<fvVectorMatrix> qZeta::divDevReff(volVectorField& U) const
 {
     return
     (
@@ -253,7 +253,7 @@ tmp<fvVectorMatrix> QZeta::divDevReff(volVectorField& U) const
 }
 
 
-bool QZeta::read()
+bool qZeta::read()
 {
     if (RASModel::read())
     {
@@ -272,7 +272,7 @@ bool QZeta::read()
 }
 
 
-void QZeta::correct()
+void qZeta::correct()
 {
     RASModel::correct();
 
diff --git a/src/turbulenceModels/incompressible/RAS/QZeta/QZeta.H b/src/turbulenceModels/incompressible/RAS/qZeta/qZeta.H
similarity index 95%
rename from src/turbulenceModels/incompressible/RAS/QZeta/QZeta.H
rename to src/turbulenceModels/incompressible/RAS/qZeta/qZeta.H
index cdc4a1e134a9f015c2230c0e1a140fedb5cf75c3..6300868d2d7f8b40b0d47bdc5c8068ad381846cb 100644
--- a/src/turbulenceModels/incompressible/RAS/QZeta/QZeta.H
+++ b/src/turbulenceModels/incompressible/RAS/qZeta/qZeta.H
@@ -23,19 +23,19 @@ License
     Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
 
 Class
-    Foam::incompressible::RASModels::QZeta
+    Foam::incompressible::RASModels::qZeta
 
 Description
     Gibson and Dafa'Alla's q-zeta two-equation low-Re turbulence model
     for incompressible flows
 
 SourceFiles
-    QZeta.C
+    qZeta.C
 
 \*---------------------------------------------------------------------------*/
 
-#ifndef QZeta_H
-#define QZeta_H
+#ifndef qZeta_H
+#define qZeta_H
 
 #include "RASModel.H"
 
@@ -49,10 +49,10 @@ namespace RASModels
 {
 
 /*---------------------------------------------------------------------------*\
-                           Class QZeta Declaration
+                           Class qZeta Declaration
 \*---------------------------------------------------------------------------*/
 
-class QZeta
+class qZeta
 :
     public RASModel
 {
@@ -87,12 +87,12 @@ class QZeta
 public:
 
     //- Runtime type information
-    TypeName("QZeta");
+    TypeName("qZeta");
 
     // Constructors
 
         //- Construct from components
-        QZeta
+        qZeta
         (
             const volVectorField& U,
             const surfaceScalarField& phi,
@@ -101,7 +101,7 @@ public:
 
 
     //- Destructor
-    virtual ~QZeta()
+    virtual ~qZeta()
     {}
 
 
diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/constant/LESProperties b/tutorials/combustion/XiFoam/les/pitzDaily/constant/LESProperties
index 9beb4b86874706700d06e051527b255c451d8c74..43f63e2551eb7a934abe1e71684f54cfa41d4d52 100644
--- a/tutorials/combustion/XiFoam/les/pitzDaily/constant/LESProperties
+++ b/tutorials/combustion/XiFoam/les/pitzDaily/constant/LESProperties
@@ -23,42 +23,6 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-oneEqEddyCoeffs
-{
-    ce              1.048;
-    ck              0.094;
-}
-
-dynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-lowReOneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-    beta            0.01;
-}
-
-SmagorinskyCoeffs
-{
-    ck              0.02;
-    ce              0.202;
-}
-
-DeardorffDiffStressCoeffs
-{
-    ce              1.048;
-    ck              0.094;
-    cm              4.13;
-}
-
 cubeRootVolCoeffs
 {
     deltaCoeff      1;
@@ -120,13 +84,5 @@ smoothCoeffs
     maxDeltaRatio   1.1;
 }
 
-kappa           0.4187;
-
-wallFunctionCoeffs
-{
-    E               9;
-    Prt             0.85;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/system/setFieldsDict b/tutorials/combustion/XiFoam/les/pitzDaily/system/setFieldsDict
new file mode 100644
index 0000000000000000000000000000000000000000..9821378899ae56520b78268cc3ef3992ac40c716
--- /dev/null
+++ b/tutorials/combustion/XiFoam/les/pitzDaily/system/setFieldsDict
@@ -0,0 +1,38 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  1.5                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      setFieldsDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+defaultFieldValues
+(
+    volScalarFieldValue b 1
+    volScalarFieldValue T 293
+);
+
+regions
+(
+    boxToCell
+    {
+        box (-1 -1 -1) (1 0 1);
+        fieldValues
+        (
+            volScalarFieldValue b 0
+            volScalarFieldValue T 1650
+        );
+    }
+);
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/XiFoam/les/pitzDaily3D/0/U b/tutorials/combustion/XiFoam/les/pitzDaily3D/0/U
index c2ff1ef6915ae289c29a94f3489aa01287d46a86..b1b98a1871997c78db7cca32761a688a405e7352 100644
--- a/tutorials/combustion/XiFoam/les/pitzDaily3D/0/U
+++ b/tutorials/combustion/XiFoam/les/pitzDaily3D/0/U
@@ -25,6 +25,7 @@ boundaryField
         type            turbulentInlet;
         referenceField  uniform (13.3 0 0);
         fluctuationScale (0.04 0.02 0.02);
+        alpha            0.1;
     }
 
     outlet
diff --git a/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/LESProperties b/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/LESProperties
index 9beb4b86874706700d06e051527b255c451d8c74..c0b9ec7e0be5c2c776b698d3b37230683d5b5263 100644
--- a/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/LESProperties
+++ b/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/LESProperties
@@ -17,48 +17,12 @@ FoamFile
 
 LESModel        oneEqEddy;
 
-delta           cubeRootVol;
+delta           vanDriest;
 
 turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-oneEqEddyCoeffs
-{
-    ce              1.048;
-    ck              0.094;
-}
-
-dynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-lowReOneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-    beta            0.01;
-}
-
-SmagorinskyCoeffs
-{
-    ck              0.02;
-    ce              0.202;
-}
-
-DeardorffDiffStressCoeffs
-{
-    ce              1.048;
-    ck              0.094;
-    cm              4.13;
-}
-
 cubeRootVolCoeffs
 {
     deltaCoeff      1;
@@ -120,13 +84,5 @@ smoothCoeffs
     maxDeltaRatio   1.1;
 }
 
-kappa           0.4187;
-
-wallFunctionCoeffs
-{
-    E               9;
-    Prt             0.85;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/combustion/XiFoam/les/pitzDaily3D/system/fvSchemes b/tutorials/combustion/XiFoam/les/pitzDaily3D/system/fvSchemes
index d4a2457583dceab7d059e43372428e151a27c69a..2f2d8e9ebbda709e58ac04d54c4b52261edf0d01 100644
--- a/tutorials/combustion/XiFoam/les/pitzDaily3D/system/fvSchemes
+++ b/tutorials/combustion/XiFoam/les/pitzDaily3D/system/fvSchemes
@@ -34,7 +34,11 @@ divSchemes
     div(phiXi,Xi)   Gauss limitedLinear01 0.1;
     div(phiXi,Su)   Gauss limitedLinear01 0.1;
     div(phiSt,b)    Gauss limitedLinear01 0.1;
-    div(phi,ft_b_h_hu) Gauss multivariateSelection
+    div(phi,ft) Gauss limitedLinear01 0.1;
+    div(phi,b) Gauss limitedLinear01 0.1;
+    div(phi,h) Gauss limitedLinear 0.1;
+    div(phi,hu) Gauss limitedLinear 0.1;
+    div(phi,ft_b_h_hu)_0 Gauss multivariateSelection
     {
         ft limitedLinear01 0.1;
         b limitedLinear01 0.1;
diff --git a/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/constant/RASProperties b/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/constant/RASProperties
index 564a9fbe2369dd88931d20ecbd46eca762ded935..2c10ab8a57759b03b600798b9a4c18d2e3496d2d 100644
--- a/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/constant/RASProperties
+++ b/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0;
-    alphah          1.111;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              0;
-    alphah          1.111;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0;
-    alphah          1.111;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/combustion/dieselFoam/aachenBomb/0/k b/tutorials/combustion/dieselFoam/aachenBomb/0/k
index b037171c72f46447a17c3aa8a16e71f5ae3acc3b..6650fed2abfb771031243c55cf53e7fb7ddfd573 100644
--- a/tutorials/combustion/dieselFoam/aachenBomb/0/k
+++ b/tutorials/combustion/dieselFoam/aachenBomb/0/k
@@ -23,7 +23,7 @@ boundaryField
 {
     walls
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 1;
     }
 }
diff --git a/tutorials/combustion/dieselFoam/aachenBomb/constant/RASProperties b/tutorials/combustion/dieselFoam/aachenBomb/constant/RASProperties
index 991a2915d96e31f7a47ab1334189ddd642009f6c..d5a0479c350d898eaa7f6367b7ff92f108114de6 100644
--- a/tutorials/combustion/dieselFoam/aachenBomb/constant/RASProperties
+++ b/tutorials/combustion/dieselFoam/aachenBomb/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-    muLimiter       on;
-    Lsgs            0.0002;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    Cs              0.25;
-    Ceps            0.15;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/combustion/engineFoam/kivaTest/-180/k b/tutorials/combustion/engineFoam/kivaTest/-180/k
index b97d4da7fd174f32e08295627f20475d8e1db435..3b0e378049e19a487e76042c7dd439ec4b971a84 100644
--- a/tutorials/combustion/engineFoam/kivaTest/-180/k
+++ b/tutorials/combustion/engineFoam/kivaTest/-180/k
@@ -23,17 +23,17 @@ boundaryField
 {
     piston
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 4;
     }
     liner
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 4;
     }
     cylinderHead
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 4;
     }
 }
diff --git a/tutorials/combustion/engineFoam/kivaTest/constant/RASProperties b/tutorials/combustion/engineFoam/kivaTest/constant/RASProperties
index 62bcf8bb7155662932d3e2550af5bd866b54cc4e..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/combustion/engineFoam/kivaTest/constant/RASProperties
+++ b/tutorials/combustion/engineFoam/kivaTest/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0;
-    alphah          1.111;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimpleFoam/angledDuct/0/k b/tutorials/compressible/rhoPimpleFoam/angledDuct/0/k
index 36be49f2ea41fa4546f2b605b525f151f624a334..655a91bb45e3aa597a5280c13d1a8262524a0fbd 100644
--- a/tutorials/compressible/rhoPimpleFoam/angledDuct/0/k
+++ b/tutorials/compressible/rhoPimpleFoam/angledDuct/0/k
@@ -23,22 +23,22 @@ boundaryField
 {
     front
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 1;
     }
     back
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 1;
     }
     wall
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 1;
     }
     porosityWall
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 1;
     }
     inlet
diff --git a/tutorials/compressible/rhoPimpleFoam/angledDuct/constant/RASProperties b/tutorials/compressible/rhoPimpleFoam/angledDuct/constant/RASProperties
index 26216fcde0621aa1c526ab843d2825da511d520a..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/compressible/rhoPimpleFoam/angledDuct/constant/RASProperties
+++ b/tutorials/compressible/rhoPimpleFoam/angledDuct/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/compressible/rhoPisoFoam/les/pitzDaily/constant/LESProperties b/tutorials/compressible/rhoPisoFoam/les/pitzDaily/constant/LESProperties
index 251fe1ae80b2be0a6a9e6faa697aceab16a3bbfd..a09776e023491f788fa9d957a572fb376ff74023 100644
--- a/tutorials/compressible/rhoPisoFoam/les/pitzDaily/constant/LESProperties
+++ b/tutorials/compressible/rhoPisoFoam/les/pitzDaily/constant/LESProperties
@@ -23,42 +23,6 @@ printCoeffs     on;
 
 delta           cubeRootVol;
 
-laminarCoeffs
-{
-}
-
-oneEqEddyCoeffs
-{
-    ce              1.048;
-    ck              0.094;
-}
-
-dynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-lowReOneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-    beta            0.01;
-}
-
-SmagorinskyCoeffs
-{
-    ck              0.02;
-    ce              0.202;
-}
-
-DeardorffDiffStressCoeffs
-{
-    ce              1.048;
-    ck              0.094;
-    cm              4.13;
-}
-
 cubeRootVolCoeffs
 {
     deltaCoeff      1;
@@ -120,12 +84,5 @@ smoothCoeffs
     maxDeltaRatio   1.1;
 }
 
-kappa           0.4187;
-
-wallFunctionCoeffs
-{
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/compressible/rhoPisoFoam/ras/cavity/0/R b/tutorials/compressible/rhoPisoFoam/ras/cavity/0/R
index 6d7f9a3db106f1323009644400e2b003cdc1d0bd..be21f26a9ecc13647d852108184efac0f619890b 100644
--- a/tutorials/compressible/rhoPisoFoam/ras/cavity/0/R
+++ b/tutorials/compressible/rhoPisoFoam/ras/cavity/0/R
@@ -23,13 +23,13 @@ boundaryField
 {
     movingWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform ( 0 0 0 0 0 0 );
     }
 
     fixedWalls
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform ( 0 0 0 0 0 0 );
     }
 
diff --git a/tutorials/compressible/rhoPisoFoam/ras/cavity/0/k b/tutorials/compressible/rhoPisoFoam/ras/cavity/0/k
index 8f645b088c807cbc6b2215416a42a7e5e316c791..01415635a2c40c37924f549a0fac910e3154251b 100644
--- a/tutorials/compressible/rhoPisoFoam/ras/cavity/0/k
+++ b/tutorials/compressible/rhoPisoFoam/ras/cavity/0/k
@@ -23,12 +23,12 @@ boundaryField
 {
     movingWall
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0;
     }
     fixedWalls
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0;
     }
     frontAndBack
diff --git a/tutorials/compressible/rhoPisoFoam/ras/cavity/constant/RASProperties b/tutorials/compressible/rhoPisoFoam/ras/cavity/constant/RASProperties
index 15184ba185eeec5496fdf68cd9236f4120a7b634..480abbfe0e982c895c981180ef06f857e9ffe988 100644
--- a/tutorials/compressible/rhoPisoFoam/ras/cavity/constant/RASProperties
+++ b/tutorials/compressible/rhoPisoFoam/ras/cavity/constant/RASProperties
@@ -21,97 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1         0.85034;
-    alphaK2         1;
-    alphaOmega1     0.5;
-    alphaOmega2     0.85616;
-    gamma1          0.5532;
-    gamma2          0.4403;
-    beta1           0.075;
-    beta2           0.0828;
-    betaStar        0.09;
-    a1              0.31;
-    c1              10;
-    Cmu             0.09;
-    alphah          1;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/k b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/k
index 1243952ec2d5bc9a98375a7c5de17f4f406689c2..2252063de2da2fc51ac778cc1dff80a604800708 100644
--- a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/k
+++ b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/k
@@ -23,25 +23,25 @@ boundaryField
 {
     front
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 1;
     }
 
     back
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 1;
     }
 
     wall
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 1;
     }
 
     porosityWall
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 1;
     }
 
diff --git a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/constant/RASProperties b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/constant/RASProperties
index 48bd2ba11798f2e75054f36380ba62c9f1f1628c..d5a0479c350d898eaa7f6367b7ff92f108114de6 100644
--- a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/constant/RASProperties
+++ b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/compressible/sonicFoam/ras/nacaAirfoil/constant/RASProperties b/tutorials/compressible/sonicFoam/ras/nacaAirfoil/constant/RASProperties
index 226b420b22c824b9f604219a77865aae3774212b..34805a0b264a3d2754bbc41be045a96d19192e1b 100644
--- a/tutorials/compressible/sonicFoam/ras/nacaAirfoil/constant/RASProperties
+++ b/tutorials/compressible/sonicFoam/ras/nacaAirfoil/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/compressible/sonicFoam/ras/prism/0/k b/tutorials/compressible/sonicFoam/ras/prism/0/k
index 77ca6b529a59dfca7a4e8fe3b54408af7224eca2..2917c4e84935a3cac8f07fd3bc56986c9a383495 100644
--- a/tutorials/compressible/sonicFoam/ras/prism/0/k
+++ b/tutorials/compressible/sonicFoam/ras/prism/0/k
@@ -46,7 +46,7 @@ boundaryField
     }
     prismWall
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 1000;
     }
     defaultFaces
diff --git a/tutorials/compressible/sonicFoam/ras/prism/constant/RASProperties b/tutorials/compressible/sonicFoam/ras/prism/constant/RASProperties
index 26216fcde0621aa1c526ab843d2825da511d520a..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/compressible/sonicFoam/ras/prism/constant/RASProperties
+++ b/tutorials/compressible/sonicFoam/ras/prism/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/0/k b/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/0/k
index 38c2a542ef4c0c57799adb46dbd114f24947f474..8e5e6563ee09d954a0efb1fab65f3230ed32fdf2 100644
--- a/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/0/k
+++ b/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/0/k
@@ -23,17 +23,17 @@ boundaryField
 {
     floor
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
     ceiling
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
     fixedWalls
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
 }
diff --git a/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/constant/RASProperties b/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/constant/RASProperties
index 35b5a409f230c180f07469bfe0679cdf00cb419d..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/constant/RASProperties
+++ b/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0.85;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/0/k b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/0/k
index 38c2a542ef4c0c57799adb46dbd114f24947f474..8e5e6563ee09d954a0efb1fab65f3230ed32fdf2 100644
--- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/0/k
+++ b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/0/k
@@ -23,17 +23,17 @@ boundaryField
 {
     floor
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
     ceiling
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
     fixedWalls
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
 }
diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/constant/RASProperties b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/constant/RASProperties
index 35b5a409f230c180f07469bfe0679cdf00cb419d..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/constant/RASProperties
+++ b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0.85;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/0/k b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/0/k
index bd0cf46f0db295c3f0170202b33472417c20bca3..a6ee8bf7dda47478d164856e87a24dc257faf795 100644
--- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/0/k
+++ b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/0/k
@@ -23,25 +23,25 @@ boundaryField
 {
     ground
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
 
     igloo_region0
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
 
     twoFridgeFreezers_seal_0
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
 
     twoFridgeFreezers_herring_1
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
 }
diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/constant/RASProperties b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/constant/RASProperties
index 35b5a409f230c180f07469bfe0679cdf00cb419d..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/constant/RASProperties
+++ b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0.85;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantPisoFoam/hotRoom/0/k b/tutorials/heatTransfer/buoyantPisoFoam/hotRoom/0/k
index 4ec7f08960c175a6d955e2c1d3cfb98453524647..62dd722078f97fe6bafb63653f4d1941347e893a 100644
--- a/tutorials/heatTransfer/buoyantPisoFoam/hotRoom/0/k
+++ b/tutorials/heatTransfer/buoyantPisoFoam/hotRoom/0/k
@@ -23,17 +23,17 @@ boundaryField
 {
     floor
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.1;
     }
     ceiling
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.1;
     }
     fixedWalls
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.1;
     }
 }
diff --git a/tutorials/heatTransfer/buoyantPisoFoam/hotRoom/constant/RASProperties b/tutorials/heatTransfer/buoyantPisoFoam/hotRoom/constant/RASProperties
index 35b5a409f230c180f07469bfe0679cdf00cb419d..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/heatTransfer/buoyantPisoFoam/hotRoom/constant/RASProperties
+++ b/tutorials/heatTransfer/buoyantPisoFoam/hotRoom/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0.85;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/k b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/k
index 4ec7f08960c175a6d955e2c1d3cfb98453524647..62dd722078f97fe6bafb63653f4d1941347e893a 100644
--- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/k
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/k
@@ -23,17 +23,17 @@ boundaryField
 {
     floor
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.1;
     }
     ceiling
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.1;
     }
     fixedWalls
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.1;
     }
 }
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/RASProperties b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/RASProperties
index 35b5a409f230c180f07469bfe0679cdf00cb419d..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/RASProperties
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0.85;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/k b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/k
index daee97520994b149a137abd69b67b21858d2303a..2b618db2f3e3fdf27faeb43ab2d1f58d2a559f8e 100644
--- a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/k
+++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/k
@@ -23,22 +23,22 @@ boundaryField
 {
     box
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.1;
     }
     floor
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.1;
     }
     ceiling
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.1;
     }
     fixedWalls
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.1;
     }
 }
diff --git a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/constant/RASProperties b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/constant/RASProperties
index 35b5a409f230c180f07469bfe0679cdf00cb419d..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/constant/RASProperties
+++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0.85;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/0/k b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/0/k
index 5b206f8e4e379cbc9d5a2764071140549649d354..e545d6fb8ec5b2749648f736a1b9d404bb958125 100644
--- a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/0/k
+++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/0/k
@@ -23,25 +23,25 @@ boundaryField
 {
     floor
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0;
     }
 
     ceiling
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0;
     }
 
     fixedWalls
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0;
     }
 
     box
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0;
     }
 }
diff --git a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/constant/RASProperties b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/constant/RASProperties
index 35b5a409f230c180f07469bfe0679cdf00cb419d..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/constant/RASProperties
+++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/constant/RASProperties
@@ -21,80 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0.85;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    alphah          1;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaR          1;
-    alphaEps        0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/k b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/k
index 49df1e0d2bbc086f04854475877bdd9fe4b596ee..0ce36fa0846e8377fcddcc577320e9037b04617e 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/k
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/k
@@ -23,12 +23,12 @@ boundaryField
 {
     minY
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
     maxY
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
     minX
@@ -42,12 +42,12 @@ boundaryField
     }
     minZ
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
     maxZ
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
     topAir_to_leftSolid
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/RASProperties
index 6b4cc41e7a84e17964ea8f308450c5a26a43b9b5..f0056ac03862b836cd2d6eb593d1d48bb17765f7 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/RASProperties
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/RASProperties
@@ -18,79 +18,7 @@ RASModel kEpsilon;
 
 turbulence      off;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    C3               0.85;
-    alphah           1;
-    alphak           1;
-    alphaEps         0.76923;
-}
+printCoeffs     on;
 
-RNGkEpsilonCoeffs
-{
-    Cmu              0.0845;
-    C1               1.42;
-    C2               1.68;
-    C3               -0.33;
-    alphah           1;
-    alphak           1.39;
-    alphaEps         1.39;
-    eta0             4.38;
-    beta             0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    C3               -0.33;
-    alphah           1;
-    alphak           1;
-    alphaEps         0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu              0.09;
-    Clrr1            1.8;
-    Clrr2            0.6;
-    C1               1.44;
-    C2               1.92;
-    alphah           1;
-    Cs               0.25;
-    Ceps             0.15;
-    alphaR           1;
-    alphaEps         0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu              0.09;
-    Clg1             1.8;
-    Clg2             0.6;
-    C1               1.44;
-    C2               1.92;
-    alphah           1;
-    C1Ref            0.5;
-    C2Ref            0.3;
-    Cs               0.25;
-    Ceps             0.15;
-    alphaR           1;
-    alphaEps         0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa            0.4187;
-    E                9;
-}
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/RASProperties
index 9037f279053fe08eee8d5191bb8f984e287ff50e..f0056ac03862b836cd2d6eb593d1d48bb17765f7 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/RASProperties
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/RASProperties
@@ -16,82 +16,9 @@ FoamFile
 
 RASModel kEpsilon;
 
-//turbulence      on;
 turbulence      off;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    C3               0.85;
-    alphah           1;
-    alphak           1;
-    alphaEps         0.76923;
-}
+printCoeffs     on;
 
-RNGkEpsilonCoeffs
-{
-    Cmu              0.0845;
-    C1               1.42;
-    C2               1.68;
-    C3               -0.33;
-    alphah           1;
-    alphak           1.39;
-    alphaEps         1.39;
-    eta0             4.38;
-    beta             0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    C3               -0.33;
-    alphah           1;
-    alphak           1;
-    alphaEps         0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu              0.09;
-    Clrr1            1.8;
-    Clrr2            0.6;
-    C1               1.44;
-    C2               1.92;
-    alphah           1;
-    Cs               0.25;
-    Ceps             0.15;
-    alphaR           1;
-    alphaEps         0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu              0.09;
-    Clg1             1.8;
-    Clg2             0.6;
-    C1               1.44;
-    C2               1.92;
-    alphah           1;
-    C1Ref            0.5;
-    C2Ref            0.3;
-    Cs               0.25;
-    Ceps             0.15;
-    alphaR           1;
-    alphaEps         0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa            0.4187;
-    E                9;
-}
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/RASProperties
index 6b4cc41e7a84e17964ea8f308450c5a26a43b9b5..f0056ac03862b836cd2d6eb593d1d48bb17765f7 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/RASProperties
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/RASProperties
@@ -18,79 +18,7 @@ RASModel kEpsilon;
 
 turbulence      off;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    C3               0.85;
-    alphah           1;
-    alphak           1;
-    alphaEps         0.76923;
-}
+printCoeffs     on;
 
-RNGkEpsilonCoeffs
-{
-    Cmu              0.0845;
-    C1               1.42;
-    C2               1.68;
-    C3               -0.33;
-    alphah           1;
-    alphak           1.39;
-    alphaEps         1.39;
-    eta0             4.38;
-    beta             0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    C3               -0.33;
-    alphah           1;
-    alphak           1;
-    alphaEps         0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu              0.09;
-    Clrr1            1.8;
-    Clrr2            0.6;
-    C1               1.44;
-    C2               1.92;
-    alphah           1;
-    Cs               0.25;
-    Ceps             0.15;
-    alphaR           1;
-    alphaEps         0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu              0.09;
-    Clg1             1.8;
-    Clg2             0.6;
-    C1               1.44;
-    C2               1.92;
-    alphah           1;
-    C1Ref            0.5;
-    C2Ref            0.3;
-    Cs               0.25;
-    Ceps             0.15;
-    alphaR           1;
-    alphaEps         0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa            0.4187;
-    E                9;
-}
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties
index 9037f279053fe08eee8d5191bb8f984e287ff50e..f0056ac03862b836cd2d6eb593d1d48bb17765f7 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties
@@ -16,82 +16,9 @@ FoamFile
 
 RASModel kEpsilon;
 
-//turbulence      on;
 turbulence      off;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    C3               0.85;
-    alphah           1;
-    alphak           1;
-    alphaEps         0.76923;
-}
+printCoeffs     on;
 
-RNGkEpsilonCoeffs
-{
-    Cmu              0.0845;
-    C1               1.42;
-    C2               1.68;
-    C3               -0.33;
-    alphah           1;
-    alphak           1.39;
-    alphaEps         1.39;
-    eta0             4.38;
-    beta             0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    C3               -0.33;
-    alphah           1;
-    alphak           1;
-    alphaEps         0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu              0.09;
-    Clrr1            1.8;
-    Clrr2            0.6;
-    C1               1.44;
-    C2               1.92;
-    alphah           1;
-    Cs               0.25;
-    Ceps             0.15;
-    alphaR           1;
-    alphaEps         0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu              0.09;
-    Clg1             1.8;
-    Clg2             0.6;
-    C1               1.44;
-    C2               1.92;
-    alphah           1;
-    C1Ref            0.5;
-    C2Ref            0.3;
-    Cs               0.25;
-    Ceps             0.15;
-    alphaR           1;
-    alphaEps         0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa            0.4187;
-    E                9;
-}
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/0/k b/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/0/k
index e78fcca795300548ec365c43472256d7c8f1ae8c..60208ba1315b9f30cb3dbcfc013eaf2118504c1a 100644
--- a/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/0/k
+++ b/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/0/k
@@ -23,13 +23,13 @@ boundaryField
 {
     rotor
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0;
     }
 
     stator
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0;
     }
 
diff --git a/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/RASProperties b/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/RASProperties
index 36c840062fd1dd27bc791d712469bc3bbc828a37..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/RASProperties
+++ b/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/RASProperties
@@ -21,172 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1         0.85034;
-    alphaK2         1;
-    alphaOmega1     0.5;
-    alphaOmega2     0.85616;
-    gamma1          0.5532;
-    gamma2          0.4403;
-    beta1           0.075;
-    beta2           0.0828;
-    betaStar        0.09;
-    a1              0.31;
-    c1              10;
-    Cmu             0.09;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/boundaryFoam/boundaryLaunderSharma/constant/RASProperties b/tutorials/incompressible/boundaryFoam/boundaryLaunderSharma/constant/RASProperties
index 7bffdbfa6bc2ebdb4515aecbbd6893f5b05a1dfd..2c10ab8a57759b03b600798b9a4c18d2e3496d2d 100644
--- a/tutorials/incompressible/boundaryFoam/boundaryLaunderSharma/constant/RASProperties
+++ b/tutorials/incompressible/boundaryFoam/boundaryLaunderSharma/constant/RASProperties
@@ -21,172 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1         0.85034;
-    alphaK2         1;
-    alphaOmega1     0.5;
-    alphaOmega2     0.85616;
-    gamma1          0.5532;
-    gamma2          0.4403;
-    beta1           0.075;
-    beta2           0.0828;
-    betaStar        0.09;
-    a1              0.31;
-    c1              10;
-    Cmu             0.09;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/0/k b/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/0/k
index 007ca488434d81472bc40090d27d23e0f08950cc..be915cb2bbdbf4cfa66d6aa9aea0fe4978527346 100644
--- a/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/0/k
+++ b/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/0/k
@@ -23,12 +23,12 @@ boundaryField
 {
     lowerWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 1e-10;
     }
     upperWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 1e-10;
     }
     frontBack
diff --git a/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/constant/RASProperties b/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/constant/RASProperties
index 36c840062fd1dd27bc791d712469bc3bbc828a37..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/constant/RASProperties
+++ b/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/constant/RASProperties
@@ -21,172 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1         0.85034;
-    alphaK2         1;
-    alphaOmega1     0.5;
-    alphaOmega2     0.85616;
-    gamma1          0.5532;
-    gamma2          0.4403;
-    beta1           0.075;
-    beta2           0.0828;
-    betaStar        0.09;
-    a1              0.31;
-    c1              10;
-    Cmu             0.09;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/channelFoam/channel395/constant/LESProperties b/tutorials/incompressible/channelFoam/channel395/constant/LESProperties
index 9bcc936fc34053578e2137be0b6ea9475747824b..1a2958dabcbafac324334de871ea6cdb12202417 100644
--- a/tutorials/incompressible/channelFoam/channel395/constant/LESProperties
+++ b/tutorials/incompressible/channelFoam/channel395/constant/LESProperties
@@ -21,98 +21,6 @@ printCoeffs     on;
 
 delta           vanDriest;
 
-laminarCoeffs
-{
-}
-
-oneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-}
-
-dynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-locDynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-SmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-}
-
-Smagorinsky2Coeffs
-{
-    ce              1.05;
-    ck              0.07;
-    cD2             0.02;
-}
-
-spectEddyViscCoeffs
-{
-    ce              1.05;
-    cB              8.22;
-    cK1             0.83;
-    cK2             1.03;
-    cK3             4.75;
-    cK4             2.55;
-}
-
-dynSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-mixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-    filter          simple;
-}
-
-dynMixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-LRRDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    c1              1.8;
-    c2              0.6;
-}
-
-DeardorffDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    cm              4.13;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-    CDES            0.65;
-    ck              0.07;
-}
-
 cubeRootVolCoeffs
 {
     deltaCoeff      1;
@@ -174,12 +82,5 @@ smoothCoeffs
     maxDeltaRatio   1.1;
 }
 
-kappa           0.4187;
-
-wallFunctionCoeffs
-{
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/pimpleFoam/t-junction/0/k b/tutorials/incompressible/pimpleFoam/t-junction/0/k
index ad217bc9e476cda1ff0b268aa0f160f4c13c2701..1ca528b597f77f2f72b4378915ca53f4fac3b58f 100644
--- a/tutorials/incompressible/pimpleFoam/t-junction/0/k
+++ b/tutorials/incompressible/pimpleFoam/t-junction/0/k
@@ -42,7 +42,7 @@ boundaryField
 
     defaultFaces
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0;
     }
 }
diff --git a/tutorials/incompressible/pimpleFoam/t-junction/constant/RASProperties b/tutorials/incompressible/pimpleFoam/t-junction/constant/RASProperties
index 559c506d1113db8266b365093851601b52fde4e5..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/incompressible/pimpleFoam/t-junction/constant/RASProperties
+++ b/tutorials/incompressible/pimpleFoam/t-junction/constant/RASProperties
@@ -21,181 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-realizableKECoeffs
-{
-    Cmu             0.09;
-    A0              4;
-    C2              1.9;
-    alphak          1;
-    alphaEps        0.833333;
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1         0.85034;
-    alphaK2         1;
-    alphaOmega1     0.5;
-    alphaOmega2     0.85616;
-    gamma1          0.5532;
-    gamma2          0.4403;
-    beta1           0.075;
-    beta2           0.0828;
-    betaStar        0.09;
-    a1              0.31;
-    c1              10;
-    Cmu             0.09;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/pisoFoam/les/pitzDaily/constant/LESProperties b/tutorials/incompressible/pisoFoam/les/pitzDaily/constant/LESProperties
index 034085751aebb376b727c99f0d14c65bcefcb7b5..f2f9ebe735181f00f5cea8d66b4ff587022d5707 100644
--- a/tutorials/incompressible/pisoFoam/les/pitzDaily/constant/LESProperties
+++ b/tutorials/incompressible/pisoFoam/les/pitzDaily/constant/LESProperties
@@ -21,98 +21,6 @@ delta           cubeRootVol;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-oneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-}
-
-dynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-locDynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-SmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-}
-
-Smagorinsky2Coeffs
-{
-    ce              1.05;
-    ck              0.07;
-    cD2             0.02;
-}
-
-spectEddyViscCoeffs
-{
-    ce              1.05;
-    cB              8.22;
-    cK1             0.83;
-    cK2             1.03;
-    cK3             4.75;
-    cK4             2.55;
-}
-
-dynSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-mixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-    filter          simple;
-}
-
-dynMixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-LRRDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    c1              1.8;
-    c2              0.6;
-}
-
-DeardorffDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    cm              4.13;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-    CDES            0.65;
-    ck              0.07;
-}
-
 cubeRootVolCoeffs
 {
     deltaCoeff      1;
@@ -174,12 +82,5 @@ smoothCoeffs
     maxDeltaRatio   1.1;
 }
 
-kappa           0.4187;
-
-wallFunctionCoeffs
-{
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/LESProperties b/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/LESProperties
index 034085751aebb376b727c99f0d14c65bcefcb7b5..f2f9ebe735181f00f5cea8d66b4ff587022d5707 100644
--- a/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/LESProperties
+++ b/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/LESProperties
@@ -21,98 +21,6 @@ delta           cubeRootVol;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-oneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-}
-
-dynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-locDynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-SmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-}
-
-Smagorinsky2Coeffs
-{
-    ce              1.05;
-    ck              0.07;
-    cD2             0.02;
-}
-
-spectEddyViscCoeffs
-{
-    ce              1.05;
-    cB              8.22;
-    cK1             0.83;
-    cK2             1.03;
-    cK3             4.75;
-    cK4             2.55;
-}
-
-dynSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-mixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-    filter          simple;
-}
-
-dynMixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-LRRDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    c1              1.8;
-    c2              0.6;
-}
-
-DeardorffDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    cm              4.13;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-    CDES            0.65;
-    ck              0.07;
-}
-
 cubeRootVolCoeffs
 {
     deltaCoeff      1;
@@ -174,12 +82,5 @@ smoothCoeffs
     maxDeltaRatio   1.1;
 }
 
-kappa           0.4187;
-
-wallFunctionCoeffs
-{
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/polyMesh/boundary b/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/polyMesh/boundary
index fb820c3f431bddc293e836306da8021afe61362f..051b65760265744b69432074086fd674fcc96216 100644
--- a/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/polyMesh/boundary
+++ b/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/polyMesh/boundary
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  dev                                   |
+|  \\    /   O peration     | Version:  1.6                                   |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/incompressible/pisoFoam/ras/cavity/0/R b/tutorials/incompressible/pisoFoam/ras/cavity/0/R
index fec1a87fa5d49eea46b2b46fb93fb7e299a06594..9583f146b512b74810a0efe2d24d1f7e95c2e13b 100644
--- a/tutorials/incompressible/pisoFoam/ras/cavity/0/R
+++ b/tutorials/incompressible/pisoFoam/ras/cavity/0/R
@@ -22,12 +22,12 @@ boundaryField
 {
     movingWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
     }
 
     fixedWalls
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
     }
 
     frontAndBack
diff --git a/tutorials/incompressible/pisoFoam/ras/cavity/0/k b/tutorials/incompressible/pisoFoam/ras/cavity/0/k
index 021fce6763409ae2d5f416c34311ac0d7ea4b165..e097460e45e30e95f629be5ca6d71564c51bbd1d 100644
--- a/tutorials/incompressible/pisoFoam/ras/cavity/0/k
+++ b/tutorials/incompressible/pisoFoam/ras/cavity/0/k
@@ -23,12 +23,12 @@ boundaryField
 {
     movingWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.00325;
     }
     fixedWalls
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.00325;
     }
     frontAndBack
diff --git a/tutorials/incompressible/pisoFoam/ras/cavity/constant/RASProperties b/tutorials/incompressible/pisoFoam/ras/cavity/constant/RASProperties
index 559c506d1113db8266b365093851601b52fde4e5..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/incompressible/pisoFoam/ras/cavity/constant/RASProperties
+++ b/tutorials/incompressible/pisoFoam/ras/cavity/constant/RASProperties
@@ -21,181 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-realizableKECoeffs
-{
-    Cmu             0.09;
-    A0              4;
-    C2              1.9;
-    alphak          1;
-    alphaEps        0.833333;
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1         0.85034;
-    alphaK2         1;
-    alphaOmega1     0.5;
-    alphaOmega2     0.85616;
-    gamma1          0.5532;
-    gamma2          0.4403;
-    beta1           0.075;
-    beta2           0.0828;
-    betaStar        0.09;
-    a1              0.31;
-    c1              10;
-    Cmu             0.09;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/simpleFoam/airFoil2D/constant/RASProperties b/tutorials/incompressible/simpleFoam/airFoil2D/constant/RASProperties
index ec7ffbd28bddc32280b11e167efc7b00f466ce47..a7c70936d41482db81cf19134bb5dc38b26a3156 100644
--- a/tutorials/incompressible/simpleFoam/airFoil2D/constant/RASProperties
+++ b/tutorials/incompressible/simpleFoam/airFoil2D/constant/RASProperties
@@ -19,156 +19,7 @@ RASModel        SpalartAllmaras;
 
 turbulence      on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
+printCoeffs     on;
 
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/simpleFoam/motorBike/0/turbulentBoundaryField b/tutorials/incompressible/simpleFoam/motorBike/0/turbulentBoundaryField
index 39fd6f16c15cfea5efbc1c2b7aecd239ccfbd80c..c55ca7f000d78e88b417596e32868c4cab2e8f69 100644
--- a/tutorials/incompressible/simpleFoam/motorBike/0/turbulentBoundaryField
+++ b/tutorials/incompressible/simpleFoam/motorBike/0/turbulentBoundaryField
@@ -19,12 +19,12 @@ boundaryField
 
     lowerWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
     }
 
     "motorBike_.*"
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
     }
 
     #include "frontBackUpperPatches"
diff --git a/tutorials/incompressible/simpleFoam/motorBike/constant/RASProperties b/tutorials/incompressible/simpleFoam/motorBike/constant/RASProperties
index e9be8519b47fd95aeb13fe0eefb01471ec88d7ff..7a083b65c19ba08e4b92163c1921196f2df15ceb 100644
--- a/tutorials/incompressible/simpleFoam/motorBike/constant/RASProperties
+++ b/tutorials/incompressible/simpleFoam/motorBike/constant/RASProperties
@@ -20,181 +20,5 @@ turbulence          on;
 
 printCoeffs         on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    alphaEps         0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu              0.0845;
-    C1               1.42;
-    C2               1.68;
-    alphak           1.39;
-    alphaEps         1.39;
-    eta0             4.38;
-    beta             0.012;
-}
-
-realizableKECoeffs
-{
-    Cmu              0.09;
-    A0               4.0;
-    C2               1.9;
-    alphak           1;
-    alphaEps         0.833333;
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1          0.85034;
-    alphaK2          1.0;
-    alphaOmega1      0.5;
-    alphaOmega2      0.85616;
-    gamma1           0.5532;
-    gamma2           0.4403;
-    beta1            0.0750;
-    beta2            0.0828;
-    betaStar         0.09;
-    a1               0.31;
-    c1               10;
-
-    Cmu              0.09;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    alphak           1;
-    alphaEps         0.76932;
-    A1               1.25;
-    A2               1000;
-    Ctau1            -4;
-    Ctau2            13;
-    Ctau3            -2;
-    alphaKsi         0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1               1.44;
-    C2               1.92;
-    alphak           1;
-    alphaEps         0.76923;
-    A1               1.25;
-    A2               1000;
-    Ctau1            -4;
-    Ctau2            13;
-    Ctau3            -2;
-    alphaKsi         0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    alphaZeta        0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    alphaEps         0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    alphaEps         0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    alphak           1;
-    alphaEps         0.76923;
-    A1               1.25;
-    A2               1000;
-    Ctau1            -4;
-    Ctau2            13;
-    Ctau3            -2;
-    alphaKsi         0.9;
-    Am               0.016;
-    Aepsilon         0.263;
-    Amu              0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu              0.09;
-    C1               1.44;
-    C2               1.92;
-    alphak           1;
-    alphaEps         0.76923;
-    Am               0.016;
-    Aepsilon         0.263;
-    Amu              0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu              0.09;
-    Clrr1            1.8;
-    Clrr2            0.6;
-    C1               1.44;
-    C2               1.92;
-    Cs               0.25;
-    Ceps             0.15;
-    alphaEps         0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu              0.09;
-    Clg1             1.8;
-    Clg2             0.6;
-    C1               1.44;
-    C2               1.92;
-    C1Ref            0.5;
-    C2Ref            0.3;
-    Cs               0.25;
-    Ceps             0.15;
-    alphaEps         0.76923;
-    alphaR           1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut         1.5;
-    Cb1              0.1355;
-    Cb2              0.622;
-    Cw2              0.3;
-    Cw3              2;
-    Cv1              7.1;
-    Cv2              5.0;
-}
-
-wallFunctionCoeffs
-{
-    kappa            0.4187;
-    E                9;
-}
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/simpleFoam/pitzDaily/0/R b/tutorials/incompressible/simpleFoam/pitzDaily/0/R
index f5e0a978209171573884c3be4be2096816e32df4..0a7a351a5245c18975ee86e7fd2aeaf81f8dbcbd 100644
--- a/tutorials/incompressible/simpleFoam/pitzDaily/0/R
+++ b/tutorials/incompressible/simpleFoam/pitzDaily/0/R
@@ -33,12 +33,12 @@ boundaryField
 
     upperWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
     }
 
     lowerWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
     }
 
     frontAndBack
diff --git a/tutorials/incompressible/simpleFoam/pitzDaily/0/k b/tutorials/incompressible/simpleFoam/pitzDaily/0/k
index 41e4f133aa778b329b7cbcf76cb979d1c57ff3bd..7de1adf4b5d6b4518dc306b6d4ab6d0f40ea2312 100644
--- a/tutorials/incompressible/simpleFoam/pitzDaily/0/k
+++ b/tutorials/incompressible/simpleFoam/pitzDaily/0/k
@@ -32,12 +32,12 @@ boundaryField
     }
     upperWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.375;
     }
     lowerWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.375;
     }
     frontAndBack
diff --git a/tutorials/incompressible/simpleFoam/pitzDaily/constant/RASProperties b/tutorials/incompressible/simpleFoam/pitzDaily/constant/RASProperties
index 559c506d1113db8266b365093851601b52fde4e5..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/incompressible/simpleFoam/pitzDaily/constant/RASProperties
+++ b/tutorials/incompressible/simpleFoam/pitzDaily/constant/RASProperties
@@ -21,181 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-realizableKECoeffs
-{
-    Cmu             0.09;
-    A0              4;
-    C2              1.9;
-    alphak          1;
-    alphaEps        0.833333;
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1         0.85034;
-    alphaK2         1;
-    alphaOmega1     0.5;
-    alphaOmega2     0.85616;
-    gamma1          0.5532;
-    gamma2          0.4403;
-    beta1           0.075;
-    beta2           0.0828;
-    betaStar        0.09;
-    a1              0.31;
-    c1              10;
-    Cmu             0.09;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/R b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/R
index f5e0a978209171573884c3be4be2096816e32df4..0a7a351a5245c18975ee86e7fd2aeaf81f8dbcbd 100644
--- a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/R
+++ b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/R
@@ -33,12 +33,12 @@ boundaryField
 
     upperWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
     }
 
     lowerWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
     }
 
     frontAndBack
diff --git a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/k b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/k
index d33d92f39f6147a530080449b798f3ed3c5ea120..bc8f856acc540db07c30dace7c67519b9708ae85 100644
--- a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/k
+++ b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/k
@@ -67,12 +67,12 @@ boundaryField
     }
     upperWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.375;
     }
     lowerWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.375;
     }
     frontAndBack
diff --git a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/constant/RASProperties b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/constant/RASProperties
index 559c506d1113db8266b365093851601b52fde4e5..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/constant/RASProperties
+++ b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/constant/RASProperties
@@ -21,181 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-realizableKECoeffs
-{
-    Cmu             0.09;
-    A0              4;
-    C2              1.9;
-    alphak          1;
-    alphaEps        0.833333;
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1         0.85034;
-    alphaK2         1;
-    alphaOmega1     0.5;
-    alphaOmega2     0.85616;
-    gamma1          0.5532;
-    gamma2          0.4403;
-    beta1           0.075;
-    beta2           0.0828;
-    betaStar        0.09;
-    a1              0.31;
-    c1              10;
-    Cmu             0.09;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/simpleSRFFoam/mixer/0/k b/tutorials/incompressible/simpleSRFFoam/mixer/0/k
index 59c1b73fc341de0269e7d827e7bd10d725220416..ec118fa2df2651acf47fbda90341bddd76df3a2b 100644
--- a/tutorials/incompressible/simpleSRFFoam/mixer/0/k
+++ b/tutorials/incompressible/simpleSRFFoam/mixer/0/k
@@ -32,12 +32,12 @@ boundaryField
     }
     innerWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.375;
     }
     outerWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.375;
     }
     cyclic
diff --git a/tutorials/incompressible/simpleSRFFoam/mixer/constant/RASProperties b/tutorials/incompressible/simpleSRFFoam/mixer/constant/RASProperties
index f543226c9b0ae5af82f266274304fb8acf2f5ab6..480abbfe0e982c895c981180ef06f857e9ffe988 100644
--- a/tutorials/incompressible/simpleSRFFoam/mixer/constant/RASProperties
+++ b/tutorials/incompressible/simpleSRFFoam/mixer/constant/RASProperties
@@ -21,172 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1         0.85034;
-    alphaK2         1;
-    alphaOmega1     0.5;
-    alphaOmega2     0.85616;
-    gamma1          0.5532;
-    gamma2          0.4403;
-    beta1           0.075;
-    beta2           0.0828;
-    betaStar        0.09;
-    a1              0.31;
-    c1              10;
-    Cmu             0.09;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/0/k b/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/0/k
index 9abb57fdb013a1d9dd1ac7859f9554dc0c642b71..d5f2de2074bbefdbb035222b6b68a2406e4ed9f6 100644
--- a/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/0/k
+++ b/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/0/k
@@ -23,17 +23,17 @@ boundaryField
 {
     top
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 37.5;
     }
     bottom
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 37.5;
     }
     walls
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 37.5;
     }
     symmetry
diff --git a/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0.org/k b/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0.org/k
index eed0dcdd366eab874e4fb2dc3ba7e5c542e35b76..21282254cba0531a821666aa8ff0ef8ab7f12e00 100644
--- a/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0.org/k
+++ b/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0.org/k
@@ -23,7 +23,7 @@ boundaryField
 {
     walls
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.0938;
     }
     inlet
diff --git a/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0/k b/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0/k
index eed0dcdd366eab874e4fb2dc3ba7e5c542e35b76..21282254cba0531a821666aa8ff0ef8ab7f12e00 100644
--- a/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0/k
+++ b/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0/k
@@ -23,7 +23,7 @@ boundaryField
 {
     walls
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 0.0938;
     }
     inlet
diff --git a/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/constant/RASProperties b/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/constant/RASProperties
index 71270c8d7cdd49831a45d2e34e2020fb49265ed1..b412674cb413ab19ece681b82896cd24ce3b5a5b 100644
--- a/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/constant/RASProperties
+++ b/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/constant/RASProperties
@@ -20,150 +20,5 @@ turbulence          on;
 
 printCoeffs         on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    // Cmu
-    Cmu              0.09;
-    // C1
-    C1               1.44;
-    // C2
-    C2               1.92;
-    // C3
-    C3               -0.33;
-    // alphah
-    alphah           1;
-    // alphak
-    alphak           1;
-    // alphaEps
-    alphaEps         0.76923;
-}
-
-// RNG k-epsilon model coefficients
-RNGkEpsilonCoeffs
-{
-    // Cmu
-    Cmu              0.0845;
-    // C1
-    C1               1.42;
-    // C2
-    C2               1.68;
-    // C3
-    C3               -0.33;
-    // alphah
-    alphah           1;
-    // alphak
-    alphak           1.39;
-    // alphaEps
-    alphaEps         1.39;
-    // eta0
-    eta0             4.38;
-    // beta
-    beta             0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    // Cmu
-    Cmu              0.09;
-    // C1
-    C1               1.44;
-    // C2
-    C2               1.92;
-    // C3
-    C3               -0.33;
-    // alphah
-    alphah           1;
-    // alphak
-    alphak           1;
-    // alphaEps
-    alphaEps         0.76923;
-}
-
-// Launder-Reece-Rodi RSTM with wall functions model coefficients
-LRRCoeffs
-{
-    // Cmu
-    Cmu              0.09;
-    // Clrr1
-    Clrr1            1.8;
-    // Clrr2
-    Clrr2            0.6;
-    // C1
-    C1               1.44;
-    // C2
-    C2               1.92;
-    // Cs
-    Cs               0.25;
-    // Ceps
-    Ceps             0.15;
-    // alphah
-    alphah           1;
-    // alphaEps
-    alphaEps         0.76923;
-    // alphaR
-    alphaR           1.22;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    // Cmu
-    Cmu              0.09;
-    // Clg1
-    Clg1             1.8;
-    // Clg2
-    Clg2             0.6;
-    // C1
-    C1               1.44;
-    // C2
-    C2               1.92;
-    // C1Ref
-    C1Ref            0.5;
-    // C2Ref
-    C2Ref            0.3;
-    // Cs
-    Cs               0.25;
-    // Ceps
-    Ceps             0.15;
-    // alphah
-    alphah           1;
-    // alphaEps
-    alphaEps         0.76923;
-    // alphaR
-    alphaR           1.22;
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1          0.85034;
-    alphaK2          1.0;
-    alphaOmega1      0.5;
-    alphaOmega2      0.85616;
-    gamma1           0.5532;
-    gamma2           0.4403;
-    beta1            0.0750;
-    beta2            0.0828;
-    betaStar         0.09;
-    a1               0.31;
-    c1               10;
-
-    Cmu              0.09;
-
-    alphah           1;
-}
-
-wallFunctionCoeffs
-{
-    // kappa
-    kappa            0.4187;
-    // E
-    E                9;
-    // Prt
-    Prt              1;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/0/k b/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/0/k
index 9abb57fdb013a1d9dd1ac7859f9554dc0c642b71..d5f2de2074bbefdbb035222b6b68a2406e4ed9f6 100644
--- a/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/0/k
+++ b/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/0/k
@@ -23,17 +23,17 @@ boundaryField
 {
     top
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 37.5;
     }
     bottom
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 37.5;
     }
     walls
     {
-        type            compressible::kQRWallFunction;
+        type            compressible::kqRWallFunction;
         value           uniform 37.5;
     }
     symmetry
diff --git a/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/constant/RASProperties b/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/constant/RASProperties
index 26216fcde0621aa1c526ab843d2825da511d520a..44c471f517fa30958c0c009b585ee4fa08029678 100644
--- a/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/constant/RASProperties
+++ b/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/constant/RASProperties
@@ -21,80 +21,4 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    C3              -0.33;
-    alphah          1;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.33;
-    alphah          1;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphah          1;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
-
 // ************************************************************************* //
diff --git a/tutorials/multiphase/bubbleFoam/bubbleColumn/constant/RASProperties b/tutorials/multiphase/bubbleFoam/bubbleColumn/constant/RASProperties
index 3569e78dc3564dc685fe71877c195db359d8343e..4bd60ebb769e41f0e6f200d6a140bbfe365e6f83 100644
--- a/tutorials/multiphase/bubbleFoam/bubbleColumn/constant/RASProperties
+++ b/tutorials/multiphase/bubbleFoam/bubbleColumn/constant/RASProperties
@@ -21,24 +21,5 @@ turbulence      off;
 
 printCoeffs     off;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/cavitatingFoam/les/throttle/constant/LESProperties b/tutorials/multiphase/cavitatingFoam/les/throttle/constant/LESProperties
index 583bb948964bbf8d164ff2da1da6600d27ae24cf..1ba57ff22e0237529d8d8d74b5b6f5f085311411 100644
--- a/tutorials/multiphase/cavitatingFoam/les/throttle/constant/LESProperties
+++ b/tutorials/multiphase/cavitatingFoam/les/throttle/constant/LESProperties
@@ -19,104 +19,6 @@ LESModel        oneEqEddy;
 
 delta           smooth;
 
-laminarCoeffs
-{
-}
-
-devOneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-}
-
-oneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-}
-
-dynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-locDynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-SmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-}
-
-Smagorinsky2Coeffs
-{
-    ce              1.05;
-    ck              0.07;
-    cD2             0.02;
-}
-
-spectEddyViscCoeffs
-{
-    ce              1.05;
-    cB              8.22;
-    cK1             0.83;
-    cK2             1.03;
-    cK3             4.75;
-    cK4             2.55;
-}
-
-dynSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-mixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-    filter          simple;
-}
-
-dynMixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-LRRDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    c1              1.8;
-    c2              0.6;
-}
-
-DeardorffDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    cm              4.13;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-    CDES            0.65;
-    ck              0.07;
-}
-
 cubeRootVolCoeffs
 {
     deltaCoeff      1;
@@ -178,12 +80,5 @@ smoothCoeffs
     maxDeltaRatio   1.1;
 }
 
-kappa           0.4187;
-
-wallFunctionCoeffs
-{
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/LESProperties b/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/LESProperties
index 583bb948964bbf8d164ff2da1da6600d27ae24cf..1ba57ff22e0237529d8d8d74b5b6f5f085311411 100644
--- a/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/LESProperties
+++ b/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/LESProperties
@@ -19,104 +19,6 @@ LESModel        oneEqEddy;
 
 delta           smooth;
 
-laminarCoeffs
-{
-}
-
-devOneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-}
-
-oneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-}
-
-dynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-locDynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-SmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-}
-
-Smagorinsky2Coeffs
-{
-    ce              1.05;
-    ck              0.07;
-    cD2             0.02;
-}
-
-spectEddyViscCoeffs
-{
-    ce              1.05;
-    cB              8.22;
-    cK1             0.83;
-    cK2             1.03;
-    cK3             4.75;
-    cK4             2.55;
-}
-
-dynSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-mixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-    filter          simple;
-}
-
-dynMixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-LRRDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    c1              1.8;
-    c2              0.6;
-}
-
-DeardorffDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    cm              4.13;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-    CDES            0.65;
-    ck              0.07;
-}
-
 cubeRootVolCoeffs
 {
     deltaCoeff      1;
@@ -178,12 +80,5 @@ smoothCoeffs
     maxDeltaRatio   1.1;
 }
 
-kappa           0.4187;
-
-wallFunctionCoeffs
-{
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/cavitatingFoam/ras/throttle/0/k b/tutorials/multiphase/cavitatingFoam/ras/throttle/0/k
index 732cdd4d128bc45a4ba908f6ffafd53c5da08971..25ca30f1e13f1092112b38fef9f1bcabad7533b5 100644
--- a/tutorials/multiphase/cavitatingFoam/ras/throttle/0/k
+++ b/tutorials/multiphase/cavitatingFoam/ras/throttle/0/k
@@ -33,7 +33,7 @@ boundaryField
     }
     walls
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 10;
     }
     frontBack
diff --git a/tutorials/multiphase/cavitatingFoam/ras/throttle/constant/RASProperties b/tutorials/multiphase/cavitatingFoam/ras/throttle/constant/RASProperties
index 461a7c61ff5489e67e96b994a036d66ca9355ed8..480abbfe0e982c895c981180ef06f857e9ffe988 100644
--- a/tutorials/multiphase/cavitatingFoam/ras/throttle/constant/RASProperties
+++ b/tutorials/multiphase/cavitatingFoam/ras/throttle/constant/RASProperties
@@ -19,181 +19,7 @@ RASModel        kOmegaSST;
 
 turbulence      on;
 
-laminarCoeffs
-{
-}
-
-kOmegaSSTCoeffs
-{
-    alphaK1         0.85034;
-    alphaK2         1;
-    alphaOmega1     0.5;
-    alphaOmega2     0.85616;
-    gamma1          0.5532;
-    gamma2          0.4403;
-    beta1           0.075;
-    beta2           0.0828;
-    betaStar        0.09;
-    a1              0.31;
-    c1              10;
-    Cmu             0.09;
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-realizableKECoeffs
-{
-    Cmu             0.09;
-    A0              4;
-    C2              1.9;
-    alphak          1;
-    alphaEps        0.833333;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
+printCoeffs     on;
 
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/cavitatingFoam/ras/throttle/constant/polyMesh/boundary b/tutorials/multiphase/cavitatingFoam/ras/throttle/constant/polyMesh/boundary
index 03d26bcf3c96c86ca8ecf11604193892ebc80d29..b5008d95cda2ff30fef45cb13f6649f082f871d1 100644
--- a/tutorials/multiphase/cavitatingFoam/ras/throttle/constant/polyMesh/boundary
+++ b/tutorials/multiphase/cavitatingFoam/ras/throttle/constant/polyMesh/boundary
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  dev                                   |
+|  \\    /   O peration     | Version:  1.6                                   |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/LESProperties b/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/LESProperties
index 14b6ce249d6815c46519a43956116bd9cd2e7a3b..b3cfc0ba03af3fb2a7f427c61867c23853f224fc 100644
--- a/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/LESProperties
+++ b/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/LESProperties
@@ -19,97 +19,6 @@ LESModel        laminar;
 
 delta           cubeRootVol;
 
-laminarCoeffs
-{
-}
-
-oneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-}
-
-dynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-locDynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-SmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-}
-
-Smagorinsky2Coeffs
-{
-    ce              1.05;
-    ck              0.07;
-    cD2             0.02;
-}
-
-spectEddyViscCoeffs
-{
-    ce              1.05;
-    cB              8.22;
-    cK1             0.83;
-    cK2             1.03;
-    cK3             4.75;
-    cK4             2.55;
-}
-
-dynSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-mixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-    filter          simple;
-}
-
-dynMixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-LRRDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    c1              1.8;
-    c2              0.6;
-}
-
-DeardorffDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    cm              4.13;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    CDES            0.65;
-    ck              0.07;
-}
-
 cubeRootVolCoeffs
 {
     deltaCoeff      1;
@@ -171,12 +80,5 @@ smoothCoeffs
     maxDeltaRatio   1.1;
 }
 
-kappa           0.4187;
-
-wallFunctionCoeffs
-{
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/LESProperties b/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/LESProperties
index 14b6ce249d6815c46519a43956116bd9cd2e7a3b..b3cfc0ba03af3fb2a7f427c61867c23853f224fc 100644
--- a/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/LESProperties
+++ b/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/LESProperties
@@ -19,97 +19,6 @@ LESModel        laminar;
 
 delta           cubeRootVol;
 
-laminarCoeffs
-{
-}
-
-oneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-}
-
-dynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-locDynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-SmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-}
-
-Smagorinsky2Coeffs
-{
-    ce              1.05;
-    ck              0.07;
-    cD2             0.02;
-}
-
-spectEddyViscCoeffs
-{
-    ce              1.05;
-    cB              8.22;
-    cK1             0.83;
-    cK2             1.03;
-    cK3             4.75;
-    cK4             2.55;
-}
-
-dynSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-mixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-    filter          simple;
-}
-
-dynMixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-LRRDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    c1              1.8;
-    c2              0.6;
-}
-
-DeardorffDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    cm              4.13;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    CDES            0.65;
-    ck              0.07;
-}
-
 cubeRootVolCoeffs
 {
     deltaCoeff      1;
@@ -171,12 +80,5 @@ smoothCoeffs
     maxDeltaRatio   1.1;
 }
 
-kappa           0.4187;
-
-wallFunctionCoeffs
-{
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/RASProperties b/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/RASProperties
index 035a467881184ab15b7f8e2874b04983bc167675..e62f5f6ce4a87c875c774a81a739fb1bedbfe0c2 100644
--- a/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/RASProperties
+++ b/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/RASProperties
@@ -21,156 +21,5 @@ turbulence      on;
 
 printCoeffs     off;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/RASProperties b/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/RASProperties
index ac647d46427282fac607f94584e78ca379f120a8..4773e27a41a100b308cec5d0fd481bb6aab1eda0 100644
--- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/RASProperties
+++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/RASProperties
@@ -19,156 +19,7 @@ RASModel        laminar;
 
 turbulence      off;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
+printCoeffs     on;
 
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D3DoF/constant/RASProperties b/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D3DoF/constant/RASProperties
index ac647d46427282fac607f94584e78ca379f120a8..4773e27a41a100b308cec5d0fd481bb6aab1eda0 100644
--- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D3DoF/constant/RASProperties
+++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D3DoF/constant/RASProperties
@@ -19,156 +19,7 @@ RASModel        laminar;
 
 turbulence      off;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
+printCoeffs     on;
 
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/RASProperties b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/RASProperties
index ac647d46427282fac607f94584e78ca379f120a8..4773e27a41a100b308cec5d0fd481bb6aab1eda0 100644
--- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/RASProperties
+++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/RASProperties
@@ -19,156 +19,7 @@ RASModel        laminar;
 
 turbulence      off;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
+printCoeffs     on;
 
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/RASProperties b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/RASProperties
index ac647d46427282fac607f94584e78ca379f120a8..8107da2ca193720996c5ec4d70558f90ef300d94 100644
--- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/RASProperties
+++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/RASProperties
@@ -19,156 +19,5 @@ RASModel        laminar;
 
 turbulence      off;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/RASProperties b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/RASProperties
index ac647d46427282fac607f94584e78ca379f120a8..4773e27a41a100b308cec5d0fd481bb6aab1eda0 100644
--- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/RASProperties
+++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/RASProperties
@@ -19,156 +19,7 @@ RASModel        laminar;
 
 turbulence      off;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
+printCoeffs     on;
 
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/LESProperties b/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/LESProperties
index c4072e231d795e2e5997ea71f619cdb53658219c..c8ccdc8716888eb2b117702aa440d37cc626b23f 100644
--- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/LESProperties
+++ b/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/LESProperties
@@ -21,98 +21,6 @@ delta           smooth;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-oneEqEddyCoeffs
-{
-    ck              0.07;
-    ce              1.05;
-}
-
-dynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-locDynOneEqEddyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-SmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-}
-
-Smagorinsky2Coeffs
-{
-    ce              1.05;
-    ck              0.07;
-    cD2             0.02;
-}
-
-spectEddyViscCoeffs
-{
-    ce              1.05;
-    cB              8.22;
-    cK1             0.83;
-    cK2             1.03;
-    cK3             4.75;
-    cK4             2.55;
-}
-
-dynSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-mixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    ck              0.07;
-    filter          simple;
-}
-
-dynMixedSmagorinskyCoeffs
-{
-    ce              1.05;
-    filter          simple;
-}
-
-LRRDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    c1              1.8;
-    c2              0.6;
-}
-
-DeardorffDiffStressCoeffs
-{
-    ce              1.05;
-    ck              0.09;
-    cm              4.13;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-    CDES            0.65;
-    ck              0.07;
-}
-
 cubeRootVolCoeffs
 {
     deltaCoeff      1;
@@ -174,12 +82,5 @@ smoothCoeffs
     maxDeltaRatio   1.1;
 }
 
-kappa           0.4187;
-
-wallFunctionCoeffs
-{
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/interFoam/ras/damBreak/0/R b/tutorials/multiphase/interFoam/ras/damBreak/0/R
index e62afda35fcc821151c4141fada9e9401e4837de..2bc3b606121cd19f2444d4073502945a8c2ef19d 100644
--- a/tutorials/multiphase/interFoam/ras/damBreak/0/R
+++ b/tutorials/multiphase/interFoam/ras/damBreak/0/R
@@ -23,19 +23,19 @@ boundaryField
 {
     leftWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform ( 0 0 0 0 0 0 );
     }
 
     rightWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform ( 0 0 0 0 0 0 );
     }
 
     lowerWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform ( 0 0 0 0 0 0 );
     }
 
diff --git a/tutorials/multiphase/interFoam/ras/damBreak/0/k b/tutorials/multiphase/interFoam/ras/damBreak/0/k
index 897224d725f3bd8e0f02800a735dae854a9b03e9..8fd8f798ffdda10581861fc95c97f0b15df5706b 100644
--- a/tutorials/multiphase/interFoam/ras/damBreak/0/k
+++ b/tutorials/multiphase/interFoam/ras/damBreak/0/k
@@ -23,17 +23,17 @@ boundaryField
 {
     leftWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
     rightWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
     lowerWall
     {
-        type            kQRWallFunction;
+        type            kqRWallFunction;
         value           uniform 0.1;
     }
     atmosphere
diff --git a/tutorials/multiphase/interFoam/ras/damBreak/constant/RASProperties b/tutorials/multiphase/interFoam/ras/damBreak/constant/RASProperties
index ce5406cd7aadd133ad41d268c5e2771a33d1c979..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/multiphase/interFoam/ras/damBreak/constant/RASProperties
+++ b/tutorials/multiphase/interFoam/ras/damBreak/constant/RASProperties
@@ -21,165 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-RNGkEpsilonCoeffs
-{
-    Cmu             0.0845;
-    C1              1.42;
-    C2              1.68;
-    alphak          1.39;
-    alphaEps        1.39;
-    eta0            4.38;
-    beta            0.012;
-}
-
-realizableKECoeffs
-{
-    Cmu             0.09;
-    A0              4;
-    C2              1.9;
-    alphak          1;
-    alphaEps        0.833333;
-}
-
-NonlinearKEShihCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76932;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-LienCubicKECoeffs
-{
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-}
-
-QZetaCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaZeta       0.76923;
-    anisotropic     no;
-}
-
-LaunderSharmaKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LamBremhorstKECoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphaEps        0.76923;
-}
-
-LienCubicKELowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    A1              1.25;
-    A2              1000;
-    Ctau1           -4;
-    Ctau2           13;
-    Ctau3           -2;
-    alphaKsi        0.9;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LienLeschzinerLowReCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-    Am              0.016;
-    Aepsilon        0.263;
-    Amu             0.00222;
-}
-
-LRRCoeffs
-{
-    Cmu             0.09;
-    Clrr1           1.8;
-    Clrr2           0.6;
-    C1              1.44;
-    C2              1.92;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-}
-
-LaunderGibsonRSTMCoeffs
-{
-    Cmu             0.09;
-    Clg1            1.8;
-    Clg2            0.6;
-    C1              1.44;
-    C2              1.92;
-    C1Ref           0.5;
-    C2Ref           0.3;
-    Cs              0.25;
-    Ceps            0.15;
-    alphaEps        0.76923;
-    alphaR          1.22;
-}
-
-SpalartAllmarasCoeffs
-{
-    alphaNut        1.5;
-    Cb1             0.1355;
-    Cb2             0.622;
-    Cw2             0.3;
-    Cw3             2;
-    Cv1             7.1;
-    Cv2             5;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/constant/RASProperties b/tutorials/multiphase/settlingFoam/ras/dahl/constant/RASProperties
index 7d55e238e459fd3486cc80530d7f34fd00c7d15e..72415161305c19ac50f93aa8ff27750a826d0637 100644
--- a/tutorials/multiphase/settlingFoam/ras/dahl/constant/RASProperties
+++ b/tutorials/multiphase/settlingFoam/ras/dahl/constant/RASProperties
@@ -21,25 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0.85;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/RASProperties b/tutorials/multiphase/settlingFoam/ras/tank3D/constant/RASProperties
index a19f0292e20c63566acdb0e9a8dd8bb9a1ff4589..a4937b503a46850b2626f0d301e4a07b9f691507 100644
--- a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/RASProperties
+++ b/tutorials/multiphase/settlingFoam/ras/tank3D/constant/RASProperties
@@ -21,25 +21,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-laminarCoeffs
-{
-}
-
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              0.85;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/twoPhaseEulerFoam/bed/constant/RASProperties b/tutorials/multiphase/twoPhaseEulerFoam/bed/constant/RASProperties
index 530659456503c852fcdd3b45b7f60d014b64063f..282dde8a41809ebade8adc9abf54427f5f17b3cf 100644
--- a/tutorials/multiphase/twoPhaseEulerFoam/bed/constant/RASProperties
+++ b/tutorials/multiphase/twoPhaseEulerFoam/bed/constant/RASProperties
@@ -19,21 +19,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.375;
-    alphak          1;
-    alphaEps        0.82142;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/twoPhaseEulerFoam/bed/system/fvSchemes b/tutorials/multiphase/twoPhaseEulerFoam/bed/system/fvSchemes
index 1e881ca7e568902f1f3448eb5b67053c9c2fce3a..8e76e961b3da1f018587ff5bcf58367db6e1146b 100644
--- a/tutorials/multiphase/twoPhaseEulerFoam/bed/system/fvSchemes
+++ b/tutorials/multiphase/twoPhaseEulerFoam/bed/system/fvSchemes
@@ -46,8 +46,8 @@ laplacianSchemes
     laplacian(nuEffb,Ub) Gauss linear corrected;
     laplacian((rho*(1|A(U))),p) Gauss linear corrected;
     laplacian(alphaPpMag,alpha) Gauss linear corrected;
-    laplacian((alphaEps*nuEffb),epsilon) Gauss linear corrected;
-    laplacian((alphak*nuEffb),k) Gauss linear corrected;
+    laplacian(DkEff,k) Gauss linear corrected;
+    laplacian(DepsilonEff,epsilon) Gauss linear corrected;
 }
 
 interpolationSchemes
diff --git a/tutorials/multiphase/twoPhaseEulerFoam/bed2/constant/RASProperties b/tutorials/multiphase/twoPhaseEulerFoam/bed2/constant/RASProperties
index 803255b5a016ac955f309243d387795460ff0030..9589aa497f9759d31e40f4ebb894ea4ee1370cf4 100644
--- a/tutorials/multiphase/twoPhaseEulerFoam/bed2/constant/RASProperties
+++ b/tutorials/multiphase/twoPhaseEulerFoam/bed2/constant/RASProperties
@@ -19,21 +19,5 @@ turbulence      on;
 
 printCoeffs     on;
 
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    C3              -0.375;
-    alphak          1;
-    alphaEps        0.82142;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //
diff --git a/tutorials/multiphase/twoPhaseEulerFoam/bed2/system/fvSchemes b/tutorials/multiphase/twoPhaseEulerFoam/bed2/system/fvSchemes
index d007d55f784a4b6daad339d280ddc3c25a47e786..e85cd3bf9364501a8bfa283790fa69d02dab44fd 100644
--- a/tutorials/multiphase/twoPhaseEulerFoam/bed2/system/fvSchemes
+++ b/tutorials/multiphase/twoPhaseEulerFoam/bed2/system/fvSchemes
@@ -47,8 +47,8 @@ laplacianSchemes
     laplacian((rho*(1|A(U))),p) Gauss linear corrected;
     laplacian(alphaPpMag,alpha) Gauss linear corrected;
     laplacian(Galphaf,alpha) Gauss linear corrected;
-    laplacian((alphak*nuEffb),k) Gauss linear corrected;
-    laplacian((alphaEps*nuEffb),epsilon) Gauss linear corrected;
+    laplacian(DkEff,k) Gauss linear corrected;
+    laplacian(DepsilonEff,epsilon) Gauss linear corrected;
     laplacian(kappa,Theta) Gauss linear corrected;
 }
 
diff --git a/tutorials/multiphase/twoPhaseEulerFoam/bubbleColumn/constant/RASProperties b/tutorials/multiphase/twoPhaseEulerFoam/bubbleColumn/constant/RASProperties
index b84915eafc5afd9f32c3e7585564fb023a24c077..fe181621ac530762fa81443a4708216c22fc0c45 100644
--- a/tutorials/multiphase/twoPhaseEulerFoam/bubbleColumn/constant/RASProperties
+++ b/tutorials/multiphase/twoPhaseEulerFoam/bubbleColumn/constant/RASProperties
@@ -21,20 +21,5 @@ turbulence      off;
 
 printCoeffs     off;
 
-kEpsilonCoeffs
-{
-    Cmu             0.09;
-    C1              1.44;
-    C2              1.92;
-    alphak          1;
-    alphaEps        0.76923;
-}
-
-wallFunctionCoeffs
-{
-    kappa           0.4187;
-    E               9;
-}
-
 
 // ************************************************************************* //