diff --git a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/Make/files b/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/Make/files
deleted file mode 100644
index cd3553a3027dc21ead56f619b6615465267c60aa..0000000000000000000000000000000000000000
--- a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/Make/files
+++ /dev/null
@@ -1,3 +0,0 @@
-buoyantBaffleSimpleFoam.C
-
-EXE = $(FOAM_APPBIN)/buoyantBaffleSimpleFoam
diff --git a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/Make/options b/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/Make/options
deleted file mode 100644
index 0c40e8943020cd29877db0aaf0eba8941f6504e6..0000000000000000000000000000000000000000
--- a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/Make/options
+++ /dev/null
@@ -1,22 +0,0 @@
-EXE_INC = \
-    -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
-    -I$(LIB_SRC)/thermophysicalModels/basicSolidThermo/lnInclude \
-    -I$(LIB_SRC)/thermophysicalModels/specie/lnInclude \
-    -I$(LIB_SRC)/meshTools/lnInclude \
-    -I$(LIB_SRC)/turbulenceModels \
-    -I$(LIB_SRC)/turbulenceModels/compressible/RAS/lnInclude \
-    -I$(LIB_SRC)/finiteVolume/cfdTools \
-    -I$(LIB_SRC)/finiteVolume/lnInclude \
-    -I$(LIB_SRC)/regionModels/regionModel/lnInclude \
-    -I$(LIB_SRC)/regionModels/thermoBaffleModels/lnInclude
-
-EXE_LIBS = \
-    -lmeshTools \
-    -lbasicThermophysicalModels \
-    -lspecie \
-    -lcompressibleTurbulenceModel \
-    -lcompressibleRASModels \
-    -lfiniteVolume \
-    -lmeshTools \
-    -lthermoBaffleModels \
-    -lregionModels
diff --git a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/UEqn.H b/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/UEqn.H
deleted file mode 100644
index ca28910aaf3c51186663b2fb5919104d4fd07398..0000000000000000000000000000000000000000
--- a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/UEqn.H
+++ /dev/null
@@ -1,25 +0,0 @@
-    // Solve the Momentum equation
-
-    tmp<fvVectorMatrix> UEqn
-    (
-        fvm::div(phi, U)
-      + turbulence->divDevRhoReff(U)
-    );
-
-    UEqn().relax();
-
-    if (simple.momentumPredictor())
-    {
-        solve
-        (
-            UEqn()
-         ==
-            fvc::reconstruct
-            (
-                (
-                  - ghf*fvc::snGrad(rho)
-                  - fvc::snGrad(p_rgh)
-                )*mesh.magSf()
-            )
-        );
-    }
diff --git a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/buoyantBaffleSimpleFoam.C b/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/buoyantBaffleSimpleFoam.C
deleted file mode 100644
index 1a5b66f0c74786b871aa65769536d868a889f65b..0000000000000000000000000000000000000000
--- a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/buoyantBaffleSimpleFoam.C
+++ /dev/null
@@ -1,83 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 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
-    buoyantBaffleSimpleFoam
-
-Description
-    Steady-state solver for buoyant, turbulent flow of compressible fluids
-    using thermal baffles
-
-\*---------------------------------------------------------------------------*/
-
-#include "fvCFD.H"
-#include "basicPsiThermo.H"
-#include "RASModel.H"
-#include "fixedGradientFvPatchFields.H"
-#include "simpleControl.H"
-#include "thermoBaffleModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-int main(int argc, char *argv[])
-{
-    #include "setRootCase.H"
-    #include "createTime.H"
-    #include "createMesh.H"
-    #include "readGravitationalAcceleration.H"
-    #include "createFields.H"
-    #include "initContinuityErrs.H"
-
-    simpleControl simple(mesh);
-
-    // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-    Info<< "\nStarting time loop\n" << endl;
-
-    while (simple.loop())
-    {
-        Info<< "Time = " << runTime.timeName() << nl << endl;
-
-        // Pressure-velocity SIMPLE corrector
-        {
-            #include "UEqn.H"
-            #include "hEqn.H"
-            #include "pEqn.H"
-        }
-
-        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/heatTransfer/buoyantBaffleSimpleFoam/createFields.H b/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/createFields.H
deleted file mode 100644
index 7adb8e41e712d34bfde5fae5152a1567cc26bb42..0000000000000000000000000000000000000000
--- a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/createFields.H
+++ /dev/null
@@ -1,94 +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::NO_READ,
-            IOobject::NO_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"
-
-    Info<< "Creating turbulence model\n" << endl;
-    autoPtr<compressible::RASModel> turbulence
-    (
-        compressible::RASModel::New
-        (
-            rho,
-            U,
-            phi,
-            thermo
-        )
-    );
-
-
-    Info<< "Calculating field g.h\n" << endl;
-    volScalarField gh("gh", g & mesh.C());
-    surfaceScalarField ghf("ghf", g & mesh.Cf());
-
-    Info<< "Reading field p_rgh\n" << endl;
-    volScalarField p_rgh
-    (
-        IOobject
-        (
-            "p_rgh",
-            runTime.timeName(),
-            mesh,
-            IOobject::MUST_READ,
-            IOobject::AUTO_WRITE
-        ),
-        mesh
-    );
-
-    // Force p_rgh to be consistent with p
-    p_rgh = p - rho*gh;
-
-
-    label pRefCell = 0;
-    scalar pRefValue = 0.0;
-    setRefCell
-    (
-        p,
-        p_rgh,
-        mesh.solutionDict().subDict("SIMPLE"),
-        pRefCell,
-        pRefValue
-    );
-
-    autoPtr<regionModels::thermoBaffleModels::thermoBaffleModel> baffles
-    (
-        regionModels::thermoBaffleModels::thermoBaffleModel::New(mesh)
-    );
-
-    dimensionedScalar initialMass = fvc::domainIntegrate(rho);
-    dimensionedScalar totalVolume = sum(mesh.V());
diff --git a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/hEqn.H b/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/hEqn.H
deleted file mode 100644
index 23313b56cf10d7819fe0cd0f69cae76341941cc9..0000000000000000000000000000000000000000
--- a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/hEqn.H
+++ /dev/null
@@ -1,17 +0,0 @@
-{
-    fvScalarMatrix hEqn
-    (
-        fvm::div(phi, h)
-      - fvm::Sp(fvc::div(phi), h)
-      - fvm::laplacian(turbulence->alphaEff(), h)
-     ==
-        fvc::div(phi/fvc::interpolate(rho)*fvc::interpolate(p))
-      - p*fvc::div(phi/fvc::interpolate(rho))
-    );
-
-    hEqn.relax();
-    hEqn.solve();
-
-    baffles->evolve();
-    thermo.correct();
-}
diff --git a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/pEqn.H b/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/pEqn.H
deleted file mode 100644
index d2793d719261317317db265f4909c3594aa50fa4..0000000000000000000000000000000000000000
--- a/applications/solvers/heatTransfer/buoyantBaffleSimpleFoam/pEqn.H
+++ /dev/null
@@ -1,59 +0,0 @@
-{
-    rho = thermo.rho();
-    rho.relax();
-
-    volScalarField rAU(1.0/UEqn().A());
-    surfaceScalarField rhorAUf("(rho*(1|A(U)))", fvc::interpolate(rho*rAU));
-
-    U = rAU*UEqn().H();
-    UEqn.clear();
-
-    phi = fvc::interpolate(rho)*(fvc::interpolate(U) & mesh.Sf());
-    bool closedVolume = adjustPhi(phi, U, p_rgh);
-
-    surfaceScalarField buoyancyPhi(rhorAUf*ghf*fvc::snGrad(rho)*mesh.magSf());
-    phi -= buoyancyPhi;
-
-    while (simple.correctNonOrthogonal())
-    {
-        fvScalarMatrix p_rghEqn
-        (
-            fvm::laplacian(rhorAUf, p_rgh) == fvc::div(phi)
-        );
-
-        p_rghEqn.setReference(pRefCell, getRefCellValue(p_rgh, pRefCell));
-        p_rghEqn.solve();
-
-        if (simple.finalNonOrthogonalIter())
-        {
-            // Calculate the conservative fluxes
-            phi -= p_rghEqn.flux();
-
-            // Explicitly relax pressure for momentum corrector
-            p_rgh.relax();
-
-            // Correct the momentum source with the pressure gradient flux
-            // calculated from the relaxed pressure
-            U -= rAU*fvc::reconstruct((buoyancyPhi + p_rghEqn.flux())/rhorAUf);
-            U.correctBoundaryConditions();
-        }
-    }
-
-    #include "continuityErrs.H"
-
-    p = p_rgh + rho*gh;
-
-    // For closed-volume cases adjust the pressure level
-    // to obey overall mass continuity
-    if (closedVolume)
-    {
-        p += (initialMass - fvc::domainIntegrate(psi*p))
-            /fvc::domainIntegrate(psi);
-        p_rgh = p - rho*gh;
-    }
-
-    rho = thermo.rho();
-    rho.relax();
-    Info<< "rho max/min : " << max(rho).value() << " " << min(rho).value()
-        << endl;
-}
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/Allrun b/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/Allrun
deleted file mode 100755
index ef3b6603482809bcb0987a0e11c4a37df13b78e2..0000000000000000000000000000000000000000
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/Allrun
+++ /dev/null
@@ -1,27 +0,0 @@
-#!/bin/sh
-. $WM_PROJECT_DIR/bin/tools/RunFunctions
-
-# Get application name
-application=`getApplication`
-
-cp -r 0.org 0
-runApplication blockMesh
-
-runApplication setSet -batch baffle.setSet
-
-unset FOAM_SETNAN
-unset FOAM_SIGFPE
-
-# Add the patches for the baffles
-runApplication changeDictionary -literalRE
-rm log.changeDictionary
-
-# Create first baffle
-createBaffles baffleFaces '(baffle1Wall_0 baffle1Wall_1)' -overwrite > log.createBaffles 2>&1
-# Create second baffle
-createBaffles baffleFaces2 '(baffle2Wall_0 baffle2Wall_1)' -overwrite > log.createBaffles 2>&1
-
-# Reset proper values at the baffles
-runApplication changeDictionary
-
-runApplication $application
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/baffle.setSet b/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/baffle.setSet
deleted file mode 100644
index 89be31e65e3839d150cf49aad44b84408862fca3..0000000000000000000000000000000000000000
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/baffle.setSet
+++ /dev/null
@@ -1,6 +0,0 @@
-# Create face set
-faceSet baffleFaces new boxToFace (0.29 0 0) (0.31 0.18 2)
-faceZoneSet baffleFaces new setToFaceZone baffleFaces
-
-faceSet baffleFaces2 new boxToFace (0.59 0.0 0.0)(0.61 0.18 2.0)
-faceZoneSet baffleFaces2 new setToFaceZone baffleFaces2
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/T b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/T
similarity index 95%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/T
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/T
index 92fbe4aaac1a0b84bdf24d482a9f61a8a007b046..8fbb73eff0a77df2dfa7f1c74c43b77a3fc5c5b6 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/T
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/T
@@ -44,6 +44,10 @@ boundaryField
     {
         type            empty;
     }
+    "baffle1Wall.*"
+    {
+        type           calculated;
+    }
 }
 
 
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/U b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/U
similarity index 95%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/U
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/U
index 01f67a17395b676e7585bae74ae32f46b9d555a8..e24d69c2022ae1a42c3d805c4c58a86dd383b0cd 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/U
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/U
@@ -46,6 +46,10 @@ boundaryField
     {
         type            empty;
     }
+    "baffle1Wall.*"
+    {
+        type            calculated;
+    }
 }
 
 
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/alphat b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/alphat
similarity index 95%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/alphat
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/alphat
index 3bc99dd80842ce5c24663ff2f90700cf992ae00b..977203512af76a1a6b6069e46a79016ceed42041 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/alphat
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/alphat
@@ -45,6 +45,10 @@ boundaryField
     {
         type            empty;
     }
+    "baffle1Wall.*"
+    {
+        type            calculated;
+    }
 }
 
 
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/baffleRegion/Q b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/baffleRegion/Q
new file mode 100644
index 0000000000000000000000000000000000000000..d5a2ba9cfd78def195cf153e7418fe8ae49b9989
--- /dev/null
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/baffleRegion/Q
@@ -0,0 +1,30 @@
+/*--------------------------------*- 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      Q;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [1 -1 -3 0 0 0 0];
+
+internalField   uniform 17000;
+
+boundaryField
+{
+    ".*"
+    {
+        type            zeroGradient;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/baffleRegion/T b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/baffleRegion/T
new file mode 100644
index 0000000000000000000000000000000000000000..014bb7621ed9d675a3ccf2ac526e5c47c5eb36c0
--- /dev/null
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/baffleRegion/T
@@ -0,0 +1,27 @@
+/*--------------------------------*- 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      T;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [ 0 0 0 1 0 0 0 ];
+
+internalField   uniform 300;
+
+boundaryField
+{
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/epsilon b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/epsilon
similarity index 95%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/epsilon
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/epsilon
index 69f9ac68038d554c538eee00ace54ab86d56286d..21a6d42fa82dbd3969e667a7f6288a5454da2068 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/epsilon
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/epsilon
@@ -44,6 +44,10 @@ boundaryField
     {
         type            empty;
     }
+    "baffle1Wall.*"
+    {
+         type           calculated;
+    }
 }
 
 
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/k b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/k
similarity index 95%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/k
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/k
index 9ecfe3d9f81f3c09d5318f3d6ff78f6185e7f19a..5f4612566950433a4dea33c49bb15c141e422a22 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/k
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/k
@@ -44,6 +44,10 @@ boundaryField
     {
         type            empty;
     }
+    "baffle1Wall.*"
+    {
+        type            calculated;
+    }
 }
 
 
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/mut b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/mut
similarity index 95%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/mut
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/mut
index f83a004214fcb79130c0afe91bf098bb0afe6db9..41310b7ced3210d164ec057f293a1e61f2a184c8 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/mut
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/mut
@@ -45,6 +45,10 @@ boundaryField
     {
         type            empty;
     }
+    "baffle1Wall.*"
+    {
+        type           calculated;
+    }
 }
 
 
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/p b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/p
similarity index 84%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/p
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/p
index a4dbde342453af85286b8ec98bf1e4b2278869bb..8bbeb86853e72244e693f6d353a0f16019ac5ab1 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/p
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/p
@@ -24,27 +24,31 @@ boundaryField
     floor
     {
         type            calculated;
-        value           uniform 101325;
+        value           $internalField;
     }
     ceiling
     {
         type            calculated;
-        value           uniform 101325;
+        value           $internalField;
     }
     inlet
     {
         type            calculated;
-        value           uniform 101325;
+        value           $internalField;
     }
     outlet
     {
         type            calculated;
-        value           uniform 101325;
+        value           $internalField;
     }
     fixedWalls
     {
         type            empty;
     }
+    "baffle1Wall.*"
+    {
+        type           calculated;
+    }
 }
 
 
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/p_rgh b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/p_rgh
similarity index 79%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/p_rgh
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/p_rgh
index 320d9670ebc207b5098930ae8a6c5c357d73e2c6..94fc0bd9f339981c6d0bf17cb33f9f0a7183be4e 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/0.org/p_rgh
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/0.org/p_rgh
@@ -17,38 +17,38 @@ FoamFile
 
 dimensions      [ 1 -1 -2 0 0 0 0 ];
 
-internalField   uniform 0;
+internalField   uniform 101325;
 
 boundaryField
 {
     floor
     {
         type            buoyantPressure;
-        gradient        uniform 0;
-        value           uniform 0;
+        value           $internalField;
     }
     ceiling
     {
         type            buoyantPressure;
-        gradient        uniform 0;
-        value           uniform 0;
+        value           $internalField;
     }
     inlet
     {
         type            buoyantPressure;
-        gradient        uniform 0;
-        value           uniform 0;
+        value           $internalField;
     }
     outlet
     {
         type            buoyantPressure;
-        gradient        uniform 0;
-        value           uniform 0;
+        value           $internalField;
     }
     fixedWalls
     {
         type            empty;
     }
+    "baffle1Wall.*"
+    {
+        type           calculated;
+    }
 }
 
 
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/Allclean b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/Allclean
similarity index 86%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/Allclean
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/Allclean
index bbb2246df08410f7bb8f06844669078600886730..8bb8e3f1be4ecd3e416d9d61b8cf460ad9d70a74 100755
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/Allclean
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/Allclean
@@ -5,6 +5,7 @@ cd ${0%/*} || exit 1    # run from this directory
 . $WM_PROJECT_DIR/bin/tools/CleanFunctions
 
 cleanCase
+rm -rf constant/baffleRegion/polyMesh
 rm -rf sets 0
 
 # ----------------------------------------------------------------- end-of-file
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/Allrun b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/Allrun
new file mode 100755
index 0000000000000000000000000000000000000000..6de4b18840f513923647e10ed3211e3520d17546
--- /dev/null
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/Allrun
@@ -0,0 +1,32 @@
+#!/bin/sh
+. $WM_PROJECT_DIR/bin/tools/RunFunctions
+
+# Get application name
+application=`getApplication`
+
+cp -r 0.org 0
+runApplication blockMesh
+
+runApplication topoSet
+
+unset FOAM_SETNAN
+unset FOAM_SIGFPE
+
+# Create first baffle
+createBaffles baffleFaces '(baffle1Wall_0 baffle1Wall_1)' -overwrite > log.createBaffles 2>&1
+
+# Create region
+runApplication extrudeToRegionMesh -overwrite
+
+# Set the BC's for the baffle
+runApplication changeDictionary -dict system/changeDictionaryDict.baffle
+rm log.changeDictionary
+
+# Set Bc's for the region baffle
+runApplication changeDictionary -dict system/changeDictionaryDict.baffleRegion -literalRE
+rm log.changeDictionary
+
+# Reset proper values at the region
+runApplication changeDictionary -region baffleRegion -literalRE
+
+runApplication $application
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/RASProperties b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/RASProperties
similarity index 100%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/RASProperties
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/RASProperties
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/g b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/g
similarity index 100%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/g
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/g
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/polyMesh/blockMeshDict b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/polyMesh/blockMeshDict
similarity index 75%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/polyMesh/blockMeshDict
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/polyMesh/blockMeshDict
index 8f7aad9c7f2e6411061ee485c0e8680a1fa84816..dc9f8d9b4676f74b5a31681ad2c5c495ab58626b 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/polyMesh/blockMeshDict
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/polyMesh/blockMeshDict
@@ -30,7 +30,7 @@ vertices
 
 blocks
 (
-    hex (0 1 2 3 4 5 6 7) (40 20 1) simpleGrading (1 1 1)
+    hex (0 1 2 3 4 5 6 7) (50 40 1) simpleGrading (1 1 1)
 );
 
 edges
@@ -87,7 +87,7 @@ boundary
 
     baffle1Wall_0
     {
-        type            mappedWall;
+        type            directMappedWall;
         sampleMode      nearestPatchFace;
         sampleRegion    region0;
         samplePatch     baffle1Wall_1;
@@ -98,7 +98,7 @@ boundary
 
     baffle1Wall_1
     {
-        type            mappedWall;
+        type            directMappedWall;
         sampleMode      nearestPatchFace;
         sampleRegion    region0;
         samplePatch     baffle1Wall_0;
@@ -106,28 +106,6 @@ boundary
         offset          (0 0 0);
         faces ();
     }
-
-    baffle2Wall_0
-    {
-        type            mappedWall;
-        sampleMode      nearestPatchFace;
-        sampleRegion    region0;
-        samplePatch     baffle2Wall_1;
-        offsetMode      uniform;
-        offset          (0 0 0);
-        faces ();
-    }
-
-    baffle2Wall_1
-    {
-        type            mappedWall;
-        sampleMode      nearestPatchFace;
-        sampleRegion    region0;
-        samplePatch     baffle2Wall_0;
-        offsetMode      uniform;
-        offset          (0 0 0);
-        faces ();
-    }
 );
 
 mergePatchPairs
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/polyMesh/boundary b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/polyMesh/boundary
similarity index 58%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/polyMesh/boundary
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/polyMesh/boundary
index 34705fde36251e7ebaa9b3073ab8198b043d2355..058c08def36d93640ad3ebab96aff71302a74d33 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/polyMesh/boundary
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/polyMesh/boundary
@@ -15,81 +15,61 @@ FoamFile
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-9
+7
 (
     floor
     {
         type            wall;
-        nFaces          40;
-        startFace       1526;
+        nFaces          50;
+        startFace       3896;
     }
     ceiling
     {
         type            wall;
-        nFaces          40;
-        startFace       1566;
+        nFaces          50;
+        startFace       3946;
     }
     inlet
     {
         type            patch;
-        nFaces          20;
-        startFace       1606;
+        nFaces          40;
+        startFace       3996;
     }
     outlet
     {
         type            patch;
-        nFaces          20;
-        startFace       1626;
+        nFaces          40;
+        startFace       4036;
     }
     fixedWalls
     {
         type            empty;
-        nFaces          1600;
-        startFace       1646;
+        nFaces          4000;
+        startFace       4076;
     }
     baffle1Wall_0
     {
-        type            mappedWall;
-        nFaces          7;
-        startFace       3246;
+        type            directMappedWall;
+        nFaces          14;
+        startFace       8076;
         sampleMode      nearestPatchFace;
         sampleRegion    region0;
         samplePatch     baffle1Wall_1;
         offsetMode      uniform;
-        offset          (0 0 0);
+        offset          ( 0 0 0 );
+        faces           ( );
     }
     baffle1Wall_1
     {
-        type            mappedWall;
-        nFaces          7;
-        startFace       3253;
+        type            directMappedWall;
+        nFaces          14;
+        startFace       8090;
         sampleMode      nearestPatchFace;
         sampleRegion    region0;
         samplePatch     baffle1Wall_0;
         offsetMode      uniform;
-        offset          (0 0 0);
-    }
-    baffle2Wall_0
-    {
-        type            mappedWall;
-        nFaces          7;
-        startFace       3260;
-        sampleMode      nearestPatchFace;
-        sampleRegion    region0;
-        samplePatch     baffle2Wall_1;
-        offsetMode      uniform;
-        offset          (0 0 0);
-    }
-    baffle2Wall_1
-    {
-        type            mappedWall;
-        nFaces          7;
-        startFace       3267;
-        sampleMode      nearestPatchFace;
-        sampleRegion    region0;
-        samplePatch     baffle2Wall_0;
-        offsetMode      uniform;
-        offset          (0 0 0);
+        offset          ( 0 0 0 );
+        faces           ( );
     }
 )
 
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/thermoBaffleProperties b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/thermoBaffleProperties
similarity index 100%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/thermoBaffleProperties
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/thermoBaffleProperties
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/thermophysicalProperties b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/thermophysicalProperties
similarity index 100%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/constant/thermophysicalProperties
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/constant/thermophysicalProperties
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/changeDictionaryDict b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/changeDictionaryDict
new file mode 100644
index 0000000000000000000000000000000000000000..6391270926844a1db3db341cc9de562c69b82335
--- /dev/null
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/changeDictionaryDict
@@ -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       dictionary;
+    object      changeDictionaryDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dictionaryReplacement
+{
+    T
+    {
+        boundaryField
+        {
+            "region0_to.*"
+            {
+                type                compressible::temperatureThermoBaffle;
+                neighbourFieldName  T;
+                K                   solidThermo;
+                KName               none;
+
+                value               uniform 300;
+            }
+            baffleFaces2_side
+            {
+                type            zeroGradient;
+            }
+            floor
+            {
+                type            fixedValue;
+                value           uniform 300;
+            }
+            fixedWalls
+            {
+                type            empty;
+            }
+        }
+    }
+
+    boundary
+    {
+        floor
+        {
+            type        patch;
+        }
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/fvSchemes b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/fvSchemes
new file mode 100644
index 0000000000000000000000000000000000000000..3cf3fd7ea9f0524aceb07de61e051e4d843bf68c
--- /dev/null
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/fvSchemes
@@ -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    "system/baffleRegion";
+    object      fvSchemes;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+ddtSchemes
+{
+    default         steadyState;
+}
+
+divSchemes
+{
+     default        none;
+}
+
+gradSchemes
+{
+    default         Gauss linear;
+}
+
+laplacianSchemes
+{
+    default         none;
+    laplacian(K,T) Gauss linear uncorrected;
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/fvSolution b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/fvSolution
new file mode 100644
index 0000000000000000000000000000000000000000..2c233c4e2df4297cabd4c799169f62d9a5385952
--- /dev/null
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/baffleRegion/fvSolution
@@ -0,0 +1,37 @@
+/*--------------------------------*- 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/baffleRegion";
+    object      fvSolution;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+solvers
+{
+    T
+    {
+        solver           PCG;
+        smoother         GaussSeidel;
+        preconditioner   DIC;
+        tolerance        1e-06;
+        relTol           0;
+    }
+}
+
+nNonOrthCorr        0;
+
+relaxationFactors
+{
+    T       1;
+}
+
+// ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/system/changeDictionaryDict b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict
similarity index 100%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/system/changeDictionaryDict
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffle b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffle
new file mode 100644
index 0000000000000000000000000000000000000000..6b4a777a530d2ad349e5075ac4cc6ec6ef04c336
--- /dev/null
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffle
@@ -0,0 +1,131 @@
+/*--------------------------------*- 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      changeDictionaryDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dictionaryReplacement
+{
+    alphat
+    {
+        boundaryField
+        {
+            "baffle1.*"
+            {
+                type            alphatWallFunction;
+                value           uniform 0;
+            }
+        }
+    }
+    epsilon
+    {
+        boundaryField
+        {
+            "baffle1.*"
+            {
+                type            compressible::epsilonWallFunction;
+                value           uniform 0.01;
+            }
+        }
+    }
+    k
+    {
+        boundaryField
+        {
+            "baffle1.*"
+            {
+                type            compressible::kqRWallFunction;
+                value           uniform 0.01;
+            }
+        }
+    }
+    mut
+    {
+        boundaryField
+        {
+            "baffle1.*"
+            {
+                type            mutkWallFunction;
+                value           uniform 0.0;
+            }
+        }
+    }
+    p
+    {
+        boundaryField
+        {
+            "baffle1.*"
+            {
+                type            calculated;
+                value           $internalField;
+            }
+        }
+    }
+    p_rgh
+    {
+        boundaryField
+        {
+            "baffle1.*"
+            {
+                type            buoyantPressure;
+                value           $internalField;
+            }
+        }
+    }
+    T
+    {
+        boundaryField
+        {
+            "baffle1Wall.*"
+            {
+                type   compressible::temperatureThermoBaffle1D<constSolidThermoPhysics>;
+                baffleActivated yes;
+                thickness       uniform 0.005;  // thickness [m]
+                Qs              uniform 300;    // heat flux [W/m2]
+                transport
+                {
+                    K               1.0;
+                }
+                radiation
+                {
+                    sigmaS          0;
+                    kappa           0;
+                    emissivity      0;
+                }
+                thermodynamics
+                {
+                    Hf              0;
+                    Cp              10;
+                }
+                density
+                {
+                    rho             10;
+                }
+                value           uniform 300;
+            }
+        }
+    }
+    U
+    {
+        boundaryField
+        {
+            "baffle1.*"
+            {
+                type            fixedValue;
+                value           uniform (0 0 0);
+            }
+        }
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffleRegion b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffleRegion
new file mode 100644
index 0000000000000000000000000000000000000000..8c6c66145c1034445aecba0b1866d5ca580ec1ed
--- /dev/null
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/changeDictionaryDict.baffleRegion
@@ -0,0 +1,149 @@
+/*--------------------------------*- 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      changeDictionaryDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dictionaryReplacement
+{
+    alphat
+    {
+        boundaryField
+        {
+            "region0_to_.*"
+            {
+                type            alphatWallFunction;
+                value           uniform 0;
+            }
+        }
+    }
+    epsilon
+    {
+        boundaryField
+        {
+            "region0_to_.*"
+            {
+                type            compressible::epsilonWallFunction;
+                value           uniform 0.01;
+            }
+        }
+    }
+    k
+    {
+        boundaryField
+        {
+            "region0_to_.*"
+            {
+                type            compressible::kqRWallFunction;
+                value           uniform 0.01;
+            }
+
+        }
+    }
+    mut
+    {
+        boundaryField
+        {
+            "region0_to_.*"
+            {
+                type            mutkWallFunction;
+                value           uniform 0.0;
+            }
+        }
+    }
+    p
+    {
+        boundaryField
+        {
+            "region0_to_.*"
+            {
+                type            calculated;
+                value           $internalField;
+            }
+        }
+    }
+    p_rgh
+    {
+        boundaryField
+        {
+            "region0_to_.*"
+            {
+                type            buoyantPressure;
+                value           $internalField;
+            }
+
+        }
+    }
+    T
+    {
+        boundaryField
+        {
+
+            "region0_to.*"
+            {
+                type                compressible::temperatureThermoBaffle;
+
+                // Coupled BC.
+                neighbourFieldName  T;
+                K                   basicThermo;
+                KName               none;
+
+
+                // Thermo baffle model
+                thermoBaffleModel   thermoBaffle2D;
+                regionName          baffleRegion;
+                infoOutput          yes;
+                active              yes;
+                thermoBaffle2DCoeffs
+                {
+                }
+
+
+                // Solid thermo
+                thermoType constSolidThermo;
+
+                constSolidThermoCoeffs
+                {
+                    //- 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;
+
+                    //- radiative properties
+                    kappa kappa [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;
+
+                    //- chemical properties
+                    Hf  Hf  [0  2 -2  0 0 0 0]              0;
+                }
+
+                value               uniform 300;
+            }
+        }
+    }
+    U
+    {
+        boundaryField
+        {
+            "region0_to_.*"
+            {
+                type            fixedValue;
+                value           uniform (0 0 0);
+            }
+
+        }
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/system/controlDict b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/controlDict
similarity index 92%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/system/controlDict
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/controlDict
index 19bdfee19ac1e0cb938e06db2da14f17bc587bea..bf43b31cf5738cb17bc70f5b3d5c7d30c80c1c12 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/system/controlDict
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/controlDict
@@ -14,9 +14,9 @@ FoamFile
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-application     buoyantBaffleSimpleFoam;
+application     buoyantSimpleFoam;
 
-startFrom       latestTime;
+startFrom       startTime;
 
 startTime       0;
 
@@ -44,5 +44,6 @@ timePrecision   6;
 
 runTimeModifiable true;
 
+libs ("libthermoBaffleModels.so");
 
 // ************************************************************************* //
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/extrudeToRegionMeshDict b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/extrudeToRegionMeshDict
new file mode 100644
index 0000000000000000000000000000000000000000..fd563a35d10e72d360ac3995ec147a01625d2a63
--- /dev/null
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/extrudeToRegionMeshDict
@@ -0,0 +1,38 @@
+/*--------------------------------*- 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      extrudeToRegionMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+region          baffleRegion;
+
+faceZones       (baffleFaces2);
+
+oneD            false;
+
+extrudeModel    linearNormal;
+
+nLayers         10;
+
+expansionRatio  1;
+
+adaptMesh       yes; // apply directMapped to both regions
+
+sampleMode      nearestPatchFace;
+
+linearNormalCoeffs
+{
+    thickness       0.02;
+}
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/system/fvSchemes b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSchemes
similarity index 100%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/system/fvSchemes
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSchemes
diff --git a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/system/fvSolution b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSolution
similarity index 78%
rename from tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/system/fvSolution
rename to tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSolution
index d30cdf20b496e354128a273418811f504df1abed..ad42f98fc1a2ce425128185c2b41f13647d87c6b 100644
--- a/tutorials/heatTransfer/buoyantBaffleSimpleFoam/circuitBoardCooling/system/fvSolution
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSolution
@@ -35,42 +35,36 @@ solvers
     {
         solver          PBiCG;
         preconditioner  DILU;
-        tolerance       1e-8;
-        relTol          0.1;
+        tolerance       1e-7;
+        relTol          0.01;
     }
 }
 
 SIMPLE
 {
-    momentumPredictor yes;
+    momentumPredictor no;
     nNonOrthogonalCorrectors 0;
     pRefCell        0;
     pRefValue       0;
 
     residualControl
     {
-        p_rgh           1e-2;
-        U               1e-3;
-        h               1e-3;
+        p_rgh           5e-3;
+        U               3e-4;
+        h               3e-4;
 
         // possibly check turbulence fields
-        "(k|epsilon|omega)" 1e-3;
+        "(k|epsilon|omega)" 5e-3;
     }
 }
 
 relaxationFactors
 {
-    fields
-    {
-        rho             1.0;
-        p_rgh           0.7;
-    }
-    equations
-    {
-        U               0.3;
-        h               0.3;
-        "(k|epsilon|omega)" 0.7;
-    }
+    rho             1.0;
+    p_rgh           0.7;
+    U               0.7;
+    h               0.3;
+    "(k|epsilon|omega)" 0.3;
 }
 
 
diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/topoSetDict b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/topoSetDict
new file mode 100644
index 0000000000000000000000000000000000000000..36f5b003b9a063e8b8a3eeec043a6cf221388bf6
--- /dev/null
+++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/topoSetDict
@@ -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;
+    object      topoSetDict;
+}
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+actions
+(
+    {
+        name    baffleFaces;
+        type    faceSet;
+        action  new;
+        source  boxToFace;
+        sourceInfo
+        {
+            box (0.296 0 0) (0.306 0.18 2);
+        }
+    }
+
+    {
+        name    baffleFacesSlaveCells;
+        type    cellSet;
+        action  new;
+        source  boxToCell;
+        sourceInfo
+        {
+            box (0 0 0) (0.295 0.2 2);
+        }
+    }
+
+    {
+        name    baffleFaces;
+        type    faceZoneSet;
+        action  new;
+        source  setsToFaceZone;
+        sourceInfo
+        {
+            faceSet baffleFaces;
+            cellSet baffleFacesSlaveCells;
+        }
+    }
+
+    {
+        name    baffleFaces2;
+        type    faceSet;
+        action  new;
+        source  boxToFace;
+        sourceInfo
+        {
+            box (0.5944 0 0) (0.605 0.18 2);
+        }
+    }
+
+    {
+        name    baffleFacesSlaveCells2;
+        type    cellSet;
+        action  new;
+        source  boxToCell;
+        sourceInfo
+        {
+            box (0 0 0) (0.594 0.2 2);
+        }
+    }
+
+    {
+        name    baffleFaces2;
+        type    faceZoneSet;
+        action  new;
+        source  setsToFaceZone;
+        sourceInfo
+        {
+            faceSet baffleFaces2;
+            cellSet baffleFacesSlaveCells2;
+        }
+    }
+);
+
+// ************************************************************************* //