diff --git a/applications/solvers/compressible/rhoPimpleFoam/Allwmake b/applications/solvers/compressible/rhoPimpleFoam/Allwmake
index 241e22eb1b6c4fd85d2b42836dcc7d78cbfa4915..f6f8ad3635d10f11e2557d9e6f0af3258a738bb2 100755
--- a/applications/solvers/compressible/rhoPimpleFoam/Allwmake
+++ b/applications/solvers/compressible/rhoPimpleFoam/Allwmake
@@ -3,6 +3,7 @@ cd ${0%/*} || exit 1    # run from this directory
 set -x
 
 wmake
+wmake rhoPimplecFoam
 wmake rhoPorousMRFPimpleFoam
 wmake rhoPorousMRFLTSPimpleFoam
 
diff --git a/applications/solvers/compressible/rhoPimpleFoam/UEqn.H b/applications/solvers/compressible/rhoPimpleFoam/UEqn.H
index 1e39e983e42a476d62c73a65a0ef531771f43991..b7b4b04db5c477cefc3dd2dfeab98d3ee6557a11 100644
--- a/applications/solvers/compressible/rhoPimpleFoam/UEqn.H
+++ b/applications/solvers/compressible/rhoPimpleFoam/UEqn.H
@@ -4,13 +4,12 @@ tmp<fvVectorMatrix> UEqn
 (
     fvm::ddt(rho, U)
   + fvm::div(phi, U)
+  - fvm::Sp(fvc::ddt(rho) + fvc::div(phi), U)
   + turbulence->divDevRhoReff(U)
 );
 
 UEqn().relax();
 
-volScalarField rAU(1.0/UEqn().A());
-
 if (pimple.momentumPredictor())
 {
     solve(UEqn() == -fvc::grad(p));
diff --git a/applications/solvers/compressible/rhoPimpleFoam/hEqn.H b/applications/solvers/compressible/rhoPimpleFoam/hEqn.H
index b1d9e4e8b0237ca0b9f28f6d36c8f5162121c846..57d72887e60ba1f6dda559ff3353d1294ff3346d 100644
--- a/applications/solvers/compressible/rhoPimpleFoam/hEqn.H
+++ b/applications/solvers/compressible/rhoPimpleFoam/hEqn.H
@@ -3,10 +3,14 @@
     (
         fvm::ddt(rho, h)
       + fvm::div(phi, h)
+      - fvm::Sp(fvc::ddt(rho) + fvc::div(phi), h)
       - fvm::laplacian(turbulence->alphaEff(), h)
      ==
         dpdt
-      - (fvc::ddt(rho, K) + fvc::div(phi, K))
+      - (
+            fvc::ddt(rho, K) + fvc::div(phi, K)
+          - (fvc::ddt(rho) + fvc::div(phi))*K
+        )
     );
 
     hEqn.relax();
diff --git a/applications/solvers/compressible/rhoPimpleFoam/pEqn.H b/applications/solvers/compressible/rhoPimpleFoam/pEqn.H
index cfe34f2873146dabbcc4880755867b57e7609766..3d324e085b943574aec0f3ef60f8901e13d8cb0c 100644
--- a/applications/solvers/compressible/rhoPimpleFoam/pEqn.H
+++ b/applications/solvers/compressible/rhoPimpleFoam/pEqn.H
@@ -3,6 +3,7 @@ rho = max(rho, rhoMin);
 rho = min(rho, rhoMax);
 rho.relax();
 
+volScalarField rAU(1.0/UEqn().A());
 volVectorField HbyA("HbyA", U);
 HbyA = rAU*UEqn().H();
 
@@ -23,13 +24,15 @@ if (pimple.transonic())
         )
     );
 
+    volScalarField Dp("Dp", rho*rAU);
+
     while (pimple.correctNonOrthogonal())
     {
         fvScalarMatrix pEqn
         (
             fvm::ddt(psi, p)
           + fvm::div(phid, p)
-          - fvm::laplacian(rho*rAU, p)
+          - fvm::laplacian(Dp, p)
         );
 
         pEqn.solve(mesh.solver(p.select(pimple.finalInnerIter())));
@@ -52,6 +55,8 @@ else
         )
     );
 
+    volScalarField Dp("Dp", rho*rAU);
+
     while (pimple.correctNonOrthogonal())
     {
         // Pressure corrector
@@ -59,7 +64,7 @@ else
         (
             fvm::ddt(psi, p)
           + fvc::div(phiHbyA)
-          - fvm::laplacian(rho*rAU, p)
+          - fvm::laplacian(Dp, p)
         );
 
         pEqn.solve(mesh.solver(p.select(pimple.finalInnerIter())));
diff --git a/applications/solvers/compressible/rhoPimpleFoam/rhoPimpleFoam.C b/applications/solvers/compressible/rhoPimpleFoam/rhoPimpleFoam.C
index 26d11a14aa6694211f3c9dfba3e97825bd7a79e1..28787716e0ac365dbb84a8a130e6cf23fdad0c5b 100644
--- a/applications/solvers/compressible/rhoPimpleFoam/rhoPimpleFoam.C
+++ b/applications/solvers/compressible/rhoPimpleFoam/rhoPimpleFoam.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -66,7 +66,10 @@ int main(int argc, char *argv[])
 
         Info<< "Time = " << runTime.timeName() << nl << endl;
 
-        #include "rhoEqn.H"
+        if (pimple.nCorrPIMPLE() <= 1)
+        {
+            #include "rhoEqn.H"
+        }
 
         // --- Pressure-velocity PIMPLE corrector loop
         while (pimple.loop())
diff --git a/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/Make/files b/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/Make/files
new file mode 100644
index 0000000000000000000000000000000000000000..5bb1f8d0239f1f82a86fbe88e38b7203ca9f8023
--- /dev/null
+++ b/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/Make/files
@@ -0,0 +1,3 @@
+rhoPimplecFoam.C
+
+EXE = $(FOAM_APPBIN)/rhoPimplecFoam
diff --git a/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/Make/options b/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/Make/options
new file mode 100644
index 0000000000000000000000000000000000000000..d16a0ee1d88a2d9a037f976e6f5b9bc7c7074261
--- /dev/null
+++ b/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/Make/options
@@ -0,0 +1,15 @@
+EXE_INC = \
+    -I.. \
+    -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
+    -I$(LIB_SRC)/turbulenceModels/compressible/turbulenceModel \
+    -I$(LIB_SRC)/finiteVolume/cfdTools \
+    -I$(LIB_SRC)/finiteVolume/lnInclude
+
+EXE_LIBS = \
+    -lbasicThermophysicalModels \
+    -lspecie \
+    -lcompressibleTurbulenceModel \
+    -lcompressibleRASModels \
+    -lcompressibleLESModels \
+    -lfiniteVolume \
+    -lmeshTools
diff --git a/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/pEqn.H b/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/pEqn.H
new file mode 100644
index 0000000000000000000000000000000000000000..7ef1b6253319db33d97a6617e6ba464e34eef840
--- /dev/null
+++ b/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/pEqn.H
@@ -0,0 +1,117 @@
+rho = thermo.rho();
+rho = max(rho, rhoMin);
+rho = min(rho, rhoMax);
+rho.relax();
+
+volScalarField rAU(1.0/UEqn().A());
+volScalarField rAtU(1.0/(1.0/rAU - UEqn().H1()));
+
+volVectorField HbyA("HbyA", U);
+HbyA = rAU*UEqn().H();
+
+if (pimple.nCorrPIMPLE() <= 1)
+{
+    UEqn.clear();
+}
+
+if (pimple.transonic())
+{
+    surfaceScalarField phid
+    (
+        "phid",
+        fvc::interpolate(psi)
+       *(
+            (fvc::interpolate(HbyA) & mesh.Sf())
+          + fvc::ddtPhiCorr(rAU, rho, U, phi)
+        )
+    );
+
+    surfaceScalarField phic
+    (
+        "phic",
+        fvc::interpolate(rho*(rAtU - rAU))*fvc::snGrad(p)*mesh.magSf()
+    );
+
+    HbyA -= (rAU - rAtU)*fvc::grad(p);
+
+    volScalarField Dp("Dp", rho*rAtU);
+
+    while (pimple.correctNonOrthogonal())
+    {
+        fvScalarMatrix pEqn
+        (
+            fvm::ddt(psi, p)
+          + fvm::div(phid, p)
+          + fvc::div(phic)
+          - fvm::laplacian(Dp, p)
+        );
+
+        // Relax the pressure equation to maintain diagonal dominance
+        pEqn.relax();
+
+        pEqn.solve();
+
+        if (pimple.finalNonOrthogonalIter())
+        {
+            phi == phic + pEqn.flux();
+        }
+    }
+}
+else
+{
+    surfaceScalarField phiHbyA
+    (
+        "phiHbyA",
+        fvc::interpolate(rho)
+       *(
+            (fvc::interpolate(HbyA) & mesh.Sf())
+          + fvc::ddtPhiCorr(rAU, rho, U, phi)
+        )
+    );
+
+    phiHbyA += fvc::interpolate(rho*(rAtU - rAU))*fvc::snGrad(p)*mesh.magSf();
+    HbyA -= (rAU - rAtU)*fvc::grad(p);
+
+    volScalarField Dp("Dp", rho*rAtU);
+
+    while (pimple.correctNonOrthogonal())
+    {
+        fvScalarMatrix pEqn
+        (
+            fvm::ddt(psi, p)
+          + fvc::div(phiHbyA)
+          - fvm::laplacian(Dp, p)
+        );
+
+        pEqn.solve();
+
+        if (pimple.finalNonOrthogonalIter())
+        {
+            phi = phiHbyA + pEqn.flux();
+        }
+    }
+}
+
+#include "rhoEqn.H"
+#include "compressibleContinuityErrs.H"
+
+// Explicitly relax pressure for momentum corrector
+p.relax();
+
+U = HbyA - rAtU*fvc::grad(p);
+U.correctBoundaryConditions();
+K = 0.5*magSqr(U);
+
+dpdt = fvc::ddt(p);
+
+// Recalculate density from the relaxed pressure
+rho = thermo.rho();
+rho = max(rho, rhoMin);
+rho = min(rho, rhoMax);
+
+if (!pimple.transonic())
+{
+    rho.relax();
+}
+
+Info<< "rho max/min : " << max(rho).value() << " " << min(rho).value() << endl;
diff --git a/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/rhoPimplecFoam.C b/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/rhoPimplecFoam.C
new file mode 100644
index 0000000000000000000000000000000000000000..0b01f51c8217540f654a7d10d57817f9d69b6fc6
--- /dev/null
+++ b/applications/solvers/compressible/rhoPimpleFoam/rhoPimplecFoam/rhoPimplecFoam.C
@@ -0,0 +1,105 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+Application
+    rhoPimplecFoam
+
+Description
+    Transient solver for laminar or turbulent flow of compressible fluids
+    for HVAC and similar applications.
+
+    Uses the flexible PIMPLEC (PISOC-SIMPLEC) solution for time-resolved and
+    pseudo-transient simulations.
+
+\*---------------------------------------------------------------------------*/
+
+#include "fvCFD.H"
+#include "basicPsiThermo.H"
+#include "turbulenceModel.H"
+#include "bound.H"
+#include "pimpleControl.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+int main(int argc, char *argv[])
+{
+    #include "setRootCase.H"
+    #include "createTime.H"
+    #include "createMesh.H"
+
+    pimpleControl pimple(mesh);
+
+    #include "createFields.H"
+    #include "initContinuityErrs.H"
+
+    // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+    Info<< "\nStarting time loop\n" << endl;
+
+    while (runTime.run())
+    {
+        #include "readTimeControls.H"
+        #include "compressibleCourantNo.H"
+        #include "setDeltaT.H"
+
+        runTime++;
+
+        Info<< "Time = " << runTime.timeName() << nl << endl;
+
+        if (pimple.nCorrPIMPLE() <= 1)
+        {
+            #include "rhoEqn.H"
+        }
+
+        // --- Pressure-velocity PIMPLE corrector loop
+        while (pimple.loop())
+        {
+            #include "UEqn.H"
+            #include "hEqn.H"
+
+            // --- Pressure corrector loop
+            while (pimple.correct())
+            {
+                #include "pEqn.H"
+            }
+
+            if (pimple.turbCorr())
+            {
+                turbulence->correct();
+            }
+        }
+
+        runTime.write();
+
+        Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s"
+            << "  ClockTime = " << runTime.elapsedClockTime() << " s"
+            << nl << endl;
+    }
+
+    Info<< "End\n" << endl;
+
+    return 0;
+}
+
+
+// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFLTSPimpleFoam/rhoPorousMRFLTSPimpleFoam.C b/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFLTSPimpleFoam/rhoPorousMRFLTSPimpleFoam.C
index de32f1f5c633c48aae0434b92799818183829cf5..e305916f2928e2dd7dcb1a66fc2a6d2ad8f27dc6 100644
--- a/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFLTSPimpleFoam/rhoPorousMRFLTSPimpleFoam.C
+++ b/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFLTSPimpleFoam/rhoPorousMRFLTSPimpleFoam.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -74,7 +74,10 @@ int main(int argc, char *argv[])
 
         #include "setrDeltaT.H"
 
-        #include "rhoEqn.H"
+        if (pimple.nCorrPIMPLE() <= 1)
+        {
+            #include "rhoEqn.H"
+        }
 
         // --- Pressure-velocity PIMPLE corrector loop
         while (pimple.loop())
diff --git a/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/UEqn.H b/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/UEqn.H
index c63f0f8e4b080cdb6c6662788c176982a6c42a59..c24b1f587a59bac6cd7b305b5dc6ccdf55986613 100644
--- a/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/UEqn.H
+++ b/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/UEqn.H
@@ -13,8 +13,6 @@ UEqn().relax();
 mrfZones.addCoriolis(rho, UEqn());
 pZones.addResistance(UEqn());
 
-volScalarField rAU(1.0/UEqn().A());
-
 if (pimple.momentumPredictor())
 {
     solve(UEqn() == -fvc::grad(p));
diff --git a/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/pEqn.H b/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/pEqn.H
index c5c7602a43ff4bbbf5230305157bcdc3e9b03cb3..3c75e87e6461998422e897f490c5edff9668dfe2 100644
--- a/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/pEqn.H
+++ b/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/pEqn.H
@@ -25,13 +25,15 @@ if (pimple.transonic())
     );
     mrfZones.relativeFlux(fvc::interpolate(psi), phid);
 
+    volScalarField Dp("Dp", rho*rAU);
+
     while (pimple.correctNonOrthogonal())
     {
         fvScalarMatrix pEqn
         (
             fvm::ddt(psi, p)
           + fvm::div(phid, p)
-          - fvm::laplacian(rho*rAU, p)
+          - fvm::laplacian(Dp, p)
         );
 
         pEqn.solve(mesh.solver(p.select(pimple.finalInnerIter())));
@@ -56,6 +58,8 @@ else
 
     mrfZones.relativeFlux(fvc::interpolate(rho), phiHbyA);
 
+    volScalarField Dp("Dp", rho*rAU);
+
     while (pimple.correctNonOrthogonal())
     {
         // Pressure corrector
@@ -63,7 +67,7 @@ else
         (
             fvm::ddt(psi, p)
           + fvc::div(phiHbyA)
-          - fvm::laplacian(rho*rAU, p)
+          - fvm::laplacian(Dp, p)
         );
 
         pEqn.solve(mesh.solver(p.select(pimple.finalInnerIter())));
diff --git a/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/rhoPorousMRFPimpleFoam.C b/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/rhoPorousMRFPimpleFoam.C
index 068de89952e1f5b940ffac33f4af63c3c82b20ec..e02787c35d6201c2c7c92635b4177521ce356707 100644
--- a/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/rhoPorousMRFPimpleFoam.C
+++ b/applications/solvers/compressible/rhoPimpleFoam/rhoPorousMRFPimpleFoam/rhoPorousMRFPimpleFoam.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -69,7 +69,10 @@ int main(int argc, char *argv[])
 
         Info<< "Time = " << runTime.timeName() << nl << endl;
 
-        #include "rhoEqn.H"
+        if (pimple.nCorrPIMPLE() <= 1)
+        {
+            #include "rhoEqn.H"
+        }
 
         // --- Pressure-velocity PIMPLE corrector loop
         while (pimple.loop())
diff --git a/applications/solvers/compressible/rhoSimpleFoam/createFields.H b/applications/solvers/compressible/rhoSimpleFoam/createFields.H
index 27bfb8313317147b91ca84655b61e7086cf19975..8a7d636f99a17060d6e3d4054cae88c3a9e88958 100644
--- a/applications/solvers/compressible/rhoSimpleFoam/createFields.H
+++ b/applications/solvers/compressible/rhoSimpleFoam/createFields.H
@@ -20,7 +20,7 @@
     );
 
     volScalarField& p = thermo.p();
-    volScalarField& h = thermo.h();
+    volScalarField& e = thermo.e();
     const volScalarField& psi = thermo.psi();
 
     Info<< "Reading field U\n" << endl;
diff --git a/applications/solvers/compressible/rhoSimpleFoam/eEqn.H b/applications/solvers/compressible/rhoSimpleFoam/eEqn.H
new file mode 100644
index 0000000000000000000000000000000000000000..a1ea77157311f3f475957a725a237c7baa8fbed3
--- /dev/null
+++ b/applications/solvers/compressible/rhoSimpleFoam/eEqn.H
@@ -0,0 +1,18 @@
+{
+    // Kinetic + pressure energy
+    volScalarField Ekp("Ekp", 0.5*magSqr(U) + p/rho);
+
+    fvScalarMatrix eEqn
+    (
+        fvm::div(phi, e)
+      - fvm::Sp(fvc::div(phi), e)
+      - fvm::laplacian(turbulence->alphaEff(), e)
+     ==
+        fvc::div(phi)*Ekp - fvc::div(phi, Ekp)
+    );
+
+    eEqn.relax();
+    eEqn.solve();
+
+    thermo.correct();
+}
diff --git a/applications/solvers/compressible/rhoSimpleFoam/hEqn.H b/applications/solvers/compressible/rhoSimpleFoam/hEqn.H
deleted file mode 100644
index 879578cf49d9d34b0e30b56e426a59dcd969cc09..0000000000000000000000000000000000000000
--- a/applications/solvers/compressible/rhoSimpleFoam/hEqn.H
+++ /dev/null
@@ -1,18 +0,0 @@
-{
-    volScalarField K("K", 0.5*magSqr(U));
-
-    fvScalarMatrix hEqn
-    (
-        fvm::div(phi, h)
-      - fvm::Sp(fvc::div(phi), h)
-      - fvm::laplacian(turbulence->alphaEff(), h)
-     ==
-        fvc::div(phi)*K - fvc::div(phi, K)
-    );
-
-    hEqn.relax();
-
-    hEqn.solve();
-
-    thermo.correct();
-}
diff --git a/applications/solvers/compressible/rhoSimpleFoam/pEqn.H b/applications/solvers/compressible/rhoSimpleFoam/pEqn.H
index cefee48969acf984baf1c8a8b54211290576ab45..6c64056be2e8e2e11a00c5286515b93e277fa085 100644
--- a/applications/solvers/compressible/rhoSimpleFoam/pEqn.H
+++ b/applications/solvers/compressible/rhoSimpleFoam/pEqn.H
@@ -54,7 +54,8 @@ else
     {
         fvScalarMatrix pEqn
         (
-            fvm::laplacian(rho*rAU, p) == fvc::div(phiHbyA)
+            fvc::div(phiHbyA)
+          - fvm::laplacian(rho*rAU, p)
         );
 
         pEqn.setReference(pRefCell, pRefValue);
@@ -63,7 +64,7 @@ else
 
         if (simple.finalNonOrthogonalIter())
         {
-            phi = phiHbyA - pEqn.flux();
+            phi = phiHbyA + pEqn.flux();
         }
     }
 }
@@ -88,5 +89,10 @@ if (closedVolume)
 rho = thermo.rho();
 rho = max(rho, rhoMin);
 rho = min(rho, rhoMax);
-rho.relax();
+
+if (!simple.transonic())
+{
+    rho.relax();
+}
+
 Info<< "rho max/min : " << max(rho).value() << " " << min(rho).value() << endl;
diff --git a/applications/solvers/compressible/rhoSimpleFoam/rhoPorousMRFSimpleFoam/eEqn.H b/applications/solvers/compressible/rhoSimpleFoam/rhoPorousMRFSimpleFoam/eEqn.H
new file mode 100644
index 0000000000000000000000000000000000000000..4791062d35ac4c8031951ca123e2d215c9b6695f
--- /dev/null
+++ b/applications/solvers/compressible/rhoSimpleFoam/rhoPorousMRFSimpleFoam/eEqn.H
@@ -0,0 +1,19 @@
+{
+    volScalarField Ekp("Ekp", 0.5*magSqr(U) + p/rho);
+
+    fvScalarMatrix eEqn
+    (
+        fvm::div(phi, e)
+      - fvm::Sp(fvc::div(phi), e)
+      - fvm::laplacian(turbulence->alphaEff(), e)
+     ==
+        fvc::div(phi)*Ekp - fvc::div(phi, Ekp)
+    );
+
+    //pZones.addEnergySource(thermo, rho, eEqn);
+
+    eEqn.relax();
+    eEqn.solve();
+
+    thermo.correct();
+}
diff --git a/applications/solvers/compressible/rhoSimpleFoam/rhoPorousMRFSimpleFoam/hEqn.H b/applications/solvers/compressible/rhoSimpleFoam/rhoPorousMRFSimpleFoam/hEqn.H
deleted file mode 100644
index cb989b804f3a01533fabd085f4c1bf0e05b74b4a..0000000000000000000000000000000000000000
--- a/applications/solvers/compressible/rhoSimpleFoam/rhoPorousMRFSimpleFoam/hEqn.H
+++ /dev/null
@@ -1,18 +0,0 @@
-{
-    fvScalarMatrix hEqn
-    (
-        fvm::div(phi, h)
-      - fvm::Sp(fvc::div(phi), h)
-      - fvm::laplacian(turbulence->alphaEff(), h)
-     ==
-      - fvc::div(phi, 0.5*magSqr(U), "div(phi,K)")
-    );
-
-    pZones.addEnthalpySource(thermo, rho, hEqn);
-
-    hEqn.relax();
-
-    hEqn.solve();
-
-    thermo.correct();
-}
diff --git a/applications/solvers/compressible/rhoSimpleFoam/rhoPorousMRFSimpleFoam/rhoPorousMRFSimpleFoam.C b/applications/solvers/compressible/rhoSimpleFoam/rhoPorousMRFSimpleFoam/rhoPorousMRFSimpleFoam.C
index 1cb421e5f41f9c306b3808b078994737cc903e68..c866aea7df043df5fd323b44b87d949d2b21ea72 100644
--- a/applications/solvers/compressible/rhoSimpleFoam/rhoPorousMRFSimpleFoam/rhoPorousMRFSimpleFoam.C
+++ b/applications/solvers/compressible/rhoSimpleFoam/rhoPorousMRFSimpleFoam/rhoPorousMRFSimpleFoam.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -63,7 +63,7 @@ int main(int argc, char *argv[])
         // Pressure-velocity SIMPLE corrector
         {
             #include "UEqn.H"
-            #include "hEqn.H"
+            #include "eEqn.H"
             #include "pEqn.H"
         }
 
diff --git a/applications/solvers/compressible/rhoSimpleFoam/rhoSimpleFoam.C b/applications/solvers/compressible/rhoSimpleFoam/rhoSimpleFoam.C
index e87a35fab27c22ecf7562a0dd4d204dd14b1f4ad..bb249f5430950548e154c8241a8c644a5f8b03c3 100644
--- a/applications/solvers/compressible/rhoSimpleFoam/rhoSimpleFoam.C
+++ b/applications/solvers/compressible/rhoSimpleFoam/rhoSimpleFoam.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -59,7 +59,7 @@ int main(int argc, char *argv[])
         // Pressure-velocity SIMPLE corrector
         {
             #include "UEqn.H"
-            #include "hEqn.H"
+            #include "eEqn.H"
             #include "pEqn.H"
         }
 
diff --git a/applications/solvers/compressible/rhoSimpleFoam/rhoSimplecFoam/createFields.H b/applications/solvers/compressible/rhoSimpleFoam/rhoSimplecFoam/createFields.H
deleted file mode 100644
index 46a382864e72740185c60ca49560ff95f2a2bfdb..0000000000000000000000000000000000000000
--- a/applications/solvers/compressible/rhoSimpleFoam/rhoSimplecFoam/createFields.H
+++ /dev/null
@@ -1,61 +0,0 @@
-    Info<< "Reading thermophysical properties\n" << endl;
-
-    autoPtr<basicPsiThermo> pThermo
-    (
-        basicPsiThermo::New(mesh)
-    );
-    basicPsiThermo& thermo = pThermo();
-
-    volScalarField rho
-    (
-        IOobject
-        (
-            "rho",
-            runTime.timeName(),
-            mesh,
-            IOobject::READ_IF_PRESENT,
-            IOobject::AUTO_WRITE
-        ),
-        thermo.rho()
-    );
-
-    volScalarField& p = thermo.p();
-    volScalarField& h = thermo.h();
-    const volScalarField& psi = thermo.psi();
-
-    Info<< "Reading field U\n" << endl;
-    volVectorField U
-    (
-        IOobject
-        (
-            "U",
-            runTime.timeName(),
-            mesh,
-            IOobject::MUST_READ,
-            IOobject::AUTO_WRITE
-        ),
-        mesh
-    );
-
-    #include "compressibleCreatePhi.H"
-
-    label pRefCell = 0;
-    scalar pRefValue = 0.0;
-    setRefCell(p, simple.dict(), pRefCell, pRefValue);
-
-    dimensionedScalar rhoMax(simple.dict().lookup("rhoMax"));
-    dimensionedScalar rhoMin(simple.dict().lookup("rhoMin"));
-
-    Info<< "Creating turbulence model\n" << endl;
-    autoPtr<compressible::RASModel> turbulence
-    (
-        compressible::RASModel::New
-        (
-            rho,
-            U,
-            phi,
-            thermo
-        )
-    );
-
-    dimensionedScalar initialMass = fvc::domainIntegrate(rho);
diff --git a/applications/solvers/compressible/rhoSimpleFoam/rhoSimplecFoam/pEqn.H b/applications/solvers/compressible/rhoSimpleFoam/rhoSimplecFoam/pEqn.H
index 379e720c042eb8d08cdae81ed4064549a84aa7f1..8c7405c346ffdebce86d052fe60be505cb52d584 100644
--- a/applications/solvers/compressible/rhoSimpleFoam/rhoSimplecFoam/pEqn.H
+++ b/applications/solvers/compressible/rhoSimpleFoam/rhoSimplecFoam/pEqn.H
@@ -3,13 +3,11 @@ rho = max(rho, rhoMin);
 rho = min(rho, rhoMax);
 rho.relax();
 
-volScalarField p0(p);
-
-volScalarField AU(UEqn().A());
-volScalarField AtU(AU - UEqn().H1());
+volScalarField rAU(1.0/UEqn().A());
+volScalarField rAtU(1.0/(1.0/rAU - UEqn().H1()));
 
 volVectorField HbyA("HbyA", U);
-HbyA = UEqn().H()/AU;
+HbyA = rAU*UEqn().H();
 
 UEqn.clear();
 
@@ -17,28 +15,32 @@ bool closedVolume = false;
 
 if (simple.transonic())
 {
-    while (simple.correctNonOrthogonal())
-    {
-        surfaceScalarField phid
-        (
-            "phid",
-            fvc::interpolate(psi*HbyA) & mesh.Sf()
-        );
+    surfaceScalarField phid
+    (
+        "phid",
+        fvc::interpolate(psi)*(fvc::interpolate(HbyA) & mesh.Sf())
+    );
 
-        surfaceScalarField phic
-        (
-            "phic",
-            fvc::interpolate(rho/AtU - rho/AU)*fvc::snGrad(p)*mesh.magSf()
-        );
+    surfaceScalarField phic
+    (
+        "phic",
+        fvc::interpolate(rho*(rAtU - rAU))*fvc::snGrad(p)*mesh.magSf()
+    );
+
+    HbyA -= (rAU - rAtU)*fvc::grad(p);
 
+    volScalarField Dp("Dp", rho*rAtU);
+
+    while (simple.correctNonOrthogonal())
+    {
         fvScalarMatrix pEqn
         (
             fvm::div(phid, p)
           + fvc::div(phic)
-          - fvm::laplacian(rho/AtU, p)
+          - fvm::laplacian(Dp, p)
         );
 
-        // Relax the pressure equation to ensure diagonal-dominance
+        // Relax the pressure equation to maintain diagonal dominance
         pEqn.relax();
 
         pEqn.setReference(pRefCell, pRefValue);
@@ -53,21 +55,25 @@ if (simple.transonic())
 }
 else
 {
-    while (simple.correctNonOrthogonal())
-    {
-        surfaceScalarField phiHbyA
-        (
-            "phiHbyA",
-            fvc::interpolate(rho*HbyA) & mesh.Sf()
-        );
+    surfaceScalarField phiHbyA
+    (
+        "phiHbyA",
+        fvc::interpolate(rho)*(fvc::interpolate(HbyA) & mesh.Sf())
+    );
 
-        closedVolume = adjustPhi(phi, U, p);
-        phi += fvc::interpolate(rho/AtU - rho/AU)*fvc::snGrad(p)*mesh.magSf();
+    closedVolume = adjustPhi(phiHbyA, U, p);
 
+    phiHbyA += fvc::interpolate(rho*(rAtU - rAU))*fvc::snGrad(p)*mesh.magSf();
+    HbyA -= (rAU - rAtU)*fvc::grad(p);
+
+    volScalarField Dp("Dp", rho*rAtU);
+
+    while (simple.correctNonOrthogonal())
+    {
         fvScalarMatrix pEqn
         (
             fvc::div(phiHbyA)
-          - fvm::laplacian(rho/AtU, p)
+          - fvm::laplacian(Dp, p)
         );
 
         pEqn.setReference(pRefCell, pRefValue);
@@ -81,16 +87,14 @@ else
     }
 }
 
-// The incompressibe for of the continuity error check is appropriate for
+// The incompressibe form of the continuity error check is appropriate for
 // steady-state compressible also.
 #include "incompressible/continuityErrs.H"
 
 // Explicitly relax pressure for momentum corrector
 p.relax();
 
-U = HbyA - (fvc::grad(p0)*(1.0/AU - 1.0/AtU) + fvc::grad(p)/AtU);
-//U = HbyA - fvc::grad(p)/AU;
-
+U = HbyA - rAtU*fvc::grad(p);
 U.correctBoundaryConditions();
 
 // For closed-volume cases adjust the pressure and density levels
@@ -101,6 +105,7 @@ if (closedVolume)
         /fvc::domainIntegrate(psi);
 }
 
+// Recalculate density from the relaxed pressure
 rho = thermo.rho();
 rho = max(rho, rhoMin);
 rho = min(rho, rhoMax);
diff --git a/applications/solvers/compressible/rhoSimpleFoam/rhoSimplecFoam/rhoSimplecFoam.C b/applications/solvers/compressible/rhoSimpleFoam/rhoSimplecFoam/rhoSimplecFoam.C
index 37334e7955417deae9f48ba7a8c0901f2c129012..198b5eea40cd64ceec65f2f79f165424c08736c9 100644
--- a/applications/solvers/compressible/rhoSimpleFoam/rhoSimplecFoam/rhoSimplecFoam.C
+++ b/applications/solvers/compressible/rhoSimpleFoam/rhoSimplecFoam/rhoSimplecFoam.C
@@ -61,8 +61,8 @@ int main(int argc, char *argv[])
         // Velocity-pressure-enthalpy SIMPLEC corrector
         {
             #include "UEqn.H"
+            #include "eEqn.H"
             #include "pEqn.H"
-            #include "hEqn.H"
         }
 
         turbulence->correct();
diff --git a/applications/solvers/compressible/sonicFoam/pEqn.H b/applications/solvers/compressible/sonicFoam/pEqn.H
index 46cc36216c45da4dde31afbddf045ae740952fe5..aeebee2df51502346e832f342259848a83934e1a 100644
--- a/applications/solvers/compressible/sonicFoam/pEqn.H
+++ b/applications/solvers/compressible/sonicFoam/pEqn.H
@@ -14,13 +14,16 @@ surfaceScalarField phid
     )
 );
 
+
+volScalarField Dp("Dp", rho*rAU);
+
 for (int nonOrth=0; nonOrth<=nNonOrthCorr; nonOrth++)
 {
     fvScalarMatrix pEqn
     (
         fvm::ddt(psi, p)
       + fvm::div(phid, p)
-      - fvm::laplacian(rho*rAU, p)
+      - fvm::laplacian(Dp, p)
     );
 
     pEqn.solve();
diff --git a/applications/solvers/compressible/sonicFoam/sonicDyMFoam/pEqn.H b/applications/solvers/compressible/sonicFoam/sonicDyMFoam/pEqn.H
index cad5bb72170900e8d4fae2c7600468f4284f1ce2..21dc48614ec948ebd3d51c6fb22556aefdf85c5b 100644
--- a/applications/solvers/compressible/sonicFoam/sonicDyMFoam/pEqn.H
+++ b/applications/solvers/compressible/sonicFoam/sonicDyMFoam/pEqn.H
@@ -14,13 +14,15 @@ surfaceScalarField phid
     )
 );
 
+volScalarField Dp("Dp", rho*rAU);
+
 for (int nonOrth=0; nonOrth<=nNonOrthCorr; nonOrth++)
 {
     fvScalarMatrix pEqn
     (
         fvm::ddt(psi, p)
       + fvm::div(phid, p)
-      - fvm::laplacian(rho*rAU, p)
+      - fvm::laplacian(Dp, p)
     );
 
     pEqn.solve();
diff --git a/applications/solvers/compressible/sonicFoam/sonicLiquidFoam/sonicLiquidFoam.C b/applications/solvers/compressible/sonicFoam/sonicLiquidFoam/sonicLiquidFoam.C
index 6388caea6952dfac09eebb645de7cd25df0080ab..19a530a6aaa52c9d41198f4d3aa6a42346ea9af6 100644
--- a/applications/solvers/compressible/sonicFoam/sonicLiquidFoam/sonicLiquidFoam.C
+++ b/applications/solvers/compressible/sonicFoam/sonicLiquidFoam/sonicLiquidFoam.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -85,13 +85,14 @@ int main(int argc, char *argv[])
             );
 
             phi = (rhoO/psi)*phid;
+            volScalarField Dp("Dp", rho*rAU);
 
             fvScalarMatrix pEqn
             (
                 fvm::ddt(psi, p)
               + fvc::div(phi)
               + fvm::div(phid, p)
-              - fvm::laplacian(rho*rAU, p)
+              - fvm::laplacian(Dp, p)
             );
 
             pEqn.solve();
diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/porousSolid/setPorousRegionSolidFields.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/porousSolid/setPorousRegionSolidFields.H
index 102ba89a09a9aeeedb4d36c7bbf436f0ba7fbbb9..bbbd079ef2a1933953cf975268709857de6cee04 100644
--- a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/porousSolid/setPorousRegionSolidFields.H
+++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/porousSolid/setPorousRegionSolidFields.H
@@ -9,8 +9,8 @@
     tmp<volScalarField> tcp = thermo.Cp();
     const volScalarField& cp = tcp();
 
-    tmp<volScalarField> tkappa = thermo.K();
-    //tmp<volSymmTensorField> tkappa = thermo.directionalK()*betav;
+    tmp<volScalarField> tkappa = thermo.kappa();
+    //tmp<volSymmTensorField> tkappa = thermo.directionalKappa()*betav;
 
     const volScalarField& kappa = tkappa();
     //const volSymmTensorField& K = tK();
diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/solid/setRegionSolidFields.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/solid/setRegionSolidFields.H
index 7ff98e6211ea01aac48e362c43228da061dda68f..73269420c0c8597c284012e7411d6ff94b80c4f4 100644
--- a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/solid/setRegionSolidFields.H
+++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/solid/setRegionSolidFields.H
@@ -7,7 +7,7 @@
     tmp<volScalarField> tcp = thermo.Cp();
     const volScalarField& cp = tcp();
 
-    tmp<volScalarField> tkappa = thermo.K();
+    tmp<volScalarField> tkappa = thermo.kappa();
     //tmp<volSymmTensorField> tkappa = thermo.directionalkappa();
     const volScalarField& kappa = tkappa();
 
diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/porousSolid/setPorousRegionSolidFields.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/porousSolid/setPorousRegionSolidFields.H
index f4c7081e9bd72d54e10f7521aa2dca3118a02c16..6f4834000dfc55aeee29fad65e25a38e130a05e2 100644
--- a/applications/solvers/heatTransfer/chtMultiRegionFoam/porousSolid/setPorousRegionSolidFields.H
+++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/porousSolid/setPorousRegionSolidFields.H
@@ -9,8 +9,8 @@
     tmp<volScalarField> tcp = thermo.Cp();
     const volScalarField& cp = tcp();
 
-    tmp<volScalarField> tkappa = thermo.K();
-    //tmp<volSymmTensorField> tkappa = thermo.directionalK()*betav;
+    tmp<volScalarField> tkappa = thermo.kappa();
+    //tmp<volSymmTensorField> tkappa = thermo.directionalKappa()*betav;
 
     const volScalarField& kappa = tkappa();
     //const volSymmTensorField& K = tK();
diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/setRegionSolidFields.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/setRegionSolidFields.H
index 8cf6f1c38caf14daf82243682ec4b15f8ee0abe2..47bd9dad9a61b5b4bdaf552ac19671fda7e95d90 100644
--- a/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/setRegionSolidFields.H
+++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/setRegionSolidFields.H
@@ -7,9 +7,9 @@
     tmp<volScalarField> tcp = thermo.Cp();
     const volScalarField& cp = tcp();
 
-    tmp<volScalarField> tkappa = thermo.K();
+    tmp<volScalarField> tkappa = thermo.kappa();
     const volScalarField& kappa = tkappa();
-    //tmp<volSymmTensorField> tkappa = thermo.directionalK();
+    //tmp<volSymmTensorField> tkappa = thermo.directionalKappa();
     //const volSymmTensorField& kappa = tkappa();
 
     volScalarField& T = thermo.T();
diff --git a/applications/utilities/mesh/advanced/collapseEdges/Make/files b/applications/utilities/mesh/advanced/collapseEdges/Make/files
index d89ca6e737c6c84ce878bd4e57566fbd070333a4..a15838abe84da087d0c63693617ed5b410e56b22 100644
--- a/applications/utilities/mesh/advanced/collapseEdges/Make/files
+++ b/applications/utilities/mesh/advanced/collapseEdges/Make/files
@@ -1,3 +1,4 @@
 collapseEdges.C
+pointEdgeCollapse/pointEdgeCollapse.C
 
 EXE = $(FOAM_APPBIN)/collapseEdges
diff --git a/applications/utilities/mesh/advanced/collapseEdges/Make/options b/applications/utilities/mesh/advanced/collapseEdges/Make/options
index 21b17b14c9d7dd8ae8c0c55fdcf698ce54019fcb..d1efa61fd56aef52623d7e352c300f8948503fd2 100644
--- a/applications/utilities/mesh/advanced/collapseEdges/Make/options
+++ b/applications/utilities/mesh/advanced/collapseEdges/Make/options
@@ -1,6 +1,10 @@
 EXE_INC = \
-    -I$(LIB_SRC)/dynamicMesh/lnInclude
+    -I$(LIB_SRC)/dynamicMesh/lnInclude \
+    -I$(LIB_SRC)/meshTools/lnInclude \
+    -I$(LIB_SRC)/finiteVolume/lnInclude \
+    -IpointEdgeCollapse
 
 EXE_LIBS = \
     -ldynamicMesh \
-    -lmeshTools
+    -lmeshTools \
+    -lfiniteVolume
diff --git a/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C b/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C
index f1eb28e5947759fe22aee59bf0c28a3ed3a2c0f0..899159b2a29ba4005f6fdd740260f1fee794674b 100644
--- a/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C
+++ b/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -41,170 +41,634 @@ Description
 
 #include "argList.H"
 #include "Time.H"
-#include "edgeCollapser.H"
 #include "polyTopoChange.H"
 #include "polyTopoChanger.H"
 #include "polyMesh.H"
+#include "fvMesh.H"
 #include "mapPolyMesh.H"
 #include "mathematicalConstants.H"
 #include "PackedBoolList.H"
 #include "SortableList.H"
 #include "unitConversion.H"
+#include "globalMeshData.H"
+#include "globalIndex.H"
+#include "PointEdgeWave.H"
+#include "pointEdgeCollapse.H"
+#include "motionSmoother.H"
+
+#include "OFstream.H"
+#include "meshTools.H"
 
 using namespace Foam;
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-// Get faceEdges in order of face points, i.e. faceEdges[0] is between
-// f[0] and f[1]
-labelList getSortedEdges
+label findIndex
 (
-    const edgeList& edges,
-    const labelList& f,
-    const labelList& edgeLabels
+    const labelList& elems,
+    const label start,
+    const label size,
+    const label val
 )
 {
-    labelList faceEdges(edgeLabels.size(), -1);
+    for (label i = start; i < size; i++)
+    {
+        if (elems[i] == val)
+        {
+            return i;
+        }
+    }
+    return -1;
+}
 
-    // Find starting pos in f for every edgeLabels
-    forAll(edgeLabels, i)
+
+void filterFace
+(
+    const label faceI,
+    face& f,
+    const List<pointEdgeCollapse>& allPointInfo,
+    const Map<DynamicList<label> >& collapseStrings
+)
+{
+    label newFp = 0;
+
+    face oldFace = f;
+
+    forAll(f, fp)
     {
-        label edgeI = edgeLabels[i];
+        label pointI = f[fp];
 
-        const edge& e = edges[edgeI];
+        label collapsePoint = allPointInfo[pointI].collapseIndex();
 
-        label fp = findIndex(f, e[0]);
-        label fp1 = f.fcIndex(fp);
+        if (collapseStrings.found(collapsePoint))
+        {
+            collapsePoint = collapseStrings[collapsePoint][0];
+        }
 
-        if (f[fp1] == e[1])
+        if (collapsePoint == -1)
         {
-            // EdgeI between fp -> fp1
-            faceEdges[fp] = edgeI;
+            WarningIn
+                (
+                    "filterFace"
+                    "(const label, face&, const List<pointEdgeCollapse>&)"
+                )
+                << "Point " << pointI << " was not visited by PointEdgeWave"
+                << endl;
+        }
+        else if (collapsePoint == -2)
+        {
+            f[newFp++] = pointI;
         }
         else
         {
-            // EdgeI between fp-1 -> fp
-            faceEdges[f.rcIndex(fp)] = edgeI;
+            if (findIndex(f, 0, newFp, collapsePoint) == -1)
+            {
+                f[newFp++] = collapsePoint;
+            }
         }
     }
 
-    return faceEdges;
+
+    // Check for pinched face. Tries to correct
+    // - consecutive duplicate vertex. Removes duplicate vertex.
+    // - duplicate vertex with one other vertex in between (spike).
+    // Both of these should not really occur! and should be checked before
+    // collapsing edges.
+
+    const label size = newFp;
+
+    newFp = 2;
+
+    for (label fp = 2; fp < size; fp++)
+    {
+        label fp1 = fp-1;
+        label fp2 = fp-2;
+
+        label pointI = f[fp];
+
+        // Search for previous occurrence.
+        label index = findIndex(f, 0, fp, pointI);
+
+        if (index == fp1)
+        {
+            WarningIn
+            (
+                "Foam::edgeCollapser::filterFace(const label faceI, "
+                "face& f) const"
+            )   << "Removing consecutive duplicate vertex in face "
+                << f << endl;
+            // Don't store current pointI
+        }
+        else if (index == fp2)
+        {
+            WarningIn
+            (
+                "Foam::edgeCollapser::filterFace(const label faceI, "
+                "face& f) const"
+            )   << "Removing non-consecutive duplicate vertex in face "
+                << f << endl;
+            // Don't store current pointI and remove previous
+            newFp--;
+        }
+        else if (index != -1)
+        {
+            WarningIn
+            (
+                "Foam::edgeCollapser::filterFace(const label faceI, "
+                "face& f) const"
+            )   << "Pinched face " << f << endl;
+            f[newFp++] = pointI;
+        }
+        else
+        {
+            f[newFp++] = pointI;
+        }
+    }
+
+    f.setSize(newFp);
 }
 
 
-// Merges edges which are in straight line. I.e. edge split by point.
-label mergeEdges
+bool setRefinement
 (
     const polyMesh& mesh,
-    const scalar maxCos,
-    edgeCollapser& collapser
+    polyTopoChange& meshMod,
+    const List<pointEdgeCollapse>& allPointInfo
 )
 {
-    const pointField& points = mesh.points();
-    const edgeList& edges = mesh.edges();
-    const labelListList& pointEdges = mesh.pointEdges();
-    const labelList& region = collapser.pointRegion();
-    const labelList& master = collapser.pointRegionMaster();
+    const cellList& cells = mesh.cells();
+    const labelList& faceOwner = mesh.faceOwner();
+    const labelList& faceNeighbour = mesh.faceNeighbour();
+    const labelListList& pointFaces = mesh.pointFaces();
+    const pointZoneMesh& pointZones = mesh.pointZones();
 
+    globalIndex globalStrings(mesh.nPoints());
+
+    boolList removedPoints(mesh.nPoints(), false);
+
+    // Create strings of edges
+    Map<DynamicList<label> > collapseStrings;
+
+    forAll(allPointInfo, pointI)
+    {
+        const label collapseIndex = allPointInfo[pointI].collapseIndex();
+
+        if (collapseIndex != -1 && collapseIndex != -2)
+        {
+            collapseStrings(collapseIndex).append(pointI);
+        }
+    }
+
+    bool meshChanged = false;
+
+    // Current faces (is also collapseStatus: f.size() < 3)
+    faceList newFaces(mesh.faces());
+
+    // Current cellCollapse status
+    boolList cellRemoved(mesh.nCells(), false);
+
+    label nUnvisited = 0;
+    label nUncollapsed = 0;
     label nCollapsed = 0;
 
-    forAll(pointEdges, pointI)
+    forAll(allPointInfo, pI)
     {
-        const labelList& pEdges = pointEdges[pointI];
+        const pointEdgeCollapse& pec = allPointInfo[pI];
 
-        if (pEdges.size() == 2)
+        if (pec.collapseIndex() == -1)
+        {
+            nUnvisited++;
+        }
+        else if (pec.collapseIndex() == -2)
         {
-            const edge& leftE = edges[pEdges[0]];
-            const edge& rightE = edges[pEdges[1]];
+            nUncollapsed++;
+        }
+        else if (pec.collapseIndex() >= 0)
+        {
+            nCollapsed++;
+        }
+    }
+
+    label nPoints = allPointInfo.size();
+
+    reduce(nPoints, sumOp<label>());
+    reduce(nUnvisited, sumOp<label>());
+    reduce(nUncollapsed, sumOp<label>());
+    reduce(nCollapsed, sumOp<label>());
 
-            // Get the two vertices on both sides of the point
-            label leftV = leftE.otherVertex(pointI);
-            label rightV = rightE.otherVertex(pointI);
+    Info<< incrIndent;
+    Info<< indent << "Number of points : " << nPoints << nl
+        << indent << "Not visited      : " << nUnvisited << nl
+        << indent << "Not collapsed    : " << nUncollapsed << nl
+        << indent << "Collapsed        : " << nCollapsed << nl
+        << endl;
+    Info<< decrIndent;
 
-            // Collapse only if none of the points part of merge network
-            // or all of networks with different masters.
-            label midMaster = -1;
-            if (region[pointI] != -1)
+    do
+    {
+        // Update face collapse from edge collapses
+        forAll(newFaces, faceI)
+        {
+            filterFace(faceI, newFaces[faceI], allPointInfo, collapseStrings);
+        }
+
+        // Check if faces to be collapsed cause cells to become collapsed.
+        label nCellCollapsed = 0;
+
+        forAll(cells, cellI)
+        {
+            if (!cellRemoved[cellI])
             {
-                midMaster = master[region[pointI]];
+                const cell& cFaces = cells[cellI];
+
+                label nFaces = cFaces.size();
+
+                forAll(cFaces, i)
+                {
+                    label faceI = cFaces[i];
+
+                    if (newFaces[faceI].size() < 3)
+                    {
+                        --nFaces;
+
+                        if (nFaces < 4)
+                        {
+                            Info<< "Cell:" << cellI
+                                << " uses faces:" << cFaces
+                                << " of which too many are marked for removal:"
+                                << endl
+                                << "   ";
+                            forAll(cFaces, j)
+                            {
+                                if (newFaces[cFaces[j]].size() < 3)
+                                {
+                                    Info<< ' '<< cFaces[j];
+                                }
+                            }
+                            Info<< endl;
+
+                            cellRemoved[cellI] = true;
+
+                            // Collapse all edges of cell to nothing
+                            //collapseEdges(cellEdges[cellI]);
+
+                            nCellCollapsed++;
+
+                            break;
+                        }
+                    }
+                }
             }
+        }
+
+        if (nCellCollapsed == 0)
+        {
+            break;
+        }
+    } while (true);
+
+
+    // Keep track of faces that have been done already.
+    boolList doneFace(mesh.nFaces(), false);
+
+    {
+        // Mark points used.
+        boolList usedPoint(mesh.nPoints(), false);
 
-            label leftMaster = -2;
-            if (region[leftV] != -1)
+        forAll(cellRemoved, cellI)
+        {
+            if (cellRemoved[cellI])
             {
-                leftMaster = master[region[leftV]];
+                meshMod.removeCell(cellI, -1);
             }
+        }
+
+        // Remove faces
+        forAll(newFaces, faceI)
+        {
+            const face& f = newFaces[faceI];
+
+            if (f.size() < 3)
+            {
+                meshMod.removeFace(faceI, -1);
+                meshChanged = true;
 
-            label rightMaster = -3;
-            if (region[rightV] != -1)
+                // Mark face as been done.
+                doneFace[faceI] = true;
+            }
+            else
             {
-                rightMaster = master[region[rightV]];
+                // Kept face. Mark vertices
+                forAll(f, fp)
+                {
+                    usedPoint[f[fp]] = true;
+                }
             }
+        }
 
-            if
-            (
-                midMaster != leftMaster
-             && midMaster != rightMaster
-             && leftMaster != rightMaster
-            )
+        // Remove unused vertices that have not been marked for removal already
+        forAll(usedPoint, pointI)
+        {
+            if (!usedPoint[pointI])
             {
-                // Check if the two edge are in line
-                vector leftVec = points[pointI] - points[leftV];
-                leftVec /= mag(leftVec) + VSMALL;
+                removedPoints[pointI] = true;
+                meshMod.removePoint(pointI, -1);
+                meshChanged = true;
+            }
+        }
+    }
+
+    // Modify the point location of the remaining points
+    forAll(allPointInfo, pointI)
+    {
+        const label collapseIndex = allPointInfo[pointI].collapseIndex();
+        const point& collapsePoint = allPointInfo[pointI].collapsePoint();
+
+        if
+        (
+            removedPoints[pointI] == false
+         && collapseIndex != -1
+         && collapseIndex != -2
+        )
+        {
+            meshMod.modifyPoint
+            (
+                pointI,
+                collapsePoint,
+                pointZones.whichZone(pointI),
+                false
+            );
+        }
+    }
+
+
+    const polyBoundaryMesh& boundaryMesh = mesh.boundaryMesh();
+    const faceZoneMesh& faceZones = mesh.faceZones();
+
+    // Renumber faces that use points
+    forAll(allPointInfo, pointI)
+    {
+        if (removedPoints[pointI] == true)
+        {
+            const labelList& changedFaces = pointFaces[pointI];
 
-                vector rightVec = points[rightV] - points[pointI];
-                rightVec /= mag(rightVec) + VSMALL;
+            forAll(changedFaces, changedFaceI)
+            {
+                label faceI = changedFaces[changedFaceI];
 
-                if ((leftVec & rightVec) > maxCos)
+                if (!doneFace[faceI])
                 {
-                    // Collapse one (left) side of the edge. Make left vertex
-                    // the master.
-                    //if (collapser.unaffectedEdge(pEdges[0]))
+                    doneFace[faceI] = true;
+
+                    // Get current zone info
+                    label zoneID = faceZones.whichZone(faceI);
+
+                    bool zoneFlip = false;
+
+                    if (zoneID >= 0)
                     {
-                        collapser.collapseEdge(pEdges[0], leftV);
-                        nCollapsed++;
+                        const faceZone& fZone = faceZones[zoneID];
+
+                        zoneFlip = fZone.flipMap()[fZone.whichFace(faceI)];
+                    }
+
+                    // Get current connectivity
+                    label own = faceOwner[faceI];
+                    label nei = -1;
+                    label patchID = -1;
+
+                    if (mesh.isInternalFace(faceI))
+                    {
+                        nei = faceNeighbour[faceI];
+                    }
+                    else
+                    {
+                        patchID = boundaryMesh.whichPatch(faceI);
                     }
+
+                    meshMod.modifyFace
+                    (
+                        newFaces[faceI],            // face
+                        faceI,                      // faceI to change
+                        own,                        // owner
+                        nei,                        // neighbour
+                        false,                      // flipFaceFlux
+                        patchID,                    // patch
+                        zoneID,
+                        zoneFlip
+                    );
+                    meshChanged = true;
                 }
             }
         }
     }
 
-    return nCollapsed;
+    // Print regions:
+//    printRegions();
+
+    return meshChanged;
+}
+
+
+// Get faceEdges in order of face points, i.e. faceEdges[0] is between
+// f[0] and f[1]
+labelList getSortedEdges
+(
+    const edgeList& edges,
+    const labelList& f,
+    const labelList& edgeLabels
+)
+{
+    labelList faceEdges(edgeLabels.size(), -1);
+
+    // Find starting pos in f for every edgeLabels
+    forAll(edgeLabels, i)
+    {
+        label edgeI = edgeLabels[i];
+
+        const edge& e = edges[edgeI];
+
+        label fp = findIndex(f, e[0]);
+        label fp1 = f.fcIndex(fp);
+
+        if (f[fp1] == e[1])
+        {
+            // EdgeI between fp -> fp1
+            faceEdges[fp] = edgeI;
+        }
+        else
+        {
+            // EdgeI between fp-1 -> fp
+            faceEdges[f.rcIndex(fp)] = edgeI;
+        }
+    }
+
+    return faceEdges;
 }
 
 
+// Merges edges which are in straight line. I.e. edge split by point.
+//label mergeEdges
+//(
+//    const polyMesh& mesh,
+//    const scalar maxCos,
+//    List<pointEdgeCollapse>& allPointInfo
+//)
+//{
+//    const pointField& points = mesh.points();
+//    const edgeList& edges = mesh.edges();
+//    const labelListList& pointEdges = mesh.pointEdges();
+//    const labelList& region = collapser.pointRegion();
+//    const labelList& master = collapser.pointRegionMaster();
+//
+//    label nCollapsed = 0;
+//
+//    forAll(pointEdges, pointI)
+//    {
+//        const labelList& pEdges = pointEdges[pointI];
+//
+//        if (pEdges.size() == 2)
+//        {
+//            const edge& leftE = edges[pEdges[0]];
+//            const edge& rightE = edges[pEdges[1]];
+//
+//            // Get the two vertices on both sides of the point
+//            label leftV = leftE.otherVertex(pointI);
+//            label rightV = rightE.otherVertex(pointI);
+//
+//            // Collapse only if none of the points part of merge network
+//            // or all of networks with different masters.
+//            label midMaster = -1;
+//            if (region[pointI] != -1)
+//            {
+//                midMaster = master[region[pointI]];
+//            }
+//
+//            label leftMaster = -2;
+//            if (region[leftV] != -1)
+//            {
+//                leftMaster = master[region[leftV]];
+//            }
+//
+//            label rightMaster = -3;
+//            if (region[rightV] != -1)
+//            {
+//                rightMaster = master[region[rightV]];
+//            }
+//
+//            if
+//            (
+//                midMaster != leftMaster
+//             && midMaster != rightMaster
+//             && leftMaster != rightMaster
+//            )
+//            {
+//                // Check if the two edge are in line
+//                vector leftVec = points[pointI] - points[leftV];
+//                leftVec /= mag(leftVec) + VSMALL;
+//
+//                vector rightVec = points[rightV] - points[pointI];
+//                rightVec /= mag(rightVec) + VSMALL;
+//
+//                if ((leftVec & rightVec) > maxCos)
+//                {
+//                    // Collapse one (left) side of the edge. Make left vertex
+//                    // the master.
+//                    //if (collapser.unaffectedEdge(pEdges[0]))
+//                    const edge& e = mesh.edges()[pEdges[0]];
+//
+//                    if
+//                    (
+//                        allPointInfo[e[0]].collapseIndex() < 0
+//                     && allPointInfo[e[1]].collapseIndex() < 0
+//                    )
+//                    {
+//                        //pointEdgeCollapse pec(mesh.points()[leftV], leftV);
+//
+//                        allPointInfo[e[0]] = pec;
+//                        allPointInfo[e[1]] = pec;
+//
+//                        //collapser.collapseEdge(pEdges[0], leftV);
+//                        nCollapsed++;
+//                    }
+//                }
+//            }
+//        }
+//    }
+//
+//    return nCollapsed;
+//}
+
+
 // Return master point edge needs to be collapsed to (or -1)
-label edgeMaster(const PackedBoolList& boundaryPoint, const edge& e)
+label edgeMaster
+(
+    const labelList& boundaryPoint,
+    const bool flipEdge,
+    const edge& e
+)
 {
     label masterPoint = -1;
 
+    label e0 = e[0];
+    label e1 = e[1];
+
+    if (flipEdge)
+    {
+        e0 = e[1];
+        e1 = e[0];
+    }
+
+    // Check if one of the points is on a processor
+//    if
+//    (
+//        boundaryPoint[e0] > 0
+//     && boundaryPoint[e1] > 0
+//    )
+//    {
+//        if (boundaryPoint[e0] != boundaryPoint[e1])
+//        {
+//            return -1;
+//        }
+//    }
+//
+//    if (boundaryPoint[e0] > 0)
+//    {
+//        return e0;
+//    }
+//    else if (boundaryPoint[e1] > 0)
+//    {
+//        return e1;
+//    }
+
     // Collapse edge to boundary point.
-    if (boundaryPoint.get(e[0]))
+    if (boundaryPoint[e0] == 0)
     {
-        if (boundaryPoint.get(e[1]))
+        if (boundaryPoint[e1] == 0)
         {
             // Both points on boundary. Choose one to collapse to.
             // Note: should look at feature edges/points!
-            masterPoint = e[0];
+            masterPoint = e0;
         }
         else
         {
-            masterPoint = e[0];
+            masterPoint = e0;
         }
     }
     else
     {
-        if (boundaryPoint.get(e[1]))
+        if (boundaryPoint[e1] == 0)
         {
-            masterPoint = e[1];
+            masterPoint = e1;
         }
         else
         {
             // None on boundary. Choose arbitrary.
             // Note: should look at geometry?
-            masterPoint = e[0];
+            masterPoint = e0;
         }
     }
+
     return masterPoint;
 }
 
@@ -212,124 +676,266 @@ label edgeMaster(const PackedBoolList& boundaryPoint, const edge& e)
 label collapseSmallEdges
 (
     const polyMesh& mesh,
-    const PackedBoolList& boundaryPoint,
+    const scalarList& freezeEdges,
+    const labelList& boundaryPoint,
     const scalar minLen,
-    edgeCollapser& collapser
+    List<pointEdgeCollapse>& allPointInfo
 )
 {
     const pointField& points = mesh.points();
     const edgeList& edges = mesh.edges();
 
-    // Collapse all edges that are too small. Choose intelligently which
-    // point to collapse edge to.
-
-    label nCollapsed = 0;
+    // Store collapse direction in collapseEdge
+    //   -1 -> Do not collapse
+    //    0 -> Collapse to start point
+    //    1 -> Collapse to end point
+    labelList collapseEdge(edges.size(), -1);
 
     forAll(edges, edgeI)
     {
         const edge& e = edges[edgeI];
 
-        if (e.mag(points) < minLen)
+        if (e.mag(points) < minLen*freezeEdges[edgeI])
         {
-            label master = edgeMaster(boundaryPoint, e);
-
-            if (master != -1) // && collapser.unaffectedEdge(edgeI))
-            {
-                collapser.collapseEdge(edgeI, master);
-                nCollapsed++;
-            }
+            collapseEdge[edgeI] = 0;
         }
     }
-    return nCollapsed;
-}
-
-
-// Faces which have edges just larger than collapse length but faces which
-// are very small. This one tries to collapse them if it can be done with
-// edge collapse. For faces where a face gets replace by two edges use
-// collapseFaces
-label collapseHighAspectFaces
-(
-    const polyMesh& mesh,
-    const PackedBoolList& boundaryPoint,
-    const scalar areaFac,
-    const scalar edgeRatio,
-    edgeCollapser& collapser
-)
-{
-    const pointField& points = mesh.points();
-    const edgeList& edges = mesh.edges();
-    const faceList& faces = mesh.faces();
-    const labelListList& faceEdges = mesh.faceEdges();
 
-    scalarField magArea(mag(mesh.faceAreas()));
+    // Check whether edge point order is reversed from mesh to coupledPatch
+//    const globalMeshData& globalData = mesh.globalData();
+//    const mapDistribute& map = globalData.globalEdgeSlavesMap();
+//    const labelList& coupledMeshEdges = globalData.coupledPatchMeshEdges();
+//    const indirectPrimitivePatch& coupledPatch = globalData.coupledPatch();
+//    const PackedBoolList& cppOrientation = globalData.globalEdgeOrientation();
+//    PackedBoolList meshToPatchSameOrientation(coupledMeshEdges.size(), true);
+//
+//    forAll(coupledMeshEdges, eI)
+//    {
+//        const label meshEdgeIndex = coupledMeshEdges[eI];
+//
+//        if (collapseEdge[meshEdgeIndex] != -1)
+//        {
+//            const edge& meshEdge = edges[meshEdgeIndex];
+//            const edge& coupledPatchEdge = coupledPatch.edges()[eI];
+//
+//            if
+//            (
+//                meshEdge[0] == coupledPatch.meshPoints()[coupledPatchEdge[1]]
+//             && meshEdge[1] == coupledPatch.meshPoints()[coupledPatchEdge[0]]
+//            )
+//            {
+//                meshToPatchSameOrientation[eI] = false;
+//            }
+//        }
+//    }
+//
+//
+//    labelList cppEdgeData(coupledMeshEdges.size(), -1);
+//
+//    forAll(coupledMeshEdges, eI)
+//    {
+//        const label meshEdgeIndex = coupledMeshEdges[eI];
+//
+//        if (collapseEdge[meshEdgeIndex] != -1)
+//        {
+//            if (meshToPatchSameOrientation[eI] == cppOrientation[eI])
+//            {
+//                cppEdgeData[eI] = 0;
+//            }
+//            else
+//            {
+//                cppEdgeData[eI] = 1;
+//            }
+//        }
+//    }
+//
+//
+//    // Synchronise cppEdgeData
+//    // Use minEqOp reduction, so that edge will only be collapsed on processor
+//    // boundary if both processors agree to collapse it
+//    globalData.syncData
+//    (
+//        cppEdgeData,
+//        globalData.globalEdgeSlaves(),
+//        globalData.globalEdgeTransformedSlaves(),
+//        map,
+//        minEqOp<label>()
+//    );
+//
+//
+//    forAll(coupledMeshEdges, eI)
+//    {
+//        const label meshEdgeIndex = coupledMeshEdges[eI];
+//
+//        if (collapseEdge[meshEdgeIndex] != -1)
+//        {
+//            if (meshToPatchSameOrientation[eI] == cppOrientation[eI])
+//            {
+//                collapseEdge[meshEdgeIndex] = 0;
+//            }
+//            else
+//            {
+//                collapseEdge[meshEdgeIndex] = 1;
+//            }
+//        }
+//    }
 
-    label maxIndex = findMax(magArea);
+    label nCollapsed = 0;
 
-    scalar minArea = areaFac * magArea[maxIndex];
+    DynamicList<label> initPoints(mesh.nPoints());
+    DynamicList<pointEdgeCollapse> initPointInfo(mesh.nPoints());
+    allPointInfo.resize(mesh.nPoints());
 
-    Info<< "Max face area:" << magArea[maxIndex] << endl
-        << "Collapse area factor:" << areaFac << endl
-        << "Collapse area:" << minArea << endl;
+    globalIndex globalStrings(mesh.nPoints());
 
-    label nCollapsed = 0;
+    List<pointEdgeCollapse> allEdgeInfo(mesh.nEdges());
+    forAll(allEdgeInfo, edgeI)
+    {
+        allEdgeInfo[edgeI] = pointEdgeCollapse(vector::zero, -1);
+    }
 
-    forAll(faces, faceI)
+    forAll(edges, edgeI)
     {
-        if (magArea[faceI] < minArea)
-        {
-            const face& f = faces[faceI];
+        const edge& e = edges[edgeI];
 
-            // Get the edges in face point order
-            labelList fEdges(getSortedEdges(edges, f, faceEdges[faceI]));
+        if (collapseEdge[edgeI] != -1)
+        {
+            const label master =
+                edgeMaster
+                (
+                    boundaryPoint,
+                    collapseEdge[edgeI],
+                    e
+                );
 
-            SortableList<scalar> lengths(fEdges.size());
-            forAll(fEdges, i)
+//            if (master != -1)
             {
-                lengths[i] = edges[fEdges[i]].mag(points);
-            }
-            lengths.sort();
-
-
-            label edgeI = -1;
+                pointEdgeCollapse pec
+                (
+                    points[master],
+                    globalStrings.toGlobal(master)
+                );
 
-            if (f.size() == 4)
-            {
-                // Compare second largest to smallest
-                if (lengths[2] > edgeRatio*lengths[0])
-                {
-                    // Collapse smallest only. Triangle should be cleared
-                    // next time around.
-                    edgeI = fEdges[lengths.indices()[0]];
-                }
-            }
-            else if (f.size() == 3)
-            {
-                // Compare second largest to smallest
-                if (lengths[1] > edgeRatio*lengths[0])
-                {
-                    edgeI = fEdges[lengths.indices()[0]];
-                }
-            }
+                allEdgeInfo[edgeI] = pec;
 
+                initPointInfo.append(pec);
+                initPoints.append(e.start());
 
-            if (edgeI != -1)
-            {
-                label master = edgeMaster(boundaryPoint, edges[edgeI]);
+                initPointInfo.append(pec);
+                initPoints.append(e.end());
 
-                if (master != -1)// && collapser.unaffectedEdge(edgeI))
-                {
-                    collapser.collapseEdge(edgeI, master);
-                    nCollapsed++;
-                }
+                nCollapsed++;
             }
         }
     }
 
+    PointEdgeWave<pointEdgeCollapse> collapsePropagator
+    (
+        mesh,
+        initPoints,
+        initPointInfo,
+        allPointInfo,
+        allEdgeInfo,
+        mesh.globalData().nTotalPoints()  // Maximum number of iterations
+    );
+
     return nCollapsed;
 }
 
 
+// Faces which have edges just larger than collapse length but faces which
+// are very small. This one tries to collapse them if it can be done with
+// edge collapse. For faces where a face gets replace by two edges use
+// collapseFaces
+//label collapseHighAspectFaces
+//(
+//    const polyMesh& mesh,
+//    const PackedBoolList& boundaryPoint,
+//    const Map<label>& processorPoints,
+//    const scalar areaFac,
+//    const scalar edgeRatio,
+//    edgeCollapser& collapser
+//)
+//{
+//    const pointField& points = mesh.points();
+//    const edgeList& edges = mesh.edges();
+//    const faceList& faces = mesh.faces();
+//    const labelListList& faceEdges = mesh.faceEdges();
+//
+//    scalarField magArea(mag(mesh.faceAreas()));
+//
+//    label maxIndex = findMax(magArea);
+//
+//    scalar minArea = areaFac * magArea[maxIndex];
+//
+//    Info<< "Max face area:" << magArea[maxIndex] << endl
+//        << "Collapse area factor:" << areaFac << endl
+//        << "Collapse area:" << minArea << endl;
+//
+//    label nCollapsed = 0;
+//
+//    forAll(faces, faceI)
+//    {
+//        if (magArea[faceI] < minArea)
+//        {
+//            const face& f = faces[faceI];
+//
+//            // Get the edges in face point order
+//            labelList fEdges(getSortedEdges(edges, f, faceEdges[faceI]));
+//
+//            SortableList<scalar> lengths(fEdges.size());
+//            forAll(fEdges, i)
+//            {
+//                lengths[i] = edges[fEdges[i]].mag(points);
+//            }
+//            lengths.sort();
+//
+//
+//            label edgeI = -1;
+//
+//            if (f.size() == 4)
+//            {
+//                // Compare second largest to smallest
+//                if (lengths[2] > edgeRatio*lengths[0])
+//                {
+//                    // Collapse smallest only. Triangle should be cleared
+//                    // next time around.
+//                    edgeI = fEdges[lengths.indices()[0]];
+//                }
+//            }
+//            else if (f.size() == 3)
+//            {
+//                // Compare second largest to smallest
+//                if (lengths[1] > edgeRatio*lengths[0])
+//                {
+//                    edgeI = fEdges[lengths.indices()[0]];
+//                }
+//            }
+//
+//
+//            if (edgeI != -1)
+//            {
+//                label master = edgeMaster
+//                    (
+//                        boundaryPoint,
+//                        processorPoints,
+//                        false,
+//                        edges[edgeI]
+//                    );
+//
+//                if (master != -1)// && collapser.unaffectedEdge(edgeI))
+//                {
+//                    collapser.collapseEdge(edgeI, master);
+//                    nCollapsed++;
+//                }
+//            }
+//        }
+//    }
+//
+//    return nCollapsed;
+//}
+
+
 void set(const labelList& elems, const bool val, boolList& status)
 {
     forAll(elems, i)
@@ -340,122 +946,254 @@ void set(const labelList& elems, const bool val, boolList& status)
 
 
 // Tries to simplify polygons to face of minSize (4=quad, 3=triangle)
-label simplifyFaces
-(
-    const polyMesh& mesh,
-    const PackedBoolList& boundaryPoint,
-    const label minSize,
-    const scalar lenGap,
-    edgeCollapser& collapser
-)
+//label simplifyFaces
+//(
+//    const polyMesh& mesh,
+//    const PackedBoolList& boundaryPoint,
+//    const Map<label>& processorPoints,
+//    const label minSize,
+//    const scalar lenGap,
+//    edgeCollapser& collapser
+//)
+//{
+//    const pointField& points = mesh.points();
+//    const edgeList& edges = mesh.edges();
+//    const faceList& faces = mesh.faces();
+//    const cellList& cells = mesh.cells();
+//    const labelListList& faceEdges = mesh.faceEdges();
+//    const labelList& faceOwner = mesh.faceOwner();
+//    const labelList& faceNeighbour = mesh.faceNeighbour();
+//    const labelListList& pointCells = mesh.pointCells();
+//    const labelListList& cellEdges = mesh.cellEdges();
+//
+//    label nCollapsed = 0;
+//
+//    boolList protectedEdge(mesh.nEdges(), false);
+//
+//    forAll(faces, faceI)
+//    {
+//        const face& f = faces[faceI];
+//
+//        if
+//        (
+//            f.size() > minSize
+//         && cells[faceOwner[faceI]].size() >= 6
+//         && (
+//                mesh.isInternalFace(faceI)
+//             && cells[faceNeighbour[faceI]].size() >= 6
+//            )
+//        )
+//        {
+//            // Get the edges in face point order
+//            labelList fEdges(getSortedEdges(edges, f, faceEdges[faceI]));
+//
+//            SortableList<scalar> lengths(fEdges.size());
+//            forAll(fEdges, i)
+//            {
+//                lengths[i] = edges[fEdges[i]].mag(points);
+//            }
+//            lengths.sort();
+//
+//
+//            // Now find a gap in length between consecutive elements greater
+//            // than lenGap.
+//
+//            label gapPos = -1;
+//
+//            for (label i = f.size()-1-minSize; i >= 0; --i)
+//            {
+//                if (lengths[i+1] > lenGap*lengths[i])
+//                {
+//                    gapPos = i;
+//
+//                    break;
+//                }
+//            }
+//
+//            if (gapPos != -1)
+//            {
+//                //for (label i = gapPos; i >= 0; --i)
+//                label i = 0;  // Hack: collapse smallest edge only.
+//                {
+//                    label edgeI = fEdges[lengths.indices()[i]];
+//
+//                    if (!protectedEdge[edgeI])
+//                    {
+//                        const edge& e = edges[edgeI];
+//
+//                        label master
+//                       = edgeMaster(boundaryPoint, processorPoints, false, e);
+//
+//                        if (master != -1)
+//                        {
+//                            collapser.collapseEdge(edgeI, master);
+//
+//                            // Protect all other edges on all cells using edge
+//                            // points.
+//
+//                            const labelList& pCells0 = pointCells[e[0]];
+//
+//                            forAll(pCells0, i)
+//                            {
+//                              set(cellEdges[pCells0[i]], true, protectedEdge);
+//                            }
+//                            const labelList& pCells1 = pointCells[e[1]];
+//
+//                            forAll(pCells1, i)
+//                            {
+//                              set(cellEdges[pCells1[i]], true, protectedEdge);
+//                            }
+//
+//                            nCollapsed++;
+//                        }
+//                    }
+//                }
+//            }
+//        }
+//    }
+//
+//    return nCollapsed;
+//}
+
+
+labelHashSet checkMeshQuality(const polyMesh& mesh)
 {
-    const pointField& points = mesh.points();
-    const edgeList& edges = mesh.edges();
-    const faceList& faces = mesh.faces();
-    const cellList& cells = mesh.cells();
-    const labelListList& faceEdges = mesh.faceEdges();
-    const labelList& faceOwner = mesh.faceOwner();
-    const labelList& faceNeighbour = mesh.faceNeighbour();
-    const labelListList& pointCells = mesh.pointCells();
-    const labelListList& cellEdges = mesh.cellEdges();
+    //mesh.checkMesh(true);
+    labelHashSet freezePoints;
 
-    label nCollapsed = 0;
+    IOdictionary meshQualityDict
+    (
+        IOobject
+        (
+            "meshQualityControls",
+            mesh.time().system(),
+            mesh.time(),
+            IOobject::MUST_READ,
+            IOobject::NO_WRITE
+        )
+    );
 
-    boolList protectedEdge(mesh.nEdges(), false);
+    labelHashSet badFaces(mesh.nFaces()/100);
+    DynamicList<label> checkFaces(mesh.nFaces());
 
-    forAll(faces, faceI)
-    {
-        const face& f = faces[faceI];
+    const vectorField& fAreas = mesh.faceAreas();
 
-        if
-        (
-            f.size() > minSize
-         && cells[faceOwner[faceI]].size() >= 6
-         && (
-                mesh.isInternalFace(faceI)
-             && cells[faceNeighbour[faceI]].size() >= 6
-            )
-        )
+    scalar faceAreaLimit = SMALL;
+
+    forAll(fAreas, fI)
+    {
+        if (mag(fAreas[fI]) > faceAreaLimit)
         {
-            // Get the edges in face point order
-            labelList fEdges(getSortedEdges(edges, f, faceEdges[faceI]));
+            checkFaces.append(fI);
+        }
+    }
 
-            SortableList<scalar> lengths(fEdges.size());
-            forAll(fEdges, i)
-            {
-                lengths[i] = edges[fEdges[i]].mag(points);
-            }
-            lengths.sort();
+    motionSmoother::checkMesh
+    (
+        false,
+        mesh,
+        meshQualityDict,
+        checkFaces,
+        badFaces
+    );
 
+    label nBadFaces = badFaces.size();
+    reduce(nBadFaces, sumOp<label>());
 
-            // Now find a gap in length between consecutive elements greater
-            // than lenGap.
+    Info<< nl << "Number of bad faces          : " << nBadFaces << endl;
 
-            label gapPos = -1;
+    forAllConstIter(labelHashSet, badFaces, iter)
+    {
+        const face& f = mesh.faces()[iter.key()];
 
-            for (label i = f.size()-1-minSize; i >= 0; --i)
-            {
-                if (lengths[i+1] > lenGap*lengths[i])
-                {
-                    gapPos = i;
+        forAll(f, pI)
+        {
+            freezePoints.insert(f[pI]);
+        }
+    }
 
-                    break;
-                }
-            }
+//    const edgeList& edges = mesh.edges();
+//
+//    label nFrozenEdges = 0;
+//
+//    OFstream str("frozenEdges.obj");
+//
+//    label count = 0;
+//    forAll(edges, eI)
+//    {
+//        const edge& e = edges[eI];
+//
+//        if (freezePoints.found(e[0]) && freezePoints.found(e[1]))
+//        {
+//            freezeEdges[eI] = true;
+//            nFrozenEdges++;
+//        }
+//    }
+
+    return freezePoints;
+}
 
-            if (gapPos != -1)
-            {
-                //for (label i = gapPos; i >= 0; --i)
-                label i = 0;  // Hack: collapse smallest edge only.
-                {
-                    label edgeI = fEdges[lengths.indices()[i]];
 
-                    if (!protectedEdge[edgeI])
-                    {
-                        const edge& e = edges[edgeI];
+// Mark boundary points
+// boundaryPoint:
+// + -1 : point not on boundary
+// +  0 : point on a real boundary
+// + >0 : point on a processor patch with that ID
+labelList findBoundaryPoints(const polyMesh& mesh)
+{
+    const faceList& faces = mesh.faces();
+    const polyBoundaryMesh& bMesh = mesh.boundaryMesh();
 
-                        label master = edgeMaster(boundaryPoint, e);
 
-                        if (master != -1)
-                        {
-                            collapser.collapseEdge(edgeI, master);
+    labelList boundaryPoint(mesh.nPoints(), -1);
 
-                            // Protect all other edges on all cells using edge
-                            // points.
+    // Get all points on a boundary
+    label nIntFaces = mesh.nInternalFaces();
+    for (label faceI = nIntFaces; faceI < mesh.nFaces(); faceI++)
+    {
+        const face& f = faces[faceI];
 
-                            const labelList& pCells0 = pointCells[e[0]];
+        forAll(f, fp)
+        {
+           boundaryPoint[f[fp]] = 0;
+        }
+    }
 
-                            forAll(pCells0, i)
-                            {
-                                set(cellEdges[pCells0[i]], true, protectedEdge);
-                            }
-                            const labelList& pCells1 = pointCells[e[1]];
+    // Get all processor boundary points and the processor patch label
+    // that they are on.
+    forAll(bMesh, patchI)
+    {
+        const polyPatch& patch = bMesh[patchI];
 
-                            forAll(pCells1, i)
-                            {
-                                set(cellEdges[pCells1[i]], true, protectedEdge);
-                            }
+        if (isA<processorPolyPatch>(patch))
+        {
+            const processorPolyPatch& pPatch =
+                refCast<const processorPolyPatch>(patch);
 
-                            nCollapsed++;
-                        }
-                    }
+            forAll(pPatch, fI)
+            {
+                const face& f = pPatch[fI];
+
+                forAll(f, fp)
+                {
+                    boundaryPoint[f[fp]] = patchI;
                 }
             }
         }
     }
 
-    return nCollapsed;
+    return boundaryPoint;
 }
 
 
 // Main program:
-
 int main(int argc, char *argv[])
 {
 #   include "addOverwriteOption.H"
-    argList::noParallel();
+
     argList::validArgs.append("edge length [m]");
     argList::validArgs.append("merge angle (degrees)");
+    argList::addOption("minLenFactor", "scalar", "edge length factor");
 
 #   include "setRootCase.H"
 #   include "createTime.H"
@@ -463,8 +1201,11 @@ int main(int argc, char *argv[])
 #   include "createPolyMesh.H"
     const word oldInstance = mesh.pointsInstance();
 
-    const scalar minLen  = args.argRead<scalar>(1);
+    scalar minLen  = args.argRead<scalar>(1);
     const scalar angle   = args.argRead<scalar>(2);
+    const scalar minLenFactor
+        = args.optionLookupOrDefault<scalar>("minLenFactor", 0.5);
+
     const bool overwrite = args.optionFound("overwrite");
 
     scalar maxCos = Foam::cos(degToRad(angle));
@@ -475,108 +1216,196 @@ int main(int argc, char *argv[])
         << " degrees" << nl
         << endl;
 
+    Info<< "If an invalid mesh is generated then the edge length will be " << nl
+        << "multiplied by a factor of " << minLenFactor << " and collapsing "
+        << "will be reattempted" << nl << endl;
 
     bool meshChanged = false;
 
-    while (true)
-    {
-        const faceList& faces = mesh.faces();
+    checkMeshQuality(mesh);
 
-        // Get all points on the boundary
-        PackedBoolList boundaryPoint(mesh.nPoints());
+    autoPtr<fvMesh> fvMeshPtr;
 
-        label nIntFaces = mesh.nInternalFaces();
-        for (label faceI = nIntFaces; faceI < mesh.nFaces(); faceI++)
-        {
-            const face& f = faces[faceI];
+    scalarList freezeEdges(mesh.nEdges(), 1.0);
 
-            forAll(f, fp)
-            {
-                boundaryPoint.set(f[fp], 1);
-            }
-        }
+    do
+    {
+        label nIterations = 0;
+        label nFrozenEdges = 0;
 
-        // Edge collapsing engine
-        edgeCollapser collapser(mesh);
+        fvMeshPtr.reset(new fvMesh(mesh));
+        fvMesh& fvMeshRef = fvMeshPtr();
 
+        // Contains new point label for original points
+        labelList pointMap(identity(mesh.nPoints()));
 
-        // Collapse all edges that are too small.
-        label nCollapsed =
-            collapseSmallEdges
-            (
-                mesh,
-                boundaryPoint,
-                minLen,
-                collapser
-            );
-        Info<< "Collapsing " << nCollapsed << " small edges" << endl;
+        scalarList tmpFreezeEdges = freezeEdges;
 
+        autoPtr<mapPolyMesh> morphMap;
 
-        // Remove midpoints on straight edges.
-        if (nCollapsed == 0)
+        while (true)
         {
-            nCollapsed = mergeEdges(mesh, maxCos, collapser);
-            Info<< "Collapsing " << nCollapsed << " in line edges" << endl;
-        }
+            Info<< "Iteration " << nIterations << incrIndent << endl;
 
+            labelList boundaryPoint = findBoundaryPoints(fvMeshRef);
 
-        // Remove small sliver faces that can be collapsed to single edge
-        if (nCollapsed == 0)
-        {
-            nCollapsed =
-                collapseHighAspectFaces
+            List<pointEdgeCollapse> allPointInfo;
+
+            // Collapse all edges that are too small.
+            label nSmallCollapsed =
+                collapseSmallEdges
                 (
-                    mesh,
+                    fvMeshRef,
+                    tmpFreezeEdges,
                     boundaryPoint,
-                    1e-9,       // factor of largest face area
-                    5,          // factor between smallest and largest edge on
-                                // face
-                    collapser
+                    minLen,
+                    allPointInfo
                 );
-            Info<< "Collapsing " << nCollapsed
+
+            reduce(nSmallCollapsed, sumOp<label>());
+
+            Info<< indent << "Collapsing " << nSmallCollapsed
+                << " small edges" << endl;
+
+
+
+
+
+            label nMerged = 0;
+
+            // Remove midpoints on straight edges.
+            if (nSmallCollapsed == 0)
+            {
+                //nMerged = mergeEdges(fvMeshRef, maxCos, allPointInfo);
+            }
+
+            reduce(nMerged, sumOp<label>());
+
+            Info<< indent << "Collapsing " << nMerged << " in line edges"
+                << endl;
+
+
+
+
+
+
+            label nSliversCollapsed = 0;
+
+            // Remove small sliver faces that can be collapsed to single edge
+//            if (nSmallCollapsed == 0 && nMerged == 0)
+//            {
+//                nSliversCollapsed =
+//                    collapseHighAspectFaces
+//                    (
+//                        mesh,
+//                        boundaryPoint,
+//                        processorPoints,
+//                        1E-9,
+//                        5,
+//                        collapser
+//                    );
+//            }
+
+            reduce(nSliversCollapsed, sumOp<label>());
+
+            Info<< indent << "Collapsing " << nSliversCollapsed
                 << " small high aspect ratio faces" << endl;
-        }
 
-        // Simplify faces to quads wherever possible
-        //if (nCollapsed == 0)
-        //{
-        //    nCollapsed =
-        //        simplifyFaces
-        //        (
-        //            mesh,
-        //            boundaryPoint,
-        //            4,              // minimum size of face
-        //            0.2,            // gap in edge lengths on face
-        //            collapser
-        //        );
-        //    Info<< "Collapsing " << nCollapsed << " polygonal faces" << endl;
-        //}
 
+            // Simplify faces to quads wherever possible
+            //if (nCollapsed == 0)
+            //{
+            //    nCollapsed =
+            //        simplifyFaces
+            //        (
+            //            mesh,
+            //            boundaryPoint,
+            //            4,              // minimum size of face
+            //            0.2,            // gap in edge lengths on face
+            //            collapser
+            //        );
+            //    Info<< "Collapsing " << nCollapsed << " polygonal faces"
+            //        << endl;
+            //}
+
+
+            label totalCollapsed =
+                nSmallCollapsed
+              + nMerged
+              + nSliversCollapsed;
+
+            polyTopoChange meshMod(fvMeshRef);
+
+            // Insert mesh refinement into polyTopoChange.
+            setRefinement(fvMeshRef, meshMod, allPointInfo);
+
+            // Do all changes
+            Info<< indent << "Applying changes to the mesh" << nl
+                << decrIndent << endl;
+
+            morphMap = meshMod.changeMesh(fvMeshRef, false);
+
+//            // Contains new point label for old points
+//            const labelList& reversePointMap = morphMap().reversePointMap();
+//
+//            forAll(pointMap, pI)
+//            {
+//                const label originalPoint = pI;
+//                const label currentPoint = pointMap[pI];
+//
+//                if (currentPoint < reversePointMap.size())
+//                {
+//                    const label newPoint = reversePointMap[currentPoint];
+//
+//                    if (newPoint != -1)
+//                    {
+//                        pointMap[originalPoint] = newPoint;
+//                    }
+//                }
+//            }
+
+            if (totalCollapsed == 0)
+            {
+                labelHashSet freezePoints = checkMeshQuality(fvMeshRef);
 
-        if (nCollapsed == 0)
-        {
-            break;
-        }
+                label nFreezePoints = freezePoints.size();
+                reduce(nFreezePoints, sumOp<label>());
 
-        polyTopoChange meshMod(mesh);
+                nFrozenEdges = nFreezePoints;
 
-        // Insert mesh refinement into polyTopoChange.
-        collapser.setRefinement(meshMod);
+                Info<< "Number of frozen points      : " << nFreezePoints
+                    << endl;
 
-        // Do all changes
-        Info<< "Morphing ..." << endl;
+                break;
+            }
 
-        autoPtr<mapPolyMesh> morphMap = meshMod.changeMesh(mesh, false);
+            if (morphMap().hasMotionPoints())
+            {
+                fvMeshRef.movePoints(morphMap().preMotionPoints());
+            }
 
-        collapser.updateMesh(morphMap());
+            meshChanged = true;
 
-        if (morphMap().hasMotionPoints())
+            nIterations++;
+        }
+
+        if (nFrozenEdges > 0)
         {
-            mesh.movePoints(morphMap().preMotionPoints());
+            minLen *= minLenFactor;
         }
 
-        meshChanged = true;
-    }
+        reduce(nFrozenEdges, sumOp<label>());
+
+        Info<< "Number of frozen edges       : " << nFrozenEdges << nl
+            << endl;
+
+        if (nFrozenEdges == 0)
+        {
+            break;
+        }
+
+    } while (true);
+
 
     if (meshChanged)
     {
@@ -587,14 +1416,21 @@ int main(int argc, char *argv[])
         }
         else
         {
-            mesh.setInstance(oldInstance);
+            fvMeshPtr().setInstance(oldInstance);
         }
 
-        Info<< "Writing collapsed mesh to time " << runTime.timeName() << endl;
+        Info<< nl << "Writing collapsed mesh to time "
+            << runTime.timeName() << nl << endl;
 
-        mesh.write();
+        fvMeshPtr().write();
     }
 
+    Info<< "Final minimum length : " << minLen << " m" << nl << endl;
+
+    Info<< nl << "ExecutionTime = " << runTime.elapsedCpuTime() << " s"
+        << "  ClockTime = " << runTime.elapsedClockTime() << " s"
+        << nl << endl;
+
     Info<< "End\n" << endl;
 
     return 0;
diff --git a/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapse.C b/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapse.C
new file mode 100644
index 0000000000000000000000000000000000000000..6830e1c8f56ed18c006241ffb16388012da4b042
--- /dev/null
+++ b/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapse.C
@@ -0,0 +1,51 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "pointEdgeCollapse.H"
+
+// * * * * * * * * * * * * * * * Friend Operators  * * * * * * * * * * * * * //
+
+Foam::Ostream& Foam::operator<<
+(
+    Foam::Ostream& os,
+    const Foam::pointEdgeCollapse& wDist
+)
+{
+    return os
+        << wDist.collapsePoint_ << wDist.collapseIndex_;
+}
+
+Foam::Istream& Foam::operator>>
+(
+    Foam::Istream& is,
+    Foam::pointEdgeCollapse& wDist
+)
+{
+    return is
+        >> wDist.collapsePoint_ >> wDist.collapseIndex_;
+}
+
+
+// ************************************************************************* //
diff --git a/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapse.H b/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapse.H
new file mode 100644
index 0000000000000000000000000000000000000000..cd8383b8b33b6ed6ddb0b03a172aa632205f3cee
--- /dev/null
+++ b/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapse.H
@@ -0,0 +1,227 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::pointEdgeCollapse
+
+Description
+    Determines length of string of edges walked to point.
+
+SourceFiles
+    pointEdgeCollapseI.H
+    pointEdgeCollapse.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef pointEdgeCollapse_H
+#define pointEdgeCollapse_H
+
+#include "point.H"
+#include "tensor.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+// Forward declaration of classes
+class polyPatch;
+class polyMesh;
+
+/*---------------------------------------------------------------------------*\
+                           Class pointEdgeCollapse Declaration
+\*---------------------------------------------------------------------------*/
+
+class pointEdgeCollapse
+{
+    // Private data
+
+        //- Collapse location
+        point collapsePoint_;
+
+        //- Collapse string index
+        label collapseIndex_;
+
+
+    // Private Member Functions
+
+        //- Evaluate distance to point.
+        template<class TrackingData>
+        inline bool update
+        (
+            const pointEdgeCollapse& w2,
+            const scalar tol,
+            TrackingData& td
+        );
+
+
+        //- Check for same coordinate
+        inline bool samePoint(const point& pt) const;
+
+public:
+
+    // Constructors
+
+        //- Construct null
+        inline pointEdgeCollapse();
+
+        //- Construct from components
+        inline pointEdgeCollapse
+        (
+            const point& collapsePoint,
+            const label collapseIndex
+        );
+
+
+    // Member Functions
+
+        // Access
+
+            inline const point& collapsePoint() const;
+
+            inline label collapseIndex() const;
+
+
+        // Needed by meshWave
+
+            //- Check whether origin has been changed at all or
+            //  still contains original (invalid) value.
+            template<class TrackingData>
+            inline bool valid(TrackingData& td) const;
+
+            //- Convert origin to relative vector to leaving point
+            //  (= point coordinate)
+            template<class TrackingData>
+            inline void leaveDomain
+            (
+                const polyPatch& patch,
+                const label patchPointI,
+                const point& pos,
+                TrackingData& td
+            );
+
+            //- Convert relative origin to absolute by adding entering point
+            template<class TrackingData>
+            inline void enterDomain
+            (
+                const polyPatch& patch,
+                const label patchPointI,
+                const point& pos,
+                TrackingData& td
+            );
+
+            //- Apply rotation matrix to origin
+            template<class TrackingData>
+            inline void transform
+            (
+                const tensor& rotTensor,
+                TrackingData& td
+            );
+
+            //- Influence of edge on point
+            template<class TrackingData>
+            inline bool updatePoint
+            (
+                const polyMesh& mesh,
+                const label pointI,
+                const label edgeI,
+                const pointEdgeCollapse& edgeInfo,
+                const scalar tol,
+                TrackingData& td
+            );
+
+            //- Influence of different value on same point.
+            //  Merge new and old info.
+            template<class TrackingData>
+            inline bool updatePoint
+            (
+                const polyMesh& mesh,
+                const label pointI,
+                const pointEdgeCollapse& newPointInfo,
+                const scalar tol,
+                TrackingData& td
+            );
+
+            //- Influence of different value on same point.
+            //  No information about current position whatsoever.
+            template<class TrackingData>
+            inline bool updatePoint
+            (
+                const pointEdgeCollapse& newPointInfo,
+                const scalar tol,
+                TrackingData& td
+            );
+
+            //- Influence of point on edge.
+            template<class TrackingData>
+            inline bool updateEdge
+            (
+                const polyMesh& mesh,
+                const label edgeI,
+                const label pointI,
+                const pointEdgeCollapse& pointInfo,
+                const scalar tol,
+                TrackingData& td
+            );
+
+            //- Same (like operator==)
+            template<class TrackingData>
+            inline bool equal(const pointEdgeCollapse&, TrackingData&)
+            const;
+
+
+    // Member Operators
+
+        //Note: Used to determine whether to call update.
+        inline bool operator==(const pointEdgeCollapse&) const;
+        inline bool operator!=(const pointEdgeCollapse&) const;
+
+
+    // IOstream Operators
+
+        friend Ostream& operator<<(Ostream&, const pointEdgeCollapse&);
+        friend Istream& operator>>(Istream&, pointEdgeCollapse&);
+};
+
+
+//- Data associated with pointEdgeCollapse type are contiguous
+template<>
+inline bool contiguous<pointEdgeCollapse>()
+{
+    return true;
+}
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#include "pointEdgeCollapseI.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapseI.H b/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapseI.H
new file mode 100644
index 0000000000000000000000000000000000000000..a064bcf781dad9cbdbc24f7fc617269f6b355f7f
--- /dev/null
+++ b/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapseI.H
@@ -0,0 +1,313 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "polyMesh.H"
+#include "transform.H"
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+// Update this with w2.
+template<class TrackingData>
+inline bool Foam::pointEdgeCollapse::update
+(
+    const pointEdgeCollapse& w2,
+    const scalar tol,
+    TrackingData& td
+)
+{
+    if (!w2.valid(td))
+    {
+        FatalErrorIn("pointEdgeCollapse::update(..)")
+            << "problem." << abort(FatalError);
+    }
+
+    if (w2.collapseIndex_ == -1)
+    {
+        // Not marked for collapse; only happens on edges.
+        return false;
+    }
+
+    if (!valid(td))
+    {
+        operator=(w2);
+        return true;
+    }
+    else
+    {
+        // Same coordinate. Same string?
+        if (w2.collapseIndex_ < collapseIndex_)
+        {
+            // Take over string index from w2 (and also coordinate but this
+            // was same)
+            operator=(w2);
+            return true;
+        }
+        else if (w2.collapseIndex_ == collapseIndex_)
+        {
+            bool identicalPoint = samePoint(w2.collapsePoint_);
+            bool nearer = magSqr(w2.collapsePoint_) < magSqr(collapsePoint_);
+            if (nearer)
+            {
+                operator=(w2);
+            }
+            if (identicalPoint)
+            {
+                return false;
+            }
+            else
+            {
+                return nearer;
+            }
+        }
+        else
+        {
+            return false;
+        }
+
+//        if (samePoint(w2.collapsePoint_))
+//        {
+//            // Same coordinate. Same string?
+//            if (w2.collapseIndex_ < collapseIndex_)
+//            {
+//                // Take over string index from w2 (and also coordinate but
+//                // this was same)
+//                operator=(w2);
+//                return true;
+//            }
+//            else
+//            {
+//                return false;
+//            }
+//        }
+//        else
+//        {
+//            // Find nearest coordinate
+//            if (magSqr(w2.collapsePoint_) < magSqr(collapsePoint_))
+//            {
+//                operator=(w2);
+//                return true;
+//            }
+//            else
+//            {
+//                return false;
+//            }
+//        }
+    }
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+// Null constructor
+inline Foam::pointEdgeCollapse::pointEdgeCollapse()
+:
+    collapsePoint_(GREAT, GREAT, GREAT),
+    collapseIndex_(-2)
+{}
+
+
+// Construct from origin, distance
+inline Foam::pointEdgeCollapse::pointEdgeCollapse
+(
+    const point& collapsePoint,
+    const label collapseIndex
+)
+:
+    collapsePoint_(collapsePoint),
+    collapseIndex_(collapseIndex)
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+inline const Foam::point& Foam::pointEdgeCollapse::collapsePoint() const
+{
+    return collapsePoint_;
+}
+
+
+inline Foam::label Foam::pointEdgeCollapse::collapseIndex() const
+{
+    return collapseIndex_;
+}
+
+
+inline bool Foam::pointEdgeCollapse::samePoint(const point& pt) const
+{
+    bool isLegal1 = (cmptMin(collapsePoint_) < 0.5*GREAT);
+    bool isLegal2 = (cmptMin(pt) < 0.5*GREAT);
+
+    if (isLegal1 && isLegal2)
+    {
+        return mag(collapsePoint_ - pt) < 1e-9;//SMALL;
+    }
+    else
+    {
+        return isLegal1 == isLegal2;
+    }
+}
+
+
+template<class TrackingData>
+inline bool Foam::pointEdgeCollapse::valid(TrackingData& td) const
+{
+    return collapseIndex_ != -2;
+}
+
+
+template<class TrackingData>
+inline void Foam::pointEdgeCollapse::leaveDomain
+(
+    const polyPatch& patch,
+    const label patchPointI,
+    const point& coord,
+    TrackingData& td
+)
+{
+    collapsePoint_ -= coord;
+}
+
+
+template<class TrackingData>
+inline void Foam::pointEdgeCollapse::transform
+(
+    const tensor& rotTensor,
+    TrackingData& td
+)
+{
+    collapsePoint_ = Foam::transform(rotTensor, collapsePoint_);
+}
+
+
+// Update absolute geometric quantities. Note that distance (dist_)
+// is not affected by leaving/entering domain.
+template<class TrackingData>
+inline void Foam::pointEdgeCollapse::enterDomain
+(
+    const polyPatch& patch,
+    const label patchPointI,
+    const point& coord,
+    TrackingData& td
+)
+{
+    // back to absolute form
+    collapsePoint_ += coord;
+}
+
+
+// Update this with information from connected edge
+template<class TrackingData>
+inline bool Foam::pointEdgeCollapse::updatePoint
+(
+    const polyMesh& mesh,
+    const label pointI,
+    const label edgeI,
+    const pointEdgeCollapse& edgeInfo,
+    const scalar tol,
+    TrackingData& td
+)
+{
+    return update(edgeInfo, tol, td);
+}
+
+
+// Update this with new information on same point
+template<class TrackingData>
+inline bool Foam::pointEdgeCollapse::updatePoint
+(
+    const polyMesh& mesh,
+    const label pointI,
+    const pointEdgeCollapse& newPointInfo,
+    const scalar tol,
+    TrackingData& td
+)
+{
+    return update(newPointInfo, tol, td);
+}
+
+
+// Update this with new information on same point. No extra information.
+template<class TrackingData>
+inline bool Foam::pointEdgeCollapse::updatePoint
+(
+    const pointEdgeCollapse& newPointInfo,
+    const scalar tol,
+    TrackingData& td
+)
+{
+    return update(newPointInfo, tol, td);
+}
+
+
+// Update this with information from connected point
+template<class TrackingData>
+inline bool Foam::pointEdgeCollapse::updateEdge
+(
+    const polyMesh& mesh,
+    const label edgeI,
+    const label pointI,
+    const pointEdgeCollapse& pointInfo,
+    const scalar tol,
+    TrackingData& td
+)
+{
+    return update(pointInfo, tol, td);
+}
+
+
+template <class TrackingData>
+inline bool Foam::pointEdgeCollapse::equal
+(
+    const pointEdgeCollapse& rhs,
+    TrackingData& td
+) const
+{
+    return operator==(rhs);
+}
+
+
+// * * * * * * * * * * * * * * * Member Operators  * * * * * * * * * * * * * //
+
+inline bool Foam::pointEdgeCollapse::operator==
+(
+    const Foam::pointEdgeCollapse& rhs
+) const
+{
+    return
+        collapseIndex_ == rhs.collapseIndex_
+     && samePoint(rhs.collapsePoint_);
+}
+
+
+inline bool Foam::pointEdgeCollapse::operator!=
+(
+    const Foam::pointEdgeCollapse& rhs
+) const
+{
+    return !(*this == rhs);
+}
+
+
+// ************************************************************************* //
diff --git a/applications/utilities/mesh/manipulation/checkMesh/printMeshStats.C b/applications/utilities/mesh/manipulation/checkMesh/printMeshStats.C
index 874ebc3fb269162756e6cc3005b3bd6a6502ac22..9ff4ed0334b64bd8b532af204c0759acffaa1d7a 100644
--- a/applications/utilities/mesh/manipulation/checkMesh/printMeshStats.C
+++ b/applications/utilities/mesh/manipulation/checkMesh/printMeshStats.C
@@ -152,13 +152,17 @@ void Foam::printMeshStats(const polyMesh& mesh, const bool allTopology)
     {
         Pstream::mapCombineGather(polyhedralFaces, plusEqOp<label>());
 
-        Info<< "    Breakdown of polyhedra by number of faces:" << endl;
-        Info<< "        faces" << "   number of cells" << endl;
+        Info<< "    Breakdown of polyhedra by number of faces:" << nl
+            << "        faces" << "   number of cells" << endl;
 
-        forAllConstIter(Map<label>, polyhedralFaces, iter)
+        labelList sortedKeys = polyhedralFaces.sortedToc();
+
+        forAll(sortedKeys, keyI)
         {
+            label nFaces = sortedKeys[keyI];
+
             Info<< setf(std::ios::right) << setw(13)
-                << iter.key() << "   " << iter() << nl;
+                << nFaces << "   " << polyhedralFaces[nFaces] << nl;
         }
     }
 
diff --git a/applications/utilities/postProcessing/wall/solidWallHeatFlux/solidWallHeatFlux.C b/applications/utilities/postProcessing/wall/solidWallHeatFlux/solidWallHeatFlux.C
index f728a626b18ec33551cf9e71dd5a5438d7804617..281107856e3144cca1086a3fdb8ccbe3fea4a651 100644
--- a/applications/utilities/postProcessing/wall/solidWallHeatFlux/solidWallHeatFlux.C
+++ b/applications/utilities/postProcessing/wall/solidWallHeatFlux/solidWallHeatFlux.C
@@ -73,7 +73,7 @@ int main(int argc, char *argv[])
         forAll(wallHeatFlux.boundaryField(), patchi)
         {
             wallHeatFlux.boundaryField()[patchi] =
-                thermo().K(patchi)
+                thermo().kappa(patchi)
                *T.boundaryField()[patchi].snGrad();
 
             if (isA<wallFvPatch>(mesh.boundary()[patchi]))
diff --git a/etc/codeTemplates/dynamicCode/codedBasicSourceTemplate.C b/etc/codeTemplates/dynamicCode/codedBasicSourceTemplate.C
new file mode 100644
index 0000000000000000000000000000000000000000..d5fdb11a0be2625738d2bce91df3b67efdd1a7bc
--- /dev/null
+++ b/etc/codeTemplates/dynamicCode/codedBasicSourceTemplate.C
@@ -0,0 +1,180 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "codedBasicSourceTemplate.H"
+#include "addToRunTimeSelectionTable.H"
+#include "fvPatchFieldMapper.H"
+#include "volFields.H"
+#include "surfaceFields.H"
+#include "unitConversion.H"
+//{{{ begin codeInclude
+${codeInclude}
+//}}} end codeInclude
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+// * * * * * * * * * * * * * * * Local Functions * * * * * * * * * * * * * * //
+
+//{{{ begin localCode
+${localCode}
+//}}} end localCode
+
+
+// * * * * * * * * * * * * * * * Global Functions  * * * * * * * * * * * * * //
+
+extern "C"
+{
+    // dynamicCode:
+    // SHA1 = ${SHA1sum}
+    //
+    // unique function name that can be checked if the correct library version
+    // has been loaded
+    void ${typeName}_${SHA1sum}(bool load)
+    {
+        if (load)
+        {
+            // code that can be explicitly executed after loading
+        }
+        else
+        {
+            // code that can be explicitly executed before unloading
+        }
+    }
+}
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+//makeRemovablePatchTypeField
+//(
+//    fvPatch${FieldType},
+//    ${typeName}CodedBasic${SourceType}
+//);
+defineTypeNameAndDebug(${typeName}CodedBasic${SourceType}, 0);
+addRemovableToRunTimeSelectionTable
+(
+    basicSource,
+    ${typeName}CodedBasic${SourceType},
+    dictionary
+);
+
+
+const char* const ${typeName}CodedBasic${SourceType}::SHA1sum =
+    "${SHA1sum}";
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+${typeName}CodedBasic${SourceType}::
+${typeName}CodedBasic${SourceType}
+(
+    const word& name,
+    const word& modelType,
+    const dictionary& dict,
+    const fvMesh& mesh
+)
+:
+    basicSource(name, modelType, dict, mesh)
+{
+    if (${verbose:-false})
+    {
+        Info<<"construct ${typeName} sha1: ${SHA1sum}"
+            " from components\n";
+    }
+}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+${typeName}CodedBasic${SourceType}::
+~${typeName}CodedBasic${SourceType}()
+{
+    if (${verbose:-false})
+    {
+        Info<<"destroy ${typeName} sha1: ${SHA1sum}\n";
+    }
+}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+void ${typeName}CodedBasic${SourceType}::correct
+(
+    GeometricField<${TemplateType}, fvPatchField, volMesh>& fld
+)
+{
+    if (${verbose:-false})
+    {
+        Info<<"${typeName}CodedBasic${SourceType}::correct()\n";
+    }
+
+//{{{ begin code
+    ${codeCorrect}
+//}}} end code
+}
+
+
+void ${typeName}CodedBasic${SourceType}::addSup
+(
+    fvMatrix<${TemplateType}>& eqn,
+    const label fieldI
+)
+{
+    if (${verbose:-false})
+    {
+        Info<<"${typeName}CodedBasic${SourceType}::addSup()\n";
+    }
+
+//{{{ begin code
+    ${codeAddSup}
+//}}} end code
+}
+
+
+void ${typeName}CodedBasic${SourceType}::setValue
+(
+    fvMatrix<${TemplateType}>& eqn,
+    const label fieldI
+)
+{
+    if (${verbose:-false})
+    {
+        Info<<"${typeName}CodedBasic${SourceType}::setValue()\n";
+    }
+
+//{{{ begin code
+    ${codeSetValue}
+//}}} end code
+}
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// ************************************************************************* //
diff --git a/etc/codeTemplates/dynamicCode/codedBasicSourceTemplate.H b/etc/codeTemplates/dynamicCode/codedBasicSourceTemplate.H
new file mode 100644
index 0000000000000000000000000000000000000000..7f80510507e6e8bec0ae185bb7932309880905e8
--- /dev/null
+++ b/etc/codeTemplates/dynamicCode/codedBasicSourceTemplate.H
@@ -0,0 +1,108 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+Description
+    Template for use with dynamic code generation of a basicSource
+
+    - without state
+
+SourceFiles
+    codedBasicSourceTemplate.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef codedBasicSourceTemplate_H
+#define codedBasicSourceTemplate_H
+
+#include "basicSource.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                         A templated CodedBasicSource
+\*---------------------------------------------------------------------------*/
+
+class ${typeName}CodedBasic${SourceType}
+:
+    public basicSource
+{
+public:
+
+    //- Information about the SHA1 of the code itself
+    static const char* const SHA1sum;
+
+    //- Runtime type information
+    TypeName("${typeName}");
+
+
+    // Constructors
+
+        //- Construct from patch and internal field
+        ${typeName}CodedBasic${SourceType}
+        (
+            const word& name,
+            const word& modelType,
+            const dictionary& dict,
+            const fvMesh& mesh
+        );
+
+    //- Destructor
+    virtual ~${typeName}CodedBasic${SourceType}();
+
+
+    // Member functions
+
+            //- Correct field
+            virtual void correct
+            (
+                GeometricField<${TemplateType}, fvPatchField, volMesh>&
+            );
+
+            //- Explicit and implicit matrix contributions
+            virtual void addSup
+            (
+                fvMatrix<${TemplateType}>& eqn,
+                const label fieldI
+            );
+
+            //- Set value
+            virtual void setValue
+            (
+                fvMatrix<${TemplateType}>& eqn,
+                const label fieldI
+            );
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/OpenFOAM/interpolations/interpolationWeights/interpolationWeights/interpolationWeights.C b/src/OpenFOAM/interpolations/interpolationWeights/interpolationWeights/interpolationWeights.C
index 30fc2fc0f69fe8fb9018dfc057788f6ffd9013ad..779f134de372034089edf1de3ed1ec0fc81768fc 100644
--- a/src/OpenFOAM/interpolations/interpolationWeights/interpolationWeights/interpolationWeights.C
+++ b/src/OpenFOAM/interpolations/interpolationWeights/interpolationWeights/interpolationWeights.C
@@ -57,8 +57,12 @@ autoPtr<interpolationWeights> interpolationWeights::New
     const scalarField& samples
 )
 {
-    Info<< nl << "Selecting interpolationWeights "
-        << type << endl;
+    if (debug)
+    {
+        InfoIn("interpolationWeights::New")
+            << "Selecting interpolationWeights "
+            << type << endl;
+    }
 
     wordConstructorTable::iterator cstrIter =
         wordConstructorTablePtr_->find(type);
@@ -87,33 +91,6 @@ interpolationWeights::~interpolationWeights()
 {}
 
 
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-//objectRegistry& interpolationWeights::registry
-//(
-//    const objectRegistry& obr,
-//    const word& name
-//)
-//{
-//    if (!obr.foundObject<objectRegistry>(name))
-//    {
-//        objectRegistry* fieldsCachePtr = new objectRegistry
-//        (
-//            IOobject
-//            (
-//                name,
-//                obr.time().constant(),
-//                obr,
-//                IOobject::NO_READ,
-//                IOobject::NO_WRITE
-//            )
-//        );
-//        fieldsCachePtr->store();
-//    }
-//    return const_cast<objectRegistry&>(obr.subRegistry(name));
-//}
-
-
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
 } // End namespace Foam
diff --git a/src/OpenFOAM/matrices/LduMatrix/LduMatrix/SolverPerformance.C b/src/OpenFOAM/matrices/LduMatrix/LduMatrix/SolverPerformance.C
index 62ce85abb7f9f438408235c0c2192ef6922812d1..5f307718eb200ef4f420a2bdb7222b337b123682 100644
--- a/src/OpenFOAM/matrices/LduMatrix/LduMatrix/SolverPerformance.C
+++ b/src/OpenFOAM/matrices/LduMatrix/LduMatrix/SolverPerformance.C
@@ -99,8 +99,16 @@ void Foam::SolverPerformance<Type>::print
 {
     for(direction cmpt=0; cmpt<pTraits<Type>::nComponents; cmpt++)
     {
-        os  << solverName_ << ":  Solving for "
-            << word(fieldName_ + pTraits<Type>::componentNames[cmpt]);
+        if (pTraits<Type>::nComponents == 1)
+        {
+            os  << solverName_ << ":  Solving for " << fieldName_;
+
+        }
+        else
+        {
+            os  << solverName_ << ":  Solving for "
+                << word(fieldName_ + pTraits<Type>::componentNames[cmpt]);
+        }
 
         if (singular_[cmpt])
         {
diff --git a/src/OpenFOAM/matrices/lduMatrix/lduMatrix/lduMatrixATmul.C b/src/OpenFOAM/matrices/lduMatrix/lduMatrix/lduMatrixATmul.C
index db2b6d8bbb4f077a306466c040b6ce61405ecf19..723a99980646532ea78c7739fe89efa10204a8ec 100644
--- a/src/OpenFOAM/matrices/lduMatrix/lduMatrix/lduMatrixATmul.C
+++ b/src/OpenFOAM/matrices/lduMatrix/lduMatrix/lduMatrixATmul.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -295,4 +295,36 @@ Foam::tmp<Foam::scalarField> Foam::lduMatrix::residual
 }
 
 
+Foam::tmp<Foam::scalarField > Foam::lduMatrix::H1() const
+{
+    tmp<scalarField > tH1
+    (
+        new scalarField(lduAddr().size(), 0.0)
+    );
+
+    if (lowerPtr_ || upperPtr_)
+    {
+        scalarField& H1_ = tH1();
+
+        scalar* __restrict__ H1Ptr = H1_.begin();
+
+        const label* __restrict__ uPtr = lduAddr().upperAddr().begin();
+        const label* __restrict__ lPtr = lduAddr().lowerAddr().begin();
+
+        const scalar* __restrict__ lowerPtr = lower().begin();
+        const scalar* __restrict__ upperPtr = upper().begin();
+
+        register const label nFaces = upper().size();
+
+        for (register label face=0; face<nFaces; face++)
+        {
+            H1Ptr[uPtr[face]] -= lowerPtr[face];
+            H1Ptr[lPtr[face]] -= upperPtr[face];
+        }
+    }
+
+    return tH1;
+}
+
+
 // ************************************************************************* //
diff --git a/src/OpenFOAM/matrices/lduMatrix/lduMatrix/lduMatrixOperations.C b/src/OpenFOAM/matrices/lduMatrix/lduMatrix/lduMatrixOperations.C
index 07260b4a91009fdbdc7265ab6ad6765f75183c40..df1ba0d9455eaa0ef1b35dcf6bd8b9571b5cdbb4 100644
--- a/src/OpenFOAM/matrices/lduMatrix/lduMatrix/lduMatrixOperations.C
+++ b/src/OpenFOAM/matrices/lduMatrix/lduMatrix/lduMatrixOperations.C
@@ -351,36 +351,4 @@ void Foam::lduMatrix::operator*=(scalar s)
 }
 
 
-Foam::tmp<Foam::scalarField > Foam::lduMatrix::H1() const
-{
-    tmp<scalarField > tH1
-    (
-        new scalarField(lduAddr().size(), 0.0)
-    );
-
-    if (lowerPtr_ || upperPtr_)
-    {
-        scalarField& H1_ = tH1();
-
-        scalar* __restrict__ H1Ptr = H1_.begin();
-
-        const label* __restrict__ uPtr = lduAddr().upperAddr().begin();
-        const label* __restrict__ lPtr = lduAddr().lowerAddr().begin();
-
-        const scalar* __restrict__ lowerPtr = lower().begin();
-        const scalar* __restrict__ upperPtr = upper().begin();
-
-        register const label nFaces = upper().size();
-
-        for (register label face=0; face<nFaces; face++)
-        {
-            H1Ptr[uPtr[face]] -= lowerPtr[face];
-            H1Ptr[lPtr[face]] -= upperPtr[face];
-        }
-    }
-
-    return tH1;
-}
-
-
 // ************************************************************************* //
diff --git a/src/OpenFOAM/primitives/functions/DataEntry/Table/TableBase.C b/src/OpenFOAM/primitives/functions/DataEntry/Table/TableBase.C
index e59c5ec898d3427c074141e7404c7d71dcb9937d..4b52d26699939fb872ab7e68244303b7f1fc32b9 100644
--- a/src/OpenFOAM/primitives/functions/DataEntry/Table/TableBase.C
+++ b/src/OpenFOAM/primitives/functions/DataEntry/Table/TableBase.C
@@ -45,6 +45,7 @@ const Foam::interpolationWeights& Foam::TableBase<Type>::interpolator() const
             tableSamples_
         );
     }
+
     return interpolatorPtr_();
 }
 
@@ -172,6 +173,7 @@ Foam::TableBase<Type>::outOfBounds
 {
     boundsHandling prev = boundsHandling_;
     boundsHandling_ = bound;
+
     return prev;
 }
 
@@ -366,22 +368,8 @@ Type Foam::TableBase<Type>::value(const scalar x) const
     {
         t += currentWeights_[i]*table_[currentIndices_[i]].second();
     }
-    return t;
 
-    //// Find i such that x(i) < xDash < x(i+1)
-    //label i = 0;
-    //while ((table_[i+1].first() < xDash) && (i+1 < table_.size()))
-    //{
-    //    i++;
-    //}
-    //
-    //// Linear interpolation to find value
-    //return Type
-    //(
-    //    (xDash - table_[i].first())/(table_[i+1].first() - table_[i].first())
-    //  * (table_[i+1].second() - table_[i].second())
-    //  + table_[i].second()
-    //);
+    return t;
 }
 
 
@@ -396,66 +384,8 @@ Type Foam::TableBase<Type>::integrate(const scalar x1, const scalar x2) const
     {
        sum += currentWeights_[i]*table_[currentIndices_[i]].second();
     }
-    return sum;
 
-
-    //// Initialise return value
-    //Type sum = pTraits<Type>::zero;
-    //
-    //// Return zero if out of bounds
-    //if ((x1 > table_.last().first()) || (x2 < table_[0].first()))
-    //{
-    //    return sum;
-    //}
-    //
-    //// Find next index greater than x1
-    //label id1 = 0;
-    //while ((table_[id1].first() < x1) && (id1 < table_.size()))
-    //{
-    //    id1++;
-    //}
-    //
-    //// Find next index less than x2
-    //label id2 = table_.size() - 1;
-    //while ((table_[id2].first() > x2) && (id2 >= 1))
-    //{
-    //    id2--;
-    //}
-    //
-    //if ((id1 - id2) == 1)
-    //{
-    //    // x1 and x2 lie within 1 interval
-    //    sum = 0.5*(value(x1) + value(x2))*(x2 - x1);
-    //}
-    //else
-    //{
-    //    // x1 and x2 cross multiple intervals
-    //
-    //    // Integrate table body
-    //    for (label i=id1; i<id2; i++)
-    //    {
-    //        sum +=
-    //            (table_[i].second() + table_[i+1].second())
-    //          * (table_[i+1].first() - table_[i].first());
-    //    }
-    //    sum *= 0.5;
-    //
-    //    // Add table ends (partial segments)
-    //    if (id1 > 0)
-    //    {
-    //        sum += 0.5
-    //          * (value(x1) + table_[id1].second())
-    //          * (table_[id1].first() - x1);
-    //    }
-    //    if (id2 < table_.size() - 1)
-    //    {
-    //        sum += 0.5
-    //          * (table_[id2].second() + value(x2))
-    //          * (x2 - table_[id2].first());
-    //    }
-    //}
-    //
-    //return sum;
+    return sum;
 }
 
 
@@ -481,9 +411,9 @@ Foam::dimensioned<Type> Foam::TableBase<Type>::dimIntegrate
     );
 }
 
+
 // * * * * * * * * * * * * * *  IOStream operators * * * * * * * * * * * * * //
 
 #include "TableBaseIO.C"
 
-
 // ************************************************************************* //
diff --git a/src/dynamicMesh/polyTopoChange/polyTopoChange/edgeCollapser.C b/src/dynamicMesh/polyTopoChange/polyTopoChange/edgeCollapser.C
index 415c6facdca40204dfe3e097e10452ec756a9933..22872abf47d6b1c5f87150831ef4ce1d22a82b3a 100644
--- a/src/dynamicMesh/polyTopoChange/polyTopoChange/edgeCollapser.C
+++ b/src/dynamicMesh/polyTopoChange/polyTopoChange/edgeCollapser.C
@@ -27,6 +27,10 @@ License
 #include "polyMesh.H"
 #include "polyTopoChange.H"
 #include "ListOps.H"
+#include "globalMeshData.H"
+#include "OFstream.H"
+#include "meshTools.H"
+#include "syncTools.H"
 
 // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
 
@@ -121,6 +125,7 @@ void Foam::edgeCollapser::filterFace(const label faceI, face& f) const
         }
     }
 
+
     // Check for pinched face. Tries to correct
     // - consecutive duplicate vertex. Removes duplicate vertex.
     // - duplicate vertex with one other vertex in between (spike).
@@ -190,15 +195,15 @@ void Foam::edgeCollapser::printRegions() const
 
         if (master != -1)
         {
-            Info<< "Region:" << regionI << nl
+            Pout<< "Region:" << regionI << nl
                 << "    master:" << master
-                << ' ' << mesh_.points()[master] << nl;
+                << ' ' << pointRegionMasterLocation_[regionI] << nl;
 
             forAll(pointRegion_, pointI)
             {
                 if (pointRegion_[pointI] == regionI && pointI != master)
                 {
-                    Info<< "    slave:" << pointI
+                    Pout<< "    slave:" << pointI
                         << ' ' <<  mesh_.points()[pointI] << nl;
                 }
             }
@@ -272,6 +277,7 @@ Foam::edgeCollapser::edgeCollapser(const polyMesh& mesh)
 :
     mesh_(mesh),
     pointRegion_(mesh.nPoints(), -1),
+    pointRegionMasterLocation_(mesh.nPoints() / 100),
     pointRegionMaster_(mesh.nPoints() / 100),
     freeRegions_()
 {}
@@ -289,6 +295,8 @@ bool Foam::edgeCollapser::unaffectedEdge(const label edgeI) const
 
 bool Foam::edgeCollapser::collapseEdge(const label edgeI, const label master)
 {
+    const pointField& points = mesh_.points();
+
     const edge& e = mesh_.edges()[edgeI];
 
     label pointRegion0 = pointRegion_[e[0]];
@@ -310,7 +318,7 @@ bool Foam::edgeCollapser::collapseEdge(const label edgeI, const label master)
                 {
                     FatalErrorIn
                     ("edgeCollapser::collapseEdge(const label, const label)")
-                        << "Problem : freeed region :" << freeRegion
+                        << "Problem : freed region :" << freeRegion
                         << " has already master "
                         << pointRegionMaster_[freeRegion]
                         << abort(FatalError);
@@ -327,13 +335,22 @@ bool Foam::edgeCollapser::collapseEdge(const label edgeI, const label master)
             pointRegion_[e[1]] = freeRegion;
 
             pointRegionMaster_(freeRegion) = master;
+            pointRegionMasterLocation_(freeRegion) = points[master];
         }
         else
         {
             // e[1] is part of collapse network, e[0] not. Add e0 to e1 region.
             pointRegion_[e[0]] = pointRegion1;
 
-            pointRegionMaster_[pointRegion1] = master;
+            if
+            (
+                pointRegionMaster_[pointRegion1] == e[0]
+             || pointRegionMaster_[pointRegion1] == e[1]
+            )
+            {
+                pointRegionMaster_[pointRegion1] = master;
+                pointRegionMasterLocation_[pointRegion1] = points[master];
+            }
         }
     }
     else
@@ -343,7 +360,15 @@ bool Foam::edgeCollapser::collapseEdge(const label edgeI, const label master)
             // e[0] is part of collapse network. Add e1 to e0 region
             pointRegion_[e[1]] = pointRegion0;
 
-            pointRegionMaster_[pointRegion0] = master;
+            if
+            (
+                pointRegionMaster_[pointRegion0] == e[0]
+             || pointRegionMaster_[pointRegion0] == e[1]
+            )
+            {
+                pointRegionMaster_[pointRegion0] = master;
+                pointRegionMasterLocation_[pointRegion0] = points[master];
+            }
         }
         else if (pointRegion0 != pointRegion1)
         {
@@ -356,6 +381,9 @@ bool Foam::edgeCollapser::collapseEdge(const label edgeI, const label master)
             // Use minRegion as region for combined net, free maxRegion.
             pointRegionMaster_[minRegion] = master;
             pointRegionMaster_[maxRegion] = -1;
+            pointRegionMasterLocation_[minRegion] = points[master];
+            pointRegionMasterLocation_[maxRegion] = point(0, 0, 0);
+
             freeRegions_.insert(maxRegion);
 
             if (minRegion != pointRegion0)
@@ -380,12 +408,61 @@ bool Foam::edgeCollapser::setRefinement(polyTopoChange& meshMod)
     const labelList& faceNeighbour = mesh_.faceNeighbour();
     const labelListList& pointFaces = mesh_.pointFaces();
     const labelListList& cellEdges = mesh_.cellEdges();
+    const pointZoneMesh& pointZones = mesh_.pointZones();
+
 
-    // Print regions:
-    //printRegions()
 
     bool meshChanged = false;
 
+    // Synchronise pointRegionMasterLocation_
+    const globalMeshData& globalData = mesh_.globalData();
+    const mapDistribute& map = globalData.globalPointSlavesMap();
+    const indirectPrimitivePatch& coupledPatch = globalData.coupledPatch();
+    const labelList& meshPoints = coupledPatch.meshPoints();
+    const Map<label>& meshPointMap = coupledPatch.meshPointMap();
+
+
+    List<point> newPoints = coupledPatch.localPoints();
+
+    for (label pI = 0; pI < coupledPatch.nPoints(); ++pI)
+    {
+        const label pointRegionMaster = pointRegion_[meshPoints[pI]];
+
+        if (pointRegionMaster != -1)
+        {
+            newPoints[pI]
+                = pointRegionMasterLocation_[pointRegionMaster];
+        }
+    }
+
+    globalData.syncData
+    (
+        newPoints,
+        globalData.globalPointSlaves(),
+        globalData.globalPointTransformedSlaves(),
+        map,
+        minMagSqrEqOp<point>()
+    );
+
+        OFstream str1("newPoints_" + name(Pstream::myProcNo()) + ".obj");
+        forAll(pointRegion_, pI)
+        {
+            if (meshPointMap.found(pI))
+            {
+                meshTools::writeOBJ(str1, newPoints[meshPointMap[pI]]);
+            }
+        }
+
+    for (label pI = 0; pI < coupledPatch.nPoints(); ++pI)
+    {
+        const label pointRegionMaster = pointRegion_[meshPoints[pI]];
+
+        if (pointRegionMaster != -1)
+        {
+            pointRegionMasterLocation_[pointRegionMaster]
+                = newPoints[pI];
+        }
+    }
 
     // Current faces (is also collapseStatus: f.size() < 3)
     faceList newFaces(mesh_.faces());
@@ -393,7 +470,6 @@ bool Foam::edgeCollapser::setRefinement(polyTopoChange& meshMod)
     // Current cellCollapse status
     boolList cellRemoved(mesh_.nCells(), false);
 
-
     do
     {
         // Update face collapse from edge collapses
@@ -521,12 +597,49 @@ bool Foam::edgeCollapser::setRefinement(polyTopoChange& meshMod)
         }
     }
 
+    // Modify the point location of the remaining points
+    forAll(pointRegion_, pointI)
+    {
+        const label pointRegion = pointRegion_[pointI];
+
+        if
+        (
+            !pointRemoved(pointI)
+         && meshPointMap.found(pointI)
+        )
+        {
+            meshMod.modifyPoint
+            (
+                pointI,
+                newPoints[meshPointMap[pointI]],
+                pointZones.whichZone(pointI),
+                false
+            );
+        }
+        else if
+        (
+            pointRegion != -1
+         && !pointRemoved(pointI)
+         && !meshPointMap.found(pointI)
+        )
+        {
+            const point& collapsePoint
+                = pointRegionMasterLocation_[pointRegion];
+
+            meshMod.modifyPoint
+            (
+                pointI,
+                collapsePoint,
+                pointZones.whichZone(pointI),
+                false
+            );
+        }
+    }
 
 
     const polyBoundaryMesh& boundaryMesh = mesh_.boundaryMesh();
     const faceZoneMesh& faceZones = mesh_.faceZones();
 
-
     // Renumber faces that use points
     forAll(pointRegion_, pointI)
     {
@@ -585,6 +698,9 @@ bool Foam::edgeCollapser::setRefinement(polyTopoChange& meshMod)
         }
     }
 
+    // Print regions:
+//    printRegions();
+
     return meshChanged;
 }
 
@@ -593,8 +709,10 @@ void Foam::edgeCollapser::updateMesh(const mapPolyMesh& map)
 {
     pointRegion_.setSize(mesh_.nPoints());
     pointRegion_ = -1;
+
     // Reset count, do not remove underlying storage
     pointRegionMaster_.clear();
+    pointRegionMasterLocation_.clear();
     freeRegions_.clear();
 }
 
diff --git a/src/dynamicMesh/polyTopoChange/polyTopoChange/edgeCollapser.H b/src/dynamicMesh/polyTopoChange/polyTopoChange/edgeCollapser.H
index 98d8ef30d5bce148647499c65cbcbde299df9fc1..3a10a9319749081af5960967cb6eaf09ec3e17d4 100644
--- a/src/dynamicMesh/polyTopoChange/polyTopoChange/edgeCollapser.H
+++ b/src/dynamicMesh/polyTopoChange/polyTopoChange/edgeCollapser.H
@@ -39,6 +39,7 @@ SourceFiles
 
 #include "labelList.H"
 #include "DynamicList.H"
+#include "point.H"
 #include "typeInfo.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@@ -66,6 +67,10 @@ class edgeCollapser
         //- For every point -1 or region number
         labelList pointRegion_;
 
+        //- Actual location of the point to collapse to for every region master
+        //  point. This will be forced to be consistent across processors
+        DynamicList<point> pointRegionMasterLocation_;
+
         //- -1 or master vertex for region number
         DynamicList<label> pointRegionMaster_;
 
diff --git a/src/fieldSources/Make/files b/src/fieldSources/Make/files
index 1db2de4b5e20ccb80eb676621067c2002e012f4c..f642dd2b65a2e50f0760a1af10b807395346dab6 100644
--- a/src/fieldSources/Make/files
+++ b/src/fieldSources/Make/files
@@ -29,4 +29,6 @@ $(interRegion)/constantHeatTransfer/constantHeatTransfer.C
 $(interRegion)/tabulatedHeatTransfer/tabulatedHeatTransfer.C
 $(interRegion)/variableHeatTransfer/variableHeatTransfer.C
 
+basicSource/codedSource/codedSource.C
+
 LIB = $(FOAM_LIBBIN)/libfieldSources
diff --git a/src/fieldSources/basicSource/codedSource/CodedSource.C b/src/fieldSources/basicSource/codedSource/CodedSource.C
new file mode 100644
index 0000000000000000000000000000000000000000..b379123e87a02524442c1c5f4a3afa6b5f0edb67
--- /dev/null
+++ b/src/fieldSources/basicSource/codedSource/CodedSource.C
@@ -0,0 +1,206 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "CodedSource.H"
+#include "fvMesh.H"
+#include "fvMatrices.H"
+#include "dynamicCode.H"
+#include "dynamicCodeContext.H"
+
+// * * * * * * * * * * * * Protected Member Functions  * * * * * * * * * * * //
+
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+template<class Type>
+void Foam::CodedSource<Type>::prepare
+(
+    dynamicCode& dynCode,
+    const dynamicCodeContext& context
+) const
+{
+    word sourceType(pTraits<Type>::typeName);
+
+    // Set additional rewrite rules
+    dynCode.setFilterVariable("typeName", redirectType_);
+    dynCode.setFilterVariable("TemplateType", sourceType);
+    dynCode.setFilterVariable("SourceType", sourceType + "Source");
+
+    //dynCode.removeFilterVariable("code");
+    dynCode.setFilterVariable("codeCorrect", codeCorrect_);
+    dynCode.setFilterVariable("codeAddSup", codeAddSup_);
+    dynCode.setFilterVariable("codeSetValue", codeSetValue_);
+
+    // compile filtered C template
+    dynCode.addCompileFile("codedBasicSourceTemplate.C");
+
+    // copy filtered H template
+    dynCode.addCopyFile("codedBasicSourceTemplate.H");
+
+    // debugging: make BC verbose
+    //         dynCode.setFilterVariable("verbose", "true");
+    //         Info<<"compile " << redirectType_ << " sha1: "
+    //             << context.sha1() << endl;
+
+    // define Make/options
+    dynCode.setMakeOptions
+        (
+            "EXE_INC = -g \\\n"
+            "-I$(LIB_SRC)/fieldSources/lnInclude \\\n"
+            "-I$(LIB_SRC)/finiteVolume/lnInclude \\\n"
+            "-I$(LIB_SRC)/meshTools/lnInclude \\\n"
+            "-I$(LIB_SRC)/sampling/lnInclude \\\n"
+            + context.options()
+            + "\n\nLIB_LIBS = \\\n"
+            + "    -lmeshTools \\\n"
+            + "    -lfieldSources \\\n"
+            + "    -lsampling \\\n"
+            + "    -lfiniteVolume \\\n"
+            + context.libs()
+        );
+}
+
+
+template<class Type>
+Foam::dlLibraryTable& Foam::CodedSource<Type>::libs() const
+{
+    return const_cast<Time&>(mesh_.time()).libs();
+}
+
+
+template<class Type>
+Foam::string Foam::CodedSource<Type>::description() const
+{
+    return "basicSource " + name_;
+}
+
+
+template<class Type>
+void Foam::CodedSource<Type>::clearRedirect() const
+{
+    redirectBasicSourcePtr_.clear();
+}
+
+
+template<class Type>
+const Foam::dictionary& Foam::CodedSource<Type>::codeDict() const
+{
+    return coeffs_;
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::CodedSource<Type>::CodedSource
+(
+    const word& name,
+    const word& modelType,
+    const dictionary& dict,
+    const fvMesh& mesh
+)
+:
+    basicSource(name, modelType, dict, mesh)
+{
+    read(dict);
+}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::basicSource& Foam::CodedSource<Type>::redirectBasicSource()
+const
+{
+    if (!redirectBasicSourcePtr_.valid())
+    {
+        dictionary constructDict(dict_);
+        constructDict.set("type", redirectType_);
+
+        redirectBasicSourcePtr_ = basicSource::New
+        (
+            redirectType_,
+            constructDict,
+            mesh_
+        );
+    }
+    return redirectBasicSourcePtr_();
+}
+
+
+template<class Type>
+void Foam::CodedSource<Type>::correct
+(
+    GeometricField<Type, fvPatchField, volMesh>& fld
+)
+{
+    if (debug)
+    {
+        Info<< "CodedSource<"<< pTraits<Type>::typeName
+            << ">::correct for source " << name_ << endl;
+    }
+
+    updateLibrary(redirectType_);
+    redirectBasicSource().correct(fld);
+}
+
+
+template<class Type>
+void Foam::CodedSource<Type>::addSup
+(
+    fvMatrix<Type>& eqn,
+    const label fieldI
+)
+{
+    if (debug)
+    {
+        Info<< "CodedSource<"<< pTraits<Type>::typeName
+            << ">::addSup for source " << name_ << endl;
+    }
+
+    updateLibrary(redirectType_);
+    redirectBasicSource().addSup(eqn, fieldI);
+}
+
+
+template<class Type>
+void Foam::CodedSource<Type>::setValue
+(
+    fvMatrix<Type>& eqn,
+    const label fieldI
+)
+{
+    if (debug)
+    {
+        Info<< "CodedSource<"<< pTraits<Type>::typeName
+            << ">::setValue for source " << name_ << endl;
+    }
+
+    updateLibrary(redirectType_);
+    redirectBasicSource().setValue(eqn, fieldI);
+}
+
+
+// ************************************************************************* //
diff --git a/src/fieldSources/basicSource/codedSource/CodedSource.H b/src/fieldSources/basicSource/codedSource/CodedSource.H
new file mode 100644
index 0000000000000000000000000000000000000000..66ad2cdb5c4e6006a5b8b5318ce444fb4d895321
--- /dev/null
+++ b/src/fieldSources/basicSource/codedSource/CodedSource.H
@@ -0,0 +1,205 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::codedSource
+
+Description
+    Constructs on-the-fly a new basicSource.
+
+    E.g. in constant/sourcesProperties
+
+    momentumSource
+    {
+        type            vectorCodedSource;
+        active          on;            //on/off switch
+        timeStart       0.0;           //start time
+        duration        1000000.0;     //duration
+        selectionMode   all;       //cellSet // points //cellZone
+
+        vectorCodedSourceCoeffs
+        {
+            fieldNames  (U);
+            redirectType    ramp;
+
+            codeCorrect
+            #{
+                Pout<< "**codeCorrect**" << endl;
+            #};
+
+            codeAddSup
+            #{
+                Pout<< "**codeAddSup**" << endl;
+            #};
+
+            codeSetValue
+            #{
+                Pout<< "**codeSetValue**" << endl;
+            #};
+
+            // Dummy entry. Make dependent on above to trigger recompilation
+            code
+            #{
+                $codeCorrect
+                $codeAddSup
+                $codeSetValue
+            #};
+        }
+
+        // Dummy entry
+        rampCoeffs
+        {}
+    }
+
+
+SourceFiles
+    codedSource.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef CodedSource_H
+#define CodedSource_H
+
+#include "basicSource.H"
+#include "codedBase.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                       Class codedSource Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class Type>
+class CodedSource
+:
+    public basicSource,
+    public codedBase
+{
+
+protected:
+
+    // Protected data
+
+        word redirectType_;
+
+        string codeCorrect_;
+        string codeAddSup_;
+        string codeSetValue_;
+
+        //- Underlying functionObject
+        mutable autoPtr<basicSource> redirectBasicSourcePtr_;
+
+
+    // Protected Member Functions
+
+        //- get the loaded dynamic libraries
+        virtual dlLibraryTable& libs() const;
+
+        //- adapt the context for the current object
+        virtual void prepare(dynamicCode &,const dynamicCodeContext&) const;
+
+        // Return a description (type + name) for the output
+        virtual string description() const;
+
+        // Clear any redirected objects
+        virtual void clearRedirect() const;
+
+        // Get the dictionary to initialize the codeContext
+        virtual const dictionary& codeDict() const;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("coded");
+
+
+    // Constructors
+
+        //- Construct from components
+        CodedSource
+        (
+            const word& name,
+            const word& modelType,
+            const dictionary& dict,
+            const fvMesh& mesh
+        );
+
+
+    // Member Functions
+
+        //- Dynamically compiled basicSource
+        basicSource& redirectBasicSource() const;
+
+        // Evaluation
+
+            //- Correct field
+            virtual void correct
+            (
+                GeometricField<Type, fvPatchField, volMesh>&
+            );
+
+            //- Explicit and implicit matrix contributions
+            virtual void addSup
+            (
+                fvMatrix<Type>& eqn,
+                const label fieldI
+            );
+
+            //- Set value
+            virtual void setValue
+            (
+                fvMatrix<Type>& eqn,
+                const label fieldI
+            );
+
+
+        // I-O
+
+            //- Write the source properties
+            virtual void writeData(Ostream&) const;
+
+            //- Read source dictionary
+            virtual bool read(const dictionary& dict);
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "CodedSource.C"
+#   include "CodedSourceIO.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/fieldSources/basicSource/codedSource/CodedSourceIO.C b/src/fieldSources/basicSource/codedSource/CodedSourceIO.C
new file mode 100644
index 0000000000000000000000000000000000000000..77075bba3e1b98d8a03a88022ab2f68979b37d03
--- /dev/null
+++ b/src/fieldSources/basicSource/codedSource/CodedSourceIO.C
@@ -0,0 +1,109 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "CodedSource.H"
+#include "stringOps.H"
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class Type>
+void Foam::CodedSource<Type>::writeData(Ostream& os) const
+{
+    os  << indent << name_ << endl;
+    dict_.write(os);
+}
+
+
+template<class Type>
+bool Foam::CodedSource<Type>::read(const dictionary& dict)
+{
+    if (basicSource::read(dict))
+    {
+        coeffs_.lookup("fieldNames") >> fieldNames_;
+        applied_.setSize(fieldNames_.size(), false);
+        coeffs_.lookup("redirectType") >> redirectType_;
+
+        // Code snippets
+        {
+            const entry& e = coeffs_.lookupEntry
+            (
+                "codeCorrect",
+                false,
+                false
+            );
+            codeCorrect_ = stringOps::trim(e.stream());
+            stringOps::inplaceExpand(codeCorrect_, coeffs_);
+            dynamicCodeContext::addLineDirective
+            (
+                codeCorrect_,
+                e.startLineNumber(),
+                coeffs_.name()
+            );
+        }
+
+        {
+            const entry& e = coeffs_.lookupEntry
+            (
+                "codeAddSup",
+                false,
+                false
+            );
+            codeAddSup_ = stringOps::trim(e.stream());
+            stringOps::inplaceExpand(codeAddSup_, coeffs_);
+            dynamicCodeContext::addLineDirective
+            (
+                codeAddSup_,
+                e.startLineNumber(),
+                coeffs_.name()
+            );
+        }
+
+        {
+            const entry& e = coeffs_.lookupEntry
+            (
+                "codeSetValue",
+                false,
+                false
+            );
+            codeSetValue_ = stringOps::trim(e.stream());
+            stringOps::inplaceExpand(codeSetValue_, coeffs_);
+            dynamicCodeContext::addLineDirective
+            (
+                codeSetValue_,
+                e.startLineNumber(),
+                coeffs_.name()
+            );
+        }
+
+        return true;
+    }
+    else
+    {
+        return false;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/src/fieldSources/basicSource/codedSource/codedSource.C b/src/fieldSources/basicSource/codedSource/codedSource.C
new file mode 100644
index 0000000000000000000000000000000000000000..5fd9d3cdb303e5c7c7a8c724afdab8cf068d5ec8
--- /dev/null
+++ b/src/fieldSources/basicSource/codedSource/codedSource.C
@@ -0,0 +1,41 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "makeBasicSource.H"
+#include "CodedSource.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    makeBasicSource(CodedSource, scalar);
+    makeBasicSource(CodedSource, vector);
+    makeBasicSource(CodedSource, sphericalTensor);
+    makeBasicSource(CodedSource, symmTensor);
+    makeBasicSource(CodedSource, tensor);
+}
+
+
+// ************************************************************************* //
diff --git a/src/fieldSources/basicSource/interRegionHeatTransferModel/interRegionHeatTransferModel/interRegionHeatTransferModel.H b/src/fieldSources/basicSource/interRegionHeatTransferModel/interRegionHeatTransferModel/interRegionHeatTransferModel.H
index 38c8141bed017e28b0a94f286fdadd2a44bcaf8f..9a521f459d33d85f7b29e4899c27762cdf92791f 100644
--- a/src/fieldSources/basicSource/interRegionHeatTransferModel/interRegionHeatTransferModel/interRegionHeatTransferModel.H
+++ b/src/fieldSources/basicSource/interRegionHeatTransferModel/interRegionHeatTransferModel/interRegionHeatTransferModel.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -49,7 +49,7 @@ namespace Foam
 
 class interRegionHeatTransferModel
 :
-    public  basicSource
+    public basicSource
 {
 
 private:
diff --git a/src/finiteVolume/fields/fvPatchFields/derived/cylindricalInletVelocity/cylindricalInletVelocityFvPatchVectorField.C b/src/finiteVolume/fields/fvPatchFields/derived/cylindricalInletVelocity/cylindricalInletVelocityFvPatchVectorField.C
index 638323c47b64b4b5baeec9f3d25c568474678d4e..0348035314a56cd6c69b6812065d92c2e93695e3 100644
--- a/src/finiteVolume/fields/fvPatchFields/derived/cylindricalInletVelocity/cylindricalInletVelocityFvPatchVectorField.C
+++ b/src/finiteVolume/fields/fvPatchFields/derived/cylindricalInletVelocity/cylindricalInletVelocityFvPatchVectorField.C
@@ -139,7 +139,7 @@ void Foam::cylindricalInletVelocityFvPatchVectorField::updateCoeffs()
         (rpm*constant::mathematical::pi/30.0)*(hatAxis) ^ d
     );
 
-    operator==(tangVel + axis_*axialVelocity + radialVelocity*d);
+    operator==(tangVel + hatAxis*axialVelocity + radialVelocity*d/mag(d));
 
     fixedValueFvPatchField<vector>::updateCoeffs();
 }
diff --git a/src/finiteVolume/fvMatrices/fvMatrix/fvMatrix.C b/src/finiteVolume/fvMatrices/fvMatrix/fvMatrix.C
index 3e65f5d1c23eeb60c89043ab10e6d127ea4d251a..87a6647ca9cda019b499c4757498da6f2c452c62 100644
--- a/src/finiteVolume/fvMatrices/fvMatrix/fvMatrix.C
+++ b/src/finiteVolume/fvMatrices/fvMatrix/fvMatrix.C
@@ -841,25 +841,23 @@ Foam::tmp<Foam::volScalarField> Foam::fvMatrix<Type>::H1() const
     );
     volScalarField& H1_ = tH1();
 
-    // Loop over field components
-    /*
-    for (direction cmpt=0; cmpt<Type::nComponents; cmpt++)
-    {
-        scalarField psiCmpt(psi_.internalField().component(cmpt));
+    H1_.internalField() = lduMatrix::H1();
 
-        scalarField boundaryDiagCmpt(psi_.size(), 0.0);
-        addBoundaryDiag(boundaryDiagCmpt, cmpt);
-        boundaryDiagCmpt.negate();
-        addCmptAvBoundaryDiag(boundaryDiagCmpt);
+    forAll(psi_.boundaryField(), patchI)
+    {
+        const fvPatchField<Type>& ptf = psi_.boundaryField()[patchI];
 
-        H1_.internalField().replace(cmpt, boundaryDiagCmpt);
+        if (ptf.coupled() && ptf.size())
+        {
+            addToInternalField
+            (
+                lduAddr().patchAddr(patchI),
+                boundaryCoeffs_[patchI].component(0),
+                H1_
+            );
+        }
     }
 
-    H1_.internalField() += lduMatrix::H1();
-    */
-
-    H1_.internalField() = lduMatrix::H1();
-
     H1_.internalField() /= psi_.mesh().V();
     H1_.correctBoundaryConditions();
 
diff --git a/src/regionModels/pyrolysisModels/noPyrolysis/noPyrolysis.C b/src/regionModels/pyrolysisModels/noPyrolysis/noPyrolysis.C
index dd779a7d4ec6099a3c7611370d618a0caa02238a..99b19f0ad85b5f636940c6c1039d3138a66583dc 100644
--- a/src/regionModels/pyrolysisModels/noPyrolysis/noPyrolysis.C
+++ b/src/regionModels/pyrolysisModels/noPyrolysis/noPyrolysis.C
@@ -151,15 +151,15 @@ const tmp<volScalarField> noPyrolysis::Cp() const
 }
 
 
-const volScalarField& noPyrolysis::kappa() const
+const volScalarField& noPyrolysis::kappaRad() const
 {
-    return (solidThermo_->kappa());
+    return (solidThermo_->kappaRad());
 }
 
 
-const volScalarField& noPyrolysis::K() const
+const volScalarField& noPyrolysis::kappa() const
 {
-     return (solidThermo_->K());
+     return (solidThermo_->kappa());
 }
 
 
diff --git a/src/regionModels/pyrolysisModels/noPyrolysis/noPyrolysis.H b/src/regionModels/pyrolysisModels/noPyrolysis/noPyrolysis.H
index 7a32de6a99e7752ca0c8e65c87298b16709bac39..0be1645fa63fc880300605074ebcc761190d4b68 100644
--- a/src/regionModels/pyrolysisModels/noPyrolysis/noPyrolysis.H
+++ b/src/regionModels/pyrolysisModels/noPyrolysis/noPyrolysis.H
@@ -124,10 +124,10 @@ public:
             virtual const tmp<volScalarField> Cp() const;
 
             //- Return the region absorptivity [1/m]
-            virtual const volScalarField& kappa() const;
+            virtual const volScalarField& kappaRad() const;
 
             //- Return the region thermal conductivity [W/m/k]
-            virtual const volScalarField& K() const;
+            virtual const volScalarField& kappa() const;
 
             //- Return the total gas mass flux to primary region [kg/m2/s]
             virtual const surfaceScalarField& phiGas() const;
diff --git a/src/regionModels/pyrolysisModels/pyrolysisModel/pyrolysisModel.H b/src/regionModels/pyrolysisModels/pyrolysisModel/pyrolysisModel.H
index 90ca858763b742b6122fd00519d0a89fe6c59386..42305f06bb9add5d9dcdd15661c96839ae1df22d 100644
--- a/src/regionModels/pyrolysisModels/pyrolysisModel/pyrolysisModel.H
+++ b/src/regionModels/pyrolysisModels/pyrolysisModel/pyrolysisModel.H
@@ -218,10 +218,10 @@ public:
                 virtual const tmp<volScalarField> Cp() const = 0;
 
                 //- Return the region absorptivity [1/m]
-                virtual const volScalarField& kappa() const = 0;
+                virtual const volScalarField& kappaRad() const = 0;
 
                 //- Return the region thermal conductivity [W/m/k]
-                virtual const volScalarField& K() const = 0;
+                virtual const volScalarField& kappa() const = 0;
 
                 //- Return the total gas mass flux to primary region [kg/m2/s]
                 virtual const surfaceScalarField& phiGas() const = 0;
diff --git a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C
index 50860533448280ea9f190aa68971346b7234da02..eb99d400677b223e83317e52f36fd73e89709243 100644
--- a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C
+++ b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C
@@ -126,7 +126,7 @@ void reactingOneDim::updateQr()
                 const label cellI = cells[k];
                 const point& Cf1 = regionMesh().cellCentres()[cellI];
                 const scalar delta = mag(Cf1 - Cf0);
-                kappaInt += kappa_[cellI]*delta;
+                kappaInt += kappaRad_[cellI]*delta;
                 Qr_[cellI] = Qr0*exp(-kappaInt);
                 Cf0 = Cf1;
             }
@@ -294,7 +294,7 @@ void reactingOneDim::solveEnergy()
     fvScalarMatrix TEqn
     (
         fvm::ddt(rhoCp, T_)
-      - fvm::laplacian(K_, T_)
+      - fvm::laplacian(kappa_, T_)
      ==
         chemistrySh_
       + fvc::div(phiQr)
@@ -347,8 +347,8 @@ reactingOneDim::reactingOneDim(const word& modelType, const fvMesh& mesh)
     pyrolysisModel(modelType, mesh),
     solidChemistry_(solidChemistryModel::New(regionMesh())),
     solidThermo_(solidChemistry_->solidThermo()),
+    kappaRad_(solidThermo_.kappaRad()),
     kappa_(solidThermo_.kappa()),
-    K_(solidThermo_.K()),
     rho_(solidThermo_.rho()),
     Ys_(solidThermo_.composition().Y()),
     T_(solidThermo_.T()),
@@ -449,8 +449,8 @@ reactingOneDim::reactingOneDim
     pyrolysisModel(modelType, mesh, dict),
     solidChemistry_(solidChemistryModel::New(regionMesh())),
     solidThermo_(solidChemistry_->solidThermo()),
+    kappaRad_(solidThermo_.kappaRad()),
     kappa_(solidThermo_.kappa()),
-    K_(solidThermo_.K()),
     rho_(solidThermo_.rho()),
     Ys_(solidThermo_.composition().Y()),
     T_(solidThermo_.T()),
@@ -584,7 +584,7 @@ scalar reactingOneDim::solidRegionDiffNo() const
         surfaceScalarField KrhoCpbyDelta
         (
             regionMesh().surfaceInterpolation::deltaCoeffs()
-          * fvc::interpolate(K_)
+          * fvc::interpolate(kappa_)
           / fvc::interpolate(Cp()*rho_)
         );
 
@@ -619,15 +619,15 @@ const tmp<volScalarField> reactingOneDim::Cp() const
 }
 
 
-const volScalarField& reactingOneDim::kappa() const
+const volScalarField& reactingOneDim::kappaRad() const
 {
-    return kappa_;
+    return kappaRad_;
 }
 
 
-const volScalarField& reactingOneDim::K() const
+const volScalarField& reactingOneDim::kappa() const
 {
-    return K_;
+    return kappa_;
 }
 
 
diff --git a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.H b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.H
index ed1bd9fa0dc65d4d59c54b758683eaef73cb0928..8cfcc7ce745b1be956889d8c5d725cc6e3a5c152 100644
--- a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.H
+++ b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.H
@@ -84,10 +84,10 @@ protected:
         // Reference to solid thermo properties
 
             //- Absorption coefficient [1/m]
-            const volScalarField& kappa_;
+            const volScalarField& kappaRad_;
 
             //- Thermal conductivity [W/m/K]
-            const volScalarField& K_;
+            const volScalarField& kappa_;
 
             //- Density [kg/m3]
             volScalarField& rho_;
@@ -230,10 +230,10 @@ public:
                 virtual const tmp<volScalarField> Cp() const;
 
                 //- Return the region absorptivity [1/m]
-                virtual const volScalarField& kappa() const;
+                virtual const volScalarField& kappaRad() const;
 
                 //- Return the region thermal conductivity [W/m/k]
-                virtual const volScalarField& K() const;
+                virtual const volScalarField& kappa() const;
 
                 //- Return the total gas mass flux to primary region [kg/m2/s]
                 virtual const surfaceScalarField& phiGas() const;
diff --git a/src/regionModels/thermoBaffleModels/derivedFvPatchFields/temperatureThermoBaffle/temperatureThermoBaffleFvPatchScalarField.H b/src/regionModels/thermoBaffleModels/derivedFvPatchFields/temperatureThermoBaffle/temperatureThermoBaffleFvPatchScalarField.H
index 83e3162c5765c6372e9df79250f6a0574a62ac7b..980fc859359d36790a4093ad788f83b77af5a411 100644
--- a/src/regionModels/thermoBaffleModels/derivedFvPatchFields/temperatureThermoBaffle/temperatureThermoBaffleFvPatchScalarField.H
+++ b/src/regionModels/thermoBaffleModels/derivedFvPatchFields/temperatureThermoBaffle/temperatureThermoBaffleFvPatchScalarField.H
@@ -35,7 +35,7 @@ Description
 
     // Coupled BC.
     neighbourFieldName  T;
-    K                   basicThermo;
+    kappa               basicThermo;
     KName               none;
 
 
@@ -57,10 +57,10 @@ Description
         //- thermo properties
         rho rho [1 -3  0  0 0 0 0]              80;
         Cp  Cp  [0  2 -2 -1 0 0 0]              15;
-        K   K   [1  1 -3 -1 0 0 0]              0.01;
+        kappa   kappa   [1  1 -3 -1 0 0 0]      0.01;
 
         //- radiative properties
-        kappa kappa [0 -1 0 0 0 0 0]            0;
+        kappaRad  kappaRad [0 -1 0 0 0 0 0]     0;
         sigmaS sigmaS [0 -1 0 0 0 0 0]          0;
         emissivity  emissivity  [0 0 0 0 0 0 0] 1;
 
diff --git a/src/regionModels/thermoBaffleModels/noThermo/noThermo.C b/src/regionModels/thermoBaffleModels/noThermo/noThermo.C
index 0d78e27cbcac11a57a2d2dbb36fcfdf1f897c902..28214923b844673c5e99ce82ae639a530fbbc3b9 100644
--- a/src/regionModels/thermoBaffleModels/noThermo/noThermo.C
+++ b/src/regionModels/thermoBaffleModels/noThermo/noThermo.C
@@ -95,9 +95,9 @@ const tmp<volScalarField> noThermo::Cp() const
     );
 }
 
-const volScalarField& noThermo::kappa() const
+const volScalarField& noThermo::kappaRad() const
 {
-    FatalErrorIn("const volScalarField& noThermo::kappa() const")
+    FatalErrorIn("const volScalarField& noThermo::kappaRad() const")
         << "kappa field not available for " << type() << abort(FatalError);
     return volScalarField::null();
 }
@@ -111,9 +111,9 @@ const volScalarField& noThermo::rho() const
 }
 
 
-const volScalarField& noThermo::K() const
+const volScalarField& noThermo::kappa() const
 {
-   FatalErrorIn("const volScalarField& noThermo::K() const")
+   FatalErrorIn("const volScalarField& noThermo::kappa() const")
         << "K field not available for " << type() << abort(FatalError);
     return volScalarField::null();
 }
diff --git a/src/regionModels/thermoBaffleModels/noThermo/noThermo.H b/src/regionModels/thermoBaffleModels/noThermo/noThermo.H
index 053519162e3bcc2aa19a39622a5cafe688ea9b80..f816e0fac375904b4fe2e03c5c4acb343bbc1b53 100644
--- a/src/regionModels/thermoBaffleModels/noThermo/noThermo.H
+++ b/src/regionModels/thermoBaffleModels/noThermo/noThermo.H
@@ -105,7 +105,7 @@ public:
             virtual const tmp<volScalarField> Cp() const;
 
             //- Return solid absortivity [1/m]
-            virtual const volScalarField& kappa() const;
+            virtual const volScalarField& kappaRad() const;
 
             //- Return the film mean temperature [K]
             virtual const volScalarField& T() const;
@@ -114,7 +114,7 @@ public:
             virtual const volScalarField& rho() const;
 
             //- Return thermal conductivity [W/m/K]
-            virtual const volScalarField& K() const;
+            virtual const volScalarField& kappa() const;
 
 
         // Evolution
diff --git a/src/regionModels/thermoBaffleModels/thermoBaffle2D/thermoBaffle2D.C b/src/regionModels/thermoBaffleModels/thermoBaffle2D/thermoBaffle2D.C
index d251bc64e034fdcd28f8f59ba516d0f1e0ab0177..9f5a19b3aeabff188d3b17072116c3ed64c42428 100644
--- a/src/regionModels/thermoBaffleModels/thermoBaffle2D/thermoBaffle2D.C
+++ b/src/regionModels/thermoBaffleModels/thermoBaffle2D/thermoBaffle2D.C
@@ -96,7 +96,7 @@ void thermoBaffle2D::solveEnergy()
     volScalarField& Q = tQ();
 
     volScalarField rhoCp("rhoCp", thermo_->rho()*thermo_->Cp()());
-    volScalarField K("K", thermo_->K());
+    volScalarField kappa("kappa", thermo_->kappa());
 
 
     //If region is one-dimension variable thickness
@@ -119,7 +119,7 @@ void thermoBaffle2D::solveEnergy()
 
                 rhoCp[cellId] *= delta_.value()/thickness_[localFaceI];
 
-                K[cellId] *= delta_.value()/thickness_[localFaceI];
+                kappa[cellId] *= delta_.value()/thickness_[localFaceI];
             }
         }
     }
@@ -131,7 +131,7 @@ void thermoBaffle2D::solveEnergy()
     fvScalarMatrix TEqn
     (
         fvm::ddt(rhoCp, T_)
-      - fvm::laplacian(K, T_)
+      - fvm::laplacian(kappa, T_)
      ==
         Q
     );
@@ -316,9 +316,9 @@ const tmp<volScalarField> thermoBaffle2D::Cp() const
 }
 
 
-const volScalarField& thermoBaffle2D::kappa() const
+const volScalarField& thermoBaffle2D::kappaRad() const
 {
-    return thermo_->kappa();
+    return thermo_->kappaRad();
 }
 
 
@@ -328,9 +328,9 @@ const volScalarField& thermoBaffle2D::rho() const
 }
 
 
-const volScalarField& thermoBaffle2D::K() const
+const volScalarField& thermoBaffle2D::kappa() const
 {
-    return thermo_->K();
+    return thermo_->kappa();
 }
 
 
@@ -362,7 +362,7 @@ void thermoBaffle2D::info() const
             (
                 mag(regionMesh().Sf().boundaryField()[patchI])
               * pT.snGrad()
-              * thermo_->K(patchI)
+              * thermo_->kappa(patchI)
             ) << endl;
     }
 }
diff --git a/src/regionModels/thermoBaffleModels/thermoBaffle2D/thermoBaffle2D.H b/src/regionModels/thermoBaffleModels/thermoBaffle2D/thermoBaffle2D.H
index bf915ec1a20d2999439f02675a1eb49de02dadcf..ac7fdc1cc5b3df93a8daa9c650c4bc76757a71a4 100644
--- a/src/regionModels/thermoBaffleModels/thermoBaffle2D/thermoBaffle2D.H
+++ b/src/regionModels/thermoBaffleModels/thermoBaffle2D/thermoBaffle2D.H
@@ -155,7 +155,7 @@ public:
                 virtual const tmp<volScalarField> Cp() const;
 
                 //- Return solid absortivity [1/m]
-                virtual const volScalarField& kappa() const;
+                virtual const volScalarField& kappaRad() const;
 
                 //- Return the film mean temperature [K]
                 virtual const volScalarField& T() const;
@@ -164,7 +164,7 @@ public:
                 virtual const volScalarField& rho() const;
 
                 //- Return thermal conductivity [W/m/K]
-                virtual const volScalarField& K() const;
+                virtual const volScalarField& kappa() const;
 
 
             // Helper functions
diff --git a/src/regionModels/thermoBaffleModels/thermoBaffleModel/thermoBaffleModel.H b/src/regionModels/thermoBaffleModels/thermoBaffleModel/thermoBaffleModel.H
index ee076ec523081a454c81cd89c4bb9c71f1b49076..a5a6cfef7ccc234cae224e01dd645dcfc21977bc 100644
--- a/src/regionModels/thermoBaffleModels/thermoBaffleModel/thermoBaffleModel.H
+++ b/src/regionModels/thermoBaffleModels/thermoBaffleModel/thermoBaffleModel.H
@@ -211,10 +211,10 @@ public:
                 virtual const tmp<volScalarField> Cp() const = 0;
 
                 //- Return the region absorptivity [1/m]
-                virtual const volScalarField& kappa() const = 0;
+                virtual const volScalarField& kappaRad() const = 0;
 
                 //- Return the region thermal conductivity [W/m/k]
-                virtual const volScalarField& K() const = 0;
+                virtual const volScalarField& kappa() const = 0;
 
 
         // Evolution
diff --git a/src/thermophysicalModels/basic/mixtures/basicMixture/basicMixtures.C b/src/thermophysicalModels/basic/mixtures/basicMixture/basicMixtures.C
index d140d3dcf137eea3e38d0825a1a221b4819e154e..7239d8d332ca0e211c87bf416308a4e84e7898a3 100644
--- a/src/thermophysicalModels/basic/mixtures/basicMixture/basicMixtures.C
+++ b/src/thermophysicalModels/basic/mixtures/basicMixture/basicMixtures.C
@@ -32,6 +32,7 @@ Description
 #include "makeBasicMixture.H"
 
 #include "perfectGas.H"
+#include "pressurePerfectGas.H"
 #include "incompressible.H"
 
 #include "eConstThermo.H"
@@ -119,6 +120,30 @@ makeBasicPolyMixture
     8
 );
 
+makeBasicMixture
+(
+    pureMixture,
+    constTransport,
+    hConstThermo,
+    pressurePerfectGas
+);
+
+makeBasicMixture
+(
+    pureMixture,
+    sutherlandTransport,
+    hConstThermo,
+    pressurePerfectGas
+);
+
+makeBasicMixture
+(
+    pureMixture,
+    sutherlandTransport,
+    janafThermo,
+    pressurePerfectGas
+);
+
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
 } // End namespace Foam
diff --git a/src/thermophysicalModels/basic/psiThermo/ePsiThermo/ePsiThermo.C b/src/thermophysicalModels/basic/psiThermo/ePsiThermo/ePsiThermo.C
index b883fb85bdcb340aab2b2e42402932c5a0e4814e..3bc235103305ec99bc06d1a4c063ffd856ad4b3d 100644
--- a/src/thermophysicalModels/basic/psiThermo/ePsiThermo/ePsiThermo.C
+++ b/src/thermophysicalModels/basic/psiThermo/ePsiThermo/ePsiThermo.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -49,7 +49,7 @@ void Foam::ePsiThermo<MixtureType>::calculate()
         psiCells[celli] = mixture_.psi(pCells[celli], TCells[celli]);
 
         muCells[celli] = mixture_.mu(TCells[celli]);
-        alphaCells[celli] = mixture_.alpha(TCells[celli]);
+        alphaCells[celli] = mixture_.alphae(TCells[celli]);
     }
 
     forAll(this->T_.boundaryField(), patchi)
@@ -74,7 +74,7 @@ void Foam::ePsiThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 pmu[facei] = mixture_.mu(pT[facei]);
-                palpha[facei] = mixture_.alpha(pT[facei]);
+                palpha[facei] = mixture_.alphae(pT[facei]);
             }
         }
         else
@@ -88,7 +88,7 @@ void Foam::ePsiThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 pmu[facei] = mixture_.mu(pT[facei]);
-                palpha[facei] = mixture_.alpha(pT[facei]);
+                palpha[facei] = mixture_.alphae(pT[facei]);
             }
         }
     }
diff --git a/src/thermophysicalModels/basic/psiThermo/hPsiThermo/hPsiThermo.C b/src/thermophysicalModels/basic/psiThermo/hPsiThermo/hPsiThermo.C
index 991e3d11a4393d77fd090c5be5a038b7487c8da1..7f4d0fe1887fd55d1da3c260c10346443f93b8e8 100644
--- a/src/thermophysicalModels/basic/psiThermo/hPsiThermo/hPsiThermo.C
+++ b/src/thermophysicalModels/basic/psiThermo/hPsiThermo/hPsiThermo.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -47,7 +47,7 @@ void Foam::hPsiThermo<MixtureType>::calculate()
         psiCells[celli] = mixture_.psi(pCells[celli], TCells[celli]);
 
         muCells[celli] = mixture_.mu(TCells[celli]);
-        alphaCells[celli] = mixture_.alpha(TCells[celli]);
+        alphaCells[celli] = mixture_.alphah(TCells[celli]);
     }
 
     forAll(T_.boundaryField(), patchi)
@@ -72,7 +72,7 @@ void Foam::hPsiThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 pmu[facei] = mixture_.mu(pT[facei]);
-                palpha[facei] = mixture_.alpha(pT[facei]);
+                palpha[facei] = mixture_.alphah(pT[facei]);
             }
         }
         else
@@ -86,7 +86,7 @@ void Foam::hPsiThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 pmu[facei] = mixture_.mu(pT[facei]);
-                palpha[facei] = mixture_.alpha(pT[facei]);
+                palpha[facei] = mixture_.alphah(pT[facei]);
             }
         }
     }
diff --git a/src/thermophysicalModels/basic/psiThermo/hsPsiThermo/hsPsiThermo.C b/src/thermophysicalModels/basic/psiThermo/hsPsiThermo/hsPsiThermo.C
index 28ce2749d2585e5b27f2d9cc6b3576e37b1027ed..a8010f8700f2721bd80c86a9843db5ed7c8ee429 100644
--- a/src/thermophysicalModels/basic/psiThermo/hsPsiThermo/hsPsiThermo.C
+++ b/src/thermophysicalModels/basic/psiThermo/hsPsiThermo/hsPsiThermo.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -47,7 +47,7 @@ void Foam::hsPsiThermo<MixtureType>::calculate()
         psiCells[celli] = mixture_.psi(pCells[celli], TCells[celli]);
 
         muCells[celli] = mixture_.mu(TCells[celli]);
-        alphaCells[celli] = mixture_.alpha(TCells[celli]);
+        alphaCells[celli] = mixture_.alphah(TCells[celli]);
     }
 
     forAll(T_.boundaryField(), patchi)
@@ -72,7 +72,7 @@ void Foam::hsPsiThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 pmu[facei] = mixture_.mu(pT[facei]);
-                palpha[facei] = mixture_.alpha(pT[facei]);
+                palpha[facei] = mixture_.alphah(pT[facei]);
             }
         }
         else
@@ -86,7 +86,7 @@ void Foam::hsPsiThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 pmu[facei] = mixture_.mu(pT[facei]);
-                palpha[facei] = mixture_.alpha(pT[facei]);
+                palpha[facei] = mixture_.alphah(pT[facei]);
             }
         }
     }
diff --git a/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermo.C b/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermo.C
index 9d3f3c2ba7a94fefabf0ef00b383ad3367d0c81d..e2e7503cfc938a1681a55fdf12940d02ad7f3044 100644
--- a/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermo.C
+++ b/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermo.C
@@ -49,7 +49,7 @@ void Foam::hRhoThermo<MixtureType>::calculate()
         rhoCells[celli] = mixture_.rho(pCells[celli], TCells[celli]);
 
         muCells[celli] = mixture_.mu(TCells[celli]);
-        alphaCells[celli] = mixture_.alpha(TCells[celli]);
+        alphaCells[celli] = mixture_.alphah(TCells[celli]);
     }
 
     forAll(this->T_.boundaryField(), patchi)
@@ -76,7 +76,7 @@ void Foam::hRhoThermo<MixtureType>::calculate()
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 prho[facei] = mixture_.rho(pp[facei], pT[facei]);
                 pmu[facei] = mixture_.mu(pT[facei]);
-                palpha[facei] = mixture_.alpha(pT[facei]);
+                palpha[facei] = mixture_.alphah(pT[facei]);
             }
         }
         else
@@ -91,7 +91,7 @@ void Foam::hRhoThermo<MixtureType>::calculate()
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 prho[facei] = mixture_.rho(pp[facei], pT[facei]);
                 pmu[facei] = mixture_.mu(pT[facei]);
-                palpha[facei] = mixture_.alpha(pT[facei]);
+                palpha[facei] = mixture_.alphah(pT[facei]);
             }
         }
     }
diff --git a/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermos.C b/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermos.C
index a1d44bb9b843a4765e1c0295b53936d7dca31f85..7da039e2678e79f7e335a20060e57be7d6e66878 100644
--- a/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermos.C
+++ b/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermos.C
@@ -26,6 +26,7 @@ License
 #include "makeBasicRhoThermo.H"
 
 #include "perfectGas.H"
+#include "pressurePerfectGas.H"
 #include "incompressible.H"
 
 #include "hConstThermo.H"
@@ -99,6 +100,33 @@ makeBasicRhoPolyThermo
     8
 );
 
+makeBasicRhoThermo
+(
+    hRhoThermo,
+    pureMixture,
+    constTransport,
+    hConstThermo,
+    pressurePerfectGas
+);
+
+makeBasicRhoThermo
+(
+    hRhoThermo,
+    pureMixture,
+    sutherlandTransport,
+    hConstThermo,
+    pressurePerfectGas
+);
+
+makeBasicRhoThermo
+(
+    hRhoThermo,
+    pureMixture,
+    sutherlandTransport,
+    janafThermo,
+    pressurePerfectGas
+);
+
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
 } // End namespace Foam
diff --git a/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermo.C b/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermo.C
index 8b395ad33790f19c12ecf4279da12e1da8bb3bf9..f8697bf675beabbcb7d650d392dd17a33bbac7f4 100644
--- a/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermo.C
+++ b/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermo.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -49,7 +49,7 @@ void Foam::hsRhoThermo<MixtureType>::calculate()
         rhoCells[celli] = mixture_.rho(pCells[celli], TCells[celli]);
 
         muCells[celli] = mixture_.mu(TCells[celli]);
-        alphaCells[celli] = mixture_.alpha(TCells[celli]);
+        alphaCells[celli] = mixture_.alphah(TCells[celli]);
     }
 
     forAll(this->T_.boundaryField(), patchi)
@@ -76,7 +76,7 @@ void Foam::hsRhoThermo<MixtureType>::calculate()
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 prho[facei] = mixture_.rho(pp[facei], pT[facei]);
                 pmu[facei] = mixture_.mu(pT[facei]);
-                palpha[facei] = mixture_.alpha(pT[facei]);
+                palpha[facei] = mixture_.alphah(pT[facei]);
             }
         }
         else
@@ -91,7 +91,7 @@ void Foam::hsRhoThermo<MixtureType>::calculate()
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 prho[facei] = mixture_.rho(pp[facei], pT[facei]);
                 pmu[facei] = mixture_.mu(pT[facei]);
-                palpha[facei] = mixture_.alpha(pT[facei]);
+                palpha[facei] = mixture_.alphah(pT[facei]);
             }
         }
     }
diff --git a/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermos.C b/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermos.C
index 8acf748c428077b407590e5b2c374037ffd7d45c..260eebe8ec2bfef649242964f1f0ec34fff10177 100644
--- a/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermos.C
+++ b/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermos.C
@@ -26,6 +26,7 @@ License
 #include "makeBasicRhoThermo.H"
 
 #include "perfectGas.H"
+#include "pressurePerfectGas.H"
 
 #include "hConstThermo.H"
 #include "janafThermo.H"
@@ -71,6 +72,32 @@ makeBasicRhoThermo
     perfectGas
 );
 
+makeBasicRhoThermo
+(
+    hsRhoThermo,
+    pureMixture,
+    constTransport,
+    hConstThermo,
+    pressurePerfectGas
+);
+
+makeBasicRhoThermo
+(
+    hsRhoThermo,
+    pureMixture,
+    sutherlandTransport,
+    hConstThermo,
+    pressurePerfectGas
+);
+
+makeBasicRhoThermo
+(
+    hsRhoThermo,
+    pureMixture,
+    sutherlandTransport,
+    janafThermo,
+    pressurePerfectGas
+);
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
diff --git a/src/thermophysicalModels/basicSolidThermo/basicSolidThermo/basicSolidThermo.C b/src/thermophysicalModels/basicSolidThermo/basicSolidThermo/basicSolidThermo.C
index 5e62a55eee3a7d5f12252385c9dde34b6498fe9d..58108d1fbf232b65ec3b62cdc15ef09ab30c207b 100644
--- a/src/thermophysicalModels/basicSolidThermo/basicSolidThermo/basicSolidThermo.C
+++ b/src/thermophysicalModels/basicSolidThermo/basicSolidThermo/basicSolidThermo.C
@@ -78,11 +78,11 @@ Foam::basicSolidThermo::basicSolidThermo(const fvMesh& mesh)
         mesh,
         dimMass/dimVolume
     ),
-    kappa_
+    kappaRad_
     (
         IOobject
         (
-            "kappa",
+            "kappaRad",
             mesh.time().timeName(),
             mesh,
             IOobject::NO_READ,
@@ -165,11 +165,11 @@ Foam::basicSolidThermo::basicSolidThermo
         mesh,
         dimMass/dimVolume
     ),
-    kappa_
+    kappaRad_
     (
         IOobject
         (
-            "kappa",
+            "kappaRad",
             mesh.time().timeName(),
             mesh,
             IOobject::NO_READ,
@@ -239,9 +239,9 @@ Foam::volScalarField& Foam::basicSolidThermo::rho()
 }
 
 
-const Foam::volScalarField& Foam::basicSolidThermo::kappa() const
+const Foam::volScalarField& Foam::basicSolidThermo::kappaRad() const
 {
-    return kappa_;
+    return kappaRad_;
 }
 
 
diff --git a/src/thermophysicalModels/basicSolidThermo/basicSolidThermo/basicSolidThermo.H b/src/thermophysicalModels/basicSolidThermo/basicSolidThermo/basicSolidThermo.H
index 3def4a0ee5235ca1bfc12b09b0c9380458329567..0f0fb67f278a5a2d3d3a9d262f7018f0b14335f9 100644
--- a/src/thermophysicalModels/basicSolidThermo/basicSolidThermo/basicSolidThermo.H
+++ b/src/thermophysicalModels/basicSolidThermo/basicSolidThermo/basicSolidThermo.H
@@ -73,7 +73,7 @@ protected:
             volScalarField rho_;
 
             //- Absorption coefficient [1/m]
-            volScalarField kappa_;
+            volScalarField kappaRad_;
 
             //- Scatter coeffcient [1/m]
             volScalarField sigmaS_;
@@ -157,7 +157,7 @@ public:
             virtual volScalarField& rho();
 
             //- Absorption coefficient [1/m]
-            virtual const volScalarField& kappa() const;
+            virtual const volScalarField& kappaRad() const;
 
             //- Emissivity coefficient
             virtual const volScalarField& sigmaS() const;
@@ -169,10 +169,10 @@ public:
         // Derived thermal properties
 
             //- Thermal conductivity [W/m/K]
-            virtual tmp<volScalarField> K() const = 0;
+            virtual tmp<volScalarField> kappa() const = 0;
 
             //- Thermal conductivity [W/m/K]
-            virtual tmp<volSymmTensorField> directionalK() const = 0;
+            virtual tmp<volSymmTensorField> directionalKappa() const = 0;
 
             //- Specific heat capacity [J/kg/K]
             virtual tmp<volScalarField> Cp() const = 0;
@@ -187,10 +187,13 @@ public:
         // Per patch calculation
 
             //- Thermal conductivity [W//m/K]
-            virtual tmp<scalarField> K(const label patchI) const = 0;
+            virtual tmp<scalarField> kappa(const label patchI) const = 0;
 
             //- Thermal conductivity [W//m/K]
-            virtual tmp<symmTensorField> directionalK(const label) const = 0;
+            virtual tmp<symmTensorField> directionalKappa
+            (
+                const label
+            ) const = 0;
 
             //- Specific heat capacity [J/kg/K)]
             virtual tmp<scalarField> Cp(const label patchI) const = 0;
diff --git a/src/thermophysicalModels/basicSolidThermo/constSolidThermo/constSolidThermo.C b/src/thermophysicalModels/basicSolidThermo/constSolidThermo/constSolidThermo.C
index ee20901aac3a79685207ccb86372e9696093dca5..4a4921cb90c78d74b64fd762158379fbd3c3a137 100644
--- a/src/thermophysicalModels/basicSolidThermo/constSolidThermo/constSolidThermo.C
+++ b/src/thermophysicalModels/basicSolidThermo/constSolidThermo/constSolidThermo.C
@@ -46,36 +46,36 @@ Foam::constSolidThermo::constSolidThermo
 :
     basicSolidThermo(mesh, dict),
     dict_(dict.subDict(typeName + "Coeffs")),
-    constK_(dimensionedScalar(dict_.lookup("K"))),
-    K_
+    constKappa_(dimensionedScalar(dict_.lookup("kappa"))),
+    kappa_
     (
         IOobject
         (
-            "K",
+            "kappa",
             mesh.time().timeName(),
             mesh,
             IOobject::NO_READ,
             IOobject::NO_WRITE
         ),
         mesh,
-        constK_
+        constKappa_
     ),
     constRho_(dimensionedScalar(dict_.lookup("rho"))),
     constCp_(dimensionedScalar(dict_.lookup("Cp"))),
     constHf_(dimensionedScalar(dict_.lookup("Hf"))),
     constEmissivity_(dimensionedScalar(dict_.lookup("emissivity"))),
-    constKappa_(dimensionedScalar(dict_.lookup("kappa"))),
+    constKappaRad_(dimensionedScalar(dict_.lookup("kappaRad"))),
     constSigmaS_(dimensionedScalar(dict_.lookup("sigmaS")))
 {
     read();
 
-    K_ = constK_;
+    kappa_ = constKappa_;
 
     rho_ = constRho_;
 
     emissivity_ = constEmissivity_;
 
-    kappa_ = constKappa_;
+    kappaRad_ = constKappaRad_;
 
     sigmaS_ = constSigmaS_;
 }
@@ -85,36 +85,36 @@ Foam::constSolidThermo::constSolidThermo(const fvMesh& mesh)
 :
     basicSolidThermo(mesh),
     dict_(subDict(typeName + "Coeffs")),
-    constK_(dimensionedScalar(dict_.lookup("K"))),
-    K_
+    constKappa_(dimensionedScalar(dict_.lookup("kappa"))),
+    kappa_
     (
         IOobject
         (
-            "K",
+            "kappa",
             mesh.time().timeName(),
             mesh,
             IOobject::NO_READ,
             IOobject::NO_WRITE
         ),
         mesh,
-        constK_
+        constKappa_
     ),
     constRho_(dimensionedScalar(dict_.lookup("rho"))),
     constCp_(dimensionedScalar(dict_.lookup("Cp"))),
     constHf_(dimensionedScalar(dict_.lookup("Hf"))),
     constEmissivity_(dimensionedScalar(dict_.lookup("emissivity"))),
-    constKappa_(dimensionedScalar(dict_.lookup("kappa"))),
+    constKappaRad_(dimensionedScalar(dict_.lookup("kappaRad"))),
     constSigmaS_(dimensionedScalar(dict_.lookup("sigmaS")))
 {
     read();
 
-    K_ = constK_;
+    kappa_ = constKappa_;
 
     rho_ = constRho_;
 
     emissivity_ = constEmissivity_;
 
-    kappa_ = constKappa_;
+    kappaRad_ = constKappaRad_;
 
     sigmaS_ = constSigmaS_;
 }
@@ -132,26 +132,27 @@ void Foam::constSolidThermo::correct()
 {}
 
 
-Foam::tmp<Foam::volScalarField> Foam::constSolidThermo::K() const
+Foam::tmp<Foam::volScalarField> Foam::constSolidThermo::kappa() const
 {
-    return K_;
+    return kappa_;
 }
 
 
-Foam::tmp<Foam::volSymmTensorField> Foam::constSolidThermo::directionalK() const
+Foam::tmp<Foam::volSymmTensorField>
+Foam::constSolidThermo::directionalKappa() const
 {
     dimensionedSymmTensor t
     (
-        constK_.name(),
-        constK_.dimensions(),
+        constKappa_.name(),
+        constKappa_.dimensions(),
         symmTensor
         (
-            constK_.value(),
+            constKappa_.value(),
             0.0,
             0.0,
-            constK_.value(),
+            constKappa_.value(),
             0.0,
-            constK_.value()
+            constKappa_.value()
         )
     );
     return tmp<volSymmTensorField>
@@ -160,7 +161,7 @@ Foam::tmp<Foam::volSymmTensorField> Foam::constSolidThermo::directionalK() const
         (
             IOobject
             (
-                "K",
+                "kappa",
                 mesh_.time().timeName(),
                 mesh_,
                 IOobject::NO_READ,
@@ -215,28 +216,28 @@ Foam::tmp<Foam::volScalarField> Foam::constSolidThermo::Hf() const
 }
 
 
-Foam::tmp<Foam::scalarField> Foam::constSolidThermo::K
+Foam::tmp<Foam::scalarField> Foam::constSolidThermo::kappa
 (
     const label patchI
 ) const
 {
-    return (K_.boundaryField()[patchI]);
+    return (kappa_.boundaryField()[patchI]);
 }
 
 
-Foam::tmp<Foam::symmTensorField> Foam::constSolidThermo::directionalK
+Foam::tmp<Foam::symmTensorField> Foam::constSolidThermo::directionalKappa
 (
     const label patchI
 ) const
 {
     symmTensor t
     (
-        constK_.value(),
+        constKappa_.value(),
         0.0,
         0.0,
-        constK_.value(),
+        constKappa_.value(),
         0.0,
-        constK_.value()
+        constKappa_.value()
     );
     return tmp<symmTensorField>
     (
@@ -291,19 +292,19 @@ bool Foam::constSolidThermo::read(const dictionary& dict)
 {
     constRho_ = dimensionedScalar(dict.lookup("rho"));
     constCp_ = dimensionedScalar(dict.lookup("Cp"));
-    constK_ = dimensionedScalar(dict.lookup("K"));
+    constKappa_ = dimensionedScalar(dict.lookup("kappa"));
     constHf_ = dimensionedScalar(dict.lookup("Hf"));
     constEmissivity_ = dimensionedScalar(dict.lookup("emissivity"));
-    constKappa_ = dimensionedScalar(dict_.lookup("kappa"));
+    constKappaRad_ = dimensionedScalar(dict_.lookup("kappaRad"));
     constSigmaS_ = dimensionedScalar(dict_.lookup("sigmaS"));
 
     Info<< "Constructed constSolidThermo with" << nl
         << "    rho        : " << constRho_ << nl
         << "    Cp         : " << constCp_ << nl
-        << "    K          : " << constK_ << nl
+        << "    kappa      : " << constKappa_ << nl
         << "    Hf         : " << constHf_ << nl
         << "    emissivity : " << constEmissivity_ << nl
-        << "    kappa      : " << constKappa_ << nl
+        << "    kappaRad   : " << constKappaRad_ << nl
         << "    sigmaS     : " << constSigmaS_ << nl
         << endl;
 
@@ -316,9 +317,9 @@ bool Foam::constSolidThermo::writeData(Ostream& os) const
     bool ok = basicSolidThermo::writeData(os);
     os.writeKeyword("rho") << constRho_ << token::END_STATEMENT << nl;
     os.writeKeyword("Cp") << constCp_ << token::END_STATEMENT << nl;
-    os.writeKeyword("K") << constK_ << token::END_STATEMENT << nl;
-    os.writeKeyword("Hf") << constHf_ << token::END_STATEMENT << nl;
     os.writeKeyword("kappa") << constKappa_ << token::END_STATEMENT << nl;
+    os.writeKeyword("Hf") << constHf_ << token::END_STATEMENT << nl;
+    os.writeKeyword("kappaRad") << constKappaRad_ << token::END_STATEMENT << nl;
     os.writeKeyword("sigmaS") << constSigmaS_ << token::END_STATEMENT << nl;
     os.writeKeyword("emissivity") << constEmissivity_ << token::END_STATEMENT
         << nl;
diff --git a/src/thermophysicalModels/basicSolidThermo/constSolidThermo/constSolidThermo.H b/src/thermophysicalModels/basicSolidThermo/constSolidThermo/constSolidThermo.H
index 75a5068552d0ed377cabc600d598e98a003db418..c5a7bd6a9214368b258df02e9d759638763bdcd0 100644
--- a/src/thermophysicalModels/basicSolidThermo/constSolidThermo/constSolidThermo.H
+++ b/src/thermophysicalModels/basicSolidThermo/constSolidThermo/constSolidThermo.H
@@ -58,10 +58,10 @@ private:
         dictionary dict_;
 
         //- Constant thermal conductivity [W/(m.K)]
-        dimensionedScalar constK_;
+        dimensionedScalar constKappa_;
 
         //- Thermal conductivity field[W/(m.K)]
-        volScalarField K_;
+        volScalarField kappa_;
 
         //- Density [kg/m3]
         dimensionedScalar constRho_;
@@ -76,7 +76,7 @@ private:
         dimensionedScalar constEmissivity_;
 
         //- Absorptivity [1/m]
-        dimensionedScalar constKappa_;
+        dimensionedScalar constKappaRad_;
 
         //- Scatter [1/m]
         dimensionedScalar constSigmaS_;
@@ -110,10 +110,10 @@ public:
         // Derived thermal properties
 
             //- Thermal conductivity [W/m/K]
-            virtual tmp<volScalarField> K() const;
+            virtual tmp<volScalarField> kappa() const;
 
             //- Thermal conductivity [W/m/K]
-            virtual tmp<volSymmTensorField> directionalK() const;
+            virtual tmp<volSymmTensorField> directionalKappa() const;
 
             //- Specific heat capacity [J/(kg.K)]
             virtual tmp<volScalarField> Cp() const;
@@ -125,10 +125,10 @@ public:
         // Per patch calculation
 
             //- Thermal conductivity [W//m/K]
-            virtual tmp<scalarField> K(const label patchI) const;
+            virtual tmp<scalarField> kappa(const label patchI) const;
 
             //- Thermal conductivity [W//m/K]
-            virtual tmp<symmTensorField>directionalK(const label) const;
+            virtual tmp<symmTensorField>directionalKappa(const label) const;
 
             //- Specific heat capacity [J/kg/K)]
             virtual tmp<scalarField> Cp(const label patchI) const;
diff --git a/src/thermophysicalModels/basicSolidThermo/directionalKSolidThermo/directionalKSolidThermo.C b/src/thermophysicalModels/basicSolidThermo/directionalKSolidThermo/directionalKSolidThermo.C
index e2185e45f5883c381a2cb9e902322e40769a9fa0..57f6eb172769f3c7786022a387c302e635f95eaf 100644
--- a/src/thermophysicalModels/basicSolidThermo/directionalKSolidThermo/directionalKSolidThermo.C
+++ b/src/thermophysicalModels/basicSolidThermo/directionalKSolidThermo/directionalKSolidThermo.C
@@ -59,11 +59,11 @@ Foam::directionalKSolidThermo::directionalKSolidThermo
 )
 :
     interpolatedSolidThermo(mesh, typeName + "Coeffs", dict),
-    directionalK_
+    directionalKappa_
     (
         IOobject
         (
-            "K",
+            "kappa",
             mesh_.time().timeName(),
             mesh_,
             IOobject::NO_READ,
@@ -93,11 +93,11 @@ Foam::directionalKSolidThermo::directionalKSolidThermo
 Foam::directionalKSolidThermo::directionalKSolidThermo(const fvMesh& mesh)
 :
     interpolatedSolidThermo(mesh, typeName + "Coeffs"),
-    directionalK_
+    directionalKappa_
     (
         IOobject
         (
-            "K",
+            "kappa",
             mesh_.time().timeName(),
             mesh_,
             IOobject::NO_READ,
@@ -134,7 +134,10 @@ Foam::directionalKSolidThermo::~directionalKSolidThermo()
 
 void Foam::directionalKSolidThermo::init()
 {
-    KValues_ = Field<vector>(subDict(typeName + "Coeffs").lookup("KValues"));
+    kappaValues_ =
+        Field<vector>(subDict(typeName + "Coeffs").lookup("kappaValues"));
+
+    Info<< "    kappa      : " << kappaValues_ << nl << endl;
 
     // Determine transforms for cell centres
     forAll(mesh_.C(), cellI)
@@ -362,51 +365,55 @@ void Foam::directionalKSolidThermo::correct()
 
 
 Foam::tmp<Foam::volSymmTensorField>
-Foam::directionalKSolidThermo::directionalK() const
+Foam::directionalKSolidThermo::directionalKappa() const
 {
-    return directionalK_;
+    return directionalKappa_;
 }
 
 
 void Foam::directionalKSolidThermo::calculate()
 {
     // Correct directionalK
-    Field<vector> localK
+    Field<vector> localKappa
     (
         interpolateXY
         (
             T_.internalField(),
             TValues_,
-            KValues_
+            kappaValues_
         )
     );
 
     // Transform into global coordinate system
     transformField
     (
-        directionalK_.internalField(),
+        directionalKappa_.internalField(),
         ccTransforms_.internalField(),
-        localK
+        localKappa
     );
 
-    forAll(directionalK_.boundaryField(), patchI)
+    forAll(directionalKappa_.boundaryField(), patchI)
     {
-        directionalK_.boundaryField()[patchI] == this->directionalK(patchI)();
+        directionalKappa_.boundaryField()[patchI] ==
+            this->directionalKappa(patchI)();
     }
 }
 
 
-Foam::tmp<Foam::symmTensorField> Foam::directionalKSolidThermo::directionalK
+Foam::tmp<Foam::symmTensorField> Foam::directionalKSolidThermo::directionalKappa
 (
     const label patchI
 ) const
 {
     const fvPatchScalarField& patchT = T_.boundaryField()[patchI];
 
-    Field<vector> localK(interpolateXY(patchT, TValues_, KValues_));
+    Field<vector> localKappa(interpolateXY(patchT, TValues_, kappaValues_));
 
-    tmp<symmTensorField> tglobalK(new symmTensorField(localK.size()));
-    transformField(tglobalK(), ccTransforms_.boundaryField()[patchI], localK);
+    tmp<symmTensorField> tglobalK(new symmTensorField(localKappa.size()));
+    transformField
+    (
+        tglobalK(), ccTransforms_.boundaryField()[patchI], localKappa
+    );
 
     return tglobalK;
 }
@@ -421,7 +428,8 @@ bool Foam::directionalKSolidThermo::read()
 bool Foam::directionalKSolidThermo::read(const dictionary& dict)
 {
     coordSys_ = coordinateSystem(dict, mesh_);
-    KValues_  = Field<vector>(subDict(typeName + "Coeffs").lookup("KValues"));
+    kappaValues_  =
+        Field<vector>(subDict(typeName + "Coeffs").lookup("kappaValues"));
     return true;
 }
 
@@ -429,7 +437,8 @@ bool Foam::directionalKSolidThermo::read(const dictionary& dict)
 bool Foam::directionalKSolidThermo::writeData(Ostream& os) const
 {
     bool ok = interpolatedSolidThermo::writeData(os);
-    os.writeKeyword("KValues") << KValues_ << token::END_STATEMENT << nl;
+    os.writeKeyword("kappaValues")
+        << kappaValues_ << token::END_STATEMENT << nl;
     return ok && os.good();
 }
 
diff --git a/src/thermophysicalModels/basicSolidThermo/directionalKSolidThermo/directionalKSolidThermo.H b/src/thermophysicalModels/basicSolidThermo/directionalKSolidThermo/directionalKSolidThermo.H
index c5c8ad9cc8288a1adfc7c72e103fe4d13b38ee52..68c176a7cc716eb7f4cfa721e255e4ae369dd3e5 100644
--- a/src/thermophysicalModels/basicSolidThermo/directionalKSolidThermo/directionalKSolidThermo.H
+++ b/src/thermophysicalModels/basicSolidThermo/directionalKSolidThermo/directionalKSolidThermo.H
@@ -54,10 +54,10 @@ class directionalKSolidThermo
     // Private data
 
         //- Thermal conductivity [W/(m.K)]
-        volSymmTensorField directionalK_;
+        volSymmTensorField directionalKappa_;
 
         //- Thermal conductivity vector
-        Field<vector> KValues_;
+        Field<vector> kappaValues_;
 
         //- Coordinate system used for the directional properties
         coordinateSystem coordSys_;
@@ -117,26 +117,29 @@ public:
         //- Access functions
 
             //- Thermal conductivity [W/m/K]
-            virtual tmp<volScalarField> K() const
+            virtual tmp<volScalarField> kappa() const
             {
-                notImplemented("directionalKSolidThermo::K() const");
+                notImplemented("directionalKSolidThermo::kappa() const");
                 return tmp<volScalarField>(NULL);
             }
 
             //- Thermal conductivity [W/m/K]
-            virtual tmp<volSymmTensorField> directionalK() const;
+            virtual tmp<volSymmTensorField> directionalKappa() const;
 
          // Per patch calculation
 
             //- Thermal conductivity [W//m/K]
-            virtual tmp<scalarField> K(const label patchI) const
+            virtual tmp<scalarField> kappa(const label patchI) const
             {
-                notImplemented("directionalKSolidThermo::K(const label) const");
+                notImplemented
+                (
+                    "directionalKSolidThermo::kappa(const label) const"
+                );
                 return tmp<scalarField>(NULL);
             }
 
             //- Thermal conductivity [W//m/K]
-            virtual tmp<symmTensorField> directionalK(const label) const;
+            virtual tmp<symmTensorField> directionalKappa(const label) const;
 
 
         // I-O
diff --git a/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolateSolid/interpolateSolid.C b/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolateSolid/interpolateSolid.C
index 65b95738dc1ecb4eaaaa7c0bca44f2ebe63800c5..7b9027110a368c613f3a3c762264407746df280b 100644
--- a/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolateSolid/interpolateSolid.C
+++ b/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolateSolid/interpolateSolid.C
@@ -33,15 +33,14 @@ Foam::interpolateSolid::interpolateSolid(const dictionary& dict)
 {
     read(dict);
 
-    Info<< "Constructed directionalKSolidThermo with samples" << nl
+    Info<< "Constructed solid thermo with samples" << nl
         << "    T          : " << TValues_ << nl
         << "    rho        : " << rhoValues_ << nl
         << "    cp         : " << cpValues_ << nl
         << "    Hf         : " << HfValues_ << nl
         << "    emissivity : " << emissivityValues_ << nl
-        << "    kappa : " << kappaValues_ << nl
-        << "    sigmaS : " << sigmaSValues_ << nl
-        << endl;
+        << "    kappaRad   : " << kappaRadValues_ << nl
+        << "    sigmaS     : " << sigmaSValues_ << nl;
 
 
     if
@@ -88,7 +87,7 @@ bool Foam::interpolateSolid::writeData(Ostream& os) const
     os.writeKeyword("HfValues") << HfValues_ << token::END_STATEMENT << nl;
     os.writeKeyword("emissivityValues") << emissivityValues_ <<
          token::END_STATEMENT << nl;
-    os.writeKeyword("kappaValues") << kappaValues_
+    os.writeKeyword("kappaRadValues") << kappaRadValues_
         << token::END_STATEMENT << nl;
     os.writeKeyword("sigmaSValues") << sigmaSValues_
         << token::END_STATEMENT << nl;
@@ -103,7 +102,7 @@ bool Foam::interpolateSolid::read(const dictionary& dict)
     TValues_ = Field<scalar>(dict.lookup("TValues"));
     rhoValues_ = Field<scalar>(dict.lookup("rhoValues"));
     cpValues_ = Field<scalar>(dict.lookup("cpValues"));
-    kappaValues_ = Field<scalar>(dict.lookup("kappaValues"));
+    kappaRadValues_ = Field<scalar>(dict.lookup("kappaRadValues"));
     sigmaSValues_ = Field<scalar>(dict.lookup("sigmaSValues"));
     HfValues_ = Field<scalar>(dict.lookup("HfValues"));
     emissivityValues_ = Field<scalar>(dict.lookup("emissivityValues"));
diff --git a/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolateSolid/interpolateSolid.H b/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolateSolid/interpolateSolid.H
index 269f982a090a357874597e5c46c5144b13483da4..81c2644b31dd7c9ebc77f3d53a28336c9ab79ed4 100644
--- a/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolateSolid/interpolateSolid.H
+++ b/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolateSolid/interpolateSolid.H
@@ -63,7 +63,7 @@ protected:
 
         Field<scalar> emissivityValues_;
 
-        Field<scalar> kappaValues_;
+        Field<scalar> kappaRadValues_;
 
         Field<scalar> sigmaSValues_;
 
diff --git a/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolatedSolidThermo.C b/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolatedSolidThermo.C
index def8dc6160e2df77d25ec775da1da57d3d801f01..2d3790c989e5aa87ee06ea7dfacabd8b3c394f70 100644
--- a/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolatedSolidThermo.C
+++ b/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolatedSolidThermo.C
@@ -69,7 +69,7 @@ Foam::tmp<Foam::scalarField> Foam::interpolatedSolidThermo::emissivity
 }
 
 
-Foam::tmp<Foam::scalarField> Foam::interpolatedSolidThermo::kappa
+Foam::tmp<Foam::scalarField> Foam::interpolatedSolidThermo::kappaRad
 (
     const label patchI
 ) const
@@ -82,7 +82,7 @@ Foam::tmp<Foam::scalarField> Foam::interpolatedSolidThermo::kappa
             (
                 T_.boundaryField()[patchI],
                 TValues_,
-                kappaValues_
+                kappaRadValues_
             )
         )
     );
@@ -178,16 +178,16 @@ void Foam::interpolatedSolidThermo::calculate()
 
 
     // Correct absorptivity
-    kappa_.internalField() = interpolateXY
+    kappaRad_.internalField() = interpolateXY
     (
         T_.internalField(),
         TValues_,
-        kappaValues_
+        kappaRadValues_
     );
 
-    forAll(kappa_.boundaryField(), patchI)
+    forAll(kappaRad_.boundaryField(), patchI)
     {
-        kappa_.boundaryField()[patchI] == this->kappa(patchI)();
+        kappaRad_.boundaryField()[patchI] == this->kappaRad(patchI)();
     }
 
 
diff --git a/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolatedSolidThermo.H b/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolatedSolidThermo.H
index 23e112db5a44159ef8cf65dc8eb99ed4d8fb7086..e35b124c3ed79348b29fcb14e187b6c8752ea2f6 100644
--- a/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolatedSolidThermo.H
+++ b/src/thermophysicalModels/basicSolidThermo/interpolatedSolidThermo/interpolatedSolidThermo.H
@@ -69,7 +69,7 @@ private:
             tmp<scalarField> sigmaS(const label) const;
 
             //- Absorption coefficient [1/m]
-            tmp<scalarField> kappa(const label) const;
+            tmp<scalarField> kappaRad(const label) const;
 
              //- Emissivity []
             tmp<scalarField> emissivity(const label) const;
diff --git a/src/thermophysicalModels/basicSolidThermo/isotropicKSolidThermo/isotropicKSolidThermo.C b/src/thermophysicalModels/basicSolidThermo/isotropicKSolidThermo/isotropicKSolidThermo.C
index 1b15c88946923e6523bcb55e875acd813b4fda3e..b1e25dfad61fc30e29b926e88fdf589b932f90af 100644
--- a/src/thermophysicalModels/basicSolidThermo/isotropicKSolidThermo/isotropicKSolidThermo.C
+++ b/src/thermophysicalModels/basicSolidThermo/isotropicKSolidThermo/isotropicKSolidThermo.C
@@ -57,11 +57,11 @@ Foam::isotropicKSolidThermo::isotropicKSolidThermo
 )
 :
     interpolatedSolidThermo(mesh, typeName + "Coeffs", dict),
-    K_
+    kappa_
     (
         IOobject
         (
-            "K",
+            "kappa",
             mesh.time().timeName(),
             mesh,
             IOobject::NO_READ,
@@ -70,8 +70,12 @@ Foam::isotropicKSolidThermo::isotropicKSolidThermo
         mesh,
         dimEnergy/dimTime/(dimLength*dimTemperature)
     ),
-    KValues_ (Field<scalar>(subDict(typeName + "Coeffs").lookup("KValues")))
+    kappaValues_
+    (
+        Field<scalar>(subDict(typeName + "Coeffs").lookup("kappaValues"))
+    )
 {
+    Info<< "    kappa      : " << kappaValues_ << nl << endl;
     correct();
 }
 
@@ -79,11 +83,11 @@ Foam::isotropicKSolidThermo::isotropicKSolidThermo
 Foam::isotropicKSolidThermo::isotropicKSolidThermo(const fvMesh& mesh)
 :
     interpolatedSolidThermo(mesh, typeName + "Coeffs"),
-    K_
+    kappa_
     (
         IOobject
         (
-            "K",
+            "kappa",
             mesh.time().timeName(),
             mesh,
             IOobject::NO_READ,
@@ -92,8 +96,12 @@ Foam::isotropicKSolidThermo::isotropicKSolidThermo(const fvMesh& mesh)
         mesh,
         dimEnergy/dimTime/(dimLength*dimTemperature)
     ),
-    KValues_ (Field<scalar>(subDict(typeName + "Coeffs").lookup("KValues")))
+    kappaValues_
+    (
+        Field<scalar>(subDict(typeName + "Coeffs").lookup("kappaValues"))
+    )
 {
+    Info<< "    kappa      : " << kappaValues_ << nl <<endl;
     correct();
 }
 
@@ -101,20 +109,20 @@ Foam::isotropicKSolidThermo::isotropicKSolidThermo(const fvMesh& mesh)
 void Foam::isotropicKSolidThermo::correct()
 {
     // Correct K
-    K_.internalField() = interpolateXY
+    kappa_.internalField() = interpolateXY
     (
         T_.internalField(),
         TValues_,
-        KValues_
+        kappaValues_
     );
 
-    forAll(K_.boundaryField(), patchI)
+    forAll(kappa_.boundaryField(), patchI)
     {
-        K_.boundaryField()[patchI] == interpolateXY
+        kappa_.boundaryField()[patchI] == interpolateXY
         (
             T_.boundaryField()[patchI],
             TValues_,
-            KValues_
+            kappaValues_
         );
     }
 
@@ -122,31 +130,33 @@ void Foam::isotropicKSolidThermo::correct()
 }
 
 
-Foam::tmp<Foam::volScalarField> Foam::isotropicKSolidThermo::K() const
+Foam::tmp<Foam::volScalarField> Foam::isotropicKSolidThermo::kappa() const
 {
-    return K_;
+    return kappa_;
 }
 
 
-Foam::tmp<Foam::scalarField> Foam::isotropicKSolidThermo::K
+Foam::tmp<Foam::scalarField> Foam::isotropicKSolidThermo::kappa
 (
     const label patchI
 ) const
 {
-    return K_.boundaryField()[patchI];
+    return kappa_.boundaryField()[patchI];
 }
 
 
 bool Foam::isotropicKSolidThermo::read()
 {
-    KValues_  = Field<scalar>(subDict(typeName + "Coeffs").lookup("KValues"));
+    kappaValues_  =
+        Field<scalar>(subDict(typeName + "Coeffs").lookup("kappaValues"));
     return true;
 }
 
 
 bool Foam::isotropicKSolidThermo::writeData(Ostream& os) const
 {
-    os.writeKeyword("KValues") << KValues_ << token::END_STATEMENT << nl;
+    os.writeKeyword("kappaValues") << kappaValues_
+        << token::END_STATEMENT << nl;
     bool ok = interpolatedSolidThermo::writeData(os);
 
     return ok && os.good();
diff --git a/src/thermophysicalModels/basicSolidThermo/isotropicKSolidThermo/isotropicKSolidThermo.H b/src/thermophysicalModels/basicSolidThermo/isotropicKSolidThermo/isotropicKSolidThermo.H
index d6acac3e91c1654837ef9e3b3b2052b2ad8e7c24..9eb1170a44d6cbdd37ec16f0a08299b1f36ccd78 100644
--- a/src/thermophysicalModels/basicSolidThermo/isotropicKSolidThermo/isotropicKSolidThermo.H
+++ b/src/thermophysicalModels/basicSolidThermo/isotropicKSolidThermo/isotropicKSolidThermo.H
@@ -53,10 +53,10 @@ class isotropicKSolidThermo
     // Private data
 
         //- Thermal conductivity [W/(m.K)]
-        volScalarField K_;
+        volScalarField kappa_;
 
         //- Thermal conductivity vector
-        Field<scalar> KValues_;
+        Field<scalar> kappaValues_;
 
 
 public:
@@ -87,26 +87,31 @@ public:
         // Access functions
 
             //- Constant access to K
-            virtual tmp<volScalarField> K() const;
+            virtual tmp<volScalarField> kappa() const;
 
             //- Thermal conductivity [W/m/K]
-            virtual tmp<volSymmTensorField> directionalK() const
+            virtual tmp<volSymmTensorField> directionalKappa() const
             {
-                notImplemented("directionalKSolidThermo::directionalK() const");
+                notImplemented
+                (
+                    "directionalKSolidThermo::directionalKappa() const"
+                );
                 return tmp<volSymmTensorField>(NULL);
             }
 
+
         // Per patch calculation
 
-            //- Thermal conductivity [W//m/K]
-            virtual tmp<scalarField> K(const label patchI) const;
+            //- Thermal conductivity [W/m/K]
+            virtual tmp<scalarField> kappa(const label patchI) const;
 
-            //- Thermal conductivity [W//m/K]
-            virtual tmp<symmTensorField> directionalK(const label) const
+            //- Thermal conductivity [W/m/K]
+            virtual tmp<symmTensorField> directionalKappa(const label) const
             {
                 notImplemented
                 (
-                    "directionalKSolidThermo::directionalK(const label) const"
+                    "directionalKSolidThermo::directionalKappa(const label)"
+                    "const"
                 );
                 return tmp<symmTensorField>(NULL);
             }
diff --git a/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/basicSolidMixture/basicSolidMixture.H b/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/basicSolidMixture/basicSolidMixture.H
index 631f4da7dea60cbdf9074f59952fb42cf2615733..14f8b7be12940df023c8fe252c49dd8e0fda8e8a 100644
--- a/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/basicSolidMixture/basicSolidMixture.H
+++ b/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/basicSolidMixture/basicSolidMixture.H
@@ -114,13 +114,13 @@ public:
         virtual scalar rho(scalar T, label celli) const = 0;
 
         //- Absorption coefficient
-        virtual scalar kappa(scalar T, label celli) const = 0;
+        virtual scalar kappaRad(scalar T, label celli) const = 0;
 
         //- Scatter coefficient
         virtual scalar sigmaS(scalar T, label celli) const = 0;
 
         //- Thermal conductivity
-        virtual scalar K(scalar T, label celli) const = 0;
+        virtual scalar kappa(scalar T, label celli) const = 0;
 
         //- Emissivity coefficient
         virtual scalar emissivity(scalar T, label celli) const = 0;
diff --git a/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/multiComponentSolidMixture/multiComponentSolidMixture.C b/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/multiComponentSolidMixture/multiComponentSolidMixture.C
index 79304dbdbbae7ebb2dc83bed913da3eed564eb90..e76b7d83fda65cb6f7b7a64e5cb9605f771dde76 100644
--- a/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/multiComponentSolidMixture/multiComponentSolidMixture.C
+++ b/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/multiComponentSolidMixture/multiComponentSolidMixture.C
@@ -159,7 +159,7 @@ Foam::scalar Foam::multiComponentSolidMixture<ThermoSolidType>::h
 
 
 template<class ThermoSolidType>
-Foam::scalar Foam::multiComponentSolidMixture<ThermoSolidType>::kappa
+Foam::scalar Foam::multiComponentSolidMixture<ThermoSolidType>::kappaRad
 (
     scalar T, label celli
 ) const
@@ -167,7 +167,7 @@ Foam::scalar Foam::multiComponentSolidMixture<ThermoSolidType>::kappa
     scalar tmp = 0.0;
     forAll(solidData_, i)
     {
-        tmp += solidData_[i].kappa(T)*X(i, celli, T);
+        tmp += solidData_[i].kappaRad(T)*X(i, celli, T);
     }
     return tmp;
 }
@@ -189,7 +189,7 @@ Foam::scalar Foam::multiComponentSolidMixture<ThermoSolidType>::sigmaS
 
 
 template<class ThermoSolidType>
-Foam::scalar Foam::multiComponentSolidMixture<ThermoSolidType>::K
+Foam::scalar Foam::multiComponentSolidMixture<ThermoSolidType>::kappa
 (
     scalar T, label celli
 ) const
@@ -197,7 +197,7 @@ Foam::scalar Foam::multiComponentSolidMixture<ThermoSolidType>::K
     scalar tmp = 0.0;
     forAll(solidData_, i)
     {
-        tmp += solidData_[i].K(T)*X(i, celli, T);
+        tmp += solidData_[i].kappa(T)*X(i, celli, T);
     }
     return tmp;
 }
diff --git a/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/multiComponentSolidMixture/multiComponentSolidMixture.H b/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/multiComponentSolidMixture/multiComponentSolidMixture.H
index 3a633da5cd04dae5c7673c415ca55dfdcd429390..75b908bb9d00dfe8da0d566d430a8421b4614d15 100644
--- a/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/multiComponentSolidMixture/multiComponentSolidMixture.H
+++ b/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/mixtures/multiComponentSolidMixture/multiComponentSolidMixture.H
@@ -99,13 +99,13 @@ public:
             virtual scalar rho(scalar T, label celli) const;
 
             //- Absorption coefficient
-            virtual scalar kappa(scalar T, label celli) const;
+            virtual scalar kappaRad(scalar T, label celli) const;
 
             //- Scatter coefficient
             virtual scalar sigmaS(scalar T, label celli) const;
 
             //- Thermal conductivity
-            virtual scalar K(scalar T, label celli) const;
+            virtual scalar kappa(scalar T, label celli) const;
 
             //- Emissivity coefficient
             virtual scalar emissivity(scalar T, label celli) const;
diff --git a/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/solidMixtureThermo/solidMixtureThermo.C b/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/solidMixtureThermo/solidMixtureThermo.C
index 0f78d32337846755d44d386e49bd5466ab32bde9..cea2e2288de3b4c0fadd096188e254662f586722 100644
--- a/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/solidMixtureThermo/solidMixtureThermo.C
+++ b/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/solidMixtureThermo/solidMixtureThermo.C
@@ -34,8 +34,8 @@ void Foam::solidMixtureThermo<MixtureType>::calculate()
 {
 
     scalarField& rhoCells = rho_.internalField();
-    scalarField& KCells = K_.internalField();
     scalarField& kappaCells = kappa_.internalField();
+    scalarField& kappaRadCells = kappaRad_.internalField();
     scalarField& sigmaSCells = sigmaS_.internalField();
     scalarField& emissivityCells = emissivity_.internalField();
 
@@ -44,9 +44,9 @@ void Foam::solidMixtureThermo<MixtureType>::calculate()
     forAll(iT, celli)
     {
         rhoCells[celli] = MixtureType::rho(iT[celli], celli);
-        kappaCells[celli] = MixtureType::kappa(iT[celli], celli);
+        kappaRadCells[celli] = MixtureType::kappaRad(iT[celli], celli);
         sigmaSCells[celli] = MixtureType::sigmaS(iT[celli], celli);
-        KCells[celli] = MixtureType::K(iT[celli], celli);
+        kappaCells[celli] = MixtureType::kappa(iT[celli], celli);
         emissivityCells[celli] = MixtureType::emissivity(iT[celli], celli);
     }
 
@@ -55,8 +55,8 @@ void Foam::solidMixtureThermo<MixtureType>::calculate()
     forAll(bT, patchI)
     {
         rho_.boundaryField()[patchI] == this->rho(patchI)();
-        K_.boundaryField()[patchI] == this->K(patchI)();
         kappa_.boundaryField()[patchI] == this->kappa(patchI)();
+        kappaRad_.boundaryField()[patchI] == this->kappaRad(patchI)();
         sigmaS_.boundaryField()[patchI] == this->sigmaS(patchI)();
         emissivity_.boundaryField()[patchI] == this->emissivity(patchI)();
     }
@@ -109,25 +109,25 @@ Foam::tmp<Foam::scalarField> Foam::solidMixtureThermo<MixtureType>::sigmaS
 
 
 template<class MixtureType>
-Foam::tmp<Foam::scalarField> Foam::solidMixtureThermo<MixtureType>::kappa
+Foam::tmp<Foam::scalarField> Foam::solidMixtureThermo<MixtureType>::kappaRad
 (
     const label patchI
 ) const
 {
     const scalarField& patchT = T_.boundaryField()[patchI];
-   const polyPatch& pp = mesh_.boundaryMesh()[patchI];
+    const polyPatch& pp = mesh_.boundaryMesh()[patchI];
     const labelUList& cells = pp.faceCells();
 
-    tmp<scalarField> tKappa(new scalarField(patchT.size()));
-    scalarField& kappa = tKappa();
+    tmp<scalarField> tKappaRad(new scalarField(patchT.size()));
+    scalarField& kappaRad = tKappaRad();
 
     forAll(patchT, celli)
     {
-        kappa[celli] =
-            MixtureType::kappa(patchT[celli], cells[celli]);
+        kappaRad[celli] =
+            MixtureType::kappaRad(patchT[celli], cells[celli]);
     }
 
-    return tKappa;
+    return tKappaRad;
 }
 
 
@@ -163,11 +163,11 @@ Foam::solidMixtureThermo<MixtureType>::solidMixtureThermo
 :
     basicSolidThermo(mesh),
     MixtureType(*this, mesh),
-    K_
+    kappa_
     (
         IOobject
         (
-            "K",
+            "kappa",
             mesh.time().timeName(),
             mesh,
             IOobject::NO_READ,
@@ -190,11 +190,11 @@ Foam::solidMixtureThermo<MixtureType>::solidMixtureThermo
 :
     basicSolidThermo(mesh, dict),
     MixtureType(*this, mesh),
-    K_
+    kappa_
     (
         IOobject
         (
-            "K",
+            "kappa",
             mesh.time().timeName(),
             mesh,
             IOobject::NO_READ,
@@ -225,9 +225,10 @@ void Foam::solidMixtureThermo<MixtureType>::correct()
 
 
 template<class MixtureType>
-Foam::tmp<Foam::volScalarField> Foam::solidMixtureThermo<MixtureType>::K() const
+Foam::tmp<Foam::volScalarField> Foam::solidMixtureThermo<MixtureType>::
+kappa() const
 {
-    return K_;
+    return kappa_;
 }
 
 
@@ -352,7 +353,7 @@ Foam::solidMixtureThermo<MixtureType>::Hf() const
 
 
 template<class MixtureType>
-Foam::tmp<Foam::scalarField> Foam::solidMixtureThermo<MixtureType>::K
+Foam::tmp<Foam::scalarField> Foam::solidMixtureThermo<MixtureType>::kappa
 (
     const label patchI
 ) const
@@ -361,15 +362,15 @@ Foam::tmp<Foam::scalarField> Foam::solidMixtureThermo<MixtureType>::K
     const polyPatch& pp = mesh_.boundaryMesh()[patchI];
     const labelUList& cells = pp.faceCells();
 
-    tmp<scalarField> tK(new scalarField(patchT.size()));
-    scalarField& K = tK();
+    tmp<scalarField> tkappa(new scalarField(patchT.size()));
+    scalarField& kappa = tkappa();
 
     forAll(patchT, celli)
     {
-        K[celli] = MixtureType::K(patchT[celli], cells[celli]);
+        kappa[celli] = MixtureType::kappa(patchT[celli], cells[celli]);
     }
 
-    return tK;
+    return tkappa;
 }
 
 
diff --git a/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/solidMixtureThermo/solidMixtureThermo.H b/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/solidMixtureThermo/solidMixtureThermo.H
index 100d371b99a8d9bd5c3c87c8196d6081a98472ae..488563ff023024806fbf93ea876cea39850de4ce 100644
--- a/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/solidMixtureThermo/solidMixtureThermo.H
+++ b/src/thermophysicalModels/basicSolidThermo/solidMixtureThermo/solidMixtureThermo/solidMixtureThermo.H
@@ -57,7 +57,7 @@ protected:
     // Protected data
 
         //- Thermal conductivity [W/m/K]
-        volScalarField K_;
+        volScalarField kappa_;
 
 
 private:
@@ -74,7 +74,7 @@ private:
 
             tmp<scalarField> sigmaS(const label patchI) const;
 
-            tmp<scalarField> kappa(const label patchI) const;
+            tmp<scalarField> kappaRad(const label patchI) const;
 
             tmp<scalarField> emissivity(const label patchI) const;
 
@@ -118,12 +118,12 @@ public:
         // Derived thermal properties
 
             //- Thermal conductivity [W/m/K]
-            virtual tmp<volScalarField> K() const;
+            virtual tmp<volScalarField> kappa() const;
 
             //- Thermal conductivity [W/m/K]
-            virtual tmp<volSymmTensorField> directionalK() const
+            virtual tmp<volSymmTensorField> directionalKappa() const
             {
-                notImplemented("solidMixtureThermo::directionalK() const");
+                notImplemented("solidMixtureThermo::directionalKappa() const");
                 return tmp<volSymmTensorField>(NULL);
             }
 
@@ -140,14 +140,14 @@ public:
         // Per patch calculation
 
             //- Thermal conductivity [W/(m.K)]
-            virtual tmp<scalarField> K(const label patchI) const;
+            virtual tmp<scalarField> kappa(const label patchI) const;
 
             //- Thermal conductivity [W/(m.K)]
-            virtual tmp<symmTensorField> directionalK(const label) const
+            virtual tmp<symmTensorField> directionalKappa(const label) const
             {
                 notImplemented
                 (
-                    "solidMixtureThermo::directionalK(const label) const"
+                    "solidMixtureThermo::directionalKappa(const label) const"
                 );
                 return tmp<symmTensorField>(NULL);
             }
diff --git a/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hPsiMixtureThermo/hPsiMixtureThermo.C b/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hPsiMixtureThermo/hPsiMixtureThermo.C
index d604d13c17d9c2a519190a3085cd5d31b3039324..7328d329666f8aa1d63fde1d932626dfca20ce54 100644
--- a/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hPsiMixtureThermo/hPsiMixtureThermo.C
+++ b/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hPsiMixtureThermo/hPsiMixtureThermo.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -49,7 +49,7 @@ void Foam::hPsiMixtureThermo<MixtureType>::calculate()
         psiCells[celli] = mixture.psi(pCells[celli], TCells[celli]);
 
         muCells[celli] = mixture.mu(TCells[celli]);
-        alphaCells[celli] = mixture.alpha(TCells[celli]);
+        alphaCells[celli] = mixture.alphah(TCells[celli]);
     }
 
     forAll(T_.boundaryField(), patchi)
@@ -74,7 +74,7 @@ void Foam::hPsiMixtureThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture.psi(pp[facei], pT[facei]);
                 pmu_[facei] = mixture.mu(pT[facei]);
-                palpha_[facei] = mixture.alpha(pT[facei]);
+                palpha_[facei] = mixture.alphah(pT[facei]);
             }
         }
         else
@@ -88,7 +88,7 @@ void Foam::hPsiMixtureThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture.psi(pp[facei], pT[facei]);
                 pmu_[facei] = mixture.mu(pT[facei]);
-                palpha_[facei] = mixture.alpha(pT[facei]);
+                palpha_[facei] = mixture.alphah(pT[facei]);
             }
         }
     }
diff --git a/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hhuMixtureThermo/hhuMixtureThermo.C b/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hhuMixtureThermo/hhuMixtureThermo.C
index 79d153245cfaeb8ff696965a002a8f73c078c91d..b58ca996825522cd3431da42cea9806fe1b54ea5 100644
--- a/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hhuMixtureThermo/hhuMixtureThermo.C
+++ b/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hhuMixtureThermo/hhuMixtureThermo.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -98,7 +98,7 @@ void Foam::hhuMixtureThermo<MixtureType>::calculate()
         psiCells[celli] = mixture_.psi(pCells[celli], TCells[celli]);
 
         muCells[celli] = mixture_.mu(TCells[celli]);
-        alphaCells[celli] = mixture_.alpha(TCells[celli]);
+        alphaCells[celli] = mixture_.alphah(TCells[celli]);
 
         TuCells[celli] =
             this->cellReactants(celli).TH(huCells[celli], TuCells[celli]);
@@ -128,7 +128,7 @@ void Foam::hhuMixtureThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 pmu_[facei] = mixture_.mu(pT[facei]);
-                palpha_[facei] = mixture_.alpha(pT[facei]);
+                palpha_[facei] = mixture_.alphah(pT[facei]);
             }
         }
         else
@@ -142,7 +142,7 @@ void Foam::hhuMixtureThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 pmu_[facei] = mixture_.mu(pT[facei]);
-                palpha_[facei] = mixture_.alpha(pT[facei]);
+                palpha_[facei] = mixture_.alphah(pT[facei]);
 
                 pTu[facei] =
                     this->patchFaceReactants(patchi, facei)
diff --git a/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hsPsiMixtureThermo/hsPsiMixtureThermo.C b/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hsPsiMixtureThermo/hsPsiMixtureThermo.C
index 08814a64fcebc03e8581703824eb06d6df30ad50..76f0a3a52f0378c5cfc8957b8c1c51b8863e5ce1 100644
--- a/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hsPsiMixtureThermo/hsPsiMixtureThermo.C
+++ b/src/thermophysicalModels/reactionThermo/combustionThermo/mixtureThermos/hsPsiMixtureThermo/hsPsiMixtureThermo.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -84,7 +84,7 @@ void Foam::hsPsiMixtureThermo<MixtureType>::calculate()
         psiCells[celli] = mixture_.psi(pCells[celli], TCells[celli]);
 
         muCells[celli] = mixture_.mu(TCells[celli]);
-        alphaCells[celli] = mixture_.alpha(TCells[celli]);
+        alphaCells[celli] = mixture_.alphah(TCells[celli]);
     }
 
     forAll(T_.boundaryField(), patchi)
@@ -109,7 +109,7 @@ void Foam::hsPsiMixtureThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 pmu_[facei] = mixture_.mu(pT[facei]);
-                palpha_[facei] = mixture_.alpha(pT[facei]);
+                palpha_[facei] = mixture_.alphah(pT[facei]);
             }
         }
         else
@@ -123,7 +123,7 @@ void Foam::hsPsiMixtureThermo<MixtureType>::calculate()
 
                 ppsi[facei] = mixture_.psi(pp[facei], pT[facei]);
                 pmu_[facei] = mixture_.mu(pT[facei]);
-                palpha_[facei] = mixture_.alpha(pT[facei]);
+                palpha_[facei] = mixture_.alphah(pT[facei]);
             }
         }
     }
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/basicMultiComponentMixture/basicMultiComponentMixture.H b/src/thermophysicalModels/reactionThermo/mixtures/basicMultiComponentMixture/basicMultiComponentMixture.H
index 6d93e5cc0e03356d0f3d118b6937546e6b1a4dc5..5fbeccdb96ff0570566d54ee9bc2798e083b7fe7 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/basicMultiComponentMixture/basicMultiComponentMixture.H
+++ b/src/thermophysicalModels/reactionThermo/mixtures/basicMultiComponentMixture/basicMultiComponentMixture.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -166,8 +166,13 @@ public:
             //- Thermal conductivity [W/m/K]
             virtual scalar kappa(const label specieI, const scalar T) const = 0;
 
-            //- Thermal diffusivity [kg/m/s]
-            virtual scalar alpha(const label specieI, const scalar T) const = 0;
+            //- Thermal diffusivity enthalpy [kg/m/s]
+            virtual scalar alphah(const label specieI, const scalar T) const
+                = 0;
+
+            //- Thermal diffusivity internal energy [kg/m/s]
+            virtual scalar alphae(const label specieI, const scalar T) const
+                = 0;
 };
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/dieselMixture/dieselMixture.C b/src/thermophysicalModels/reactionThermo/mixtures/dieselMixture/dieselMixture.C
index c6b9126408acb77e9bc10f5117e727e8545714de..50ffce15d1aa59af8eb9f6b06c6e50e97b97e1d4 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/dieselMixture/dieselMixture.C
+++ b/src/thermophysicalModels/reactionThermo/mixtures/dieselMixture/dieselMixture.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -272,13 +272,24 @@ Foam::scalar Foam::dieselMixture<ThermoType>::kappa
 
 
 template<class ThermoType>
-Foam::scalar Foam::dieselMixture<ThermoType>::alpha
+Foam::scalar Foam::dieselMixture<ThermoType>::alphah
 (
     const label specieI,
     const scalar T
 ) const
 {
-    return getLocalThermo(specieI).alpha(T);
+    return getLocalThermo(specieI).alphah(T);
+}
+
+
+template<class ThermoType>
+Foam::scalar Foam::dieselMixture<ThermoType>::alphae
+(
+    const label specieI,
+    const scalar T
+) const
+{
+    return getLocalThermo(specieI).alphae(T);
 }
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/dieselMixture/dieselMixture.H b/src/thermophysicalModels/reactionThermo/mixtures/dieselMixture/dieselMixture.H
index 67c43c626dc5c09df412731c62b85d2fbb5291a9..e62670a5ae172be75011280e8db9ad684642cf7c 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/dieselMixture/dieselMixture.H
+++ b/src/thermophysicalModels/reactionThermo/mixtures/dieselMixture/dieselMixture.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -203,8 +203,11 @@ public:
             //- Thermal conductivity [W/m/K]
             virtual scalar kappa(const label specieI, const scalar T) const;
 
-            //- Thermal diffusivity [kg/m/s]
-            virtual scalar alpha(const label specieI, const scalar T) const;
+            //- Thermal diffusivity for enthalpy [kg/m/s]
+            virtual scalar alphah(const label specieI, const scalar T) const;
+
+            //- Thermal diffusivity for internal energy [kg/m/s]
+            virtual scalar alphae(const label specieI, const scalar T) const;
 };
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/egrMixture/egrMixture.C b/src/thermophysicalModels/reactionThermo/mixtures/egrMixture/egrMixture.C
index 8bb9e5584b7278dd1144add0346bf44decbaa492..e1c992449b07318d085f7fcb2508ac79204fc72d 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/egrMixture/egrMixture.C
+++ b/src/thermophysicalModels/reactionThermo/mixtures/egrMixture/egrMixture.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -282,13 +282,24 @@ Foam::scalar Foam::egrMixture<ThermoType>::kappa
 
 
 template<class ThermoType>
-Foam::scalar Foam::egrMixture<ThermoType>::alpha
+Foam::scalar Foam::egrMixture<ThermoType>::alphah
 (
     const label specieI,
     const scalar T
 ) const
 {
-    return getLocalThermo(specieI).alpha(T);
+    return getLocalThermo(specieI).alphah(T);
+}
+
+
+template<class ThermoType>
+Foam::scalar Foam::egrMixture<ThermoType>::alphae
+(
+    const label specieI,
+    const scalar T
+) const
+{
+    return getLocalThermo(specieI).alphae(T);
 }
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/egrMixture/egrMixture.H b/src/thermophysicalModels/reactionThermo/mixtures/egrMixture/egrMixture.H
index cabe6057f6915eadb659b94e8c7f389da2f84a8e..838162792d9fdc90a973445e8456a7a6bb10af33 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/egrMixture/egrMixture.H
+++ b/src/thermophysicalModels/reactionThermo/mixtures/egrMixture/egrMixture.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -219,8 +219,11 @@ public:
             //- Thermal conductivity [W/m/K]
             virtual scalar kappa(const label specieI, const scalar T) const;
 
-            //- Thermal diffusivity [kg/m/s]
-            virtual scalar alpha(const label specieI, const scalar T) const;
+            //- Thermal diffusivity enthalpy [kg/m/s]
+            virtual scalar alphah(const label specieI, const scalar T) const;
+
+            //- Thermal diffusivity internal energy [kg/m/s]
+            virtual scalar alphae(const label specieI, const scalar T) const;
 };
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/homogeneousMixture/homogeneousMixture.C b/src/thermophysicalModels/reactionThermo/mixtures/homogeneousMixture/homogeneousMixture.C
index a44261324af935bfe58551e86c23cfc05e398f06..297adb9a00fd93558c66589c19fb06729ca1f412 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/homogeneousMixture/homogeneousMixture.C
+++ b/src/thermophysicalModels/reactionThermo/mixtures/homogeneousMixture/homogeneousMixture.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -261,13 +261,24 @@ Foam::scalar Foam::homogeneousMixture<ThermoType>::kappa
 
 
 template<class ThermoType>
-Foam::scalar Foam::homogeneousMixture<ThermoType>::alpha
+Foam::scalar Foam::homogeneousMixture<ThermoType>::alphah
 (
     const label specieI,
     const scalar T
 ) const
 {
-    return getLocalThermo(specieI).alpha(T);
+    return getLocalThermo(specieI).alphah(T);
+}
+
+
+template<class ThermoType>
+Foam::scalar Foam::homogeneousMixture<ThermoType>::alphae
+(
+    const label specieI,
+    const scalar T
+) const
+{
+    return getLocalThermo(specieI).alphae(T);
 }
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/homogeneousMixture/homogeneousMixture.H b/src/thermophysicalModels/reactionThermo/mixtures/homogeneousMixture/homogeneousMixture.H
index 9b5f9f080213f88593960991198b3f9cfea5d3a1..bb4f19a17b874bf35f4febd45e9524e83fe1b0f9 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/homogeneousMixture/homogeneousMixture.H
+++ b/src/thermophysicalModels/reactionThermo/mixtures/homogeneousMixture/homogeneousMixture.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -177,8 +177,11 @@ public:
             //- Thermal conductivity [W/m/K]
             virtual scalar kappa(const label specieI, const scalar T) const;
 
-            //- Thermal diffusivity [kg/m/s]
-            virtual scalar alpha(const label specieI, const scalar T) const;
+            //- Thermal diffusivity enthalpy [kg/m/s]
+            virtual scalar alphah(const label specieI, const scalar T) const;
+
+            //- Thermal diffusivity internal energy [kg/m/s]
+            virtual scalar alphae(const label specieI, const scalar T) const;
 };
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/inhomogeneousMixture/inhomogeneousMixture.C b/src/thermophysicalModels/reactionThermo/mixtures/inhomogeneousMixture/inhomogeneousMixture.C
index 2b6c5fc73f6d2fede8896832591cbaccd5e00a7e..38f9284c9a8fe370c1255636b65a1f520bb342e8 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/inhomogeneousMixture/inhomogeneousMixture.C
+++ b/src/thermophysicalModels/reactionThermo/mixtures/inhomogeneousMixture/inhomogeneousMixture.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -277,13 +277,24 @@ Foam::scalar Foam::inhomogeneousMixture<ThermoType>::kappa
 
 
 template<class ThermoType>
-Foam::scalar Foam::inhomogeneousMixture<ThermoType>::alpha
+Foam::scalar Foam::inhomogeneousMixture<ThermoType>::alphah
 (
     const label specieI,
     const scalar T
 ) const
 {
-    return getLocalThermo(specieI).alpha(T);
+    return getLocalThermo(specieI).alphah(T);
+}
+
+
+template<class ThermoType>
+Foam::scalar Foam::inhomogeneousMixture<ThermoType>::alphae
+(
+    const label specieI,
+    const scalar T
+) const
+{
+    return getLocalThermo(specieI).alphae(T);
 }
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/inhomogeneousMixture/inhomogeneousMixture.H b/src/thermophysicalModels/reactionThermo/mixtures/inhomogeneousMixture/inhomogeneousMixture.H
index 9a4544b084c569e0f0d0d45d1ead0a2b6318b9c6..2a779fd38261e161795cf0515f1ddc2392dd0f32 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/inhomogeneousMixture/inhomogeneousMixture.H
+++ b/src/thermophysicalModels/reactionThermo/mixtures/inhomogeneousMixture/inhomogeneousMixture.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -208,8 +208,11 @@ public:
             //- Thermal conductivity [W/m/K]
             virtual scalar kappa(const label specieI, const scalar T) const;
 
-            //- Thermal diffusivity [kg/m/s]
-            virtual scalar alpha(const label specieI, const scalar T) const;
+            //- Thermal diffusivity for enthalpy [kg/m/s]
+            virtual scalar alphah(const label specieI, const scalar T) const;
+
+            //- Thermal diffusivity for internal energy [kg/m/s]
+            virtual scalar alphae(const label specieI, const scalar T) const;
 };
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/multiComponentMixture/multiComponentMixture.C b/src/thermophysicalModels/reactionThermo/mixtures/multiComponentMixture/multiComponentMixture.C
index 3d78443860ff996c24d313f7da22119ce14b7064..3718fc3edf7493ac66415c181181a2e353b3eb1f 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/multiComponentMixture/multiComponentMixture.C
+++ b/src/thermophysicalModels/reactionThermo/mixtures/multiComponentMixture/multiComponentMixture.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -302,13 +302,24 @@ Foam::scalar Foam::multiComponentMixture<ThermoType>::kappa
 
 
 template<class ThermoType>
-Foam::scalar Foam::multiComponentMixture<ThermoType>::alpha
+Foam::scalar Foam::multiComponentMixture<ThermoType>::alphah
 (
     const label specieI,
     const scalar T
 ) const
 {
-    return speciesData_[specieI].alpha(T);
+    return speciesData_[specieI].alphah(T);
+}
+
+
+template<class ThermoType>
+Foam::scalar Foam::multiComponentMixture<ThermoType>::alphae
+(
+    const label specieI,
+    const scalar T
+) const
+{
+    return speciesData_[specieI].alphae(T);
 }
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/multiComponentMixture/multiComponentMixture.H b/src/thermophysicalModels/reactionThermo/mixtures/multiComponentMixture/multiComponentMixture.H
index f699b354bbf2bd41617f74edabf68af702160a1b..5838f517022b0d3bf526236df0b30bd7ff2c99b8 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/multiComponentMixture/multiComponentMixture.H
+++ b/src/thermophysicalModels/reactionThermo/mixtures/multiComponentMixture/multiComponentMixture.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -167,8 +167,11 @@ public:
             //- Thermal conductivity [W/m/K]
             virtual scalar kappa(const label specieI, const scalar T) const;
 
-            //- Thermal diffusivity [kg/m/s]
-            virtual scalar alpha(const label specieI, const scalar T) const;
+            //- Thermal diffusivity of enthalpy [kg/m/s]
+            virtual scalar alphah(const label specieI, const scalar T) const;
+
+            //- Thermal diffusivity of internal energy[kg/m/s]
+            virtual scalar alphae(const label specieI, const scalar T) const;
 };
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/veryInhomogeneousMixture/veryInhomogeneousMixture.C b/src/thermophysicalModels/reactionThermo/mixtures/veryInhomogeneousMixture/veryInhomogeneousMixture.C
index d8ac45ca0219e64a5b163066ab4c2738af8736f1..076693aab766a7e23df7aafaa22e77e50a6f40ba 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/veryInhomogeneousMixture/veryInhomogeneousMixture.C
+++ b/src/thermophysicalModels/reactionThermo/mixtures/veryInhomogeneousMixture/veryInhomogeneousMixture.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -278,13 +278,24 @@ Foam::scalar Foam::veryInhomogeneousMixture<ThermoType>::kappa
 
 
 template<class ThermoType>
-Foam::scalar Foam::veryInhomogeneousMixture<ThermoType>::alpha
+Foam::scalar Foam::veryInhomogeneousMixture<ThermoType>::alphah
 (
     const label specieI,
     const scalar T
 ) const
 {
-    return getLocalThermo(specieI).alpha(T);
+    return getLocalThermo(specieI).alphah(T);
+}
+
+
+template<class ThermoType>
+Foam::scalar Foam::veryInhomogeneousMixture<ThermoType>::alphae
+(
+    const label specieI,
+    const scalar T
+) const
+{
+    return getLocalThermo(specieI).alphae(T);
 }
 
 
diff --git a/src/thermophysicalModels/reactionThermo/mixtures/veryInhomogeneousMixture/veryInhomogeneousMixture.H b/src/thermophysicalModels/reactionThermo/mixtures/veryInhomogeneousMixture/veryInhomogeneousMixture.H
index 0e3bfde7b9b2576497d86045f126eb1bab86fa2c..578ace1e6cd319ce0f426fa5915b5f5835367749 100644
--- a/src/thermophysicalModels/reactionThermo/mixtures/veryInhomogeneousMixture/veryInhomogeneousMixture.H
+++ b/src/thermophysicalModels/reactionThermo/mixtures/veryInhomogeneousMixture/veryInhomogeneousMixture.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -209,8 +209,11 @@ public:
             //- Thermal conductivity [W/m/K]
             virtual scalar kappa(const label specieI, const scalar T) const;
 
-            //- Thermal diffusivity [kg/m/s]
-            virtual scalar alpha(const label specieI, const scalar T) const;
+            //- Thermal diffusivity for enthalpy [kg/m/s]
+            virtual scalar alphah(const label specieI, const scalar T) const;
+
+            //- Thermal diffusivity for internal energy [kg/m/s]
+            virtual scalar alphae(const label specieI, const scalar T) const;
 };
 
 
diff --git a/src/thermophysicalModels/reactionThermo/reactionThermo/mixtureThermos/hRhoMixtureThermo/hRhoMixtureThermo.C b/src/thermophysicalModels/reactionThermo/reactionThermo/mixtureThermos/hRhoMixtureThermo/hRhoMixtureThermo.C
index ddad4dba51de6dc63b62e316143251acf957f217..5229bea1e7062f90cc0d8d10e4ec94e907fa1082 100644
--- a/src/thermophysicalModels/reactionThermo/reactionThermo/mixtureThermos/hRhoMixtureThermo/hRhoMixtureThermo.C
+++ b/src/thermophysicalModels/reactionThermo/reactionThermo/mixtureThermos/hRhoMixtureThermo/hRhoMixtureThermo.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -51,7 +51,7 @@ void Foam::hRhoMixtureThermo<MixtureType>::calculate()
         rhoCells[celli] = mixture.rho(pCells[celli], TCells[celli]);
 
         muCells[celli] = mixture.mu(TCells[celli]);
-        alphaCells[celli] = mixture.alpha(TCells[celli]);
+        alphaCells[celli] = mixture.alphah(TCells[celli]);
     }
 
     forAll(T_.boundaryField(), patchi)
@@ -78,7 +78,7 @@ void Foam::hRhoMixtureThermo<MixtureType>::calculate()
                 ppsi[facei] = mixture.psi(pp[facei], pT[facei]);
                 prho[facei] = mixture.rho(pp[facei], pT[facei]);
                 pmu_[facei] = mixture.mu(pT[facei]);
-                palpha_[facei] = mixture.alpha(pT[facei]);
+                palpha_[facei] = mixture.alphah(pT[facei]);
             }
         }
         else
@@ -93,7 +93,7 @@ void Foam::hRhoMixtureThermo<MixtureType>::calculate()
                 ppsi[facei] = mixture.psi(pp[facei], pT[facei]);
                 prho[facei] = mixture.rho(pp[facei], pT[facei]);
                 pmu_[facei] = mixture.mu(pT[facei]);
-                palpha_[facei] = mixture.alpha(pT[facei]);
+                palpha_[facei] = mixture.alphah(pT[facei]);
             }
         }
     }
diff --git a/src/thermophysicalModels/reactionThermo/reactionThermo/mixtureThermos/hsRhoMixtureThermo/hsRhoMixtureThermo.C b/src/thermophysicalModels/reactionThermo/reactionThermo/mixtureThermos/hsRhoMixtureThermo/hsRhoMixtureThermo.C
index bd1095f46f0cec362cd470e1ac35824da7223307..6277287cbcd1e4ebe49b05dce510c2eda934bb76 100644
--- a/src/thermophysicalModels/reactionThermo/reactionThermo/mixtureThermos/hsRhoMixtureThermo/hsRhoMixtureThermo.C
+++ b/src/thermophysicalModels/reactionThermo/reactionThermo/mixtureThermos/hsRhoMixtureThermo/hsRhoMixtureThermo.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -51,7 +51,7 @@ void Foam::hsRhoMixtureThermo<MixtureType>::calculate()
         rhoCells[celli] = mixture.rho(pCells[celli], TCells[celli]);
 
         muCells[celli] = mixture.mu(TCells[celli]);
-        alphaCells[celli] = mixture.alpha(TCells[celli]);
+        alphaCells[celli] = mixture.alphah(TCells[celli]);
     }
 
     forAll(T_.boundaryField(), patchi)
@@ -78,7 +78,7 @@ void Foam::hsRhoMixtureThermo<MixtureType>::calculate()
                 ppsi[facei] = mixture.psi(pp[facei], pT[facei]);
                 prho[facei] = mixture.rho(pp[facei], pT[facei]);
                 pmu_[facei] = mixture.mu(pT[facei]);
-                palpha_[facei] = mixture.alpha(pT[facei]);
+                palpha_[facei] = mixture.alphah(pT[facei]);
             }
         }
         else
@@ -93,7 +93,7 @@ void Foam::hsRhoMixtureThermo<MixtureType>::calculate()
                 ppsi[facei] = mixture.psi(pp[facei], pT[facei]);
                 prho[facei] = mixture.rho(pp[facei], pT[facei]);
                 pmu_[facei] = mixture.mu(pT[facei]);
-                palpha_[facei] = mixture.alpha(pT[facei]);
+                palpha_[facei] = mixture.alphah(pT[facei]);
             }
         }
     }
diff --git a/src/thermophysicalModels/solid/radiation/const/constSolidRad.C b/src/thermophysicalModels/solid/radiation/const/constSolidRad.C
index 93fda8663e5a1c3cde836a062ea13b9d1dac0791..9a1ecdc89fc05cb5509f486e9edc53e2bcb8fd6c 100644
--- a/src/thermophysicalModels/solid/radiation/const/constSolidRad.C
+++ b/src/thermophysicalModels/solid/radiation/const/constSolidRad.C
@@ -37,7 +37,7 @@ template<class thermo>
 constSolidRad<thermo>::constSolidRad(const dictionary& dict)
 :
     thermo(dict),
-    kappa_(readScalar(dict.subDict("radiation").lookup("kappa"))),
+    kappaRad_(readScalar(dict.subDict("radiation").lookup("kappaRad"))),
     sigmaS_(readScalar(dict.subDict("radiation").lookup("sigmaS"))),
     emissivity_(readScalar(dict.subDict("radiation").lookup("emissivity")))
 {}
@@ -49,7 +49,7 @@ template<class thermo>
 Ostream& operator<<(Ostream& os, const constSolidRad<thermo>& pg)
 {
     os  << static_cast<const thermo&>(pg);
-    os << tab << pg.kappa_ << tab << pg.sigmaS_ << tab << pg.emissivity_;
+    os << tab << pg.kappaRad_ << tab << pg.sigmaS_ << tab << pg.emissivity_;
 
     os.check("Ostream& operator<<(Ostream& os, const constSolidRad& st)");
     return os;
diff --git a/src/thermophysicalModels/solid/radiation/const/constSolidRad.H b/src/thermophysicalModels/solid/radiation/const/constSolidRad.H
index 6919763077af937e67a7a5f67a54e937a15dd08c..0e65de99c96b708432bb6d3840bd67da10489581 100644
--- a/src/thermophysicalModels/solid/radiation/const/constSolidRad.H
+++ b/src/thermophysicalModels/solid/radiation/const/constSolidRad.H
@@ -62,7 +62,7 @@ class constSolidRad
     // Private data
 
         //- Absorption coefficient
-        scalar kappa_;
+        scalar kappaRad_;
 
         //- Scattering coefficient
         scalar sigmaS_;
@@ -75,7 +75,7 @@ class constSolidRad
         inline constSolidRad
         (
             const thermo& t,
-            const scalar kappa,
+            const scalar kappaRad,
             const scalar sigmaS,
             const scalar emissivity
         );
@@ -101,7 +101,7 @@ public:
     // Member functions
 
         //- Return absorption coefficient [1/m]
-        inline scalar kappa(scalar T) const;
+        inline scalar kappaRad(scalar T) const;
 
         //- Return scattering [1/m]
         inline scalar sigmaS(scalar T) const;
diff --git a/src/thermophysicalModels/solid/radiation/const/constSolidRadI.H b/src/thermophysicalModels/solid/radiation/const/constSolidRadI.H
index 667fae827a161c204251ab0a1d58488e6c993b6c..d60dce0834ff3a5e744f535dca3b6d4c12b85c25 100644
--- a/src/thermophysicalModels/solid/radiation/const/constSolidRadI.H
+++ b/src/thermophysicalModels/solid/radiation/const/constSolidRadI.H
@@ -36,13 +36,13 @@ template<class thermo>
 inline constSolidRad<thermo>::constSolidRad
 (
     const thermo& t,
-    const scalar kappa,
+    const scalar kappaRad,
     const scalar sigmaS,
     const scalar emissivity
 )
 :
     thermo(t),
-    kappa_(kappa),
+    kappaRad_(kappaRad),
     sigmaS_(sigmaS),
     emissivity_(emissivity)
 {}
@@ -59,7 +59,7 @@ inline constSolidRad<thermo>::constSolidRad
 )
 :
     thermo(name, pg),
-    kappa_(pg.kappa_),
+    kappaRad_(pg.kappaRad_),
     sigmaS_(pg.sigmaS_),
     emissivity_(pg.emissivity_)
 {}
@@ -82,9 +82,9 @@ inline autoPtr<constSolidRad<thermo> > constSolidRad<thermo>::New(Istream& is)
 // * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
 
 template<class thermo>
-inline scalar constSolidRad<thermo>::kappa(scalar) const
+inline scalar constSolidRad<thermo>::kappaRad(scalar) const
 {
-    return kappa_;
+    return kappaRad_;
 }
 
 
diff --git a/src/thermophysicalModels/solid/transport/const/constSolidTransport.C b/src/thermophysicalModels/solid/transport/const/constSolidTransport.C
index 1995333659a9d172d4c79baf6f6f6cd818024085..dd34e20522bc58dc66e74ea3cac76c458047a24f 100644
--- a/src/thermophysicalModels/solid/transport/const/constSolidTransport.C
+++ b/src/thermophysicalModels/solid/transport/const/constSolidTransport.C
@@ -32,7 +32,7 @@ template<class thermo>
 Foam::constSolidTransport<thermo>::constSolidTransport(const dictionary& dict)
 :
     thermo(dict),
-    K_(readScalar(dict.subDict("transport").lookup("K")))
+    kappa_(readScalar(dict.subDict("transport").lookup("kappa")))
 {}
 
 
@@ -46,7 +46,7 @@ Foam::Ostream& Foam::operator<<
 )
 {
     operator<<(os, static_cast<const thermo&>(ct));
-    os << tab << ct.K_;
+    os << tab << ct.kappa_;
 
     os.check("Ostream& operator<<(Ostream& os,const constSolidTransport& ct)");
 
diff --git a/src/thermophysicalModels/solid/transport/const/constSolidTransport.H b/src/thermophysicalModels/solid/transport/const/constSolidTransport.H
index be7b0241f819dc3dd19c61e9c721b33ff742aaab..fb8b40e5c3ea889351feac879e2cff4893238d31 100644
--- a/src/thermophysicalModels/solid/transport/const/constSolidTransport.H
+++ b/src/thermophysicalModels/solid/transport/const/constSolidTransport.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -65,7 +65,7 @@ class constSolidTransport
     // Private data
 
         //- Constant thermal conductivity.
-        scalar K_;
+        scalar kappa_;
 
 
     // Private Member Functions
@@ -74,7 +74,7 @@ class constSolidTransport
         inline constSolidTransport
         (
             const thermo& t,
-            const scalar k
+            const scalar kappa
         );
 
 
@@ -93,10 +93,7 @@ public:
     // Member functions
 
         //- Thermal conductivity [W/mK]
-        inline scalar K(const scalar T) const;
-
-        //- Thermal diffusivity [kg/ms]
-        inline scalar alpha(const scalar T) const;
+        inline scalar kappa(const scalar T) const;
 
 
     // Ostream Operator
diff --git a/src/thermophysicalModels/solid/transport/const/constSolidTransportI.H b/src/thermophysicalModels/solid/transport/const/constSolidTransportI.H
index 52a031b8c9b9d3361d210d1947bd99250ed273a8..639f3179c7a5a221873039c9917104f5af82137d 100644
--- a/src/thermophysicalModels/solid/transport/const/constSolidTransportI.H
+++ b/src/thermophysicalModels/solid/transport/const/constSolidTransportI.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -29,11 +29,11 @@ template<class thermo>
 inline Foam::constSolidTransport<thermo>::constSolidTransport
 (
     const thermo& t,
-    const scalar k
+    const scalar kappa
 )
 :
     thermo(t),
-    K_(k)
+    kappa_(kappa)
 {}
 
 
@@ -45,30 +45,17 @@ inline Foam::constSolidTransport<thermo>::constSolidTransport
 )
 :
     thermo(name, ct),
-    K_(ct.K_)
+    kappa_(ct.kappa_)
 {}
 
 
 // * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
 
 template<class thermo>
-inline Foam::scalar Foam::constSolidTransport<thermo>::K(const scalar T) const
+inline Foam::scalar Foam::constSolidTransport<thermo>::
+kappa(const scalar T) const
 {
-    return K_;
-}
-
-
-template<class thermo>
-inline Foam::scalar Foam::constSolidTransport<thermo>::alpha
-(
-    const scalar T
-) const
-{
-    scalar Cp = this->Cp(T);
-
-    scalar rho = this->rho(T);
-
-    return K_/(rho*Cp);
+    return kappa_;
 }
 
 
diff --git a/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransport.C b/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransport.C
index 233f94e2fffb61b7ba175e5b7dcf4c1bcca4a5dd..8aea92bf06b3945a87f0601474fa089f637d84c4 100644
--- a/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransport.C
+++ b/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransport.C
@@ -35,12 +35,12 @@ Foam::exponentialSolidTransport<thermo>::exponentialSolidTransport
 )
 :
     thermo(dict),
-    K0_(0.0),
+    kappa0_(0.0),
     n0_(0.0),
     Tref_(0.0)
 {
     const dictionary& subDict = dict.subDict("transport");
-    K0_ = readScalar(subDict.lookup("K0"));
+    kappa0_ = readScalar(subDict.lookup("kappa0"));
     n0_ = readScalar(subDict.lookup("n0"));
     Tref_ = readScalar(subDict.lookup("Tref"));
 }
@@ -55,7 +55,7 @@ Foam::Ostream& Foam::operator<<
 )
 {
     operator<<(os, static_cast<const thermo&>(et));
-    os << tab << et.K0_  << tab << et.n0_ << tab << et.Tref_;
+    os << tab << et.kappa0_  << tab << et.n0_ << tab << et.Tref_;
 
     os.check
     (
diff --git a/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransport.H b/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransport.H
index 397b2a3ee93a78f0aa56e6fd5681ae8e04ae1cf6..5e29f4f729836bc928e234d2f69a6712a95c7d67 100644
--- a/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransport.H
+++ b/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransport.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -64,7 +64,7 @@ class exponentialSolidTransport
     // Private data
 
         //- Constant thermal coefficient.
-        scalar K0_;
+        scalar kappa0_;
 
         //- Exponent coefficient
         scalar n0_;
@@ -79,7 +79,7 @@ class exponentialSolidTransport
         inline exponentialSolidTransport
         (
             const thermo& t,
-            const scalar K0,
+            const scalar kappa0,
             const scalar n0,
             const scalar Tref
         );
@@ -104,10 +104,7 @@ public:
     // Member functions
 
         //- Thermal conductivity [W/mK]
-        inline scalar K(const scalar T) const;
-
-        //- Thermal diffusivity [kg/ms]
-        inline scalar alpha(const scalar T) const;
+        inline scalar kappa(const scalar T) const;
 
 
     // Ostream Operator
diff --git a/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransportI.H b/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransportI.H
index 3df0e70416be385b29a1d9d35240a12a684c172e..e46eec9165f534e05f4f333c452b8d618c8eae6d 100644
--- a/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransportI.H
+++ b/src/thermophysicalModels/solid/transport/exponential/exponentialSolidTransportI.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -29,13 +29,13 @@ template<class thermo>
 inline Foam::exponentialSolidTransport<thermo>::exponentialSolidTransport
 (
     const thermo& t,
-    const scalar K0,
+    const scalar kappa0,
     const scalar n0,
     const scalar Tref
 )
 :
     thermo(t),
-    K0_(K0),
+    kappa0_(kappa0),
     n0_(n0),
     Tref_(Tref)
 {}
@@ -49,7 +49,7 @@ inline Foam::exponentialSolidTransport<thermo>::exponentialSolidTransport
 )
 :
     thermo(name, ct),
-    K0_(ct.K0_),
+    kappa0_(ct.kappa0_),
     n0_(ct.n0_),
     Tref_(ct.Tref_)
 {}
@@ -58,27 +58,14 @@ inline Foam::exponentialSolidTransport<thermo>::exponentialSolidTransport
 // * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
 
 template<class thermo>
-inline Foam::scalar Foam::exponentialSolidTransport<thermo>::K
+inline Foam::scalar Foam::exponentialSolidTransport<thermo>::kappa
 (
     const scalar T
 ) const
 {
-    return (K0_*pow(T/Tref_, n0_));
+    return (kappa0_*pow(T/Tref_, n0_));
 }
 
 
-template<class thermo>
-inline Foam::scalar Foam::exponentialSolidTransport<thermo>::alpha
-(
-    const scalar T
-) const
-{
-    scalar Cp = this->Cp(T);
-
-    scalar rho = this->rho(T);
-
-    return (K(T)/(rho*Cp));
-}
-
 
 // ************************************************************************* //
diff --git a/src/thermophysicalModels/specie/Make/files b/src/thermophysicalModels/specie/Make/files
index 2be4ebfff18a3f84a9b9d69004d6d647a29962bd..29d3c029ef1064f59070bcb8fd00a3811e11f9de 100644
--- a/src/thermophysicalModels/specie/Make/files
+++ b/src/thermophysicalModels/specie/Make/files
@@ -7,6 +7,7 @@ $(atomicWeights)/atomicWeights.C
 $(specie)/specie.C
 $(equationOfState)/perfectGas/perfectGas.C
 $(equationOfState)/incompressible/incompressible.C
+$(equationOfState)/pressurePerfectGas/pressurePerfectGas.C
 $(reactions)/makeChemkinReactions.C
 $(reactions)/makeReactionThermoReactions.C
 $(reactions)/makeLangmuirHinshelwoodReactions.C
diff --git a/src/thermophysicalModels/specie/equationOfState/pressurePerfectGas/pressurePerfectGas.C b/src/thermophysicalModels/specie/equationOfState/pressurePerfectGas/pressurePerfectGas.C
new file mode 100644
index 0000000000000000000000000000000000000000..4a58751472d87e11a5ee2d1c55eb45eec5ad354e
--- /dev/null
+++ b/src/thermophysicalModels/specie/equationOfState/pressurePerfectGas/pressurePerfectGas.C
@@ -0,0 +1,71 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "pressurePerfectGas.H"
+#include "IOstreams.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::pressurePerfectGas::pressurePerfectGas(Istream& is)
+:
+    specie(is),
+    pRef_(readScalar(is))
+{
+    is.check("pressurePerfectGas::pressurePerfectGas(Istream& is)");
+}
+
+
+Foam::pressurePerfectGas::pressurePerfectGas(const dictionary& dict)
+:
+    specie(dict),
+    pRef_(readScalar(dict.subDict("equationOfState").lookup("pRef")))
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+void Foam::pressurePerfectGas::write(Ostream& os) const
+{
+    specie::write(os);
+    dictionary dict("equationOfState");
+    dict.add("pRef", pRef_);
+
+    os  << indent << dict.dictName() << dict;
+}
+
+
+// * * * * * * * * * * * * * * * Ostream Operator  * * * * * * * * * * * * * //
+
+Foam::Ostream& Foam::operator<<(Ostream& os, const pressurePerfectGas& pg)
+{
+    os  << static_cast<const specie&>(pg)
+        << token::SPACE << pg.pRef_;
+
+    os.check("Ostream& operator<<(Ostream& os, const pressurePerfectGas& st)");
+    return os;
+}
+
+
+// ************************************************************************* //
diff --git a/src/thermophysicalModels/specie/equationOfState/pressurePerfectGas/pressurePerfectGas.H b/src/thermophysicalModels/specie/equationOfState/pressurePerfectGas/pressurePerfectGas.H
new file mode 100644
index 0000000000000000000000000000000000000000..40f4938568cbb39ef55cd19b770cd48f04146243
--- /dev/null
+++ b/src/thermophysicalModels/specie/equationOfState/pressurePerfectGas/pressurePerfectGas.H
@@ -0,0 +1,160 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::pressurePerfectGas
+
+Description
+    Perfect gas equation of state usign a reference pressure
+
+SourceFiles
+    pressurePerfectGasI.H
+    pressurePerfectGas.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef pressurePerfectGas_H
+#define pressurePerfectGas_H
+
+#include "specie.H"
+#include "autoPtr.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                           Class pressurePerfectGas Declaration
+\*---------------------------------------------------------------------------*/
+
+class pressurePerfectGas
+:
+    public specie
+{
+    // Private data
+
+        //- Reference pressure
+        scalar pRef_;
+
+
+public:
+
+    // Constructors
+
+        //- Construct from components
+        inline pressurePerfectGas(const specie& sp);
+
+        //- Construct from Istream
+        pressurePerfectGas(Istream&);
+
+        //- Construct from dictionary
+        pressurePerfectGas(const dictionary& dict);
+
+        //- Construct as named copy
+        inline pressurePerfectGas(const word& name, const pressurePerfectGas&);
+
+        //- Construct and return a clone
+        inline autoPtr<pressurePerfectGas> clone() const;
+
+        // Selector from Istream
+        inline static autoPtr<pressurePerfectGas> New(Istream& is);
+
+        // Selector from dictionary
+        inline static autoPtr<pressurePerfectGas> New(const dictionary& dict);
+
+
+    // Member functions
+
+        // Fundamental properties
+
+            //- Return density [kg/m^3]
+            inline scalar rho(scalar p, scalar T) const;
+
+            //- Return compressibility rho/p [s^2/m^2]
+            inline scalar psi(scalar p, scalar T) const;
+
+            //- Return compression factor []
+            inline scalar Z(scalar p, scalar T) const;
+
+
+        // I-O
+
+            //- Write to Ostream
+            void write(Ostream& os) const;
+
+
+    // Member operators
+
+        inline void operator+=(const pressurePerfectGas&);
+        inline void operator-=(const pressurePerfectGas&);
+
+        inline void operator*=(const scalar);
+
+
+    // Friend operators
+
+        inline friend pressurePerfectGas operator+
+        (
+            const pressurePerfectGas&,
+            const pressurePerfectGas&
+        );
+
+        inline friend pressurePerfectGas operator-
+        (
+            const pressurePerfectGas&,
+            const pressurePerfectGas&
+        );
+
+        inline friend pressurePerfectGas operator*
+        (
+            const scalar s,
+            const pressurePerfectGas&
+        );
+
+        inline friend pressurePerfectGas operator==
+        (
+            const pressurePerfectGas&,
+            const pressurePerfectGas&
+        );
+
+
+    // Ostream Operator
+
+        friend Ostream& operator<<(Ostream&, const pressurePerfectGas&);
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#include "pressurePerfectGasI.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/thermophysicalModels/specie/equationOfState/pressurePerfectGas/pressurePerfectGasI.H b/src/thermophysicalModels/specie/equationOfState/pressurePerfectGas/pressurePerfectGasI.H
new file mode 100644
index 0000000000000000000000000000000000000000..99512ecaeef53ba1cba8f732fe038fe48f149a6a
--- /dev/null
+++ b/src/thermophysicalModels/specie/equationOfState/pressurePerfectGas/pressurePerfectGasI.H
@@ -0,0 +1,163 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2012 OpenFOAM Foundation
+     \\/     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 3 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, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "pressurePerfectGas.H"
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+inline Foam::pressurePerfectGas::pressurePerfectGas(const specie& sp)
+:
+    specie(sp)
+{}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+inline Foam::pressurePerfectGas::pressurePerfectGas
+(
+    const word& name,
+    const pressurePerfectGas& pg
+)
+:
+    specie(name, pg)
+{}
+
+
+inline Foam::autoPtr<Foam::pressurePerfectGas> Foam::pressurePerfectGas::
+clone() const
+{
+    return autoPtr<pressurePerfectGas>(new pressurePerfectGas(*this));
+}
+
+
+inline Foam::autoPtr<Foam::pressurePerfectGas> Foam::pressurePerfectGas::New
+(
+    Istream& is
+)
+{
+    return autoPtr<pressurePerfectGas>(new pressurePerfectGas(is));
+}
+
+
+inline Foam::autoPtr<Foam::pressurePerfectGas> Foam::pressurePerfectGas::New
+(
+    const dictionary& dict
+)
+{
+    return autoPtr<pressurePerfectGas>(new pressurePerfectGas(dict));
+}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+inline Foam::scalar Foam::pressurePerfectGas::rho(scalar p, scalar T) const
+{
+    return pRef_/(R()*T);
+}
+
+
+inline Foam::scalar Foam::pressurePerfectGas::psi(scalar, scalar T) const
+{
+    return 0.0;
+}
+
+
+inline Foam::scalar Foam::pressurePerfectGas::Z(scalar, scalar) const
+{
+    return 0.0;
+}
+
+
+// * * * * * * * * * * * * * * * Member Operators  * * * * * * * * * * * * * //
+
+inline void Foam::pressurePerfectGas::operator+=(const pressurePerfectGas& pg)
+{
+    specie::operator+=(pg);
+}
+
+
+inline void Foam::pressurePerfectGas::operator-=(const pressurePerfectGas& pg)
+{
+    specie::operator-=(pg);
+}
+
+
+inline void Foam::pressurePerfectGas::operator*=(const scalar s)
+{
+    specie::operator*=(s);
+}
+
+
+// * * * * * * * * * * * * * * * Friend Operators  * * * * * * * * * * * * * //
+
+inline Foam::pressurePerfectGas Foam::operator+
+(
+    const pressurePerfectGas& pg1,
+    const pressurePerfectGas& pg2
+)
+{
+    return pressurePerfectGas
+    (
+        static_cast<const specie&>(pg1)
+      + static_cast<const specie&>(pg2)
+    );
+}
+
+
+inline Foam::pressurePerfectGas Foam::operator-
+(
+    const pressurePerfectGas& pg1,
+    const pressurePerfectGas& pg2
+)
+{
+    return pressurePerfectGas
+    (
+        static_cast<const specie&>(pg1)
+      - static_cast<const specie&>(pg2)
+    );
+}
+
+
+inline Foam::pressurePerfectGas Foam::operator*
+(
+    const scalar s,
+    const pressurePerfectGas& pg
+)
+{
+    return pressurePerfectGas(s*static_cast<const specie&>(pg));
+}
+
+
+inline Foam::pressurePerfectGas Foam::operator==
+(
+    const pressurePerfectGas& pg1,
+    const pressurePerfectGas& pg2
+)
+{
+    return pg2 - pg1;
+}
+
+
+// ************************************************************************* //
diff --git a/src/thermophysicalModels/specie/transport/const/constTransport.H b/src/thermophysicalModels/specie/transport/const/constTransport.H
index ca3fbef82926354c97f289539853eed4290e0467..2259a833652041229e021daf972bf963e0e9d44e 100644
--- a/src/thermophysicalModels/specie/transport/const/constTransport.H
+++ b/src/thermophysicalModels/specie/transport/const/constTransport.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -134,8 +134,11 @@ public:
         //- Thermal conductivity [W/mK]
         inline scalar kappa(const scalar T) const;
 
+        //- Thermal diffusivity for internal energy [kg/ms]
+        inline scalar alphae(const scalar T) const;
+
         //- Thermal diffusivity for enthalpy [kg/ms]
-        inline scalar alpha(const scalar T) const;
+        inline scalar alphah(const scalar T) const;
 
         // Species diffusivity
         //inline scalar D(const scalar T) const;
diff --git a/src/thermophysicalModels/specie/transport/const/constTransportI.H b/src/thermophysicalModels/specie/transport/const/constTransportI.H
index 77e4087e457c6eaf5d733348ec14acd025de9e1e..e6ae9bce1f3324203bd52fa7b2ae11f9c3c1d167 100644
--- a/src/thermophysicalModels/specie/transport/const/constTransportI.H
+++ b/src/thermophysicalModels/specie/transport/const/constTransportI.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -69,15 +69,16 @@ inline Foam::scalar Foam::constTransport<Thermo>::kappa(const scalar T) const
 
 
 template<class Thermo>
-inline Foam::scalar Foam::constTransport<Thermo>::alpha(const scalar T) const
+inline Foam::scalar Foam::constTransport<Thermo>::alphae(const scalar T) const
 {
-    scalar Cp_ = this->Cp(T);
+    return this->kappa(T)/this->Cv(T);
+}
 
-    scalar deltaT = T - specie::Tstd;
-    scalar CpBar =
-        (deltaT*(this->H(T) - this->H(specie::Tstd)) + Cp_)/(sqr(deltaT) + 1);
 
-    return Cp_*mu(T)*rPr_/CpBar;
+template<class Thermo>
+inline Foam::scalar Foam::constTransport<Thermo>::alphah(const scalar T) const
+{
+    return mu(T)*rPr_;
 }
 
 
diff --git a/src/thermophysicalModels/specie/transport/polynomial/polynomialTransport.H b/src/thermophysicalModels/specie/transport/polynomial/polynomialTransport.H
index 57f8557d87353f8896238b2e535fa503fe2b040c..67c71b1b93506dbe91538d2624fb0b1b15454d3e 100644
--- a/src/thermophysicalModels/specie/transport/polynomial/polynomialTransport.H
+++ b/src/thermophysicalModels/specie/transport/polynomial/polynomialTransport.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -148,8 +148,11 @@ public:
         //- Thermal conductivity [W/mK]
         inline scalar kappa(const scalar T) const;
 
+        //- Thermal diffusivity for internal energy [kg/ms]
+        inline scalar alphae(const scalar T) const;
+
         //- Thermal diffusivity for enthalpy [kg/ms]
-        inline scalar alpha(const scalar T) const;
+        inline scalar alphah(const scalar T) const;
 
         // Species diffusivity
         //inline scalar D(const scalar T) const;
diff --git a/src/thermophysicalModels/specie/transport/polynomial/polynomialTransportI.H b/src/thermophysicalModels/specie/transport/polynomial/polynomialTransportI.H
index 5482ef56488f33fd937c6cdbef2a1057579d2249..8d0d4f4e61ed55094bd437f551187d551e07e80e 100644
--- a/src/thermophysicalModels/specie/transport/polynomial/polynomialTransportI.H
+++ b/src/thermophysicalModels/specie/transport/polynomial/polynomialTransportI.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -122,17 +122,22 @@ inline Foam::scalar Foam::polynomialTransport<Thermo, PolySize>::kappa
 
 
 template<class Thermo, int PolySize>
-inline Foam::scalar Foam::polynomialTransport<Thermo, PolySize>::alpha
+inline Foam::scalar Foam::polynomialTransport<Thermo, PolySize>::alphae
 (
     const scalar T
 ) const
 {
-    scalar deltaT = T - specie::Tstd;
-    scalar CpBar =
-        (deltaT*(this->H(T) - this->H(specie::Tstd)) + this->Cp(T))
-       /(sqr(deltaT) + 1);
+    return kappa(T)/this->Cv(T);
+}
+
 
-    return kappa(T)/CpBar;
+template<class Thermo, int PolySize>
+inline Foam::scalar Foam::polynomialTransport<Thermo, PolySize>::alphah
+(
+    const scalar T
+) const
+{
+    return kappa(T)/this->Cp(T);
 }
 
 
diff --git a/src/thermophysicalModels/specie/transport/speciesTransport/speciesTransport.H b/src/thermophysicalModels/specie/transport/speciesTransport/speciesTransport.H
index def83e43bbce1177dc78aaab638dd506e128124e..911ab820aa51bd68fef92254a31c3bd051e6dc65 100644
--- a/src/thermophysicalModels/specie/transport/speciesTransport/speciesTransport.H
+++ b/src/thermophysicalModels/specie/transport/speciesTransport/speciesTransport.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -81,8 +81,11 @@ public:
         // Thermal conductivity [W/mK]
         //inline scalar kappa(const scalar T) const;
 
+        // Thermal diffusivity for internal energy [kg/ms]
+        //inline scalar alphae(const scalar T) const;
+
         // Thermal diffusivity for enthalpy [kg/ms]
-        //inline scalar alpha(const scalar T) const;
+        //inline scalar alphah(const scalar T) const;
 
         // Species diffusivity
         //inline scalar D(const scalar T) const;
diff --git a/src/thermophysicalModels/specie/transport/sutherland/sutherlandTransport.H b/src/thermophysicalModels/specie/transport/sutherland/sutherlandTransport.H
index 9d0cddc493b5957df24bc337ebfb8549a4f7a50c..99b943b82313389cbf0f26ffcf0e7ce6f6ec1f61 100644
--- a/src/thermophysicalModels/specie/transport/sutherland/sutherlandTransport.H
+++ b/src/thermophysicalModels/specie/transport/sutherland/sutherlandTransport.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -162,8 +162,11 @@ public:
         //- Thermal conductivity [W/mK]
         inline scalar kappa(const scalar T) const;
 
+        //- Thermal diffusivity for internal energy [kg/ms]
+        inline scalar alphae(const scalar T) const;
+
         //- Thermal diffusivity for enthalpy [kg/ms]
-        inline scalar alpha(const scalar T) const;
+        inline scalar alphah(const scalar T) const;
 
         // Species diffusivity
         //inline scalar D(const scalar T) const;
diff --git a/src/thermophysicalModels/specie/transport/sutherland/sutherlandTransportI.H b/src/thermophysicalModels/specie/transport/sutherland/sutherlandTransportI.H
index 2839cc5167541c3fc04078ae777e59aafdf7fd7c..65e0a227bd4cad55d65b2a7ae58e3df5d35c7c42 100644
--- a/src/thermophysicalModels/specie/transport/sutherland/sutherlandTransportI.H
+++ b/src/thermophysicalModels/specie/transport/sutherland/sutherlandTransportI.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -147,20 +147,23 @@ inline Foam::scalar Foam::sutherlandTransport<Thermo>::kappa
 
 
 template<class Thermo>
-inline Foam::scalar Foam::sutherlandTransport<Thermo>::alpha
+inline Foam::scalar Foam::sutherlandTransport<Thermo>::alphae
 (
     const scalar T
 ) const
 {
-    scalar Cv_ = this->Cv(T);
-    scalar R_ = this->R();
-    scalar Cp_ = Cv_ + R_;
+    return mu(T)*(1.32 + 1.77*this->R()/this->Cv(T));
+}
 
-    scalar deltaT = T - specie::Tstd;
-    scalar CpBar =
-        (deltaT*(this->H(T) - this->H(specie::Tstd)) + Cp_)/(sqr(deltaT) + 1);
 
-    return mu(T)*Cv_*(1.32 + 1.77*this->R()/Cv_)/CpBar;
+template<class Thermo>
+inline Foam::scalar Foam::sutherlandTransport<Thermo>::alphah
+(
+    const scalar T
+) const
+{
+
+    return kappa(T)/this->Cp(T);
 }
 
 
diff --git a/src/thermophysicalModels/thermalPorousZone/thermalModel/fixedTemperature/fixedTemperature.C b/src/thermophysicalModels/thermalPorousZone/thermalModel/fixedTemperature/fixedTemperature.C
index a6f6b3ca889c8a277a1bed2b326416df57b9c154..509c7d70cc6000c3d271dc65222099e8511ba741 100644
--- a/src/thermophysicalModels/thermalPorousZone/thermalModel/fixedTemperature/fixedTemperature.C
+++ b/src/thermophysicalModels/thermalPorousZone/thermalModel/fixedTemperature/fixedTemperature.C
@@ -82,20 +82,20 @@ void Foam::porousMedia::fixedTemperature::addEnthalpySource
     scalarField& hDiag = hEqn.diag();
     scalarField& hSource = hEqn.source();
 
-    tmp<volScalarField> Cp = thermo.Cp();
+    const scalarField T(hDiag.size(), T_);
 
-    // TODO: generalize for non-fixedTemperature methods
     const scalar rate = 1e6;
 
     forAll(zones, zoneI)
     {
         const labelList& cells = mesh.cellZones()[zones[zoneI]];
+        tmp<scalarField> h = thermo.h(T, cells);
 
         forAll(cells, i)
         {
             hDiag[cells[i]] += rate*V[cells[i]]*rho[cells[i]];
             hSource[cells[i]] +=
-                rate*V[cells[i]]*rho[cells[i]]*Cp()[cells[i]]*T_;
+                rate*V[cells[i]]*rho[cells[i]]*h()[cells[i]];
         }
     }
 }
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.C b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.C
index b52baebd369533dcb5bc2eed6ea56d2c4b7ba03e..0a82b2424aa1218e2e47c5194698e9643a1b0de5 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.C
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.C
@@ -86,7 +86,7 @@ externalWallHeatFluxTemperatureFvPatchScalarField
 )
 :
     mixedFvPatchScalarField(ptf, p, iF, mapper),
-    temperatureCoupledBase(patch(), ptf.KMethod(), ptf.KName()),
+    temperatureCoupledBase(patch(), ptf.KMethod(), ptf.kappaName()),
     oldMode_(unknown),
     q_(ptf.q_, mapper),
     h_(ptf.h_, mapper),
@@ -181,7 +181,7 @@ externalWallHeatFluxTemperatureFvPatchScalarField
 )
 :
     mixedFvPatchScalarField(tppsf, iF),
-    temperatureCoupledBase(patch(), tppsf.KMethod(), tppsf.KName()),
+    temperatureCoupledBase(patch(), tppsf.KMethod(), tppsf.kappaName()),
     oldMode_(tppsf.oldMode_),
     q_(tppsf.q_),
     h_(tppsf.h_),
@@ -199,7 +199,7 @@ void Foam::externalWallHeatFluxTemperatureFvPatchScalarField::updateCoeffs()
     }
 
     scalarField q(size(), 0.0);
-    scalarField KDelta(K(*this)*patch().deltaCoeffs());
+    scalarField KDelta(kappa(*this)*patch().deltaCoeffs());
 
     if (oldMode_ == fixedHeatFlux)
     {
@@ -223,7 +223,7 @@ void Foam::externalWallHeatFluxTemperatureFvPatchScalarField::updateCoeffs()
     {
         if (q[i] > 0) //in
         {
-            this->refGrad()[i] = q[i]/K(*this)()[i];
+            this->refGrad()[i] = q[i]/kappa(*this)()[i];
             this->refValue()[i] = 0.0;
             this->valueFraction()[i] = 0.0;
         }
@@ -239,7 +239,7 @@ void Foam::externalWallHeatFluxTemperatureFvPatchScalarField::updateCoeffs()
 
     if (debug)
     {
-        scalar Q = gSum(K(*this)*patch().magSf()*snGrad());
+        scalar Q = gSum(kappa(*this)*patch().magSf()*snGrad());
 
         Info<< patch().boundaryMesh().mesh().name() << ':'
             << patch().name() << ':'
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.H b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.H
index 53a466ac0bc4c7e3f9843bda3ebdf825d0048427..9b461334cb50b488a1b8167c2a92c3162f880945 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.H
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.H
@@ -34,12 +34,12 @@ Description
         myWallPatch
         {
             type            externalWallHeatFluxTemperature;
-            K               solidThermo;       // solidThermo or lookup
+            kappa           solidThermo;       // solidThermo or lookup
             q               uniform 1000;      // Heat flux / [W/m2]
             Ta              uniform 300.0;     // Tambient temperature /[K]
             h               uniform 10.0;      // Heat transfer coeff /[W/Km2]
             value           uniform 300.0;     // Initial temperature / [K]
-            KName           none;
+            kappaName       none;
         }
 
 Note:
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureCoupledBase/temperatureCoupledBase.C b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureCoupledBase/temperatureCoupledBase.C
index c3562426e36c447421364c21acb86762f7c288b3..44e43d3c67ca192ba5b04969e0e9001a5ffef3d8 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureCoupledBase/temperatureCoupledBase.C
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureCoupledBase/temperatureCoupledBase.C
@@ -58,12 +58,12 @@ Foam::temperatureCoupledBase::temperatureCoupledBase
 (
     const fvPatch& patch,
     const word& calculationType,
-    const word& KName
+    const word& kappaName
 )
 :
     patch_(patch),
     method_(KMethodTypeNames_[calculationType]),
-    KName_(KName)
+    kappaName_(kappaName)
 {}
 
 
@@ -74,14 +74,14 @@ Foam::temperatureCoupledBase::temperatureCoupledBase
 )
 :
     patch_(patch),
-    method_(KMethodTypeNames_.read(dict.lookup("K"))),
-    KName_(dict.lookup("KName"))
+    method_(KMethodTypeNames_.read(dict.lookup("kappa"))),
+    kappaName_(dict.lookup("kappaName"))
 {}
 
 
 // * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
 
-Foam::tmp<Foam::scalarField> Foam::temperatureCoupledBase::K
+Foam::tmp<Foam::scalarField> Foam::temperatureCoupledBase::kappa
 (
     const scalarField& Tp
 ) const
@@ -111,7 +111,7 @@ Foam::tmp<Foam::scalarField> Foam::temperatureCoupledBase::K
                 (
                     "solidThermophysicalProperties"
                 );
-            return thermo.K(patch_.index());
+            return thermo.kappa(patch_.index());
         }
         break;
 
@@ -124,23 +124,32 @@ Foam::tmp<Foam::scalarField> Foam::temperatureCoupledBase::K
                 (
                     "solidThermophysicalProperties"
                 );
-            return n & thermo.directionalK(patch_.index()) & n;
+            return n & thermo.directionalKappa(patch_.index()) & n;
         }
         break;
 
         case LOOKUP:
         {
-            if (mesh.objectRegistry::foundObject<volScalarField>(KName_))
+            if (mesh.objectRegistry::foundObject<volScalarField>(kappaName_))
             {
-                return patch_.lookupPatchField<volScalarField, scalar>(KName_);
+                return patch_.lookupPatchField
+                <
+                    volScalarField, scalar
+                >(kappaName_);
             }
             else if
             (
-                mesh.objectRegistry::foundObject<volSymmTensorField>(KName_)
+                mesh.objectRegistry::foundObject
+                <
+                    volSymmTensorField
+                >(kappaName_)
             )
             {
                 const symmTensorField& KWall =
-                    patch_.lookupPatchField<volSymmTensorField, scalar>(KName_);
+                    patch_.lookupPatchField
+                    <
+                        volSymmTensorField, scalar
+                    >(kappaName_);
 
                 const vectorField n(patch_.nf());
 
@@ -149,12 +158,13 @@ Foam::tmp<Foam::scalarField> Foam::temperatureCoupledBase::K
             else
             {
                 FatalErrorIn("temperatureCoupledBase::K() const")
-                    << "Did not find field " << KName_
+                    << "Did not find field " << kappaName_
                     << " on mesh " << mesh.name() << " patch " << patch_.name()
                     << endl
-                    << "Please set 'K' to one of " << KMethodTypeNames_.toc()
-                    << " and 'KName' to the name of the volScalar"
-                    << " or volSymmTensor field (if K=lookup)"
+                    << "Please set 'kappa' to one of "
+                    << KMethodTypeNames_.toc()
+                    << " and 'kappaName' to the name of the volScalar"
+                    << " or volSymmTensor field (if kappa=lookup)"
                     << exit(FatalError);
 
                 return scalarField(0);
@@ -163,11 +173,11 @@ Foam::tmp<Foam::scalarField> Foam::temperatureCoupledBase::K
 
         default:
         {
-            FatalErrorIn("temperatureCoupledBase::K() const")
+            FatalErrorIn("temperatureCoupledBase::kappa() const")
                 << "Unimplemented method " << method_ << endl
-                << "Please set 'K' to one of " << KMethodTypeNames_.toc()
-                << " and 'KName' to the name of the volScalar"
-                << " or volSymmTensor field (if K=lookup)"
+                << "Please set 'kappa' to one of " << KMethodTypeNames_.toc()
+                << " and 'kappaName' to the name of the volScalar"
+                << " or volSymmTensor field (if kappa=lookup)"
                 << exit(FatalError);
         }
         break;
@@ -178,9 +188,9 @@ Foam::tmp<Foam::scalarField> Foam::temperatureCoupledBase::K
 
 void Foam::temperatureCoupledBase::write(Ostream& os) const
 {
-    os.writeKeyword("K") << KMethodTypeNames_[method_]
+    os.writeKeyword("kappa") << KMethodTypeNames_[method_]
         << token::END_STATEMENT << nl;
-    os.writeKeyword("KName") << KName_ << token::END_STATEMENT << nl;
+    os.writeKeyword("kappaName") << kappaName_ << token::END_STATEMENT << nl;
 }
 
 
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureCoupledBase/temperatureCoupledBase.H b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureCoupledBase/temperatureCoupledBase.H
index 2a78d6b2e5ba93956965344b3685d3a61cab81fa..8c3ec69615c2e0b0bf82f1f977a4bf5ec9c16fae 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureCoupledBase/temperatureCoupledBase.H
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureCoupledBase/temperatureCoupledBase.H
@@ -27,13 +27,14 @@ Class
 Description
     Common functions for use in temperature coupled boundaries. For now only
 
-    K() : heat conduction at patch. Gets supplied how to lookup/calculate K:
+    kappa() : heat conduction at patch. Gets supplied how to lookup/calculate
+        kappa:
 
     - 'lookup' : lookup volScalarField (or volSymmTensorField) with name
     - 'basicThermo' : use basicThermo and default compressible::turbulenceModel
-       to calculate K
-    - 'solidThermo' : use basicSolidThermo K()
-    - 'directionalSolidThermo' directionalK()
+       to calculate kappa
+    - 'solidThermo' : use basicSolidThermo kappa()
+    - 'directionalSolidThermo' directionalKappa()
 
 SourceFiles
     temperatureCoupledBase.C
@@ -59,7 +60,7 @@ namespace Foam
 class temperatureCoupledBase
 {
 public:
-        //- Type of supplied K
+        //- Type of supplied Kappa
         enum KMethodType
         {
             BASICTHERMO,
@@ -81,7 +82,7 @@ private:
         const KMethodType method_;
 
         //- Name of thermal conductivity field (if looked up from database)
-        const word KName_;
+        const word kappaName_;
 
 
 public:
@@ -113,13 +114,13 @@ public:
         }
 
         //- Name of thermal conductivity field
-        const word& KName() const
+        const word& kappaName() const
         {
-            return KName_;
+            return kappaName_;
         }
 
         //- Given patch temperature calculate corresponding K field
-        tmp<scalarField> K(const scalarField& Tp) const;
+        tmp<scalarField> kappa(const scalarField& Tp) const;
 
         //- Write
         void write(Ostream&) const;
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.C b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.C
index 9d1af4167068b231a419299bad16d2325f5ec1e9..d9e3e6d40be3f98efbc5ca326ac25bc79186c5b7 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.C
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.C
@@ -292,7 +292,7 @@ void temperatureThermoBaffle1DFvPatchScalarField<solidType>::updateCoeffs()
         // Create fields for solid properties
         forAll(KDeltaw, i)
         {
-            KDeltaw[i] = solid_().K((Tp[i] + nbrTp[i])/2.0)/thickness_[i];
+            KDeltaw[i] = solid_().kappa((Tp[i] + nbrTp[i])/2.0)/thickness_[i];
         }
 
         const scalarField q
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.H b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.H
index 8ee1b01b9cfa8c69d9e004271b6c23e9294de6a1..66bba6ddedd46ea76730586d7ab20838b6c5f8bf 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.H
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.H
@@ -114,9 +114,9 @@ class temperatureThermoBaffle1DFvPatchScalarField
             }
 
 
-            scalar K(const scalar T) const
+            scalar kappa(const scalar T) const
             {
-                return solidPtr_().K(T);
+                return solidPtr_().kappa(T);
             }
     };
 
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentHeatFluxTemperature/turbulentHeatFluxTemperatureFvPatchScalarField.C b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentHeatFluxTemperature/turbulentHeatFluxTemperatureFvPatchScalarField.C
index d71cf18862de23ad9f378ae8341b177156d56a09..29757f1ea6eb381255799639c79c6c4352cc54a0 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentHeatFluxTemperature/turbulentHeatFluxTemperatureFvPatchScalarField.C
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentHeatFluxTemperature/turbulentHeatFluxTemperatureFvPatchScalarField.C
@@ -93,7 +93,7 @@ turbulentHeatFluxTemperatureFvPatchScalarField
 )
 :
     fixedGradientFvPatchScalarField(ptf, p, iF, mapper),
-    temperatureCoupledBase(patch(), ptf.KMethod(), ptf.KName()),
+    temperatureCoupledBase(patch(), ptf.KMethod(), ptf.kappaName()),
     heatSource_(ptf.heatSource_),
     q_(ptf.q_, mapper)
 {}
@@ -124,7 +124,7 @@ turbulentHeatFluxTemperatureFvPatchScalarField
 )
 :
     fixedGradientFvPatchScalarField(thftpsf),
-    temperatureCoupledBase(patch(), thftpsf.KMethod(), thftpsf.KName()),
+    temperatureCoupledBase(patch(), thftpsf.KMethod(), thftpsf.kappaName()),
     heatSource_(thftpsf.heatSource_),
     q_(thftpsf.q_)
 {}
@@ -138,7 +138,7 @@ turbulentHeatFluxTemperatureFvPatchScalarField
 )
 :
     fixedGradientFvPatchScalarField(thftpsf, iF),
-    temperatureCoupledBase(patch(), thftpsf.KMethod(), thftpsf.KName()),
+    temperatureCoupledBase(patch(), thftpsf.KMethod(), thftpsf.kappaName()),
     heatSource_(thftpsf.heatSource_),
     q_(thftpsf.q_)
 {}
@@ -188,12 +188,12 @@ void turbulentHeatFluxTemperatureFvPatchScalarField::updateCoeffs()
         case hsPower:
         {
             const scalar Ap = gSum(patch().magSf());
-            gradient() = q_/(Ap*K(Tp));
+            gradient() = q_/(Ap*kappa(Tp));
             break;
         }
         case hsFlux:
         {
-            gradient() = q_/K(Tp);
+            gradient() = q_/kappa(Tp);
             break;
         }
         default:
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentHeatFluxTemperature/turbulentHeatFluxTemperatureFvPatchScalarField.H b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentHeatFluxTemperature/turbulentHeatFluxTemperatureFvPatchScalarField.H
index 7d63f143735bf9e96f7392781631e11135d876fa..78f40e5a9d33653d95b86de4e518a515a6e4fbf3 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentHeatFluxTemperature/turbulentHeatFluxTemperatureFvPatchScalarField.H
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentHeatFluxTemperature/turbulentHeatFluxTemperatureFvPatchScalarField.H
@@ -36,7 +36,7 @@ Description
             type            compressible::turbulentHeatFluxTemperature;
             heatSource      flux;        // power [W]; flux [W/m2]
             q               uniform 10;  // heat power or flux
-            K               basicThermo; // calculate K by alphaEff*thermo.Cp
+            kappa           basicThermo; // calculate kappa=alphaEff*thermo.Cp
             value           uniform 300; // initial temperature value
         }
 
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C
index a61959a97697802795802395c8821e4b6edf51f7..850cc79f6e35cad8d63aa3c1a8126c58eb7df3d9 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C
@@ -68,7 +68,7 @@ turbulentTemperatureCoupledBaffleMixedFvPatchScalarField
 )
 :
     mixedFvPatchScalarField(ptf, p, iF, mapper),
-    temperatureCoupledBase(patch(), ptf.KMethod(), ptf.KName()),
+    temperatureCoupledBase(patch(), ptf.KMethod(), ptf.kappaName()),
     neighbourFieldName_(ptf.neighbourFieldName_)
 {}
 
@@ -131,7 +131,7 @@ turbulentTemperatureCoupledBaffleMixedFvPatchScalarField
 )
 :
     mixedFvPatchScalarField(wtcsf, iF),
-    temperatureCoupledBase(patch(), wtcsf.KMethod(), wtcsf.KName()),
+    temperatureCoupledBase(patch(), wtcsf.KMethod(), wtcsf.kappaName()),
     neighbourFieldName_(wtcsf.neighbourFieldName_)
 {}
 
@@ -186,11 +186,11 @@ void turbulentTemperatureCoupledBaffleMixedFvPatchScalarField::updateCoeffs()
     scalarField nbrIntFld(nbrField.patchInternalField());
     distMap.distribute(nbrIntFld);
 
-    // Swap to obtain full local values of neighbour K*delta
-    scalarField nbrKDelta(nbrField.K(nbrField)*nbrPatch.deltaCoeffs());
+    // Swap to obtain full local values of neighbour kappa*delta
+    scalarField nbrKDelta(nbrField.kappa(nbrField)*nbrPatch.deltaCoeffs());
     distMap.distribute(nbrKDelta);
 
-    tmp<scalarField> myKDelta = K(*this)*patch().deltaCoeffs();
+    tmp<scalarField> myKDelta = kappa(*this)*patch().deltaCoeffs();
 
 
     // Both sides agree on
@@ -219,7 +219,7 @@ void turbulentTemperatureCoupledBaffleMixedFvPatchScalarField::updateCoeffs()
 
     if (debug)
     {
-        scalar Q = gSum(K(*this)*patch().magSf()*snGrad());
+        scalar Q = gSum(kappa(*this)*patch().magSf()*snGrad());
 
         Info<< patch().boundaryMesh().mesh().name() << ':'
             << patch().name() << ':'
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.H b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.H
index c36830577dacf4bd4a3d809a4a6be65e38ab8021..2703274ed3de46390b202c264764e163ad7f6bda 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.H
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.H
@@ -41,18 +41,20 @@ Description
         {
             type        compressible::turbulentTemperatureCoupledBaffleMixed;
             neighbourFieldName  T;
-            K                   lookup;
-            KName               K;
+            kappa               lookup;
+            kappaName           kappa;
             value               uniform 300;
         }
 
     Needs to be on underlying mapped(Wall)FvPatch.
 
-    Note: K : heat conduction at patch. Gets supplied how to lookup/calculate K:
+    Note: kappa : heat conduction at patch. Gets supplied how to lookup
+        calculate kappa:
     - 'lookup' : lookup volScalarField (or volSymmTensorField) with name
-    - 'basicThermo' : use basicThermo and compressible::RASmodel to calculate K
-    - 'solidThermo' : use basicSolidThermo K()
-    - 'directionalSolidThermo' directionalK()
+    - 'basicThermo' : use basicThermo and compressible::RASmodel to calculate
+        kappa
+    - 'solidThermo' : use basicSolidThermo kappa()
+    - 'directionalSolidThermo' directionalKappa()
 
     Note: runs in parallel with arbitrary decomposition. Uses mapped
     functionality to calculate exchange.
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C
index 16f81bbeecf11f70292c6880a18769c157237737..beec3b069c67ea3acd864ed98ad1341e7695f68e 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C
@@ -67,7 +67,7 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField
 )
 :
     mixedFvPatchScalarField(psf, p, iF, mapper),
-    temperatureCoupledBase(patch(), psf.KMethod(), psf.KName()),
+    temperatureCoupledBase(patch(), psf.KMethod(), psf.kappaName()),
     TnbrName_(psf.TnbrName_),
     QrNbrName_(psf.QrNbrName_),
     QrName_(psf.QrName_)
@@ -134,7 +134,7 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField
 )
 :
     mixedFvPatchScalarField(psf, iF),
-    temperatureCoupledBase(patch(), psf.KMethod(), psf.KName()),
+    temperatureCoupledBase(patch(), psf.KMethod(), psf.kappaName()),
     TnbrName_(psf.TnbrName_),
     QrNbrName_(psf.QrNbrName_),
     QrName_(psf.QrName_)
@@ -182,11 +182,11 @@ void turbulentTemperatureRadCoupledMixedFvPatchScalarField::updateCoeffs()
 
 
     // Swap to obtain full local values of neighbour K*delta
-    scalarField KDeltaNbr(nbrField.K(nbrField)*nbrPatch.deltaCoeffs());
+    scalarField KDeltaNbr(nbrField.kappa(nbrField)*nbrPatch.deltaCoeffs());
     distMap.distribute(KDeltaNbr);
 
 
-    scalarField KDelta(K(*this)*patch().deltaCoeffs());
+    scalarField KDelta(kappa(*this)*patch().deltaCoeffs());
 
     scalarField Qr(Tp.size(), 0.0);
     if (QrName_ != "none")
diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.H b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.H
index 8f8b47c9461dcec965ca6e483e16d8187a4198b6..99f93ee8dd226f159d68fd9cb27c92878f4a4b7d 100644
--- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.H
+++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.H
@@ -35,8 +35,8 @@ Description
         {
             type compressible::turbulentTemperatureRadCoupledMixed;
             TNbr        T;      // name of T field on neighbour region
-            K           lookup;
-            KName       K;
+            kappa       lookup;
+            KappaName   kappa;
             QrNbr       Qr; // or none. Name of Qr field on neighbour region
             Qr          Qr; // or none. Name of Qr field on local region
             value       uniform 300;
@@ -44,12 +44,13 @@ Description
 
     Needs to be on underlying mapped(Wall)FvPatch.
 
-     Note: K : heat conduction at patch. Gets supplied how to lookup/calculate
-     K:
+     Note: kappa : heat conduction at patch. Gets supplied how to
+            lookup/calculate
+     kappa:
     - 'lookup' : lookup volScalarField (or volSymmTensorField) with name
     - 'basicThermo' : use basicThermo and compressible::RASmodel to calculate K
-    - 'solidThermo' : use basicSolidThermo K()
-    - 'directionalSolidThermo' directionalK()
+    - 'solidThermo' : use basicSolidThermo kappa()
+    - 'directionalSolidThermo' directionalKappa()
 
     Note: runs in parallel with arbitrary decomposition. Uses mapped
     functionality to calculate exchange.
diff --git a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/0/T b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/0/T
index 5899c6d9a23e5221a3e1200bce5a7476f205b9b7..5e07713cdcc87ef01fe2416f7c234fdcb28d80e7 100644
--- a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/0/T
+++ b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/0/T
@@ -50,10 +50,10 @@ boundaryField
     {
         type            compressible::turbulentTemperatureRadCoupledMixed;
         Tnbr            T;
-        K               basicThermo;
+        kappa           basicThermo;
         QrNbr           none;
         Qr              Qr;
-        KName           none;
+        kappaName       none;
         value           $internalField;
     }
 }
diff --git a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/0/panelRegion/T b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/0/panelRegion/T
index a4187e29d7242f01678764b58639cf50fbd5963b..900fa3ae767b2b05409da71b9611a23e779a1c29 100644
--- a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/0/panelRegion/T
+++ b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/0/panelRegion/T
@@ -41,8 +41,8 @@ boundaryField
     {
         type            compressible::turbulentTemperatureRadCoupledMixed;
         Tnbr            T;
-        K               solidThermo;
-        KName           none;
+        kappa           solidThermo;
+        kappaName       none;
         QrNbr           Qr;
         Qr              none;
         value           uniform 298.15;
diff --git a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/constant/panelRegion/solidThermophysicalProperties b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/constant/panelRegion/solidThermophysicalProperties
index 1174ecfa25f979edb332eb1c226812e6cbbcebca..7ed5edbfcb04a1193c5718e2b1289731c94d9052 100644
--- a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/constant/panelRegion/solidThermophysicalProperties
+++ b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/constant/panelRegion/solidThermophysicalProperties
@@ -26,12 +26,12 @@ vCoeffs
 {
     transport
     {
-        K           0.135;
+        kappa       0.135;
     }
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;  //opaque
+        kappaRad    0.0;  //opaque
         emissivity  0.17;
     }
     thermodynamics
@@ -49,12 +49,12 @@ charCoeffs
 {
     transport
     {
-        K           0.4;
+        kappa       0.4;
     }
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;
+        kappaRad    0.0;
         emissivity  0.85;
     }
     thermodynamics
diff --git a/tutorials/compressible/rhoPimpleFoam/les/pitzDaily/system/fvSchemes b/tutorials/compressible/rhoPimpleFoam/les/pitzDaily/system/fvSchemes
index 56aebd7a94fc31d1ae3a7d20453629f08aac63c2..de66185079e101550bf082894052c6f679fa3047 100644
--- a/tutorials/compressible/rhoPimpleFoam/les/pitzDaily/system/fvSchemes
+++ b/tutorials/compressible/rhoPimpleFoam/les/pitzDaily/system/fvSchemes
@@ -42,7 +42,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear corrected;
-    laplacian((rho*(1|A(U))),p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
     laplacian(alphaEff,h) Gauss linear corrected;
     laplacian(DkEff,k) Gauss linear corrected;
     laplacian(DBEff,B) Gauss linear corrected;
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/U b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/U
index 0d8701320a12fd4bb641f6b61c3f21c254b28bba..84b8f75f3cfe486af95eb409be5724fed1af8f31 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/U
+++ b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/U
@@ -48,7 +48,7 @@ boundaryField
     }
     outlet
     {
-        type            fluxCorrectedVelocity; //inletOutlet;
+        type            pressureInletOutletVelocity;
         value           uniform (0 0 0);
         inletValue      uniform (0 0 0);
     }
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/system/fvSchemes b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/system/fvSchemes
index 1772c2a3fd2de453b29a4d86681ed374d8c0286d..391c95e6dc3d311d1bd639b18527b57799b74ceb 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/system/fvSchemes
+++ b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/system/fvSchemes
@@ -52,7 +52,7 @@ laplacianSchemes
     laplacian(DepsilonEff,epsilon) Gauss linear corrected;
     laplacian(DREff,R) Gauss linear corrected;
     laplacian(DomegaEff,omega) Gauss linear corrected;
-    laplacian((rho*(1|A(U))),p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
     laplacian(alphaEff,h) Gauss linear corrected;
 }
 
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/system/fvSolution b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/system/fvSolution
index 859a3d046413714e9d9bfe3cc04be1a0e22d11b4..084c382e84f96dcde779b055cbbcbd6d39117bc7 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/system/fvSolution
+++ b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/system/fvSolution
@@ -52,6 +52,7 @@ solvers
 PIMPLE
 {
     momentumPredictor yes;
+    transonic       no;
     nOuterCorrectors 50;
     nCorrectors     1;
     nNonOrthogonalCorrectors 0;
@@ -66,6 +67,8 @@ PIMPLE
             tolerance       0.0001;
         }
     }
+
+    turbOnFinalIterOnly off;
 }
 
 relaxationFactors
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/cavity/system/fvSchemes b/tutorials/compressible/rhoPimpleFoam/ras/cavity/system/fvSchemes
index da4ffa1eaab98542875e2f7dc266e492b8620f12..0fa6ebaf3327be761be8e19e8622e7f1ffb22a20 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/cavity/system/fvSchemes
+++ b/tutorials/compressible/rhoPimpleFoam/ras/cavity/system/fvSchemes
@@ -52,7 +52,7 @@ laplacianSchemes
     laplacian(DepsilonEff,epsilon) Gauss linear orthogonal;
     laplacian(DREff,R) Gauss linear orthogonal;
     laplacian(DomegaEff,omega) Gauss linear orthogonal;
-    laplacian((rho*(1|A(U))),p) Gauss linear orthogonal;
+    laplacian(Dp,p) Gauss linear orthogonal;
     laplacian(alphaEff,h) Gauss linear orthogonal;
 }
 
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/T b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/T
new file mode 100644
index 0000000000000000000000000000000000000000..561ca236be3bbed252ef63b29c24063a3bea4c6b
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/T
@@ -0,0 +1,54 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    object      T;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 0 0 1 0 0 0];
+
+internalField   uniform 293;
+
+boundaryField
+{
+
+    front
+    {
+        type            zeroGradient;
+    }
+    back
+    {
+        type            zeroGradient;
+    }
+    wall
+    {
+        type            zeroGradient;
+    }
+    porosityWall
+    {
+        type            zeroGradient;
+    }
+
+    inlet
+    {
+        type            fixedValue;
+        value           $internalField;
+    }
+    outlet
+    {
+        type            inletOutlet;
+        value           $internalField;
+        inletValue      $internalField;
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/U b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/U
new file mode 100644
index 0000000000000000000000000000000000000000..84b8f75f3cfe486af95eb409be5724fed1af8f31
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/U
@@ -0,0 +1,57 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volVectorField;
+    object      U;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 1 -1 0 0 0 0];
+
+internalField   uniform (0 0 0);
+
+boundaryField
+{
+    front
+    {
+        type            fixedValue;
+        value           uniform (0 0 0);
+    }
+    back
+    {
+        type            fixedValue;
+        value           uniform (0 0 0);
+    }
+    wall
+    {
+        type            fixedValue;
+        value           uniform (0 0 0);
+    }
+    porosityWall
+    {
+        type            slip;
+        value           uniform (0 0 0);
+    }
+    inlet
+    {
+        type            flowRateInletVelocity;
+        flowRate        constant 0.1;
+        value           uniform (0 0 0);
+    }
+    outlet
+    {
+        type            pressureInletOutletVelocity;
+        value           uniform (0 0 0);
+        inletValue      uniform (0 0 0);
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/alphat b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/alphat
new file mode 100644
index 0000000000000000000000000000000000000000..f609fa6c14c41bba0ec2726af2cf56a9ca8c949a
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/alphat
@@ -0,0 +1,57 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    location    "0";
+    object      alphat;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [1 -1 -1 0 0 0 0];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    front
+    {
+        type            alphatWallFunction;
+        value           uniform 0;
+    }
+    back
+    {
+        type            alphatWallFunction;
+        value           uniform 0;
+    }
+    wall
+    {
+        type            alphatWallFunction;
+        value           uniform 0;
+    }
+    porosityWall
+    {
+        type            alphatWallFunction;
+        value           uniform 0;
+    }
+    inlet
+    {
+        type            calculated;
+        value           uniform 0;
+    }
+    outlet
+    {
+        type            calculated;
+        value           uniform 0;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/epsilon b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/epsilon
new file mode 100644
index 0000000000000000000000000000000000000000..e4dccfe57777d09934d55a61d67f94e2917585f0
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/epsilon
@@ -0,0 +1,59 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    location    "0";
+    object      epsilon;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 2 -3 0 0 0 0];
+
+internalField   uniform 200;
+
+boundaryField
+{
+    front
+    {
+        type            compressible::epsilonWallFunction;
+        value           uniform 200;
+    }
+    back
+    {
+        type            compressible::epsilonWallFunction;
+        value           uniform 200;
+    }
+    wall
+    {
+        type            compressible::epsilonWallFunction;
+        value           uniform 200;
+    }
+    porosityWall
+    {
+        type            compressible::epsilonWallFunction;
+        value           uniform 200;
+    }
+    inlet
+    {
+        type            compressible::turbulentMixingLengthDissipationRateInlet;
+        mixingLength    0.005;
+        value           uniform 200;
+    }
+    outlet
+    {
+        type            inletOutlet;
+        inletValue      uniform 200;
+        value           uniform 200;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/k b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/k
new file mode 100644
index 0000000000000000000000000000000000000000..655a91bb45e3aa597a5280c13d1a8262524a0fbd
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/k
@@ -0,0 +1,59 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    location    "0";
+    object      k;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 2 -2 0 0 0 0];
+
+internalField   uniform 1;
+
+boundaryField
+{
+    front
+    {
+        type            compressible::kqRWallFunction;
+        value           uniform 1;
+    }
+    back
+    {
+        type            compressible::kqRWallFunction;
+        value           uniform 1;
+    }
+    wall
+    {
+        type            compressible::kqRWallFunction;
+        value           uniform 1;
+    }
+    porosityWall
+    {
+        type            compressible::kqRWallFunction;
+        value           uniform 1;
+    }
+    inlet
+    {
+        type            turbulentIntensityKineticEnergyInlet;
+        intensity       0.05;
+        value           uniform 1;
+    }
+    outlet
+    {
+        type            inletOutlet;
+        inletValue      uniform 1;
+        value           uniform 1;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/mut b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/mut
new file mode 100644
index 0000000000000000000000000000000000000000..0cea2db2d2e1aa076b70254b0e314b9959cc0d78
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/mut
@@ -0,0 +1,57 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    location    "0";
+    object      mut;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [1 -1 -1 0 0 0 0];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    front
+    {
+        type            mutkWallFunction;
+        value           uniform 0;
+    }
+    back
+    {
+        type            mutkWallFunction;
+        value           uniform 0;
+    }
+    wall
+    {
+        type            mutkWallFunction;
+        value           uniform 0;
+    }
+    porosityWall
+    {
+        type            mutkWallFunction;
+        value           uniform 0;
+    }
+    inlet
+    {
+        type            calculated;
+        value           uniform 0;
+    }
+    outlet
+    {
+        type            calculated;
+        value           uniform 0;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/p b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/p
new file mode 100644
index 0000000000000000000000000000000000000000..21db04d6109a0348229d019cb3a13d728044c86d
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/p
@@ -0,0 +1,51 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    object      p;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [1 -1 -2 0 0 0 0];
+
+internalField   uniform 1.0e5;
+
+boundaryField
+{
+    front
+    {
+        type            zeroGradient;
+    }
+    back
+    {
+        type            zeroGradient;
+    }
+    wall
+    {
+        type            zeroGradient;
+    }
+    porosityWall
+    {
+        type            zeroGradient;
+    }
+
+    inlet
+    {
+        type            zeroGradient;
+    }
+    outlet
+    {
+        type            fixedValue;
+        value           $internalField;
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/Allrun b/tutorials/compressible/rhoPimplecFoam/angledDuct/Allrun
new file mode 100755
index 0000000000000000000000000000000000000000..c9fa98255753a468f44e925754d110ecf3d56332
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/Allrun
@@ -0,0 +1,10 @@
+#!/bin/sh
+cd ${0%/*} || exit 1    # run from this directory
+
+m4 constant/polyMesh/blockMeshDict.m4 > constant/polyMesh/blockMeshDict
+
+# Source tutorial run functions
+. $WM_PROJECT_DIR/bin/tools/RunFunctions
+
+runApplication blockMesh
+runApplication `getApplication`
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/RASProperties b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/RASProperties
new file mode 100644
index 0000000000000000000000000000000000000000..a4937b503a46850b2626f0d301e4a07b9f691507
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/RASProperties
@@ -0,0 +1,25 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      RASProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+RASModel        kEpsilon;
+
+turbulence      on;
+
+printCoeffs     on;
+
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/blockMeshDict.m4 b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/blockMeshDict.m4
new file mode 100644
index 0000000000000000000000000000000000000000..79da11e10ac8f655aa16fc6287c9496875d8672f
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/blockMeshDict.m4
@@ -0,0 +1,165 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    `format'      ascii;
+    class       dictionary;
+    object      blockMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+// block definition for a porosity with an angled inlet/outlet
+// the porosity is not aligned with the main axes
+//
+dnl> -----------------------------------------------------------------
+dnl> <STANDARD DEFINTIONS>
+dnl>
+changecom(//)changequote([,]) dnl>
+define(calc, [esyscmd(perl -e 'print ($1)')]) dnl>
+define(VCOUNT, 0)  dnl>
+define(vlabel, [[// ]pt VCOUNT ($1) define($1, VCOUNT)define([VCOUNT], incr(VCOUNT))])  dnl>
+dnl>
+define(hex2D, hex ($1b $2b $3b $4b $1f $2f $3f $4f)) dnl>
+define(quad2D, ($1f $1b $2b $2f))  dnl>
+define(frontQuad, ($1f $2f $3f $4f)) dnl>
+define(backQuad, ($4b $3b $2b $1b)) dnl>
+dnl>
+dnl> </STANDARD DEFINTIONS>
+dnl> -----------------------------------------------------------------
+dnl>
+define(ncells, 20) dnl>
+define(ninlet, 15) dnl>
+define(nporo, 20) dnl>
+define(noutlet, 20) dnl>
+dnl>
+define(x0,0) dnl>
+define(y0,0) dnl>
+define(y0,0) dnl>
+define(Cos,0.7071067812) dnl>   == cos(45)
+define(Sin,0.7071067812) dnl>   == sin(45)
+dnl>
+define(width,50) dnl>
+define(zBack,calc(-width/2)) dnl>
+define(zFront,calc(width/2)) dnl>
+define(leninlet,150)dnl>
+define(lenporo,100)dnl>
+define(lenoutlet,100)dnl>
+dnl>
+define(xhyp,calc(Sin*width)) dnl>
+define(yhyp,calc(Cos*width)) dnl>
+define(xinlet,leninlet)dnl>
+define(xporo,calc(Cos*lenporo)) dnl>
+define(yporo,calc(Sin*lenporo)) dnl>
+define(xoutlet,calc(xporo + Cos*lenoutlet)) dnl>
+define(youtlet,calc(yporo + Sin*lenoutlet)) dnl>
+dnl>
+
+convertToMeters 0.001;
+
+vertices
+(
+    // inlet region
+    ( -xinlet  y0  zBack )  vlabel(in1b)
+    ( -xinlet yhyp  zBack ) vlabel(in2b)
+    ( -xinlet  y0  zFront )  vlabel(in1f)
+    ( -xinlet yhyp  zFront ) vlabel(in2f)
+
+    // join inlet->outlet
+    (  x0 y0  zBack )    vlabel(join1b)
+    ( -xhyp   yhyp  zBack ) vlabel(join2b)
+    (  x0 y0  zFront )    vlabel(join1f)
+    ( -xhyp   yhyp  zFront ) vlabel(join2f)
+
+    // porosity ends ->outlet
+    ( xporo yporo  zBack )  vlabel(poro1b)
+    ( calc(xporo - xhyp) calc(yporo + yhyp)  zBack )  vlabel(poro2b)
+    ( xporo yporo  zFront )  vlabel(poro1f)
+    ( calc(xporo - xhyp) calc(yporo + yhyp)  zFront )  vlabel(poro2f)
+
+    // outlet
+    ( xoutlet youtlet zBack ) vlabel(out1b)
+    ( calc(xoutlet - xhyp) calc(youtlet + yhyp) zBack ) vlabel(out2b)
+    ( xoutlet youtlet zFront ) vlabel(out1f)
+    ( calc(xoutlet - xhyp) calc(youtlet + yhyp) zFront ) vlabel(out2f)
+);
+
+blocks
+(
+    // inlet block
+    hex2D(in1, join1, join2, in2)
+    inlet ( ninlet ncells ncells ) simpleGrading (1 1 1)
+
+    // porosity block
+    hex2D(join1, poro1, poro2, join2)
+    porosity ( nporo ncells ncells ) simpleGrading (1 1 1)
+
+    // outlet block
+    hex2D(poro1, out1, out2, poro2)
+    outlet ( noutlet ncells ncells )  simpleGrading (1 1 1)
+);
+
+edges
+(
+);
+
+patches
+(
+    // is there no way of defining all my 'defaultFaces' to be 'wall'?
+    wall front
+    (
+    // inlet block
+    frontQuad(in1, join1, join2, in2)
+    // outlet block
+    frontQuad(poro1, out1, out2, poro2)
+    )
+
+    wall back
+    (
+    // inlet block
+    backQuad(in1, join1, join2, in2)
+    // outlet block
+    backQuad(poro1, out1, out2, poro2)
+    )
+
+    wall wall
+    (
+    // inlet block
+    quad2D(in1, join1)
+    quad2D(join2, in2)
+    // outlet block
+    quad2D(poro1, out1)
+    quad2D(out2, poro2)
+    )
+
+    wall porosityWall
+    (
+    // porosity block
+    frontQuad(join1, poro1, poro2, join2)
+    // porosity block
+    backQuad(join1, poro1, poro2, join2)
+    // porosity block
+    quad2D(join1, poro1)
+    quad2D(poro2, join2)
+    )
+
+    patch inlet
+    (
+    quad2D(in2, in1)
+    )
+
+    patch outlet
+    (
+    quad2D(out2, out1)
+    )
+);
+
+mergePatchPairs
+(
+);
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/boundary b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/boundary
new file mode 100644
index 0000000000000000000000000000000000000000..0abd1608aba0dcb6aa66c9488133a3c4b51c7588
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/boundary
@@ -0,0 +1,58 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       polyBoundaryMesh;
+    location    "constant/polyMesh";
+    object      boundary;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+6
+(
+    front
+    {
+        type            wall;
+        nFaces          700;
+        startFace       63400;
+    }
+    back
+    {
+        type            wall;
+        nFaces          700;
+        startFace       64100;
+    }
+    wall
+    {
+        type            wall;
+        nFaces          1400;
+        startFace       64800;
+    }
+    porosityWall
+    {
+        type            wall;
+        nFaces          1600;
+        startFace       66200;
+    }
+    inlet
+    {
+        type            patch;
+        nFaces          400;
+        startFace       67800;
+    }
+    outlet
+    {
+        type            patch;
+        nFaces          400;
+        startFace       68200;
+    }
+)
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/porousZones b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/porousZones
new file mode 100644
index 0000000000000000000000000000000000000000..afeb6461e13249ef04a0d449173de79ecdd2111f
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/porousZones
@@ -0,0 +1,36 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      porousZones;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+1
+(
+    porosity
+    {
+        coordinateSystem
+        {
+            e1  (0.70710678 0.70710678 0);
+            e2  (0 0 1);
+        }
+
+        Darcy
+        {
+            d   d [0 -2 0 0 0 0 0] (5e7 -1000 -1000);
+            f   f [0 -1 0 0 0 0 0] (0 0 0);
+        }
+    }
+)
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/thermophysicalProperties b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/thermophysicalProperties
new file mode 100644
index 0000000000000000000000000000000000000000..d6d597d433f7d69e5e2329e6c716ed66b8a99675
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/thermophysicalProperties
@@ -0,0 +1,40 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      thermophysicalProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+thermoType      hPsiThermo<pureMixture<sutherlandTransport<specieThermo<hConstThermo<perfectGas>>>>>;
+
+mixture
+{
+    specie
+    {
+        nMoles      1;
+        molWeight   28.9;
+    }
+    thermodynamics
+    {
+        Cp          1007;
+        Hf          0;
+    }
+    transport
+    {
+        As          1.4792e-06;
+        Ts          116;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/turbulenceProperties b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/turbulenceProperties
new file mode 100644
index 0000000000000000000000000000000000000000..3721a46a2ead37eb2bf10434bcde59afa9fe9bf6
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/turbulenceProperties
@@ -0,0 +1,21 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      turbulenceProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+simulationType  RASModel;
+
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/system/controlDict b/tutorials/compressible/rhoPimplecFoam/angledDuct/system/controlDict
new file mode 100644
index 0000000000000000000000000000000000000000..bbcbeb2543fde4ea39ad5df1cb6f14005cc74202
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/system/controlDict
@@ -0,0 +1,55 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      controlDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+application     rhoPimplecFoam;
+
+startFrom       startTime;
+
+startTime       0;
+
+stopAt          endTime;
+
+endTime         10;
+
+deltaT          1;
+
+writeControl    adjustableRunTime;
+
+writeInterval   10;
+
+purgeWrite      0;
+
+writeFormat     ascii;
+
+writePrecision  6;
+
+writeCompression off;
+
+timeFormat      general;
+
+timePrecision   6;
+
+runTimeModifiable true;
+
+adjustTimeStep  no;
+
+maxCo           10;
+
+maxDeltaT       1;
+
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/system/fvSchemes b/tutorials/compressible/rhoPimplecFoam/angledDuct/system/fvSchemes
new file mode 100644
index 0000000000000000000000000000000000000000..391c95e6dc3d311d1bd639b18527b57799b74ceb
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/system/fvSchemes
@@ -0,0 +1,76 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      fvSchemes;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+ddtSchemes
+{
+    default         Euler;
+}
+
+gradSchemes
+{
+    default         Gauss linear;
+    grad(p)         Gauss linear;
+}
+
+divSchemes
+{
+    default         none;
+    div(phi,U)      Gauss upwind;
+    div(phid,p)     Gauss upwind;
+    div(phi,K)      Gauss linear;
+    div(phi,h)      Gauss upwind;
+    div(phi,k)      Gauss upwind;
+    div(phi,epsilon) Gauss upwind;
+    div(phi,R)      Gauss upwind;
+    div(phi,omega)  Gauss upwind;
+    div((rho*R))    Gauss linear;
+    div(R)          Gauss linear;
+    div(U)          Gauss linear;
+    div((muEff*dev2(T(grad(U))))) Gauss linear;
+}
+
+laplacianSchemes
+{
+    default         none;
+    laplacian(muEff,U) Gauss linear corrected;
+    laplacian(mut,U) Gauss linear corrected;
+    laplacian(DkEff,k) Gauss linear corrected;
+    laplacian(DepsilonEff,epsilon) Gauss linear corrected;
+    laplacian(DREff,R) Gauss linear corrected;
+    laplacian(DomegaEff,omega) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
+    laplacian(alphaEff,h) Gauss linear corrected;
+}
+
+interpolationSchemes
+{
+    default         linear;
+}
+
+snGradSchemes
+{
+    default         corrected;
+}
+
+fluxRequired
+{
+    default         no;
+    p               ;
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/system/fvSolution b/tutorials/compressible/rhoPimplecFoam/angledDuct/system/fvSolution
new file mode 100644
index 0000000000000000000000000000000000000000..4a126ed8e44ac2adea221069d86969dc2c51456a
--- /dev/null
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/system/fvSolution
@@ -0,0 +1,89 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      fvSolution;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+solvers
+{
+    p
+    {
+        solver          PCG;
+        preconditioner  DIC;
+        tolerance       1e-06;
+        relTol          0.01;
+    }
+
+    pFinal
+    {
+        $p;
+        tolerance       1e-06;
+        relTol          0;
+    }
+
+    "(rho|U|h|k|epsilon|omega)"
+    {
+        solver          PBiCG;
+        preconditioner  DILU;
+        tolerance       1e-05;
+        relTol          0.1;
+    }
+
+    "(rho|U|h|k|epsilon|omega)Final"
+    {
+        $U;
+        tolerance       1e-05;
+        relTol          0;
+    }
+
+}
+
+PIMPLE
+{
+    momentumPredictor yes;
+    transonic       no;
+    nOuterCorrectors 50;
+    nCorrectors     1;
+    nNonOrthogonalCorrectors 0;
+    rhoMin          rhoMin [ 1 -3 0 0 0 ] 0.1;
+    rhoMax          rhoMax [ 1 -3 0 0 0 ] 3.0;
+
+    residualControl
+    {
+        "(U|k|epsilon)"
+        {
+            relTol          0;
+            tolerance       0.0001;
+        }
+    }
+
+    turbOnFinalIterOnly off;
+}
+
+relaxationFactors
+{
+    fields
+    {
+        "p.*"           1;
+        "rho.*"         1;
+    }
+    equations
+    {
+        "(U|h|k|epsilon|omega).*" 0.85;
+        "p.*" 1;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPorousMRFLTSPimpleFoam/angledDuct/system/fvSchemes b/tutorials/compressible/rhoPorousMRFLTSPimpleFoam/angledDuct/system/fvSchemes
index 00981f61fcb6a70666b768c6177a089b00cfc7c5..62fadfb8ca3ee3c2eca193b571f5637905547972 100644
--- a/tutorials/compressible/rhoPorousMRFLTSPimpleFoam/angledDuct/system/fvSchemes
+++ b/tutorials/compressible/rhoPorousMRFLTSPimpleFoam/angledDuct/system/fvSchemes
@@ -52,7 +52,7 @@ laplacianSchemes
     laplacian(DepsilonEff,epsilon) Gauss linear corrected;
     laplacian(DREff,R) Gauss linear corrected;
     laplacian(DomegaEff,omega) Gauss linear corrected;
-    laplacian((rho*(1|A(U))),p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
     laplacian(alphaEff,h) Gauss linear corrected;
 }
 
diff --git a/tutorials/compressible/rhoPorousMRFPimpleFoam/mixerVessel2D/system/fvSchemes b/tutorials/compressible/rhoPorousMRFPimpleFoam/mixerVessel2D/system/fvSchemes
index dbca5c1607ad223ed5c440bd179c7708125c49b0..d49880685b11175bebc06136d7a7de0372e73f8c 100644
--- a/tutorials/compressible/rhoPorousMRFPimpleFoam/mixerVessel2D/system/fvSchemes
+++ b/tutorials/compressible/rhoPorousMRFPimpleFoam/mixerVessel2D/system/fvSchemes
@@ -40,7 +40,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(muEff,U) Gauss linear corrected;
-    laplacian((rho*(1|A(U))),p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
     laplacian(alphaEff,h) Gauss linear corrected;
     laplacian(DkEff,k) Gauss linear corrected;
     laplacian(DepsilonEff,epsilon) Gauss linear corrected;
diff --git a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctExplicit/system/fvSchemes b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctExplicit/system/fvSchemes
index d237bd73617ff269aa6435fc68b5269a8bca0fec..0a14cc31a562d3cf4ef18e5f212213f57ba396d9 100644
--- a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctExplicit/system/fvSchemes
+++ b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctExplicit/system/fvSchemes
@@ -29,17 +29,16 @@ divSchemes
 {
     div(phi,U)      Gauss upwind;
     div((muEff*dev2(T(grad(U))))) Gauss linear;
-    div(phi,h)      Gauss upwind;
+    div(phi,e)      Gauss upwind;
     div(phi,epsilon) Gauss upwind;
     div(phi,k)      Gauss upwind;
-    div(phi,K)      Gauss upwind;
+    div(phi,Ekp)    Gauss upwind;
 }
 
 laplacianSchemes
 {
     laplacian(muEff,U) Gauss linear corrected;
-    laplacian(alphaEff,h) Gauss linear corrected;
-    laplacian((rho|A(U)),p) Gauss linear corrected;
+    laplacian(alphaEff,e) Gauss linear corrected;
     laplacian((rho*rAU),p) Gauss linear corrected;
     laplacian(DepsilonEff,epsilon) Gauss linear corrected;
     laplacian(DkEff,k) Gauss linear corrected;
diff --git a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctExplicit/system/fvSolution b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctExplicit/system/fvSolution
index 317c954ef60beb892d00878b5fc21b414ca99a4d..a1e310922224d85f5ade01fa361b7ed0e1aeba01 100644
--- a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctExplicit/system/fvSolution
+++ b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctExplicit/system/fvSolution
@@ -38,7 +38,7 @@ solvers
         relTol          0.1;
     }
 
-    h
+    e
     {
         solver          PBiCG;
         preconditioner  DILU;
@@ -82,7 +82,7 @@ relaxationFactors
     {
         U               0.7;
         "(k|epsilon)"   0.7;
-        h               0.5;
+        e               0.5;
     }
 }
 
diff --git a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/constant/polyMesh/boundary b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/constant/polyMesh/boundary
index 0abd1608aba0dcb6aa66c9488133a3c4b51c7588..a664893343e7216491ca9913ee0171ee31980aba 100644
--- a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/constant/polyMesh/boundary
+++ b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/constant/polyMesh/boundary
@@ -8,7 +8,7 @@
 FoamFile
 {
     version     2.0;
-    format      ascii;
+    format      binary;
     class       polyBoundaryMesh;
     location    "constant/polyMesh";
     object      boundary;
diff --git a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/constant/thermophysicalProperties b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/constant/thermophysicalProperties
index d6d597d433f7d69e5e2329e6c716ed66b8a99675..cbe21562972775a88448d54c26a3dba002171ac0 100644
--- a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/constant/thermophysicalProperties
+++ b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/constant/thermophysicalProperties
@@ -15,7 +15,7 @@ FoamFile
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-thermoType      hPsiThermo<pureMixture<sutherlandTransport<specieThermo<hConstThermo<perfectGas>>>>>;
+thermoType ePsiThermo<pureMixture<sutherlandTransport<specieThermo<eConstThermo<perfectGas>>>>>;
 
 mixture
 {
@@ -26,7 +26,7 @@ mixture
     }
     thermodynamics
     {
-        Cp          1007;
+        Cv          719.3;
         Hf          0;
     }
     transport
diff --git a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/system/fvSchemes b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/system/fvSchemes
index 711e4e3233a2e700ada115f8ffeb80db86b6950d..0a14cc31a562d3cf4ef18e5f212213f57ba396d9 100644
--- a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/system/fvSchemes
+++ b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/system/fvSchemes
@@ -29,16 +29,16 @@ divSchemes
 {
     div(phi,U)      Gauss upwind;
     div((muEff*dev2(T(grad(U))))) Gauss linear;
-    div(phi,h)      Gauss upwind;
+    div(phi,e)      Gauss upwind;
     div(phi,epsilon) Gauss upwind;
     div(phi,k)      Gauss upwind;
-    div(phi,K)      Gauss upwind;
+    div(phi,Ekp)    Gauss upwind;
 }
 
 laplacianSchemes
 {
     laplacian(muEff,U) Gauss linear corrected;
-    laplacian(alphaEff,h) Gauss linear corrected;
+    laplacian(alphaEff,e) Gauss linear corrected;
     laplacian((rho*rAU),p) Gauss linear corrected;
     laplacian(DepsilonEff,epsilon) Gauss linear corrected;
     laplacian(DkEff,k) Gauss linear corrected;
diff --git a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/system/fvSolution b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/system/fvSolution
index 6f93606315e870b623e74ae0992328c26c6e7735..65a9606e7fb75aadf0be3b521903be30b9f3f193 100644
--- a/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/system/fvSolution
+++ b/tutorials/compressible/rhoPorousMRFSimpleFoam/angledDuctImplicit/system/fvSolution
@@ -29,7 +29,7 @@ solvers
         mergeLevels     1;
     }
 
-    h
+    e
     {
         solver          PBiCG;
         preconditioner  DILU;
@@ -76,7 +76,7 @@ relaxationFactors
     {
         U               0.7;
         "(k|epsilon)"   0.9;
-        h               0.9;
+        e               0.9;
     }
 }
 
diff --git a/tutorials/compressible/rhoSimplecFoam/squareBend/0/U b/tutorials/compressible/rhoSimplecFoam/squareBend/0/U
index 70988607c87df6f0cbf431c7736807fcbb9568cd..d5bd0a74cf75eac8797c6d9337e2ea656734ba4d 100644
--- a/tutorials/compressible/rhoSimplecFoam/squareBend/0/U
+++ b/tutorials/compressible/rhoSimplecFoam/squareBend/0/U
@@ -28,7 +28,7 @@ boundaryField
     inlet
     {
         type            flowRateInletVelocity;
-        flowRate        constant 0.5; //0.75;
+        flowRate        constant 0.5;
         value           uniform (0 0 0);
     }
     outlet
diff --git a/tutorials/compressible/rhoSimplecFoam/squareBend/constant/thermophysicalProperties b/tutorials/compressible/rhoSimplecFoam/squareBend/constant/thermophysicalProperties
index d6d597d433f7d69e5e2329e6c716ed66b8a99675..cbe21562972775a88448d54c26a3dba002171ac0 100644
--- a/tutorials/compressible/rhoSimplecFoam/squareBend/constant/thermophysicalProperties
+++ b/tutorials/compressible/rhoSimplecFoam/squareBend/constant/thermophysicalProperties
@@ -15,7 +15,7 @@ FoamFile
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-thermoType      hPsiThermo<pureMixture<sutherlandTransport<specieThermo<hConstThermo<perfectGas>>>>>;
+thermoType ePsiThermo<pureMixture<sutherlandTransport<specieThermo<eConstThermo<perfectGas>>>>>;
 
 mixture
 {
@@ -26,7 +26,7 @@ mixture
     }
     thermodynamics
     {
-        Cp          1007;
+        Cv          719.3;
         Hf          0;
     }
     transport
diff --git a/tutorials/compressible/rhoSimplecFoam/squareBend/system/decomposeParDict b/tutorials/compressible/rhoSimplecFoam/squareBend/system/decomposeParDict
new file mode 100644
index 0000000000000000000000000000000000000000..9e844a62ba7901b16f2d0c8c470ae7b5acb2504a
--- /dev/null
+++ b/tutorials/compressible/rhoSimplecFoam/squareBend/system/decomposeParDict
@@ -0,0 +1,45 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      decomposeParDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+numberOfSubdomains 8;
+
+method          hierarchical;
+
+simpleCoeffs
+{
+    n               (8 1 1);
+    delta           0.001;
+}
+
+hierarchicalCoeffs
+{
+    n               (4 2 1);
+    delta           0.001;
+    order           xyz;
+}
+
+manualCoeffs
+{
+    dataFile        "";
+}
+
+distributed     no;
+
+roots           ( );
+
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSimplecFoam/squareBend/system/fvSchemes b/tutorials/compressible/rhoSimplecFoam/squareBend/system/fvSchemes
index c9c95b180c2eb1e4f92092bd77559607b35226c4..e1e47211d72678553a22afbf86cea2a1328511c2 100644
--- a/tutorials/compressible/rhoSimplecFoam/squareBend/system/fvSchemes
+++ b/tutorials/compressible/rhoSimplecFoam/squareBend/system/fvSchemes
@@ -31,12 +31,13 @@ divSchemes
 
     div(phi,U)          Gauss upwind;
     div((muEff*dev2(T(grad(U)))))      Gauss linear;
-    div(phi,h)          Gauss upwind;
+    div(phi,e)          Gauss upwind;
     div(phi,epsilon)    Gauss upwind;
     div(phi,k)          Gauss upwind;
 
     div(phid,p)         Gauss upwind;
-    div(phi,K)          Gauss upwind;
+    div(phi,Ekp)        Gauss upwind;
+    div((phi|interpolate(rho)),p)  Gauss upwind;
 }
 
 laplacianSchemes
diff --git a/tutorials/compressible/rhoSimplecFoam/squareBend/system/fvSolution b/tutorials/compressible/rhoSimplecFoam/squareBend/system/fvSolution
index 09afca5761b1515ad887abe4ff8a8c39a9273876..812766041a21bed2e68133a8532c64336f224a37 100644
--- a/tutorials/compressible/rhoSimplecFoam/squareBend/system/fvSolution
+++ b/tutorials/compressible/rhoSimplecFoam/squareBend/system/fvSolution
@@ -32,7 +32,7 @@ solvers
         mergeLevels     1;
     }
 
-    "(U|h|k|epsilon)"
+    "(U|e|k|epsilon)"
     {
         solver          GAMG;
         tolerance       1e-08;
@@ -67,7 +67,7 @@ relaxationFactors
     {
         p               1;
         U               0.9;
-        h               0.9;
+        e               0.9;
         k               0.9;
         epsilon         0.9;
     }
diff --git a/tutorials/compressible/sonicFoam/laminar/forwardStep/system/fvSchemes b/tutorials/compressible/sonicFoam/laminar/forwardStep/system/fvSchemes
index b4cf8d2e38d798122b9909b0a8e91b78f1c87e23..51799627c881c59a26a6af79531717e41daf7497 100644
--- a/tutorials/compressible/sonicFoam/laminar/forwardStep/system/fvSchemes
+++ b/tutorials/compressible/sonicFoam/laminar/forwardStep/system/fvSchemes
@@ -40,7 +40,7 @@ divSchemes
 laplacianSchemes
 {
     default         none;
-    laplacian((rho*(1|A(U))),p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
     laplacian(muEff,U) Gauss linear corrected;
     laplacian(alphaEff,e) Gauss linear corrected;
 }
diff --git a/tutorials/compressible/sonicFoam/laminar/shockTube/system/fvSchemes b/tutorials/compressible/sonicFoam/laminar/shockTube/system/fvSchemes
index 616ee4aa1bb4895620df483460be5b4f0a89e45b..52cd9397231b9b09a6a718aa674299f30e7e9202 100644
--- a/tutorials/compressible/sonicFoam/laminar/shockTube/system/fvSchemes
+++ b/tutorials/compressible/sonicFoam/laminar/shockTube/system/fvSchemes
@@ -40,7 +40,7 @@ divSchemes
 laplacianSchemes
 {
     default         none;
-    laplacian((rho*(1|A(U))),p) Gauss linear orthogonal;
+    laplacian(Dp,p) Gauss linear orthogonal;
     laplacian(muEff,U) Gauss linear orthogonal;
     laplacian(alphaEff,e) Gauss linear orthogonal;
 }
diff --git a/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/fvSchemes b/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/fvSchemes
index b12dc45dcf6d0ba6aaad7e83fbbbdcac2bffd7c9..4f1434c4797986ad7e8fcf905340a7c01a2423c7 100644
--- a/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/fvSchemes
+++ b/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/fvSchemes
@@ -46,7 +46,7 @@ laplacianSchemes
     laplacian(DkEff,k) Gauss linear limited 0.5;
     laplacian(DREff,R) Gauss linear limited 0.5;
     laplacian(DepsilonEff,epsilon) Gauss linear limited 0.5;
-    laplacian((rho*(1|A(U))),p) Gauss linear limited 0.5;
+    laplacian(Dp,p) Gauss linear limited 0.5;
     laplacian(alphaEff,e) Gauss linear limited 0.5;
 }
 
diff --git a/tutorials/compressible/sonicFoam/ras/prism/system/fvSchemes b/tutorials/compressible/sonicFoam/ras/prism/system/fvSchemes
index e7b5a41a604f719f59b61610b77d2b2de68a5e4c..6aa61d831af8b7e2f1f8c47350bfba0ff2b592f3 100644
--- a/tutorials/compressible/sonicFoam/ras/prism/system/fvSchemes
+++ b/tutorials/compressible/sonicFoam/ras/prism/system/fvSchemes
@@ -46,7 +46,7 @@ laplacianSchemes
     laplacian(DkEff,k) Gauss linear corrected;
     laplacian(DREff,R) Gauss linear corrected;
     laplacian(DepsilonEff,epsilon) Gauss linear corrected;
-    laplacian((rho*(1|A(U))),p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
     laplacian(alphaEff,e) Gauss linear corrected;
 }
 
diff --git a/tutorials/compressible/sonicLiquidFoam/decompressionTank/system/fvSchemes b/tutorials/compressible/sonicLiquidFoam/decompressionTank/system/fvSchemes
index d7aad508a2c0d987406d7ab0b34a888da769ac57..d1a9bb7aa1310b3bee441fbc1800724e6f19a0a3 100644
--- a/tutorials/compressible/sonicLiquidFoam/decompressionTank/system/fvSchemes
+++ b/tutorials/compressible/sonicLiquidFoam/decompressionTank/system/fvSchemes
@@ -37,7 +37,7 @@ laplacianSchemes
 {
     default         none;
     laplacian(mu,U) Gauss linear corrected;
-    laplacian((rho*(1|A(U))),p) Gauss linear corrected;
+    laplacian(Dp,p) Gauss linear corrected;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/polyMesh/boundary b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/polyMesh/boundary
index ce35cbafd7f8f50e49222d6ed42831fefccde7ef..48ad5decf746b4bf479e124086474b778f2ca070 100644
--- a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/polyMesh/boundary
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/polyMesh/boundary
@@ -78,7 +78,7 @@ FoamFile
         sampleRegion    baffleRegion;
         samplePatch     region0_to_baffleRegion_baffleFaces2_top;
         offsetMode      nonuniform;
-        offsets         
+        offsets         nonuniform List<vector> 
 14
 (
 (0.02 8.67362e-19 -0)
@@ -107,7 +107,7 @@ FoamFile
         sampleRegion    baffleRegion;
         samplePatch     region0_to_baffleRegion_baffleFaces2_bottom;
         offsetMode      nonuniform;
-        offsets         
+        offsets         nonuniform List<vector> 
 14
 (
 (1.11022e-16 8.67362e-19 -0)
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/changeDictionaryDict b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/changeDictionaryDict
index 6391270926844a1db3db341cc9de562c69b82335..5a0ae0bb51f06f02f3dab4341e773a4b360c987f 100644
--- a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/changeDictionaryDict
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/changeDictionaryDict
@@ -24,9 +24,8 @@ dictionaryReplacement
             {
                 type                compressible::temperatureThermoBaffle;
                 neighbourFieldName  T;
-                K                   solidThermo;
-                KName               none;
-
+                kappa               solidThermo;
+                kappaName           none;
                 value               uniform 300;
             }
             baffleFaces2_side
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/fvSchemes b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/fvSchemes
index 3cf3fd7ea9f0524aceb07de61e051e4d843bf68c..82b8ff469db7dd04f692a1d1e8ed0ea27ba93d9a 100644
--- a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/fvSchemes
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/fvSchemes
@@ -32,8 +32,8 @@ gradSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear uncorrected;
+    default             none;
+    laplacian(kappa,T)  Gauss linear uncorrected;
 }
 
 
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict
index a535343ee2f50fbed03d644eaaa06c553e582155..254687533158b58902e8bc91a1d84d998444d710 100644
--- a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict
@@ -94,12 +94,12 @@ dictionaryReplacement
                 Qs              uniform 100;    // heat flux [W/m2]
                 transport
                 {
-                    K               1.0;
+                    kappa           1.0;
                 }
                 radiation
                 {
                     sigmaS          0;
-                    kappa           0;
+                    kappaRad        0;
                     emissivity      0;
                 }
                 thermodynamics
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffle b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffle
index 6b4a777a530d2ad349e5075ac4cc6ec6ef04c336..194fa15adb424c3491a1d8cb03326ef303ef1406 100644
--- a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffle
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffle
@@ -94,12 +94,12 @@ dictionaryReplacement
                 Qs              uniform 300;    // heat flux [W/m2]
                 transport
                 {
-                    K               1.0;
+                    kappa           1.0;
                 }
                 radiation
                 {
                     sigmaS          0;
-                    kappa           0;
+                    kappaRad        0;
                     emissivity      0;
                 }
                 thermodynamics
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffleRegion b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffleRegion
index 8c6c66145c1034445aecba0b1866d5ca580ec1ed..a8385331e3451ed99ce4127656c15779fbe5b75f 100644
--- a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffleRegion
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffleRegion
@@ -95,8 +95,8 @@ dictionaryReplacement
 
                 // Coupled BC.
                 neighbourFieldName  T;
-                K                   basicThermo;
-                KName               none;
+                kappa               basicThermo;
+                kappaName           none;
 
 
                 // Thermo baffle model
@@ -117,10 +117,10 @@ dictionaryReplacement
                     //- thermo properties
                     rho rho [1 -3  0  0 0 0 0]              80;
                     Cp  Cp  [0  2 -2 -1 0 0 0]              15;
-                    K   K   [1  1 -3 -1 0 0 0]              0.01;
+                    kappa   kappa   [1  1 -3 -1 0 0 0]      0.01;
 
                     //- radiative properties
-                    kappa kappa [0 -1 0 0 0 0 0]            0;
+                    kappaRad kappaRad [0 -1 0 0 0 0 0]            0;
                     sigmaS sigmaS [0 -1 0 0 0 0 0]          0;
                     emissivity  emissivity  [0 0 0 0 0 0 0] 1;
 
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allrun b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allrun
index b9137a48fa279b6ac88aae50d54590546617479b..3df64829527f2f951f6568ee615e33e771004025 100755
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allrun
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allrun
@@ -37,7 +37,7 @@ do
 done
 
 # Run
-#runParallel `getApplication` 4
+runParallel `getApplication` 4
 
 # Reconstruct
 #for i in bottomAir topAir heater leftSolid rightSolid
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/heater/solidThermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/heater/solidThermophysicalProperties
index ec1061eb2d75128ea53cbeefe2007fbca7971dd3..09f5e45bf1147df6897f3900f4545a12afed2be1 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/heater/solidThermophysicalProperties
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/heater/solidThermophysicalProperties
@@ -23,10 +23,10 @@ constSolidThermoCoeffs
     //- thermo properties
     rho rho [1 -3  0  0 0 0 0] 8000;
     Cp  Cp  [0  2 -2 -1 0 0 0] 450;
-    K   K   [1  1 -3 -1 0 0 0] 80;
+    kappa   kappa   [1  1 -3 -1 0 0 0] 80;
 
     //- radiation properties
-    kappa kappa [0 -1 0 0 0 0 0]            0;
+    kappaRad kappaRad [0 -1 0 0 0 0 0]      0;
     sigmaS sigmaS [0 -1 0 0 0 0 0]          0;
     emissivity  emissivity  [0 0 0 0 0 0 0] 0;
 
@@ -41,11 +41,11 @@ isotropicKSolidThermoCoeffs
     TValues             (100 1000);
     rhoValues           (1000 1700);
     cpValues            (1700 1700);
-    KValues             (80 40);
+    kappaValues         (80 40);
 
     //- radiation properties
     emissivityValues    (1 1);
-    kappaValues         (0 0);
+    kappaRadValues      (0 0);
     sigmaSValues        (0 0);
 
     //- chemical properties
@@ -63,7 +63,7 @@ directionalKSolidThermoCoeffs
     TValues             (100 1000);
     rhoValues           (1000 1700);
     cpValues            (1700 1700);
-    KValues             ((10 10 10) (40 40 40));
+    kappaValues         ((10 10 10) (40 40 40));
 
     coordinateSystem
     {
@@ -81,7 +81,7 @@ directionalKSolidThermoCoeffs
 
     //- radiation properties
     emissivityValues    (1 1);
-    kappaValues         (1 1);
+    kappaRadValues      (1 1);
     sigmaSValues        (1 1);
 }
 
@@ -94,14 +94,14 @@ pmmaCoeffs
 {
     transport
     {
-        K0      0.152;
+        kappa0  0.152;
         n0      1.3;
-        Tref    300; //K0*pow(T/Tref_, n0))
+        Tref    300; //kappa0*pow(T/Tref_, n0))
     }
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;
+        kappaRad    0.0;
         emissivity  0.1;
     }
     thermodynamics
@@ -121,15 +121,15 @@ charCoeffs
 {
     transport
     {
-        K0      0.4;
+        kappa0  0.4;
         n0      1.3;
-        Tref    300; //K0*pow(T/Tref_, n0))
+        Tref    300; //kappa0*pow(T/Tref_, n0))
     }
 
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;
+        kappaRad    0.0;
         emissivity  0.0;
     }
 
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict
index af17b665a6777a4cb60d52ad244ed1dc61299b36..a736e341f62764e7fea3cc6d0769b3457dbd409e 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict
@@ -57,8 +57,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               basicThermo;
-                KName           none;
+                kappa           basicThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/changeDictionaryDict
index ce32ac9f54c954bea4ae4ac55de3414a5963f1ee..1222482e8fa96ac25ee1b8118f5e3e71e59752f3 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/changeDictionaryDict
@@ -47,8 +47,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
             minY
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvSchemes
index a8f4d26129bfa7709068ea5cdca47dd299f605e4..665dada1839774556abbb071c53093e56549bc59 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear limited 0.333;
+    default             none;
+    laplacian(kappa,T)  Gauss linear limited 0.333;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict
index 5425a5ec5afef651e9bec052173eb7f6f1646056..c70f5391f632c2889eb1f33d255d6548d96abd14 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict
@@ -43,8 +43,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes
index c1747b7f0efd66ebc1bb7de1b72de998624962db..8f4342605de65cef0f2f994226489bd9397a620f 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T)   Gauss linear limited 0.333;
+    default                 none;
+    laplacian(kappa,T)      Gauss linear limited 0.333;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/changeDictionaryDict
index 2bc26681f0f3b30539494ab4860d7b943ba1fffa..913adcf7844b5fd8984ea628382de5953af89ad4 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/changeDictionaryDict
@@ -43,8 +43,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSchemes
index d8fcd9179f83ad3c6ce6e0f842fe093711598513..081089f15784a21c06add53888777809facb6144 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T)   Gauss linear limited 0.333;
+    default              none;
+    laplacian(kappa,T)   Gauss linear limited 0.333;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/changeDictionaryDict
index a64cb4027e5e81bca4729c50d5fd9b501151254b..787c1147d8fe51b83896187f272d052e6795caab 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/changeDictionaryDict
@@ -68,8 +68,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               basicThermo;
-                KName           none;
+                kappa           basicThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/heater/solidThermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/heater/solidThermophysicalProperties
index b345dace24db64ade62003bc906fb1bb296eec67..948d2be1f4402e433ebb62950de03434a7a1a18b 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/heater/solidThermophysicalProperties
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/heater/solidThermophysicalProperties
@@ -25,10 +25,10 @@ constSolidThermoCoeffs
     //- thermo properties
     rho rho [1 -3  0  0 0 0 0] 8000;
     Cp  Cp  [0  2 -2 -1 0 0 0] 450;
-    K   K   [1  1 -3 -1 0 0 0] 80;
+    kappa   kapp   [1  1 -3 -1 0 0 0] 80;
 
     //- radiation properties
-    kappa kappa [0 -1 0 0 0 0 0]            0;
+    kappaRad kappaRad [0 -1 0 0 0 0 0]      0;
     sigmaS sigmaS [0 -1 0 0 0 0 0]          0;
     emissivity  emissivity  [0 0 0 0 0 0 0] 1;
 
@@ -43,11 +43,11 @@ isotropicKSolidThermoCoeffs
     TValues             (100 1000);
     rhoValues           (1000 1700);
     cpValues            (1700 1700);
-    KValues             (80 40);
+    kappaValues         (80 40);
 
     //- radiation properties
     emissivityValues    (1 1);
-    kappaValues         (0 0);
+    kappaRadValues      (0 0);
     sigmaSValues        (0 0);
 
     //- chemical properties
@@ -65,7 +65,7 @@ directionalKSolidThermoCoeffs
     TValues             (100 1000);
     rhoValues           (1700 1700);
     cpValues            (1700 1700);
-    KValues             ((10 10 10) (40 40 40));
+    kappaValues         ((10 10 10) (40 40 40));
 
     coordinateSystem
     {
@@ -83,8 +83,8 @@ directionalKSolidThermoCoeffs
 
     //- radiation properties
     emissivityValues    (1 1);
-    kappaValues         (1 1);
-    sigmaSValues         (1 1);
+    kappaRadValues      (1 1);
+    sigmaSValues        (1 1);
 }
 
 solidComponents
@@ -96,7 +96,7 @@ pmmaCoeffs
 {
     transport
     {
-        K0      0.152;
+        kappa0  0.152;
         n0      1.3;
         Tref    300; //K0*pow(T/Tref_, n0))
     }
@@ -104,7 +104,7 @@ pmmaCoeffs
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;
+        kappaRad    0.0;
         emissivity  0.1;
     }
 
@@ -126,7 +126,7 @@ charCoeffs
 {
     transport
     {
-        K0      0.4;
+        kappa0  0.4;
         n0      1.3;
         Tref    300; //K0*pow(T/Tref_, n0))
     }
@@ -134,7 +134,7 @@ charCoeffs
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;
+        kappaRad    0.0;
         emissivity  0.0;
     }
 
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict
index 77d46927408fd7f794ddf770f4fb8276aa9f9c20..4c53b4cb8aa05d21efe07a798b2cf9a78f5b6406 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict
@@ -70,8 +70,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               basicThermo;
-                KName           none;
+                kappa           basicThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict.save b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict.save
index 1336cf032480c75c018b8180d979beee2ce7c892..35bf28b902080f15e0bf42baa1fee727e1ecc10b 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict.save
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict.save
@@ -57,8 +57,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               basicThermo;
-                KName           none;
+                kappa           basicThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/changeDictionaryDict
index 654df1e3df753d9229ca02e77c4bd46327674692..1a443947174e344775c6288c8af9f73c81e572dd 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/changeDictionaryDict
@@ -48,8 +48,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
             minY
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/fvSchemes
index a8f4d26129bfa7709068ea5cdca47dd299f605e4..665dada1839774556abbb071c53093e56549bc59 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear limited 0.333;
+    default             none;
+    laplacian(kappa,T)  Gauss linear limited 0.333;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/changeDictionaryDict
index e4af521f715221175d03e3db61ed5a583ddafb1e..fa798f65a5b34d9d8b6f5fb0e0c1767aafb1f500 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/changeDictionaryDict
@@ -43,8 +43,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/fvSchemes
index a8f4d26129bfa7709068ea5cdca47dd299f605e4..665dada1839774556abbb071c53093e56549bc59 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear limited 0.333;
+    default             none;
+    laplacian(kappa,T)  Gauss linear limited 0.333;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/changeDictionaryDict
index 16504fb92a91c7d96b4b16761f17868a6ab040a6..546b3321383cfff4dc7be0c5792ca8427b14a35a 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/changeDictionaryDict
@@ -43,8 +43,8 @@ dictionaryReplacement
             {
                 type       compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/fvSchemes
index a8f4d26129bfa7709068ea5cdca47dd299f605e4..665dada1839774556abbb071c53093e56549bc59 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear limited 0.333;
+    default             none;
+    laplacian(kappa,T)  Gauss linear limited 0.333;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/changeDictionaryDict
index 3e91079163fc67c858f968b0f2bcd5c25fb8f614..e4f2256b3cc71febc6b2971ee4b513191910fe74 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/changeDictionaryDict
@@ -69,8 +69,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               basicThermo;
-                KName           none;
+                kappa           basicThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/heater/solidThermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/heater/solidThermophysicalProperties
index 54ca602eee896e1a52b8f963df4b96964d7891b3..7aab5490fa9bda1eaa4b1e87125a77bff641c669 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/heater/solidThermophysicalProperties
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/heater/solidThermophysicalProperties
@@ -25,10 +25,10 @@ constSolidThermoCoeffs
     //- thermo properties
     rho rho [1 -3  0  0 0 0 0] 8000;
     Cp  Cp  [0  2 -2 -1 0 0 0] 450;
-    K   K   [1  1 -3 -1 0 0 0] 80;
+    kappa   kappa   [1  1 -3 -1 0 0 0] 80;
 
     //- radiation properties
-    kappa kappa [0 -1 0 0 0 0 0]            0;
+    kappaRad kappaRad [0 -1 0 0 0 0 0]      0;
     sigmaS sigmaS [0 -1 0 0 0 0 0]          0;
     emissivity  emissivity  [0 0 0 0 0 0 0] 1;
 
@@ -43,11 +43,11 @@ isotropicKSolidThermoCoeffs
     TValues             (100 1000);
     rhoValues           (1000 1700);
     cpValues            (1700 1700);
-    KValues             (80 40);
+    kappaValues         (80 40);
 
     //- radiation properties
     emissivityValues    (1 1);
-    kappaValues         (0 0);
+    kappaRadValues      (0 0);
     sigmaSValues        (0 0);
 
     //- chemical properties
@@ -65,7 +65,7 @@ directionalKSolidThermoCoeffs
     TValues             (100 1000);
     rhoValues           (1700 1700);
     cpValues            (1700 1700);
-    KValues             ((10 10 10) (40 40 40));
+    kappaValues         ((10 10 10) (40 40 40));
 
     coordinateSystem
     {
@@ -83,7 +83,7 @@ directionalKSolidThermoCoeffs
 
     //- radiation properties
     emissivityValues    (1 1);
-    kappaValues         (1 1);
+    kappaRadValues      (1 1);
     sigmaSValues        (1 1);
 }
 
@@ -96,14 +96,14 @@ pmmaCoeffs
 {
     transport
     {
-        K0      0.152;
+        kappa0      0.152;
         n0      1.3;
         Tref    300; //K0*pow(T/Tref_, n0))
     }
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;
+        kappaRad    0.0;
         emissivity  0.1;
     }
     thermodynamics
@@ -123,14 +123,14 @@ charCoeffs
 {
     transport
     {
-        K0      0.4;
+        kappa0  0.4;
         n0      1.3;
         Tref    300; //K0*pow(T/Tref_, n0))
     }
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;
+        kappaRad    0.0;
         emissivity  0.0;
     }
     thermodynamics
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/changeDictionaryDict
index 77d580fe5127bb1a9b7fc705e7613639a1b7e741..a13bf04501645ae3ab5e7c544e0d2ee46da5b612 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/changeDictionaryDict
@@ -57,8 +57,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               basicThermo;
-                KName           none;
+                kappa           basicThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/changeDictionaryDict
index ce32ac9f54c954bea4ae4ac55de3414a5963f1ee..1222482e8fa96ac25ee1b8118f5e3e71e59752f3 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/changeDictionaryDict
@@ -47,8 +47,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
             minY
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSchemes
index a8f4d26129bfa7709068ea5cdca47dd299f605e4..665dada1839774556abbb071c53093e56549bc59 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear limited 0.333;
+    default             none;
+    laplacian(kappa,T)  Gauss linear limited 0.333;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/changeDictionaryDict
index 5425a5ec5afef651e9bec052173eb7f6f1646056..c70f5391f632c2889eb1f33d255d6548d96abd14 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/changeDictionaryDict
@@ -43,8 +43,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes
index a8f4d26129bfa7709068ea5cdca47dd299f605e4..665dada1839774556abbb071c53093e56549bc59 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear limited 0.333;
+    default             none;
+    laplacian(kappa,T)  Gauss linear limited 0.333;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/changeDictionaryDict
index 2bc26681f0f3b30539494ab4860d7b943ba1fffa..913adcf7844b5fd8984ea628382de5953af89ad4 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/changeDictionaryDict
@@ -43,8 +43,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes
index a8f4d26129bfa7709068ea5cdca47dd299f605e4..665dada1839774556abbb071c53093e56549bc59 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear limited 0.333;
+    default             none;
+    laplacian(kappa,T)  Gauss linear limited 0.333;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/changeDictionaryDict
index a64cb4027e5e81bca4729c50d5fd9b501151254b..787c1147d8fe51b83896187f272d052e6795caab 100644
--- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/changeDictionaryDict
@@ -68,8 +68,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               basicThermo;
-                KName           none;
+                kappa           basicThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/heater/solidThermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/heater/solidThermophysicalProperties
index b345dace24db64ade62003bc906fb1bb296eec67..b5e64d902951c4530e30c08e0cd3d8927ae44219 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/heater/solidThermophysicalProperties
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/heater/solidThermophysicalProperties
@@ -25,10 +25,10 @@ constSolidThermoCoeffs
     //- thermo properties
     rho rho [1 -3  0  0 0 0 0] 8000;
     Cp  Cp  [0  2 -2 -1 0 0 0] 450;
-    K   K   [1  1 -3 -1 0 0 0] 80;
+    kappa   kappa   [1  1 -3 -1 0 0 0] 80;
 
     //- radiation properties
-    kappa kappa [0 -1 0 0 0 0 0]            0;
+    kappaRad kappaRad [0 -1 0 0 0 0 0]            0;
     sigmaS sigmaS [0 -1 0 0 0 0 0]          0;
     emissivity  emissivity  [0 0 0 0 0 0 0] 1;
 
@@ -43,11 +43,11 @@ isotropicKSolidThermoCoeffs
     TValues             (100 1000);
     rhoValues           (1000 1700);
     cpValues            (1700 1700);
-    KValues             (80 40);
+    kappaValues             (80 40);
 
     //- radiation properties
     emissivityValues    (1 1);
-    kappaValues         (0 0);
+    kappaRadValues         (0 0);
     sigmaSValues        (0 0);
 
     //- chemical properties
@@ -65,7 +65,7 @@ directionalKSolidThermoCoeffs
     TValues             (100 1000);
     rhoValues           (1700 1700);
     cpValues            (1700 1700);
-    KValues             ((10 10 10) (40 40 40));
+    kappaValues         ((10 10 10) (40 40 40));
 
     coordinateSystem
     {
@@ -83,8 +83,8 @@ directionalKSolidThermoCoeffs
 
     //- radiation properties
     emissivityValues    (1 1);
-    kappaValues         (1 1);
-    sigmaSValues         (1 1);
+    kappaRadValues      (1 1);
+    sigmaSValues        (1 1);
 }
 
 solidComponents
@@ -96,7 +96,7 @@ pmmaCoeffs
 {
     transport
     {
-        K0      0.152;
+        kappa0  0.152;
         n0      1.3;
         Tref    300; //K0*pow(T/Tref_, n0))
     }
@@ -104,7 +104,7 @@ pmmaCoeffs
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;
+        kappaRad    0.0;
         emissivity  0.1;
     }
 
@@ -126,7 +126,7 @@ charCoeffs
 {
     transport
     {
-        K0      0.4;
+        kappa0  0.4;
         n0      1.3;
         Tref    300; //K0*pow(T/Tref_, n0))
     }
@@ -134,7 +134,7 @@ charCoeffs
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;
+        kappaRad    0.0;
         emissivity  0.0;
     }
 
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict
index af17b665a6777a4cb60d52ad244ed1dc61299b36..a736e341f62764e7fea3cc6d0769b3457dbd409e 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict
@@ -57,8 +57,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               basicThermo;
-                KName           none;
+                kappa           basicThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/changeDictionaryDict
index ce32ac9f54c954bea4ae4ac55de3414a5963f1ee..1222482e8fa96ac25ee1b8118f5e3e71e59752f3 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/changeDictionaryDict
@@ -47,8 +47,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
             minY
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/fvSchemes
index 28195d3d1cdf3bd360b8a721e3d3eb1319aadae7..f58979beaeb42aa6428b2236da290733c5e56cc1 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear uncorrected;
+    default             none;
+    laplacian(kappa,T)  Gauss linear uncorrected;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict
index 5425a5ec5afef651e9bec052173eb7f6f1646056..c70f5391f632c2889eb1f33d255d6548d96abd14 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict
@@ -43,8 +43,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/fvSchemes
index e2b4446a8fd6ae0c280234c94dcdd39dbe8a20d6..dad61d4cea0d62edeaf14d344806031b8001e9b3 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear uncorrected;
+    default             none;
+    laplacian(kappa,T)  Gauss linear uncorrected;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/changeDictionaryDict
index 2bc26681f0f3b30539494ab4860d7b943ba1fffa..913adcf7844b5fd8984ea628382de5953af89ad4 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/changeDictionaryDict
@@ -43,8 +43,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/fvSchemes
index e2b4446a8fd6ae0c280234c94dcdd39dbe8a20d6..dad61d4cea0d62edeaf14d344806031b8001e9b3 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear uncorrected;
+    default             none;
+    laplacian(kappa,T)  Gauss linear uncorrected;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/changeDictionaryDict
index a64cb4027e5e81bca4729c50d5fd9b501151254b..787c1147d8fe51b83896187f272d052e6795caab 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/changeDictionaryDict
@@ -68,8 +68,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               basicThermo;
-                KName           none;
+                kappa           basicThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/heater/solidThermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/heater/solidThermophysicalProperties
index 004cda2c14a96c9419875792f52993a330bbcf8c..bc196818813541a6bff88ec0c067463e4c14a166 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/heater/solidThermophysicalProperties
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/heater/solidThermophysicalProperties
@@ -25,10 +25,10 @@ constSolidThermoCoeffs
     //- thermo properties
     rho rho [1 -3  0  0 0 0 0] 8000;
     Cp  Cp  [0  2 -2 -1 0 0 0] 450;
-    K   K   [1  1 -3 -1 0 0 0] 80;
+    kappa   kappa   [1  1 -3 -1 0 0 0] 80;
 
     //- radiation properties
-    kappa kappa [0 -1 0 0 0 0 0]            0;
+    kappaRad kappaRad [0 -1 0 0 0 0 0]      0;
     sigmaS sigmaS [0 -1 0 0 0 0 0]          0;
     emissivity  emissivity  [0 0 0 0 0 0 0] 0.5;
 
@@ -43,11 +43,11 @@ isotropicKSolidThermoCoeffs
     TValues             (100 1000);
     rhoValues           (1000 1700);
     cpValues            (1700 1700);
-    KValues             (80 40);
+    kappaValues         (80 40);
 
     //- radiation properties
     emissivityValues    (1 1);
-    kappaValues         (0 0);
+    kappaRadValues      (0 0);
     sigmaSValues        (0 0);
 
     //- chemical properties
@@ -65,7 +65,7 @@ directionalKSolidThermoCoeffs
     TValues             (100 1000);
     rhoValues           (1700 1700);
     cpValues            (1700 1700);
-    KValues             ((10 10 10) (40 40 40));
+    kappaValues         ((10 10 10) (40 40 40));
 
     coordinateSystem
     {
@@ -83,8 +83,8 @@ directionalKSolidThermoCoeffs
 
     //- radiation properties
     emissivityValues    (1 1);
-    kappaValues         (1 1);
-    sigmaSValues         (1 1);
+    kappaRadValues      (1 1);
+    sigmaSValues        (1 1);
 }
 
 solidComponents
@@ -96,15 +96,15 @@ pmmaCoeffs
 {
     transport
     {
-        K0      0.152;
+        kappa0  0.152;
         n0      1.3;
-        Tref    300; //K0*pow(T/Tref_, n0))
+        Tref    300; //kappa0*pow(T/Tref_, n0))
     }
 
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;
+        kappaRad    0.0;
         emissivity  0.1;
     }
 
@@ -126,15 +126,15 @@ charCoeffs
 {
     transport
     {
-        K0      0.4;
+        kappa0  0.4;
         n0      1.3;
-        Tref    300; //K0*pow(T/Tref_, n0))
+        Tref    300; //kappa0*pow(T/Tref_, n0))
     }
 
     radiation
     {
         sigmaS      0.0;
-        kappa       0.0;
+        kappaRad    0.0;
         emissivity  0.0;
     }
 
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/changeDictionaryDict
index f08a1ebff825d2d924506dbf969acd6e7f9b68f0..fb0130ea256d9b813708b8bd244b681bd10818af 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/changeDictionaryDict
@@ -55,10 +55,10 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureRadCoupledMixed;
                 Tnbr            T;
-                K               basicThermo;
+                kappa           basicThermo;
                 QrNbr           none;
                 Qr              Qr;
-                KName           none;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/changeDictionaryDict
index 476c66666792aa56b6a975e8f37731f722a64a18..1a680f09a2404fe8a9aaf975352ae5ea1ab439ad 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/changeDictionaryDict
@@ -48,10 +48,10 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureRadCoupledMixed;
                 Tnbr            T;
-                K               solidThermo;
+                kappa           solidThermo;
                 QrNbr           Qr;
                 Qr              none;
-                KName           none;
+                kappaName       none;
                 value           uniform 300;
             }
 
@@ -59,10 +59,10 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureRadCoupledMixed;
                 Tnbr            T;
-                K               solidThermo;
+                kappa           solidThermo;
                 QrNbr           Qr;
                 Qr              none;
-                KName           none;
+                kappaName       none;
                 value           uniform 300;
             }
 
@@ -70,8 +70,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
             minY
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/fvSchemes
index 5a1fe19dbf5e58b699711a2ba3ad5be5b2f2de38..dad61d4cea0d62edeaf14d344806031b8001e9b3 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T)  Gauss linear uncorrected;
+    default             none;
+    laplacian(kappa,T)  Gauss linear uncorrected;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/changeDictionaryDict
index 078796b0d9ae3e6c843c803054173c38b509e49f..59116a041a13ea466a74dd387aa9e77e27a7b62a 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/changeDictionaryDict
@@ -44,10 +44,10 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureRadCoupledMixed;
                 Tnbr            T;
-                K               solidThermo;
+                kappa           solidThermo;
                 QrNbr           Qr;
                 Qr              none;
-                KName           none;
+                kappaName       none;
                 value           uniform 300;
             }
 
@@ -55,10 +55,10 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureRadCoupledMixed;
                 Tnbr            T;
-                K               solidThermo;
+                kappa           solidThermo;
                 QrNbr           Qr;
                 Qr              none;
-                KName           none;
+                kappaName       none;
                 value           uniform 300;
             }
 
@@ -66,8 +66,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/fvSchemes
index a2f1f34c3866785e44eff889cadc509b2e0f762c..8bacef012ffb11b2e42aaacea86445aad756e23d 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear limited 0.333;
+    default             none;
+    laplacian(kappa,T)  Gauss linear limited 0.333;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/changeDictionaryDict
index 605119e2697842157166d5b5957d94761db4c125..4f018226087024a4f0527d1d122ccc260a1b2179 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/changeDictionaryDict
@@ -44,10 +44,10 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureRadCoupledMixed;
                 Tnbr            T;
-                K               solidThermo;
+                kappa           solidThermo;
                 QrNbr           Qr;
                 Qr              none;
-                KName           none;
+                kappaName       none;
                 value           uniform 300;
             }
 
@@ -55,10 +55,10 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureRadCoupledMixed;
                 Tnbr            T;
-                K               solidThermo;
+                kappa           solidThermo;
                 QrNbr           Qr;
                 Qr              none;
-                KName           none;
+                kappaName       none;
                 value           uniform 300;
             }
 
@@ -66,8 +66,8 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureCoupledBaffleMixed;
                 neighbourFieldName T;
-                K               solidThermo;
-                KName           none;
+                kappa           solidThermo;
+                kappaName       none;
                 value           uniform 300;
             }
         }
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/fvSchemes
index 304c475fe8ca5fd6407aa36f2b2bf412cc00a696..89fb780470205e25f0143729b3828b3a69ff267e 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/fvSchemes
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/fvSchemes
@@ -31,8 +31,8 @@ divSchemes
 
 laplacianSchemes
 {
-    default         none;
-    laplacian(K,T) Gauss linear uncorrected;
+    default             none;
+    laplacian(kappa,T)  Gauss linear uncorrected;
 }
 
 interpolationSchemes
diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/changeDictionaryDict
index 4c78380972a483f8db32196a70ba41df408f3cf1..369915887eca8e731698b99192f6c5856f862761 100644
--- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/changeDictionaryDict
+++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/changeDictionaryDict
@@ -66,10 +66,10 @@ dictionaryReplacement
             {
                 type            compressible::turbulentTemperatureRadCoupledMixed;
                 Tnbr            T;
-                K               basicThermo;
+                kappa           basicThermo;
                 QrNbr           none;
                 Qr              Qr;
-                KName           none;
+                kappaName       none;
                 value           uniform 300;
             }
         }