diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/Allwclean b/applications/solvers/multiphase/multiphaseEulerFoam/Allwclean
index 191aa8e312881fa30001e5c0ee890293f599d915..a1a5b83bfa5046fbbb9a68401c8c4ee434121d5d 100755
--- a/applications/solvers/multiphase/multiphaseEulerFoam/Allwclean
+++ b/applications/solvers/multiphase/multiphaseEulerFoam/Allwclean
@@ -5,7 +5,6 @@ set -x
 wclean libso phaseModel
 wclean libso multiphaseSystem
 wclean libso interfacialModels
-wclean libso kineticTheoryModels
 wclean
 
 # ----------------------------------------------------------------- end-of-file
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/Allwmake b/applications/solvers/multiphase/multiphaseEulerFoam/Allwmake
index 8f1133699c53b6c52641f56a255e207e8485270f..4ab7ebbfb942b112534fd2fa9d1cf8af31936f79 100755
--- a/applications/solvers/multiphase/multiphaseEulerFoam/Allwmake
+++ b/applications/solvers/multiphase/multiphaseEulerFoam/Allwmake
@@ -5,7 +5,6 @@ set -x
 wmake libso phaseModel
 wmake libso interfacialModels
 wmake libso multiphaseSystem
-wmake libso kineticTheoryModels
 wmake
 
 # ----------------------------------------------------------------- end-of-file
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/Make/options b/applications/solvers/multiphase/multiphaseEulerFoam/Make/options
index 06ffdda61cf603df1bc740aeb3500974b45b0e67..5799557cc969f71143ea52ce61fc2bb156b9fe85 100644
--- a/applications/solvers/multiphase/multiphaseEulerFoam/Make/options
+++ b/applications/solvers/multiphase/multiphaseEulerFoam/Make/options
@@ -2,7 +2,6 @@ EXE_INC = \
     -IphaseModel/lnInclude \
     -ImultiphaseSystem/lnInclude \
     -ImultiphaseFixedFluxPressure \
-    /*-IkineticTheoryModels/lnInclude*/ \
     -IinterfacialModels/lnInclude \
     -I$(LIB_SRC)/transportModels \
     -I$(LIB_SRC)/transportModels/incompressible/lnInclude \
@@ -20,6 +19,5 @@ EXE_LIBS = \
     -linterfaceProperties \
     -lincompressibleTransportModels \
     -lcompressibleMultiphaseEulerianInterfacialModels \
-    /*-lcompressibleKineticTheoryModel*/ \
     -lincompressibleLESModels \
     -lfiniteVolume
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/Make/files b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/Make/files
deleted file mode 100644
index ab4aa2f7afe77a06ea4b4d5cfbb1880a0c4bb6f9..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/Make/files
+++ /dev/null
@@ -1,33 +0,0 @@
-kineticTheoryModel/kineticTheoryModel.C
-
-viscosityModel/viscosityModel/viscosityModel.C
-viscosityModel/viscosityModel/newViscosityModel.C
-viscosityModel/Gidaspow/GidaspowViscosity.C
-viscosityModel/Syamlal/SyamlalViscosity.C
-viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C
-viscosityModel/none/noneViscosity.C
-
-conductivityModel/conductivityModel/conductivityModel.C
-conductivityModel/conductivityModel/newConductivityModel.C
-conductivityModel/Gidaspow/GidaspowConductivity.C
-conductivityModel/Syamlal/SyamlalConductivity.C
-conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C
-
-radialModel/radialModel/radialModel.C
-radialModel/radialModel/newRadialModel.C
-radialModel/CarnahanStarling/CarnahanStarlingRadial.C
-radialModel/Gidaspow/GidaspowRadial.C
-radialModel/LunSavage/LunSavageRadial.C
-radialModel/SinclairJackson/SinclairJacksonRadial.C
-
-granularPressureModel/granularPressureModel/granularPressureModel.C
-granularPressureModel/granularPressureModel/newGranularPressureModel.C
-granularPressureModel/Lun/LunPressure.C
-granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C
-
-frictionalStressModel/frictionalStressModel/frictionalStressModel.C
-frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C
-frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C
-frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C
-
-LIB = $(FOAM_LIBBIN)/libcompressibleMultiphaseKineticTheoryModel
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/Make/options b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/Make/options
deleted file mode 100644
index 2fcce9913d9408482098065ad511e280e366c83f..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/Make/options
+++ /dev/null
@@ -1,5 +0,0 @@
-EXE_INC = \
-    -I$(LIB_SRC)/foam/lnInclude \
-    -I$(LIB_SRC)/finiteVolume/lnInclude \
-    -I../phaseModel/lnInclude \
-    -I../interfacialModels/lnInclude
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.C
deleted file mode 100644
index b7e0d3ce9ed146cbf68a04f7233024d5881c6081..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.C
+++ /dev/null
@@ -1,93 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "GidaspowConductivity.H"
-#include "mathematicalConstants.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace conductivityModels
-{
-    defineTypeNameAndDebug(Gidaspow, 0);
-
-    addToRunTimeSelectionTable
-    (
-        conductivityModel,
-        Gidaspow,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::conductivityModels::Gidaspow::Gidaspow
-(
-    const dictionary& dict
-)
-:
-    conductivityModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::conductivityModels::Gidaspow::~Gidaspow()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::conductivityModels::Gidaspow::kappa
-(
-    const volScalarField& alpha1,
-    const volScalarField& Theta,
-    const volScalarField& g0,
-    const dimensionedScalar& rho1,
-    const volScalarField& da,
-    const dimensionedScalar& e
-) const
-{
-    const scalar sqrtPi = sqrt(constant::mathematical::pi);
-
-    return rho1*da*sqrt(Theta)*
-    (
-        2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi
-      + (9.0/8.0)*sqrtPi*g0*0.5*(1.0 + e)*sqr(alpha1)
-      + (15.0/16.0)*sqrtPi*alpha1
-      + (25.0/64.0)*sqrtPi/((1.0 + e)*g0)
-    );
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.H
deleted file mode 100644
index 463853a9a8fe884250f8054c3854e1fa9fc8d427..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.H
+++ /dev/null
@@ -1,97 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::conductivityModels::Gidaspow
-
-Description
-
-SourceFiles
-    Gidaspow.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef Gidaspow_H
-#define Gidaspow_H
-
-#include "conductivityModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace conductivityModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class Gidaspow Declaration
-\*---------------------------------------------------------------------------*/
-
-class Gidaspow
-:
-    public conductivityModel
-{
-
-public:
-
-        //- Runtime type information
-        TypeName("Gidaspow");
-
-
-    // Constructors
-
-        //- Construct from components
-        Gidaspow(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~Gidaspow();
-
-
-    // Member Functions
-
-        tmp<volScalarField> kappa
-        (
-            const volScalarField& alpha1,
-            const volScalarField& Theta,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const volScalarField& da,
-            const dimensionedScalar& e
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace conductivityModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C
deleted file mode 100644
index 9dd47fb88aaaf4a74f7c60bbfac605303147ff9f..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C
+++ /dev/null
@@ -1,104 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "HrenyaSinclairConductivity.H"
-#include "mathematicalConstants.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace conductivityModels
-{
-    defineTypeNameAndDebug(HrenyaSinclair, 0);
-
-    addToRunTimeSelectionTable
-    (
-        conductivityModel,
-        HrenyaSinclair,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::conductivityModels::HrenyaSinclair::HrenyaSinclair
-(
-    const dictionary& dict
-)
-:
-    conductivityModel(dict),
-    coeffsDict_(dict.subDict(typeName + "Coeffs")),
-    L_(coeffsDict_.lookup("L"))
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::conductivityModels::HrenyaSinclair::
-~HrenyaSinclair()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::conductivityModels::HrenyaSinclair::kappa
-(
-    const volScalarField& alpha1,
-    const volScalarField& Theta,
-    const volScalarField& g0,
-    const dimensionedScalar& rho1,
-    const volScalarField& da,
-    const dimensionedScalar& e
-) const
-{
-    const scalar sqrtPi = sqrt(constant::mathematical::pi);
-
-    volScalarField lamda
-    (
-        scalar(1) + da/(6.0*sqrt(2.0)*(alpha1 + scalar(1.0e-5)))/L_
-    );
-
-    return rho1*da*sqrt(Theta)*
-    (
-        2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi
-      + (9.0/8.0)*sqrtPi*0.25*sqr(1.0 + e)*(2.0*e - 1.0)*sqr(alpha1)
-       /(49.0/16.0 - 33.0*e/16.0)
-      + (15.0/16.0)*sqrtPi*alpha1*(0.5*sqr(e) + 0.25*e - 0.75 + lamda)
-       /((49.0/16.0 - 33.0*e/16.0)*lamda)
-      + (25.0/64.0)*sqrtPi
-       /((1.0 + e)*(49.0/16.0 - 33.0*e/16.0)*lamda*g0)
-    );
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.H
deleted file mode 100644
index 2a767f6d34f1d302bc80c62de785f9c05b78b302..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.H
+++ /dev/null
@@ -1,102 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::conductivityModels::HrenyaSinclair
-
-Description
-
-SourceFiles
-    HrenyaSinclair.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef HrenyaSinclair_H
-#define HrenyaSinclair_H
-
-#include "conductivityModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace conductivityModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class HrenyaSinclair Declaration
-\*---------------------------------------------------------------------------*/
-
-class HrenyaSinclair
-:
-    public conductivityModel
-{
-
-        dictionary coeffsDict_;
-
-        //- characteristic length of geometry
-        dimensionedScalar L_;
-
-public:
-
-        //- Runtime type information
-        TypeName("HrenyaSinclair");
-
-
-    // Constructors
-
-        //- Construct from components
-        HrenyaSinclair(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~HrenyaSinclair();
-
-
-    // Member Functions
-
-        tmp<volScalarField> kappa
-        (
-            const volScalarField& alpha1,
-            const volScalarField& Theta,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const volScalarField& da,
-            const dimensionedScalar& e
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace conductivityModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.C
deleted file mode 100644
index dcaba6f5ae30ed042528d4f195fc2c5348c9d47e..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.C
+++ /dev/null
@@ -1,93 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "SyamlalConductivity.H"
-#include "mathematicalConstants.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace conductivityModels
-{
-    defineTypeNameAndDebug(Syamlal, 0);
-
-    addToRunTimeSelectionTable
-    (
-        conductivityModel,
-        Syamlal,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::conductivityModels::Syamlal::Syamlal
-(
-    const dictionary& dict
-)
-:
-    conductivityModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::conductivityModels::Syamlal::~Syamlal()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::conductivityModels::Syamlal::kappa
-(
-    const volScalarField& alpha1,
-    const volScalarField& Theta,
-    const volScalarField& g0,
-    const dimensionedScalar& rho1,
-    const volScalarField& da,
-    const dimensionedScalar& e
-) const
-{
-    const scalar sqrtPi = sqrt(constant::mathematical::pi);
-
-    return rho1*da*sqrt(Theta)*
-    (
-        2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi
-      + (9.0/8.0)*sqrtPi*g0*0.25*sqr(1.0 + e)*(2.0*e - 1.0)*sqr(alpha1)
-       /(49.0/16.0 - 33.0*e/16.0)
-      + (15.0/32.0)*sqrtPi*alpha1/(49.0/16.0 - 33.0*e/16.0)
-    );
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.H
deleted file mode 100644
index 564d2f406e5944cb65d2d5575d8938ea95190c9d..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.H
+++ /dev/null
@@ -1,97 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::conductivityModels::Syamlal
-
-Description
-
-SourceFiles
-    Syamlal.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef Syamlal_H
-#define Syamlal_H
-
-#include "conductivityModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace conductivityModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class Syamlal Declaration
-\*---------------------------------------------------------------------------*/
-
-class Syamlal
-:
-    public conductivityModel
-{
-
-public:
-
-    //- Runtime type information
-    TypeName("Syamlal");
-
-
-    // Constructors
-
-        //- Construct from components
-        Syamlal(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~Syamlal();
-
-
-    // Member Functions
-
-        tmp<volScalarField> kappa
-        (
-            const volScalarField& alpha1,
-            const volScalarField& Theta,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const volScalarField& da,
-            const dimensionedScalar& e
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace conductivityModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C
deleted file mode 100644
index 145f10e2188ac3568107574fec9d93e6a0428b1f..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C
+++ /dev/null
@@ -1,58 +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/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "conductivityModel.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-    defineTypeNameAndDebug(conductivityModel, 0);
-
-    defineRunTimeSelectionTable(conductivityModel, dictionary);
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::conductivityModel::conductivityModel
-(
-    const dictionary& dict
-)
-:
-    dict_(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::conductivityModel::~conductivityModel()
-{}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.H
deleted file mode 100644
index aafe0eb70517c4349fdca04a5f9077131c82dbe3..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.H
+++ /dev/null
@@ -1,128 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::conductivityModel
-
-SourceFiles
-    conductivityModel.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef conductivityModel_H
-#define conductivityModel_H
-
-#include "dictionary.H"
-#include "volFields.H"
-#include "dimensionedTypes.H"
-#include "runTimeSelectionTables.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-
-/*---------------------------------------------------------------------------*\
-                    Class conductivityModel Declaration
-\*---------------------------------------------------------------------------*/
-
-class conductivityModel
-{
-    // Private member functions
-
-        //- Disallow default bitwise copy construct
-        conductivityModel(const conductivityModel&);
-
-        //- Disallow default bitwise assignment
-        void operator=(const conductivityModel&);
-
-
-protected:
-
-    // Protected data
-
-        const dictionary& dict_;
-
-
-public:
-
-    //- Runtime type information
-    TypeName("conductivityModel");
-
-    // Declare runtime constructor selection table
-    declareRunTimeSelectionTable
-    (
-        autoPtr,
-        conductivityModel,
-        dictionary,
-        (
-            const dictionary& dict
-        ),
-        (dict)
-    );
-
-
-    // Constructors
-
-        //- Construct from components
-        conductivityModel(const dictionary& dict);
-
-
-    // Selectors
-
-        static autoPtr<conductivityModel> New
-        (
-            const dictionary& dict
-        );
-
-
-    //- Destructor
-    virtual ~conductivityModel();
-
-
-    // Member Functions
-
-        virtual tmp<volScalarField> kappa
-        (
-            const volScalarField& alpha1,
-            const volScalarField& Theta,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const volScalarField& da,
-            const dimensionedScalar& e
-        ) const = 0;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C
deleted file mode 100644
index 21aa88ec6671b57c167c1d514c29d9b6e48a4cb5..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C
+++ /dev/null
@@ -1,59 +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/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "conductivityModel.H"
-
-// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * //
-
-Foam::autoPtr<Foam::kineticTheoryModels::conductivityModel>
-Foam::kineticTheoryModels::conductivityModel::New
-(
-    const dictionary& dict
-)
-{
-    word conductivityModelType(dict.lookup("conductivityModel"));
-
-    Info<< "Selecting conductivityModel "
-        << conductivityModelType << endl;
-
-    dictionaryConstructorTable::iterator cstrIter =
-        dictionaryConstructorTablePtr_->find(conductivityModelType);
-
-    if (cstrIter == dictionaryConstructorTablePtr_->end())
-    {
-        FatalError
-            << "conductivityModel::New(const dictionary&) : " << endl
-            << "    unknown conductivityModelType type "
-            << conductivityModelType
-            << ", constructor not in hash table" << endl << endl
-            << "    Valid conductivityModelType types are :" << endl;
-        Info<< dictionaryConstructorTablePtr_->sortedToc() << abort(FatalError);
-    }
-
-    return autoPtr<conductivityModel>(cstrIter()(dict));
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C
deleted file mode 100644
index eb7d0292949bfcd3bc6ee1013f6ca9ef83719c12..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C
+++ /dev/null
@@ -1,125 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "JohnsonJacksonFrictionalStress.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace frictionalStressModels
-{
-    defineTypeNameAndDebug(JohnsonJackson, 0);
-
-    addToRunTimeSelectionTable
-    (
-        frictionalStressModel,
-        JohnsonJackson,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::frictionalStressModels::JohnsonJackson::
-JohnsonJackson
-(
-    const dictionary& dict
-)
-:
-    frictionalStressModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::frictionalStressModels::JohnsonJackson::
-~JohnsonJackson()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::frictionalStressModels::JohnsonJackson::
-frictionalPressure
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMinFriction,
-    const dimensionedScalar& alphaMax,
-    const dimensionedScalar& Fr,
-    const dimensionedScalar& eta,
-    const dimensionedScalar& p
-) const
-{
-
-    return
-        Fr*pow(max(alpha1 - alphaMinFriction, scalar(0)), eta)
-       /pow(max(alphaMax - alpha1, scalar(5.0e-2)), p);
-}
-
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::frictionalStressModels::JohnsonJackson::
-frictionalPressurePrime
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMinFriction,
-    const dimensionedScalar& alphaMax,
-    const dimensionedScalar& Fr,
-    const dimensionedScalar& eta,
-    const dimensionedScalar& p
-) const
-{
-    return Fr*
-    (
-        eta*pow(max(alpha1 - alphaMinFriction, scalar(0)), eta - 1.0)
-       *(alphaMax-alpha1)
-      + p*pow(max(alpha1 - alphaMinFriction, scalar(0)), eta)
-    )/pow(max(alphaMax - alpha1, scalar(5.0e-2)), p + 1.0);
-}
-
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::frictionalStressModels::JohnsonJackson::muf
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMax,
-    const volScalarField& pf,
-    const volSymmTensorField& D,
-    const dimensionedScalar& phi
-) const
-{
-    return dimensionedScalar("0.5", dimTime, 0.5)*pf*sin(phi);
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.H
deleted file mode 100644
index 985338b741b953f8c846cf7f9b92a29e3689fe5a..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.H
+++ /dev/null
@@ -1,116 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::frictionalStressModels::JohnsonJackson
-
-Description
-
-SourceFiles
-    JohnsonJacksonFrictionalStress.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef JohnsonJackson_H
-#define JohnsonJackson_H
-
-#include "frictionalStressModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace frictionalStressModels
-{
-
-/*---------------------------------------------------------------------------*\
-               Class JohnsonJackson Declaration
-\*---------------------------------------------------------------------------*/
-
-class JohnsonJackson
-:
-    public frictionalStressModel
-{
-
-public:
-
-    //- Runtime type information
-    TypeName("JohnsonJackson");
-
-
-    // Constructors
-
-        //- Construct from components
-        JohnsonJackson(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~JohnsonJackson();
-
-
-    // Member functions
-
-        virtual tmp<volScalarField> frictionalPressure
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMinFriction,
-            const dimensionedScalar& alphaMax,
-            const dimensionedScalar& Fr,
-            const dimensionedScalar& eta,
-            const dimensionedScalar& p
-        ) const;
-
-        virtual tmp<volScalarField> frictionalPressurePrime
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMinFriction,
-            const dimensionedScalar& alphaMax,
-            const dimensionedScalar& Fr,
-            const dimensionedScalar& eta,
-            const dimensionedScalar& p
-        ) const;
-
-        virtual tmp<volScalarField> muf
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax,
-            const volScalarField& pf,
-            const volSymmTensorField& D,
-            const dimensionedScalar& phi
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace frictionalStressModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C
deleted file mode 100644
index ec6f55ab65d74039b183f233550c9ef920f8aaa7..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C
+++ /dev/null
@@ -1,158 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "SchaefferFrictionalStress.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace frictionalStressModels
-{
-    defineTypeNameAndDebug(Schaeffer, 0);
-
-    addToRunTimeSelectionTable
-    (
-        frictionalStressModel,
-        Schaeffer,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::frictionalStressModels::Schaeffer::Schaeffer
-(
-    const dictionary& dict
-)
-:
-    frictionalStressModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::frictionalStressModels::Schaeffer::~Schaeffer()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::frictionalStressModels::Schaeffer::
-frictionalPressure
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMinFriction,
-    const dimensionedScalar& alphaMax,
-    const dimensionedScalar& Fr,
-    const dimensionedScalar& eta,
-    const dimensionedScalar& p
-) const
-{
-    return
-        dimensionedScalar("1e24", dimensionSet(1, -1, -2, 0, 0), 1e24)
-       *pow(Foam::max(alpha1 - alphaMinFriction, scalar(0)), 10.0);
-}
-
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::frictionalStressModels::Schaeffer::
-frictionalPressurePrime
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMinFriction,
-    const dimensionedScalar& alphaMax,
-    const dimensionedScalar& Fr,
-    const dimensionedScalar& eta,
-    const dimensionedScalar& p
-) const
-{
-    return
-        dimensionedScalar("1e25", dimensionSet(1, -1, -2, 0, 0), 1e25)
-       *pow(Foam::max(alpha1 - alphaMinFriction, scalar(0)), 9.0);
-}
-
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::frictionalStressModels::Schaeffer::muf
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMax,
-    const volScalarField& pf,
-    const volSymmTensorField& D,
-    const dimensionedScalar& phi
-) const
-{
-    const scalar I2Dsmall = 1.0e-15;
-
-    // Creating muf assuming it should be 0 on the boundary which may not be
-    // true
-    tmp<volScalarField> tmuf
-    (
-        new volScalarField
-        (
-            IOobject
-            (
-                "muf",
-                alpha1.mesh().time().timeName(),
-                alpha1.mesh()
-            ),
-            alpha1.mesh(),
-            dimensionedScalar("muf", dimensionSet(1, -1, -1, 0, 0), 0.0)
-        )
-    );
-
-    volScalarField& muff = tmuf();
-
-    forAll (D, celli)
-    {
-        if (alpha1[celli] > alphaMax.value() - 5e-2)
-        {
-            muff[celli] =
-                0.5*pf[celli]*sin(phi.value())
-               /(
-                    sqrt(1.0/6.0*(sqr(D[celli].xx() - D[celli].yy())
-                  + sqr(D[celli].yy() - D[celli].zz())
-                  + sqr(D[celli].zz() - D[celli].xx()))
-                  + sqr(D[celli].xy()) + sqr(D[celli].xz())
-                  + sqr(D[celli].yz())) + I2Dsmall
-                );
-        }
-    }
-
-    muff.correctBoundaryConditions();
-
-    return tmuf;
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.H
deleted file mode 100644
index d99da3a32d1ab44772710f9d1f0da4923ab4e47f..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.H
+++ /dev/null
@@ -1,116 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::frictionalStressModels::Schaeffer
-
-Description
-
-SourceFiles
-    SchaefferFrictionalStress.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef Schaeffer_H
-#define Schaeffer_H
-
-#include "frictionalStressModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace frictionalStressModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class Schaeffer Declaration
-\*---------------------------------------------------------------------------*/
-
-class Schaeffer
-:
-    public frictionalStressModel
-{
-
-public:
-
-        //- Runtime type information
-        TypeName("Schaeffer");
-
-
-    // Constructors
-
-        //- Construct from components
-        Schaeffer(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~Schaeffer();
-
-
-    // Member functions
-
-        virtual tmp<volScalarField> frictionalPressure
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMinFriction,
-            const dimensionedScalar& alphaMax,
-            const dimensionedScalar& Fr,
-            const dimensionedScalar& eta,
-            const dimensionedScalar& p
-        ) const;
-
-        virtual tmp<volScalarField> frictionalPressurePrime
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMinFriction,
-            const dimensionedScalar& alphaMax,
-            const dimensionedScalar& Fr,
-            const dimensionedScalar& n,
-            const dimensionedScalar& p
-        ) const;
-
-        virtual tmp<volScalarField> muf
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax,
-            const volScalarField& pf,
-            const volSymmTensorField& D,
-            const dimensionedScalar& phi
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace frictionalStressModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.C
deleted file mode 100644
index 3b59e3615f86050567ecea083641bcd4f5f30541..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.C
+++ /dev/null
@@ -1,58 +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/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "frictionalStressModel.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-    defineTypeNameAndDebug(frictionalStressModel, 0);
-
-    defineRunTimeSelectionTable(frictionalStressModel, dictionary);
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::frictionalStressModel::frictionalStressModel
-(
-    const dictionary& dict
-)
-:
-    dict_(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::frictionalStressModel::~frictionalStressModel()
-{}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.H
deleted file mode 100644
index 913b2ad105caab94c7ddcbe0d05ce1b6dc131154..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.H
+++ /dev/null
@@ -1,147 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::frictionalStressModel
-
-SourceFiles
-    frictionalStressModel.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef frictionalStressModel_H
-#define frictionalStressModel_H
-
-#include "dictionary.H"
-#include "volFields.H"
-#include "dimensionedTypes.H"
-#include "runTimeSelectionTables.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class frictionalStressModel Declaration
-\*---------------------------------------------------------------------------*/
-
-class frictionalStressModel
-{
-    // Private member functions
-
-        //- Disallow default bitwise copy construct
-        frictionalStressModel(const frictionalStressModel&);
-
-        //- Disallow default bitwise assignment
-        void operator=(const frictionalStressModel&);
-
-
-protected:
-
-    // Protected data
-
-        const dictionary& dict_;
-
-
-public:
-
-    //- Runtime type information
-    TypeName("frictionalStressModel");
-
-    // Declare runtime constructor selection table
-    declareRunTimeSelectionTable
-    (
-        autoPtr,
-        frictionalStressModel,
-        dictionary,
-        (
-            const dictionary& dict
-        ),
-        (dict)
-    );
-
-
-    // Constructors
-
-        //- Construct from components
-        frictionalStressModel(const dictionary& dict);
-
-
-    // Selectors
-
-        static autoPtr<frictionalStressModel> New
-        (
-            const dictionary& dict
-        );
-
-
-    //- Destructor
-    virtual ~frictionalStressModel();
-
-
-    // Member Functions
-
-        virtual tmp<volScalarField> frictionalPressure
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMinFriction,
-            const dimensionedScalar& alphaMax,
-            const dimensionedScalar& Fr,
-            const dimensionedScalar& eta,
-            const dimensionedScalar& p
-        ) const = 0;
-
-        virtual tmp<volScalarField> frictionalPressurePrime
-        (
-            const volScalarField& alpha1f,
-            const dimensionedScalar& alphaMinFriction,
-            const dimensionedScalar& alphaMax,
-            const dimensionedScalar& Fr,
-            const dimensionedScalar& eta,
-            const dimensionedScalar& p
-        ) const = 0;
-
-        virtual tmp<volScalarField> muf
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax,
-            const volScalarField& pf,
-            const volSymmTensorField& D,
-            const dimensionedScalar& phi
-        ) const = 0;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C
deleted file mode 100644
index 4067c154fb80747923a35776a4ed88c3cfd9174b..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C
+++ /dev/null
@@ -1,60 +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/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "frictionalStressModel.H"
-
-// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * //
-
-Foam::autoPtr<Foam::kineticTheoryModels::frictionalStressModel>
-Foam::kineticTheoryModels::frictionalStressModel::New
-(
-    const dictionary& dict
-)
-{
-    word frictionalStressModelType(dict.lookup("frictionalStressModel"));
-
-    Info<< "Selecting frictionalStressModel "
-        << frictionalStressModelType << endl;
-
-    dictionaryConstructorTable::iterator cstrIter =
-        dictionaryConstructorTablePtr_->find(frictionalStressModelType);
-
-    if (cstrIter == dictionaryConstructorTablePtr_->end())
-    {
-        FatalError
-            << "frictionalStressModel::New(const dictionary&) : " << endl
-            << "    unknown frictionalStressModelType type "
-            << frictionalStressModelType
-            << ", constructor not in hash table" << endl << endl
-            << "    Valid frictionalStressModelType types are :" << endl;
-        Info<< dictionaryConstructorTablePtr_->sortedToc()
-            << abort(FatalError);
-    }
-
-    return autoPtr<frictionalStressModel>(cstrIter()(dict));
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.C
deleted file mode 100644
index da8ea176abd31447c6ebe389cd58d084796da115..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.C
+++ /dev/null
@@ -1,98 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "LunPressure.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace granularPressureModels
-{
-    defineTypeNameAndDebug(Lun, 0);
-
-    addToRunTimeSelectionTable
-    (
-        granularPressureModel,
-        Lun,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::granularPressureModels::Lun::Lun
-(
-    const dictionary& dict
-)
-:
-    granularPressureModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::granularPressureModels::Lun::~Lun()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::granularPressureModels::Lun::granularPressureCoeff
-(
-    const volScalarField& alpha1,
-    const volScalarField& g0,
-    const dimensionedScalar& rho1,
-    const dimensionedScalar& e
-) const
-{
-
-    return rho1*alpha1*(1.0 + 2.0*(1.0 + e)*alpha1*g0);
-}
-
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::granularPressureModels::Lun::
-granularPressureCoeffPrime
-(
-    const volScalarField& alpha1,
-    const volScalarField& g0,
-    const volScalarField& g0prime,
-    const dimensionedScalar& rho1,
-    const dimensionedScalar& e
-) const
-{
-    return rho1*(1.0 + alpha1*(1.0 + e)*(4.0*g0 + 2.0*g0prime*alpha1));
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.H
deleted file mode 100644
index ddc9b366336e1425a553b7da4e291f9c3df7841c..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.H
+++ /dev/null
@@ -1,104 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::Lun
-
-Description
-
-SourceFiles
-    LunPressure.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef Lun_H
-#define Lun_H
-
-#include "granularPressureModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace granularPressureModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class Lun Declaration
-\*---------------------------------------------------------------------------*/
-
-class Lun
-:
-    public granularPressureModel
-{
-
-public:
-
-    //- Runtime type information
-    TypeName("Lun");
-
-
-    // Constructors
-
-        //- Construct from components
-        Lun(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~Lun();
-
-
-    // Member Functions
-
-        tmp<volScalarField> granularPressureCoeff
-        (
-            const volScalarField& alpha1,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const dimensionedScalar& e
-        ) const;
-
-        tmp<volScalarField> granularPressureCoeffPrime
-        (
-            const volScalarField& alpha1,
-            const volScalarField& g0,
-            const volScalarField& g0prime,
-            const dimensionedScalar& rho1,
-            const dimensionedScalar& e
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace granularPressureModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C
deleted file mode 100644
index a0d51e431a50501c07c8e9f68807d306ddd0248b..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C
+++ /dev/null
@@ -1,101 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "SyamlalRogersOBrienPressure.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace granularPressureModels
-{
-    defineTypeNameAndDebug(SyamlalRogersOBrien, 0);
-
-    addToRunTimeSelectionTable
-    (
-        granularPressureModel,
-        SyamlalRogersOBrien,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::granularPressureModels::SyamlalRogersOBrien::
-SyamlalRogersOBrien
-(
-    const dictionary& dict
-)
-:
-    granularPressureModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::granularPressureModels::SyamlalRogersOBrien::
-~SyamlalRogersOBrien()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::granularPressureModels::SyamlalRogersOBrien::
-granularPressureCoeff
-(
-    const volScalarField& alpha1,
-    const volScalarField& g0,
-    const dimensionedScalar& rho1,
-    const dimensionedScalar& e
-) const
-{
-
-    return 2.0*rho1*(1.0 + e)*sqr(alpha1)*g0;
-}
-
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::granularPressureModels::SyamlalRogersOBrien::
-granularPressureCoeffPrime
-(
-    const volScalarField& alpha1,
-    const volScalarField& g0,
-    const volScalarField& g0prime,
-    const dimensionedScalar& rho1,
-    const dimensionedScalar& e
-) const
-{
-    return rho1*alpha1*(1.0 + e)*(4.0*g0 + 2.0*g0prime*alpha1);
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.H
deleted file mode 100644
index 8555ce9411df2800700b8cf1f9028d5d79c1ac84..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.H
+++ /dev/null
@@ -1,104 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::SyamlalRogersOBrien
-
-Description
-
-SourceFiles
-    SyamlalRogersOBrienPressure.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef SyamlalRogersOBrien_H
-#define SyamlalRogersOBrien_H
-
-#include "granularPressureModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace granularPressureModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class SyamlalRogersOBrien Declaration
-\*---------------------------------------------------------------------------*/
-
-class SyamlalRogersOBrien
-:
-    public granularPressureModel
-{
-
-public:
-
-    //- Runtime type information
-    TypeName("SyamlalRogersOBrien");
-
-
-    // Constructors
-
-        //- Construct from components
-        SyamlalRogersOBrien(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~SyamlalRogersOBrien();
-
-
-    // Member Functions
-
-        tmp<volScalarField> granularPressureCoeff
-        (
-            const volScalarField& alpha1,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const dimensionedScalar& e
-        ) const;
-
-        tmp<volScalarField> granularPressureCoeffPrime
-        (
-            const volScalarField& alpha1,
-            const volScalarField& g0,
-            const volScalarField& g0prime,
-            const dimensionedScalar& rho1,
-            const dimensionedScalar& e
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace granularPressureModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C
deleted file mode 100644
index 6bbae86d3773ca50327359646c80ab7090627ece..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C
+++ /dev/null
@@ -1,58 +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/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "granularPressureModel.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-    defineTypeNameAndDebug(granularPressureModel, 0);
-
-    defineRunTimeSelectionTable(granularPressureModel, dictionary);
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::granularPressureModel::granularPressureModel
-(
-    const dictionary& dict
-)
-:
-    dict_(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::granularPressureModel::~granularPressureModel()
-{}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.H
deleted file mode 100644
index 76d2701af6a17152f78c419f28eca36b3f6448c9..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.H
+++ /dev/null
@@ -1,137 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::granularPressureModel
-
-SourceFiles
-    granularPressureModel.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef granularPressureModel_H
-#define granularPressureModel_H
-
-#include "dictionary.H"
-#include "volFields.H"
-#include "dimensionedTypes.H"
-#include "runTimeSelectionTables.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class granularPressureModel Declaration
-\*---------------------------------------------------------------------------*/
-
-class granularPressureModel
-{
-    // Private member functions
-
-        //- Disallow default bitwise copy construct
-        granularPressureModel(const granularPressureModel&);
-
-        //- Disallow default bitwise assignment
-        void operator=(const granularPressureModel&);
-
-
-protected:
-
-    // Protected data
-
-        const dictionary& dict_;
-
-
-public:
-
-    //- Runtime type information
-    TypeName("granularPressureModel");
-
-    // Declare runtime constructor selection table
-    declareRunTimeSelectionTable
-    (
-        autoPtr,
-        granularPressureModel,
-        dictionary,
-        (
-            const dictionary& dict
-        ),
-        (dict)
-    );
-
-
-    // Constructors
-
-        //- Construct from components
-        granularPressureModel(const dictionary& dict);
-
-
-    // Selectors
-
-        static autoPtr<granularPressureModel> New
-        (
-            const dictionary& dict
-        );
-
-
-    //- Destructor
-    virtual ~granularPressureModel();
-
-
-    // Member Functions
-
-        //- Granular pressure coefficient
-        virtual tmp<volScalarField> granularPressureCoeff
-        (
-            const volScalarField& alpha1,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const dimensionedScalar& e
-        ) const = 0;
-
-        //- Derivative of the granular pressure coefficient
-        virtual tmp<volScalarField> granularPressureCoeffPrime
-        (
-            const volScalarField& alpha1,
-            const volScalarField& g0,
-            const volScalarField& g0prime,
-            const dimensionedScalar& rho1,
-            const dimensionedScalar& e
-        ) const = 0;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C
deleted file mode 100644
index d8e1540f0f059c462a510936de8f09c7c9f2ec10..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C
+++ /dev/null
@@ -1,60 +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/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "granularPressureModel.H"
-
-// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * //
-
-Foam::autoPtr<Foam::kineticTheoryModels::granularPressureModel>
-Foam::kineticTheoryModels::granularPressureModel::New
-(
-    const dictionary& dict
-)
-{
-    word granularPressureModelType(dict.lookup("granularPressureModel"));
-
-    Info<< "Selecting granularPressureModel "
-        << granularPressureModelType << endl;
-
-    dictionaryConstructorTable::iterator cstrIter =
-        dictionaryConstructorTablePtr_->find(granularPressureModelType);
-
-    if (cstrIter == dictionaryConstructorTablePtr_->end())
-    {
-        FatalError
-            << "granularPressureModel::New(const dictionary&) : " << endl
-            << "    unknown granularPressureModelType type "
-            << granularPressureModelType
-            << ", constructor not in hash table" << endl << endl
-            << "    Valid granularPressureModelType types are :" << endl;
-        Info<< dictionaryConstructorTablePtr_->sortedToc()
-            << abort(FatalError);
-    }
-
-    return autoPtr<granularPressureModel>(cstrIter()(dict));
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C
deleted file mode 100644
index f3814308700b4933706e4af81de5dac82c4895e1..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C
+++ /dev/null
@@ -1,390 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "kineticTheoryModel.H"
-#include "surfaceInterpolate.H"
-#include "mathematicalConstants.H"
-#include "fvCFD.H"
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModel::kineticTheoryModel
-(
-    const Foam::phaseModel& phase1,
-    const Foam::volVectorField& U2,
-    const Foam::volScalarField& alpha1,
-    const Foam::dragModel& drag1
-)
-:
-    phase1_(phase1),
-    U1_(phase1.U()),
-    U2_(U2),
-    alpha1_(alpha1),
-    phi1_(phase1.phi()),
-    drag1_(drag1),
-
-    rho1_(phase1.rho()),
-    nu1_(phase1.nu()),
-
-    kineticTheoryProperties_
-    (
-        IOobject
-        (
-            "kineticTheoryProperties",
-            U1_.time().constant(),
-            U1_.mesh(),
-            IOobject::MUST_READ,
-            IOobject::NO_WRITE
-        )
-    ),
-    kineticTheory_(kineticTheoryProperties_.lookup("kineticTheory")),
-    equilibrium_(kineticTheoryProperties_.lookup("equilibrium")),
-
-    viscosityModel_
-    (
-        kineticTheoryModels::viscosityModel::New
-        (
-            kineticTheoryProperties_
-        )
-    ),
-    conductivityModel_
-    (
-        kineticTheoryModels::conductivityModel::New
-        (
-            kineticTheoryProperties_
-        )
-    ),
-    radialModel_
-    (
-        kineticTheoryModels::radialModel::New
-        (
-            kineticTheoryProperties_
-        )
-    ),
-    granularPressureModel_
-    (
-        kineticTheoryModels::granularPressureModel::New
-        (
-            kineticTheoryProperties_
-        )
-    ),
-    frictionalStressModel_
-    (
-        kineticTheoryModels::frictionalStressModel::New
-        (
-            kineticTheoryProperties_
-        )
-    ),
-    e_(kineticTheoryProperties_.lookup("e")),
-    alphaMax_(kineticTheoryProperties_.lookup("alphaMax")),
-    alphaMinFriction_(kineticTheoryProperties_.lookup("alphaMinFriction")),
-    Fr_(kineticTheoryProperties_.lookup("Fr")),
-    eta_(kineticTheoryProperties_.lookup("eta")),
-    p_(kineticTheoryProperties_.lookup("p")),
-    phi_(dimensionedScalar(kineticTheoryProperties_.lookup("phi"))*M_PI/180.0),
-    Theta_
-    (
-        IOobject
-        (
-            "Theta",
-            U1_.time().timeName(),
-            U1_.mesh(),
-            IOobject::MUST_READ,
-            IOobject::AUTO_WRITE
-        ),
-        U1_.mesh()
-    ),
-    mu1_
-    (
-        IOobject
-        (
-            "mu1",
-            U1_.time().timeName(),
-            U1_.mesh(),
-            IOobject::NO_READ,
-            IOobject::AUTO_WRITE
-        ),
-        U1_.mesh(),
-        dimensionedScalar("zero", dimensionSet(1, -1, -1, 0, 0), 0.0)
-    ),
-    lambda_
-    (
-        IOobject
-        (
-            "lambda",
-            U1_.time().timeName(),
-            U1_.mesh(),
-            IOobject::NO_READ,
-            IOobject::NO_WRITE
-        ),
-        U1_.mesh(),
-        dimensionedScalar("zero", dimensionSet(1, -1, -1, 0, 0), 0.0)
-    ),
-    pa_
-    (
-        IOobject
-        (
-            "pa",
-            U1_.time().timeName(),
-            U1_.mesh(),
-            IOobject::NO_READ,
-            IOobject::AUTO_WRITE
-        ),
-        U1_.mesh(),
-        dimensionedScalar("zero", dimensionSet(1, -1, -2, 0, 0), 0.0)
-    ),
-    kappa_
-    (
-        IOobject
-        (
-            "kappa",
-            U1_.time().timeName(),
-            U1_.mesh(),
-            IOobject::NO_READ,
-            IOobject::NO_WRITE
-        ),
-        U1_.mesh(),
-        dimensionedScalar("zero", dimensionSet(1, -1, -1, 0, 0), 0.0)
-    ),
-    gs0_
-    (
-        IOobject
-        (
-            "gs0",
-            U1_.time().timeName(),
-            U1_.mesh(),
-            IOobject::NO_READ,
-            IOobject::NO_WRITE
-        ),
-        U1_.mesh(),
-        dimensionedScalar("zero", dimensionSet(0, 0, 0, 0, 0), 1.0)
-    )
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModel::~kineticTheoryModel()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-void Foam::kineticTheoryModel::solve(const volTensorField& gradU1t)
-{
-    if (!kineticTheory_)
-    {
-        return;
-    }
-
-    const scalar sqrtPi = sqrt(constant::mathematical::pi);
-
-    volScalarField da_(phase1_.d());
-
-    surfaceScalarField phi(1.5*rho1_*phi1_*fvc::interpolate(alpha1_));
-
-    volTensorField dU(gradU1t.T());    //fvc::grad(U1_);
-    volSymmTensorField D(symm(dU));
-
-    // NB, drag = K*alpha1*alpha2,
-    // (the alpha1 and alpha2 has been extracted from the drag function for
-    // numerical reasons)
-    volScalarField Ur(mag(U1_ - U2_));
-    volScalarField alpha2Prim(alpha1_*(1.0 - alpha1_)*drag1_.K(Ur));
-
-    // Calculating the radial distribution function (solid volume fraction is
-    //  limited close to the packing limit, but this needs improvements)
-    //  The solution is higly unstable close to the packing limit.
-    gs0_ = radialModel_->g0
-    (
-        min(max(alpha1_, scalar(1e-6)), alphaMax_ - 0.01),
-        alphaMax_
-    );
-
-    // particle pressure - coefficient in front of Theta (Eq. 3.22, p. 45)
-    volScalarField PsCoeff
-    (
-        granularPressureModel_->granularPressureCoeff
-        (
-            alpha1_,
-            gs0_,
-            rho1_,
-            e_
-        )
-    );
-
-    // 'thermal' conductivity (Table 3.3, p. 49)
-    kappa_ = conductivityModel_->kappa(alpha1_, Theta_, gs0_, rho1_, da_, e_);
-
-    // particle viscosity (Table 3.2, p.47)
-    mu1_ = viscosityModel_->mu1(alpha1_, Theta_, gs0_, rho1_, da_, e_);
-
-    dimensionedScalar Tsmall
-    (
-        "small",
-        dimensionSet(0 , 2 ,-2 ,0 , 0, 0, 0),
-        1.0e-6
-    );
-
-    dimensionedScalar TsmallSqrt = sqrt(Tsmall);
-    volScalarField ThetaSqrt(sqrt(Theta_));
-
-    // dissipation (Eq. 3.24, p.50)
-    volScalarField gammaCoeff
-    (
-        12.0*(1.0 - sqr(e_))*sqr(alpha1_)*rho1_*gs0_*(1.0/da_)*ThetaSqrt/sqrtPi
-    );
-
-    // Eq. 3.25, p. 50 Js = J1 - J2
-    volScalarField J1(3.0*alpha2Prim);
-    volScalarField J2
-    (
-        0.25*sqr(alpha2Prim)*da_*sqr(Ur)
-       /(max(alpha1_, scalar(1e-6))*rho1_*sqrtPi*(ThetaSqrt + TsmallSqrt))
-    );
-
-    // bulk viscosity  p. 45 (Lun et al. 1984).
-    lambda_ = (4.0/3.0)*sqr(alpha1_)*rho1_*da_*gs0_*(1.0+e_)*ThetaSqrt/sqrtPi;
-
-    // stress tensor, Definitions, Table 3.1, p. 43
-    volSymmTensorField tau(2.0*mu1_*D + (lambda_ - (2.0/3.0)*mu1_)*tr(D)*I);
-
-    if (!equilibrium_)
-    {
-        // construct the granular temperature equation (Eq. 3.20, p. 44)
-        // NB. note that there are two typos in Eq. 3.20
-        // no grad infront of Ps
-        // wrong sign infront of laplacian
-        fvScalarMatrix ThetaEqn
-        (
-            fvm::ddt(1.5*alpha1_*rho1_, Theta_)
-          + fvm::div(phi, Theta_, "div(phi,Theta)")
-         ==
-            fvm::SuSp(-((PsCoeff*I) && dU), Theta_)
-          + (tau && dU)
-          + fvm::laplacian(kappa_, Theta_, "laplacian(kappa,Theta)")
-          + fvm::Sp(-gammaCoeff, Theta_)
-          + fvm::Sp(-J1, Theta_)
-          + fvm::Sp(J2/(Theta_ + Tsmall), Theta_)
-        );
-
-        ThetaEqn.relax();
-        ThetaEqn.solve();
-    }
-    else
-    {
-        // equilibrium => dissipation == production
-        // Eq. 4.14, p.82
-        volScalarField K1(2.0*(1.0 + e_)*rho1_*gs0_);
-        volScalarField K3
-        (
-            0.5*da_*rho1_*
-            (
-                (sqrtPi/(3.0*(3.0-e_)))
-               *(1.0 + 0.4*(1.0 + e_)*(3.0*e_ - 1.0)*alpha1_*gs0_)
-               +1.6*alpha1_*gs0_*(1.0 + e_)/sqrtPi
-            )
-        );
-
-        volScalarField K2
-        (
-            4.0*da_*rho1_*(1.0 + e_)*alpha1_*gs0_/(3.0*sqrtPi) - 2.0*K3/3.0
-        );
-
-        volScalarField K4(12.0*(1.0 - sqr(e_))*rho1_*gs0_/(da_*sqrtPi));
-
-        volScalarField trD(tr(D));
-        volScalarField tr2D(sqr(trD));
-        volScalarField trD2(tr(D & D));
-
-        volScalarField t1(K1*alpha1_ + rho1_);
-        volScalarField l1(-t1*trD);
-        volScalarField l2(sqr(t1)*tr2D);
-        volScalarField l3
-        (
-            4.0
-           *K4
-           *max(alpha1_, scalar(1e-6))
-           *(2.0*K3*trD2 + K2*tr2D)
-        );
-
-        Theta_ = sqr((l1 + sqrt(l2 + l3))/(2.0*(alpha1_ + 1.0e-4)*K4));
-    }
-
-    Theta_.max(1.0e-15);
-    Theta_.min(1.0e+3);
-
-    volScalarField pf
-    (
-        frictionalStressModel_->frictionalPressure
-        (
-            alpha1_,
-            alphaMinFriction_,
-            alphaMax_,
-            Fr_,
-            eta_,
-            p_
-        )
-    );
-
-    PsCoeff += pf/(Theta_+Tsmall);
-
-    PsCoeff.min(1.0e+10);
-    PsCoeff.max(-1.0e+10);
-
-    // update particle pressure
-    pa_ = PsCoeff*Theta_;
-
-    // frictional shear stress, Eq. 3.30, p. 52
-    volScalarField muf
-    (
-        frictionalStressModel_->muf
-        (
-            alpha1_,
-            alphaMax_,
-            pf,
-            D,
-            phi_
-        )
-    );
-
-    // add frictional stress
-    mu1_ += muf;
-    mu1_.min(1.0e+2);
-    mu1_.max(0.0);
-
-    Info<< "kinTheory: max(Theta) = " << max(Theta_).value() << endl;
-
-    volScalarField ktn(mu1_/rho1_);
-
-    Info<< "kinTheory: min(nu1) = " << min(ktn).value()
-        << ", max(nu1) = " << max(ktn).value() << endl;
-
-    Info<< "kinTheory: min(pa) = " << min(pa_).value()
-        << ", max(pa) = " << max(pa_).value() << endl;
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.H
deleted file mode 100644
index 9e1e23715df8c44358c64ef8d5946b72cde45ba8..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.H
+++ /dev/null
@@ -1,197 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModel
-
-Description
-
-SourceFiles
-    kineticTheoryModel.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef kineticTheoryModel_H
-#define kineticTheoryModel_H
-
-#include "dragModel.H"
-#include "phaseModel.H"
-#include "autoPtr.H"
-#include "viscosityModel.H"
-#include "conductivityModel.H"
-#include "radialModel.H"
-#include "granularPressureModel.H"
-#include "frictionalStressModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class kineticTheoryModel Declaration
-\*---------------------------------------------------------------------------*/
-
-class kineticTheoryModel
-{
-    // Private data
-
-        const phaseModel& phase1_;
-        const volVectorField& U1_;
-        const volVectorField& U2_;
-        const volScalarField& alpha1_;
-        const surfaceScalarField& phi1_;
-
-        const dragModel& drag1_;
-
-        const dimensionedScalar& rho1_;
-        const dimensionedScalar& nu1_;
-
-        //- dictionary holding the modeling info
-        IOdictionary kineticTheoryProperties_;
-
-        //- use kinetic theory or not.
-        Switch kineticTheory_;
-
-        //- use generation == dissipation
-        Switch equilibrium_;
-
-        autoPtr<kineticTheoryModels::viscosityModel> viscosityModel_;
-
-        autoPtr<kineticTheoryModels::conductivityModel> conductivityModel_;
-
-        autoPtr<kineticTheoryModels::radialModel> radialModel_;
-
-        autoPtr<kineticTheoryModels::granularPressureModel>
-            granularPressureModel_;
-
-        autoPtr<kineticTheoryModels::frictionalStressModel>
-            frictionalStressModel_;
-
-        //- coefficient of restitution
-        const dimensionedScalar e_;
-
-        //- maximum packing
-        const dimensionedScalar alphaMax_;
-
-        //- min value for which the frictional stresses are zero
-        const dimensionedScalar alphaMinFriction_;
-
-        //- material constant for frictional normal stress
-        const dimensionedScalar Fr_;
-
-        //- material constant for frictional normal stress
-        const dimensionedScalar eta_;
-
-        //- material constant for frictional normal stress
-        const dimensionedScalar p_;
-
-        //- angle of internal friction
-        const dimensionedScalar phi_;
-
-        //- The granular energy/temperature
-        volScalarField Theta_;
-
-        //- The granular viscosity
-        volScalarField mu1_;
-
-        //- The granular bulk viscosity
-        volScalarField lambda_;
-
-        //- The granular pressure
-        volScalarField pa_;
-
-        //- The granular temperature conductivity
-        volScalarField kappa_;
-
-        //- The radial distribution function
-        volScalarField gs0_;
-
-
-    // Private Member Functions
-
-        //- Disallow default bitwise copy construct
-        kineticTheoryModel(const kineticTheoryModel&);
-
-        //- Disallow default bitwise assignment
-        void operator=(const kineticTheoryModel&);
-
-
-public:
-
-    // Constructors
-
-        //- Construct from components
-        kineticTheoryModel
-        (
-            const phaseModel& phase1,
-            const volVectorField& U2,
-            const volScalarField& alpha1,
-            const dragModel& drag1
-        );
-
-
-    //- Destructor
-    virtual ~kineticTheoryModel();
-
-
-    // Member Functions
-
-        void solve(const volTensorField& gradU1t);
-
-        bool on() const
-        {
-            return kineticTheory_;
-        }
-
-        const volScalarField& mu1() const
-        {
-            return mu1_;
-        }
-
-        const volScalarField& pa() const
-        {
-            return pa_;
-        }
-
-        const volScalarField& lambda() const
-        {
-            return lambda_;
-        }
-
-        const volScalarField& kappa() const
-        {
-            return kappa_;
-        }
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.C
deleted file mode 100644
index 3c147d7d618a33c9b385e1dae6785fc66abe912e..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.C
+++ /dev/null
@@ -1,99 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "CarnahanStarlingRadial.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace radialModels
-{
-    defineTypeNameAndDebug(CarnahanStarling, 0);
-
-    addToRunTimeSelectionTable
-    (
-        radialModel,
-        CarnahanStarling,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::radialModels::CarnahanStarling::CarnahanStarling
-(
-    const dictionary& dict
-)
-:
-    radialModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::radialModels::CarnahanStarling::~CarnahanStarling()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::radialModels::CarnahanStarling::g0
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMax
-) const
-{
-
-    return
-        1.0/(1.0 - alpha1)
-      + 3.0*alpha1/(2.0*sqr(1.0 - alpha1))
-      + sqr(alpha1)/(2.0*pow(1.0 - alpha1, 3));
-}
-
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::radialModels::CarnahanStarling::g0prime
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMax
-) const
-{
-    return
-        - alpha1/sqr(1.0 - alpha1)
-        + (3.0*(1.0 - alpha1) + 6.0*sqr(alpha1))/(2.0*(1.0 - alpha1))
-        + (2.0*alpha1*(1.0 - alpha1) + 3.0*pow(alpha1, 3))
-         /(2.0*pow(1.0 - alpha1, 4));
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.H
deleted file mode 100644
index b4b825fe12483ca6b90f433130e66a8280379645..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.H
+++ /dev/null
@@ -1,100 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::radialModels::CarnahanStarling
-
-Description
-
-SourceFiles
-    CarnahanStarlingRadial.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef CarnahanStarling_H
-#define CarnahanStarling_H
-
-#include "radialModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace radialModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class CarnahanStarling Declaration
-\*---------------------------------------------------------------------------*/
-
-class CarnahanStarling
-:
-    public radialModel
-{
-
-public:
-
-    //- Runtime type information
-    TypeName("CarnahanStarling");
-
-
-    // Constructors
-
-        //- Construct from components
-        CarnahanStarling(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~CarnahanStarling();
-
-
-    // Member Functions
-
-
-        tmp<volScalarField> g0
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax
-        ) const;
-
-        tmp<volScalarField> g0prime
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace radialModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/Gidaspow/GidaspowRadial.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/Gidaspow/GidaspowRadial.C
deleted file mode 100644
index e1c642b4f9123017533fd53928ba1bd5a5edeed8..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/Gidaspow/GidaspowRadial.C
+++ /dev/null
@@ -1,93 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "GidaspowRadial.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace radialModels
-{
-    defineTypeNameAndDebug(Gidaspow, 0);
-
-    addToRunTimeSelectionTable
-    (
-        radialModel,
-        Gidaspow,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::radialModels::Gidaspow::Gidaspow
-(
-    const dictionary& dict
-)
-:
-    radialModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::radialModels::Gidaspow::~Gidaspow()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::radialModels::Gidaspow::g0
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMax
-) const
-{
-    return 0.6/(1.0 - pow(alpha1/alphaMax, 1.0/3.0));
-}
-
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::radialModels::Gidaspow::g0prime
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMax
-) const
-{
-    return
-        (-1.0/5.0)*pow(alpha1/alphaMax, -2.0/3.0)
-       /(alphaMax*sqr(1.0 - pow(alpha1/alphaMax, 1.0/3.0)));
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/Gidaspow/GidaspowRadial.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/Gidaspow/GidaspowRadial.H
deleted file mode 100644
index 60791274b7f3a3d36efe91a746ccd17694efc580..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/Gidaspow/GidaspowRadial.H
+++ /dev/null
@@ -1,99 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::radialModels::Gidaspow
-
-Description
-
-SourceFiles
-    GidaspowRadial.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef Gidaspow_H
-#define Gidaspow_H
-
-#include "radialModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace radialModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class Gidaspow Declaration
-\*---------------------------------------------------------------------------*/
-
-class Gidaspow
-:
-    public radialModel
-{
-
-public:
-
-    //- Runtime type information
-    TypeName("Gidaspow");
-
-
-    // Constructors
-
-        //- Construct from components
-        Gidaspow(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~Gidaspow();
-
-
-    // Member Functions
-
-        tmp<volScalarField> g0
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax
-        ) const;
-
-        tmp<volScalarField> g0prime
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace radialModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.C
deleted file mode 100644
index e116a4b35e9cb4482e2dc5a2756f8578e9bba5e8..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.C
+++ /dev/null
@@ -1,92 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "LunSavageRadial.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace radialModels
-{
-    defineTypeNameAndDebug(LunSavage, 0);
-
-    addToRunTimeSelectionTable
-    (
-        radialModel,
-        LunSavage,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::radialModels::LunSavage::LunSavage
-(
-    const dictionary& dict
-)
-:
-    radialModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::radialModels::LunSavage::~LunSavage()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::radialModels::LunSavage::g0
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMax
-) const
-{
-
-    return pow(1.0 - alpha1/alphaMax, -2.5*alphaMax);
-}
-
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::radialModels::LunSavage::g0prime
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMax
-) const
-{
-    return 2.5*alphaMax*alpha1*pow(1.0 - alpha1, -1.0 - 2.5*alphaMax);
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.H
deleted file mode 100644
index 4977bfce5ed74de3e41a6064ec55809e875e53ab..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.H
+++ /dev/null
@@ -1,99 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::radialModels::LunSavage
-
-Description
-
-SourceFiles
-    LunSavage.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef LunSavage_H
-#define LunSavage_H
-
-#include "radialModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace radialModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class LunSavage Declaration
-\*---------------------------------------------------------------------------*/
-
-class LunSavage
-:
-    public radialModel
-{
-
-public:
-
-    //- Runtime type information
-    TypeName("LunSavage");
-
-
-    // Constructors
-
-        //- Construct from components
-        LunSavage(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~LunSavage();
-
-
-    // Member Functions
-
-        tmp<volScalarField> g0
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax
-        ) const;
-
-        tmp<volScalarField> g0prime
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace radialModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.C
deleted file mode 100644
index cfbdd4baa99ee29a9b8cd5d8def4f1e70bc24753..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.C
+++ /dev/null
@@ -1,93 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "SinclairJacksonRadial.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace radialModels
-{
-    defineTypeNameAndDebug(SinclairJackson, 0);
-
-    addToRunTimeSelectionTable
-    (
-        radialModel,
-        SinclairJackson,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::radialModels::SinclairJackson::SinclairJackson
-(
-    const dictionary& dict
-)
-:
-    radialModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::radialModels::SinclairJackson::~SinclairJackson()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::radialModels::SinclairJackson::g0
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMax
-) const
-{
-    return 1.0/(1.0 - pow(alpha1/alphaMax, 1.0/3.0));
-}
-
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::radialModels::SinclairJackson::g0prime
-(
-    const volScalarField& alpha1,
-    const dimensionedScalar& alphaMax
-) const
-{
-    return
-        (-1.0/3.0)*pow(alpha1/alphaMax, -2.0/3.0)
-       /(alphaMax*sqr(1.0 - pow(alpha1/alphaMax, 1.0/3.0)));
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.H
deleted file mode 100644
index 956cd568ef1a51859db46f6778ed3941dd684259..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.H
+++ /dev/null
@@ -1,99 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::SinclairJackson
-
-Description
-
-SourceFiles
-    SinclairJacksonRadial.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef SinclairJackson_H
-#define SinclairJackson_H
-
-#include "radialModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace radialModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class SinclairJackson Declaration
-\*---------------------------------------------------------------------------*/
-
-class SinclairJackson
-:
-    public radialModel
-{
-
-public:
-
-    //- Runtime type information
-    TypeName("SinclairJackson");
-
-
-    // Constructors
-
-        //- Construct from components
-        SinclairJackson(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~SinclairJackson();
-
-
-    // Member Functions
-
-        tmp<volScalarField> g0
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax
-        ) const;
-
-        tmp<volScalarField> g0prime
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace radialModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/radialModel/newRadialModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/radialModel/newRadialModel.C
deleted file mode 100644
index aa79335145b31dab7501b336fa3df44a2e06f452..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/radialModel/newRadialModel.C
+++ /dev/null
@@ -1,60 +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/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "radialModel.H"
-
-// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * //
-
-Foam::autoPtr<Foam::kineticTheoryModels::radialModel>
-Foam::kineticTheoryModels::radialModel::New
-(
-    const dictionary& dict
-)
-{
-    word radialModelType(dict.lookup("radialModel"));
-
-    Info<< "Selecting radialModel "
-        << radialModelType << endl;
-
-    dictionaryConstructorTable::iterator cstrIter =
-        dictionaryConstructorTablePtr_->find(radialModelType);
-
-    if (cstrIter == dictionaryConstructorTablePtr_->end())
-    {
-        FatalError
-            << "radialModel::New(const dictionary&) : " << endl
-            << "    unknown radialModelType type "
-            << radialModelType
-            << ", constructor not in hash table" << endl << endl
-            << "    Valid radialModelType types are :" << endl;
-        Info<< dictionaryConstructorTablePtr_->sortedToc()
-            << abort(FatalError);
-    }
-
-    return autoPtr<radialModel>(cstrIter()(dict));
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.C
deleted file mode 100644
index 7caf81d366f8241ca8df1c79e57a2d39ee8d9839..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.C
+++ /dev/null
@@ -1,58 +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/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "radialModel.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-    defineTypeNameAndDebug(radialModel, 0);
-
-    defineRunTimeSelectionTable(radialModel, dictionary);
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::radialModel::radialModel
-(
-    const dictionary& dict
-)
-:
-    dict_(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::radialModel::~radialModel()
-{}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.H
deleted file mode 100644
index a53b8f1a376eaabceb370ae1f6d81d09e4585e53..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.H
+++ /dev/null
@@ -1,132 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::radialModel
-
-SourceFiles
-    radialModel.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef radialModel_H
-#define radialModel_H
-
-#include "dictionary.H"
-#include "volFields.H"
-#include "dimensionedTypes.H"
-#include "runTimeSelectionTables.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class radialModel Declaration
-\*---------------------------------------------------------------------------*/
-
-class radialModel
-{
-    // Private member functions
-
-        //- Disallow default bitwise copy construct
-        radialModel(const radialModel&);
-
-        //- Disallow default bitwise assignment
-        void operator=(const radialModel&);
-
-
-protected:
-
-    // Protected data
-
-        const dictionary& dict_;
-
-
-public:
-
-    //- Runtime type information
-    TypeName("radialModel");
-
-    // Declare runtime constructor selection table
-    declareRunTimeSelectionTable
-    (
-        autoPtr,
-        radialModel,
-        dictionary,
-        (
-            const dictionary& dict
-        ),
-        (dict)
-    );
-
-
-    // Constructors
-
-        //- Construct from components
-        radialModel(const dictionary& dict);
-
-
-    // Selectors
-
-        static autoPtr<radialModel> New
-        (
-            const dictionary& dict
-        );
-
-
-    //- Destructor
-    virtual ~radialModel();
-
-
-    // Member Functions
-
-        //- Radial distribution function
-        virtual tmp<volScalarField> g0
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax
-        ) const = 0;
-
-        //- Derivative of the radial distribution function
-        virtual tmp<volScalarField> g0prime
-        (
-            const volScalarField& alpha1,
-            const dimensionedScalar& alphaMax
-        ) const = 0;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.C
deleted file mode 100644
index 55282b6de8953f6584d6f911d970bc23df02f467..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.C
+++ /dev/null
@@ -1,87 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "GidaspowViscosity.H"
-#include "mathematicalConstants.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace viscosityModels
-{
-    defineTypeNameAndDebug(Gidaspow, 0);
-    addToRunTimeSelectionTable(viscosityModel, Gidaspow, dictionary);
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::viscosityModels::Gidaspow::Gidaspow
-(
-    const dictionary& dict
-)
-:
-    viscosityModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::viscosityModels::Gidaspow::~Gidaspow()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::viscosityModels::Gidaspow::mu1
-(
-    const volScalarField& alpha1,
-    const volScalarField& Theta,
-    const volScalarField& g0,
-    const dimensionedScalar& rho1,
-    const volScalarField& da,
-    const dimensionedScalar& e
-) const
-{
-    const scalar sqrtPi = sqrt(constant::mathematical::pi);
-
-    return rho1*da*sqrt(Theta)*
-    (
-        (4.0/5.0)*sqr(alpha1)*g0*(1.0 + e)/sqrtPi
-      + (1.0/15.0)*sqrtPi*g0*(1.0 + e)*sqr(alpha1)
-      + (1.0/6.0)*sqrtPi*alpha1
-      + (10.0/96.0)*sqrtPi/((1.0 + e)*g0)
-    );
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.H
deleted file mode 100644
index dd286e8b2df30c9c235f19e1988cd00a23044248..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.H
+++ /dev/null
@@ -1,96 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::viscosityModels::Gidaspow
-
-Description
-
-SourceFiles
-    GidaspowViscosity.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef Gidaspow_H
-#define Gidaspow_H
-
-#include "viscosityModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace viscosityModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class Gidaspow Declaration
-\*---------------------------------------------------------------------------*/
-
-class Gidaspow
-:
-    public viscosityModel
-{
-
-public:
-
-    //- Runtime type information
-    TypeName("Gidaspow");
-
-    // Constructors
-
-        //- Construct from components
-        Gidaspow(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~Gidaspow();
-
-
-    // Member functions
-
-        tmp<volScalarField> mu1
-        (
-            const volScalarField& alpha1,
-            const volScalarField& Theta,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const volScalarField& da,
-            const dimensionedScalar& e
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace viscosityModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C
deleted file mode 100644
index e3c07f91d5bd8b1e59e200fa682977016306d9ec..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C
+++ /dev/null
@@ -1,101 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "HrenyaSinclairViscosity.H"
-#include "mathematicalConstants.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace viscosityModels
-{
-    defineTypeNameAndDebug(HrenyaSinclair, 0);
-
-    addToRunTimeSelectionTable
-    (
-        viscosityModel,
-        HrenyaSinclair,
-        dictionary
-    );
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::viscosityModels::HrenyaSinclair::HrenyaSinclair
-(
-    const dictionary& dict
-)
-:
-    viscosityModel(dict),
-    coeffsDict_(dict.subDict(typeName + "Coeffs")),
-    L_(coeffsDict_.lookup("L"))
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::viscosityModels::HrenyaSinclair::~HrenyaSinclair()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::viscosityModels::HrenyaSinclair::mu1
-(
-    const volScalarField& alpha1,
-    const volScalarField& Theta,
-    const volScalarField& g0,
-    const dimensionedScalar& rho1,
-    const volScalarField& da,
-    const dimensionedScalar& e
-) const
-{
-    const scalar sqrtPi = sqrt(constant::mathematical::pi);
-
-    volScalarField lamda
-    (
-        scalar(1) + da/(6.0*sqrt(2.0)*(alpha1 + scalar(1.0e-5)))/L_
-    );
-
-    return rho1*da*sqrt(Theta)*
-    (
-        (4.0/5.0)*sqr(alpha1)*g0*(1.0 + e)/sqrtPi
-      + (1.0/15.0)*sqrtPi*g0*(1.0 + e)*(3.0*e - 1)*sqr(alpha1)/(3.0-e)
-      + (1.0/6.0)*sqrtPi*alpha1*(0.5*lamda + 0.25*(3.0*e - 1.0))
-       /(0.5*(3.0 - e)*lamda)
-      + (10/96.0)*sqrtPi/((1.0 + e)*0.5*(3.0 - e)*g0*lamda)
-    );
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.H
deleted file mode 100644
index 2f1e54fd0347a0d78abcce3ca5da18cebc006a2c..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.H
+++ /dev/null
@@ -1,104 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::viscosityModels::HrenyaSinclair
-
-Description
-
-SourceFiles
-    HrenyaSinclairViscosity.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef HrenyaSinclair_H
-#define HrenyaSinclair_H
-
-#include "viscosityModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace viscosityModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class HrenyaSinclair Declaration
-\*---------------------------------------------------------------------------*/
-
-class HrenyaSinclair
-:
-    public viscosityModel
-{
-    // Private data
-
-        dictionary coeffsDict_;
-
-        //- characteristic length of geometry
-        dimensionedScalar L_;
-
-
-public:
-
-    //- Runtime type information
-    TypeName("HrenyaSinclair");
-
-
-    // Constructors
-
-        //- Construct from components
-        HrenyaSinclair(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~HrenyaSinclair();
-
-
-    // Member functions
-
-        tmp<volScalarField> mu1
-        (
-            const volScalarField& alpha1,
-            const volScalarField& Theta,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const volScalarField& da,
-            const dimensionedScalar& e
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace viscosityModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.C
deleted file mode 100644
index 3bc988bb48f040c21e73de28707407c967fc19b3..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.C
+++ /dev/null
@@ -1,86 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "SyamlalViscosity.H"
-#include "mathematicalConstants.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace viscosityModels
-{
-    defineTypeNameAndDebug(Syamlal, 0);
-    addToRunTimeSelectionTable(viscosityModel, Syamlal, dictionary);
-}
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::viscosityModels::Syamlal::Syamlal
-(
-    const dictionary& dict
-)
-:
-    viscosityModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::viscosityModels::Syamlal::~Syamlal()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField>
-Foam::kineticTheoryModels::viscosityModels::Syamlal::mu1
-(
-    const volScalarField& alpha1,
-    const volScalarField& Theta,
-    const volScalarField& g0,
-    const dimensionedScalar& rho1,
-    const volScalarField& da,
-    const dimensionedScalar& e
-) const
-{
-    const scalar sqrtPi = sqrt(constant::mathematical::pi);
-
-    return rho1*da*sqrt(Theta)*
-    (
-        (4.0/5.0)*sqr(alpha1)*g0*(1.0 + e)/sqrtPi
-      + (1.0/15.0)*sqrtPi*g0*(1.0 + e)*(3.0*e - 1.0)*sqr(alpha1)/(3.0 - e)
-      + (1.0/6.0)*alpha1*sqrtPi/(3.0 - e)
-    );
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.H
deleted file mode 100644
index d996e0e51a0050548042b5bf35bcb4d713d5b999..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.H
+++ /dev/null
@@ -1,97 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::kineticTheoryModels::viscosityModels::Syamlal
-
-Description
-
-SourceFiles
-    SyamlalViscosity.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef Syamlal_H
-#define Syamlal_H
-
-#include "viscosityModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-namespace viscosityModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class Syamlal Declaration
-\*---------------------------------------------------------------------------*/
-
-class Syamlal
-:
-    public viscosityModel
-{
-
-public:
-
-    //- Runtime type information
-    TypeName("Syamlal");
-
-
-    // Constructors
-
-        //- Construct from components
-        Syamlal(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~Syamlal();
-
-
-    // Member functions
-
-        tmp<volScalarField> mu1
-        (
-            const volScalarField& alpha1,
-            const volScalarField& Theta,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const volScalarField& da,
-            const dimensionedScalar& e
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace viscosityModels
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/none/noneViscosity.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/none/noneViscosity.C
deleted file mode 100644
index f6350844d5d15e1787b6850ceadb26c87ef42814..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/none/noneViscosity.C
+++ /dev/null
@@ -1,75 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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 "noneViscosity.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-    defineTypeNameAndDebug(noneViscosity, 0);
-    addToRunTimeSelectionTable(viscosityModel, noneViscosity, dictionary);
-}
-}
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::noneViscosity::noneViscosity(const dictionary& dict)
-:
-    viscosityModel(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::noneViscosity::~noneViscosity()
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
-
-Foam::tmp<Foam::volScalarField> Foam::kineticTheoryModels::noneViscosity::mu1
-(
-    const volScalarField& alpha1,
-    const volScalarField& Theta,
-    const volScalarField& g0,
-    const dimensionedScalar& rho1,
-    const volScalarField& da,
-    const dimensionedScalar& e
-) const
-{
-    return dimensionedScalar
-    (
-        "0",
-        dimensionSet(1, -1, -1, 0, 0, 0, 0),
-        0.0
-    )*alpha1;
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/none/noneViscosity.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/none/noneViscosity.H
deleted file mode 100644
index a53ffde21a7ada0709354bef9771aae3fb800caf..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/none/noneViscosity.H
+++ /dev/null
@@ -1,94 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::noneViscosity
-
-Description
-
-SourceFiles
-    noneViscosity.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef noneViscosity_H
-#define noneViscosity_H
-
-#include "viscosityModel.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class noneViscosity Declaration
-\*---------------------------------------------------------------------------*/
-
-class noneViscosity
-:
-    public viscosityModel
-{
-
-public:
-
-    //- Runtime type information
-    TypeName("none");
-
-
-    // Constructors
-
-        //- Construct from components
-        noneViscosity(const dictionary& dict);
-
-
-    //- Destructor
-    virtual ~noneViscosity();
-
-
-    // Member functions
-
-        tmp<volScalarField> mu1
-        (
-            const volScalarField& alpha1,
-            const volScalarField& Theta,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const volScalarField& da,
-            const dimensionedScalar& e
-        ) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C
deleted file mode 100644
index 2b50f093599b2a2043c30e6ea7dd68733f9f0692..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C
+++ /dev/null
@@ -1,59 +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/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "viscosityModel.H"
-
-// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * //
-
-Foam::autoPtr<Foam::kineticTheoryModels::viscosityModel>
-Foam::kineticTheoryModels::viscosityModel::New
-(
-    const dictionary& dict
-)
-{
-    word viscosityModelType(dict.lookup("viscosityModel"));
-
-    Info<< "Selecting viscosityModel "
-        << viscosityModelType << endl;
-
-    dictionaryConstructorTable::iterator cstrIter =
-        dictionaryConstructorTablePtr_->find(viscosityModelType);
-
-    if (cstrIter == dictionaryConstructorTablePtr_->end())
-    {
-        FatalError
-            << "viscosityModel::New(const dictionary&) : " << endl
-            << "    unknown viscosityModelType type "
-            << viscosityModelType
-            << ", constructor not in hash table" << endl << endl
-            << "    Valid viscosityModelType types are :" << endl;
-        Info<< dictionaryConstructorTablePtr_->sortedToc() << abort(FatalError);
-    }
-
-    return autoPtr<viscosityModel>(cstrIter()(dict));
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.C
deleted file mode 100644
index dc4c1ca1def57e5f104082c8b2ebae7f9a55660e..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.C
+++ /dev/null
@@ -1,57 +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/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "viscosityModel.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-    defineTypeNameAndDebug(viscosityModel, 0);
-    defineRunTimeSelectionTable(viscosityModel, dictionary);
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::viscosityModel::viscosityModel
-(
-    const dictionary& dict
-)
-:
-    dict_(dict)
-{}
-
-
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::kineticTheoryModels::viscosityModel::~viscosityModel()
-{}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.H b/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.H
deleted file mode 100644
index 80fb9dafce16e46116479f72a6dbcf12d3e01bff..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.H
+++ /dev/null
@@ -1,130 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-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::viscosityModel
-
-Description
-
-SourceFiles
-    viscosityModel.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef viscosityModel_H
-#define viscosityModel_H
-
-#include "dictionary.H"
-#include "volFields.H"
-#include "dimensionedTypes.H"
-#include "runTimeSelectionTables.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace kineticTheoryModels
-{
-
-/*---------------------------------------------------------------------------*\
-                           Class viscosityModel Declaration
-\*---------------------------------------------------------------------------*/
-
-class viscosityModel
-{
-    // Private member functions
-
-        //- Disallow default bitwise copy construct
-        viscosityModel(const viscosityModel&);
-
-        //- Disallow default bitwise assignment
-        void operator=(const viscosityModel&);
-
-
-protected:
-
-    // Protected data
-
-        const dictionary& dict_;
-
-
-public:
-
-    //- Runtime type information
-    TypeName("viscosityModel");
-
-    // Declare runtime constructor selection table
-    declareRunTimeSelectionTable
-    (
-        autoPtr,
-        viscosityModel,
-        dictionary,
-        (
-            const dictionary& dict
-        ),
-        (dict)
-    );
-
-
-    // Constructors
-
-        //- Construct from components
-        viscosityModel(const dictionary& dict);
-
-
-    // Selectors
-
-        static autoPtr<viscosityModel> New
-        (
-            const dictionary& dict
-        );
-
-
-    //- Destructor
-    virtual ~viscosityModel();
-
-
-    // Member Functions
-
-        virtual tmp<volScalarField> mu1
-        (
-            const volScalarField& alpha1,
-            const volScalarField& Theta,
-            const volScalarField& g0,
-            const dimensionedScalar& rho1,
-            const volScalarField& da,
-            const dimensionedScalar& e
-        ) const = 0;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace kineticTheoryModels
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //