diff --git a/applications/solvers/compressible/rhoSonicFoam/Make/files b/applications/solvers/compressible/rhoSonicFoam/Make/files
deleted file mode 100644
index 96e7916887..0000000000
--- a/applications/solvers/compressible/rhoSonicFoam/Make/files
+++ /dev/null
@@ -1,3 +0,0 @@
-rhoSonicFoam.C
-
-EXE = $(FOAM_APPBIN)/rhoSonicFoam
diff --git a/applications/solvers/compressible/rhoSonicFoam/Make/options b/applications/solvers/compressible/rhoSonicFoam/Make/options
deleted file mode 100644
index 725122ea1d..0000000000
--- a/applications/solvers/compressible/rhoSonicFoam/Make/options
+++ /dev/null
@@ -1,4 +0,0 @@
-EXE_INC = \
- -I$(LIB_SRC)/finiteVolume/lnInclude
-
-EXE_LIBS = -lfiniteVolume
diff --git a/applications/solvers/compressible/rhoSonicFoam/compressibleContinuityErrs.H b/applications/solvers/compressible/rhoSonicFoam/compressibleContinuityErrs.H
deleted file mode 100644
index 128d99c946..0000000000
--- a/applications/solvers/compressible/rhoSonicFoam/compressibleContinuityErrs.H
+++ /dev/null
@@ -1,12 +0,0 @@
-{
-# include "rhoEqn.H"
-}
-{
- scalar sumLocalContErr = (sum(mag(rho - psi*p))/sum(rho)).value();
- scalar globalContErr = (sum(rho - psi*p)/sum(rho)).value();
- cumulativeContErr += globalContErr;
-
- Info<< "time step continuity errors : sum local = " << sumLocalContErr
- << ", global = " << globalContErr
- << ", cumulative = " << cumulativeContErr << endl;
-}
diff --git a/applications/solvers/compressible/rhoSonicFoam/createFields.H b/applications/solvers/compressible/rhoSonicFoam/createFields.H
deleted file mode 100644
index f0c0e4a22a..0000000000
--- a/applications/solvers/compressible/rhoSonicFoam/createFields.H
+++ /dev/null
@@ -1,96 +0,0 @@
- Info<< "Reading field p\n" << endl;
- volScalarField p
- (
- IOobject
- (
- "p",
- runTime.timeName(),
- mesh,
- IOobject::MUST_READ,
- IOobject::AUTO_WRITE
- ),
- mesh
- );
-
-
- Info<< "Reading field T\n" << endl;
- volScalarField T
- (
- IOobject
- (
- "T",
- runTime.timeName(),
- mesh,
- IOobject::MUST_READ,
- IOobject::AUTO_WRITE
- ),
- mesh
- );
-
- Info<< "Reading field U\n" << endl;
- volVectorField U
- (
- IOobject
- (
- "U",
- runTime.timeName(),
- mesh,
- IOobject::MUST_READ,
- IOobject::AUTO_WRITE
- ),
- mesh
- );
-
- volScalarField psi
- (
- IOobject
- (
- "psi",
- runTime.timeName(),
- mesh,
- IOobject::NO_READ,
- IOobject::NO_WRITE
- ),
- 1.0/(R*T)
- );
- psi.oldTime();
-
- volScalarField rho
- (
- IOobject
- (
- "rho",
- runTime.timeName(),
- mesh
- ),
- psi*p,
- p.boundaryField().types()
- );
-
- volVectorField rhoU
- (
- IOobject
- (
- "rhoU",
- runTime.timeName(),
- mesh,
- IOobject::NO_READ,
- IOobject::NO_WRITE
- ),
- rho*U,
- U.boundaryField().types()
- );
-
- volScalarField rhoE
- (
- IOobject
- (
- "rhoE",
- runTime.timeName(),
- mesh,
- IOobject::NO_READ,
- IOobject::NO_WRITE
- ),
- rho*Cv*T + 0.5*rho*magSqr(rhoU/rho),
- T.boundaryField().types()
- );
diff --git a/applications/solvers/compressible/rhoSonicFoam/readThermodynamicProperties.H b/applications/solvers/compressible/rhoSonicFoam/readThermodynamicProperties.H
deleted file mode 100644
index 4e19adaae4..0000000000
--- a/applications/solvers/compressible/rhoSonicFoam/readThermodynamicProperties.H
+++ /dev/null
@@ -1,23 +0,0 @@
- Info<< "Reading thermodynamicProperties\n" << endl;
-
- IOdictionary thermodynamicProperties
- (
- IOobject
- (
- "thermodynamicProperties",
- runTime.constant(),
- mesh,
- IOobject::MUST_READ_IF_MODIFIED,
- IOobject::NO_WRITE
- )
- );
-
- dimensionedScalar R
- (
- thermodynamicProperties.lookup("R")
- );
-
- dimensionedScalar Cv
- (
- thermodynamicProperties.lookup("Cv")
- );
diff --git a/applications/solvers/compressible/rhoSonicFoam/rhoSonicFoam.C b/applications/solvers/compressible/rhoSonicFoam/rhoSonicFoam.C
deleted file mode 100644
index 23936fc2c4..0000000000
--- a/applications/solvers/compressible/rhoSonicFoam/rhoSonicFoam.C
+++ /dev/null
@@ -1,129 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-Application
- rhoSonicFoam
-
-Description
- Density-based compressible flow solver.
-
-\*---------------------------------------------------------------------------*/
-
-#include "fvCFD.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-int main(int argc, char *argv[])
-{
-
-# include "setRootCase.H"
-# include "createTime.H"
-# include "createMesh.H"
-# include "readThermodynamicProperties.H"
-# include "createFields.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
- Info<< "\nStarting time loop\n" << endl;
-
- while (runTime.loop())
- {
- Info<< "Time = " << runTime.timeName() << nl << endl;
-
- surfaceScalarField phiv
- (
- IOobject
- (
- "phiv",
- runTime.timeName(),
- mesh,
- IOobject::NO_READ,
- IOobject::NO_WRITE
- ),
- fvc::interpolate(rhoU)/fvc::interpolate(rho) & mesh.Sf()
- );
-
- scalar CoNum = max
- (
- mesh.surfaceInterpolation::deltaCoeffs()
- *mag(phiv)/mesh.magSf()
- ).value()*runTime.deltaTValue();
-
- Info<< "\nMax Courant Number = " << CoNum << endl;
-
- solve
- (
- fvm::ddt(rho)
- + fvm::div(phiv, rho)
- );
-
- p = rho/psi;
-
- solve
- (
- fvm::ddt(rhoU)
- + fvm::div(phiv, rhoU)
- ==
- - fvc::grad(p)
- );
-
- U == rhoU/rho;
-
- surfaceScalarField phiv2
- (
- IOobject
- (
- "phiv2",
- runTime.timeName(),
- mesh,
- IOobject::NO_READ,
- IOobject::NO_WRITE
- ),
- fvc::interpolate(rhoU)/fvc::interpolate(rho) & mesh.Sf()
- );
-
- solve
- (
- fvm::ddt(rhoE)
- + fvm::div(phiv, rhoE)
- ==
- - fvc::div(phiv2, p)
- );
-
- T = (rhoE - 0.5*rho*magSqr(rhoU/rho))/Cv/rho;
- psi = 1.0/(R*T);
-
- runTime.write();
-
- Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s"
- << " ClockTime = " << runTime.elapsedClockTime() << " s"
- << nl << endl;
- }
-
- Info<< "End\n" << endl;
-
- return 0;
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/Allwmake b/applications/solvers/compressible/rhopSonicFoam/Allwmake
deleted file mode 100755
index 5f01d96a75..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/Allwmake
+++ /dev/null
@@ -1,8 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # run from this directory
-set -x
-
-wmake libso BCs
-wmake
-
-# ----------------------------------------------------------------- end-of-file
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/Make/files b/applications/solvers/compressible/rhopSonicFoam/BCs/Make/files
deleted file mode 100644
index 3931413eae..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/Make/files
+++ /dev/null
@@ -1,8 +0,0 @@
-rho/fixedRhoFvPatchScalarField.C
-rho/gradientRhoFvPatchScalarField.C
-rhoE/fixedRhoEFvPatchScalarField.C
-rhoE/mixedRhoEFvPatchScalarField.C
-rhoU/fixedRhoUFvPatchVectorField.C
-p/inviscidWallPFvPatchScalarField.C
-
-LIB = $(FOAM_LIBBIN)/librhopSonicFoam
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/Make/options b/applications/solvers/compressible/rhopSonicFoam/BCs/Make/options
deleted file mode 100644
index 9c87caea6e..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/Make/options
+++ /dev/null
@@ -1,6 +0,0 @@
-EXE_INC = \
- -I$(LIB_SRC)/finiteVolume/lnInclude
-
-LIB_LIBS = \
- -lfiniteVolume \
- -L$(FOAM_LIBBIN)
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/p/inviscidWallPFvPatchScalarField.C b/applications/solvers/compressible/rhopSonicFoam/BCs/p/inviscidWallPFvPatchScalarField.C
deleted file mode 100644
index 8702d0aba4..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/p/inviscidWallPFvPatchScalarField.C
+++ /dev/null
@@ -1,163 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#include "inviscidWallPFvPatchScalarField.H"
-#include "fvPatchFieldMapper.H"
-#include "volFields.H"
-#include "surfaceFields.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
-
-inviscidWallPFvPatchScalarField::inviscidWallPFvPatchScalarField
-(
- const fvPatch& p,
- const DimensionedField& iF
-)
-:
- fixedGradientFvPatchScalarField(p, iF),
- fluxFraction_(1)
-{}
-
-
-inviscidWallPFvPatchScalarField::inviscidWallPFvPatchScalarField
-(
- const inviscidWallPFvPatchScalarField& ptf,
- const fvPatch& p,
- const DimensionedField& iF,
- const fvPatchFieldMapper& mapper
-)
-:
- fixedGradientFvPatchScalarField(ptf, p, iF, mapper),
- fluxFraction_(ptf.fluxFraction_)
-{}
-
-
-inviscidWallPFvPatchScalarField::inviscidWallPFvPatchScalarField
-(
- const fvPatch& p,
- const DimensionedField& iF,
- const dictionary& dict
-)
-:
- fixedGradientFvPatchScalarField(p, iF),
- fluxFraction_(readScalar(dict.lookup("fluxFraction")))
-{
- if (dict.found("gradient"))
- {
- gradient() = scalarField("gradient", dict, p.size());
- fixedGradientFvPatchScalarField::updateCoeffs();
- fixedGradientFvPatchScalarField::evaluate();
- }
- else
- {
- fvPatchField::operator=(patchInternalField());
- gradient() = 0.0;
- }
-
- if (fluxFraction_<0.0 || fluxFraction_ > 1.0)
- {
- FatalIOErrorIn
- (
- "inviscidWallPFvPatchScalarField::"
- "supersonicFreeStreamFvPatchVectorField"
- "(const fvPatch&, const scalarField&, const dictionary&)",
- dict
- ) << " unphysical fluxFraction specified (< 0.0 or > 1.0)"
- << exit(FatalIOError);
- }
-
-}
-
-
-inviscidWallPFvPatchScalarField::inviscidWallPFvPatchScalarField
-(
- const inviscidWallPFvPatchScalarField& wbppsf
-)
-:
- fixedGradientFvPatchScalarField(wbppsf),
- fluxFraction_(wbppsf.fluxFraction_)
-{}
-
-
-inviscidWallPFvPatchScalarField::inviscidWallPFvPatchScalarField
-(
- const inviscidWallPFvPatchScalarField& wbppsf,
- const DimensionedField& iF
-)
-:
- fixedGradientFvPatchScalarField(wbppsf, iF),
- fluxFraction_(wbppsf.fluxFraction_)
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
-
-void inviscidWallPFvPatchScalarField::updateCoeffs()
-{
- if (updated())
- {
- return;
- }
-
- const fvPatchField& rhoUp =
- patch().lookupPatchField("rhoU");
-
- const fvsPatchField& phip =
- patch().lookupPatchField("phi");
-
- const fvsPatchField& rAp =
- patch().lookupPatchField("rrhoUAf");
-
- gradient() = (fluxFraction_*phip - (patch().Sf() & rhoUp))/
- (rAp*patch().magSf());
-
- fixedGradientFvPatchScalarField::updateCoeffs();
-}
-
-
-void inviscidWallPFvPatchScalarField::write(Ostream& os) const
-{
- fixedGradientFvPatchScalarField::write(os);
- os.writeKeyword("fluxFraction")
- << fluxFraction_ << token::END_STATEMENT << nl;
- writeEntry("value", os);
-}
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-makePatchTypeField(fvPatchScalarField, inviscidWallPFvPatchScalarField);
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/p/inviscidWallPFvPatchScalarField.H b/applications/solvers/compressible/rhopSonicFoam/BCs/p/inviscidWallPFvPatchScalarField.H
deleted file mode 100644
index c88ec2e714..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/p/inviscidWallPFvPatchScalarField.H
+++ /dev/null
@@ -1,136 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef inviscidWallPFvPatchScalarFields_H
-#define inviscidWallPFvPatchScalarFields_H
-
-#include "fvPatchFields.H"
-#include "fixedGradientFvPatchFields.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-/*---------------------------------------------------------------------------*\
- Class inviscidWallPFvPatch Declaration
-\*---------------------------------------------------------------------------*/
-
-class inviscidWallPFvPatchScalarField
-:
- public fixedGradientFvPatchScalarField
-{
-
-public:
-
- // Private data
-
- scalar fluxFraction_;
-
- //- Runtime type information
- TypeName("inviscidWallP");
-
-
- // Constructors
-
- //- Construct from patch and internal field
- inviscidWallPFvPatchScalarField
- (
- const fvPatch&,
- const DimensionedField&
- );
-
- //- Construct from patch, internal field and dictionary
- inviscidWallPFvPatchScalarField
- (
- const fvPatch&,
- const DimensionedField&,
- const dictionary&
- );
-
- //- Construct by mapping given inviscidWallPFvPatchScalarField onto
- // a new patch
- inviscidWallPFvPatchScalarField
- (
- const inviscidWallPFvPatchScalarField&,
- const fvPatch&,
- const DimensionedField&,
- const fvPatchFieldMapper&
- );
-
- //- Construct as copy
- inviscidWallPFvPatchScalarField
- (
- const inviscidWallPFvPatchScalarField&
- );
-
- //- Construct and return a clone
- virtual tmp clone() const
- {
- return tmp
- (
- new inviscidWallPFvPatchScalarField(*this)
- );
- }
-
- //- Construct as copy setting internal field reference
- inviscidWallPFvPatchScalarField
- (
- const inviscidWallPFvPatchScalarField&,
- const DimensionedField&
- );
-
- //- Construct and return a clone setting internal field reference
- virtual tmp clone
- (
- const DimensionedField& iF
- ) const
- {
- return tmp
- (
- new inviscidWallPFvPatchScalarField(*this, iF)
- );
- }
-
-
- // Member functions
-
- //- Update the coefficients associated with the patch field
- virtual void updateCoeffs();
-
- //- Write
- virtual void write(Ostream&) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/rho/fixedRhoFvPatchScalarField.C b/applications/solvers/compressible/rhopSonicFoam/BCs/rho/fixedRhoFvPatchScalarField.C
deleted file mode 100644
index b715ac05bc..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/rho/fixedRhoFvPatchScalarField.C
+++ /dev/null
@@ -1,126 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#include "fixedRhoFvPatchScalarField.H"
-#include "addToRunTimeSelectionTable.H"
-#include "fvPatchFieldMapper.H"
-#include "volFields.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
-
-fixedRhoFvPatchScalarField::fixedRhoFvPatchScalarField
-(
- const fvPatch& p,
- const DimensionedField& iF
-)
-:
- fixedValueFvPatchScalarField(p, iF)
-{}
-
-
-fixedRhoFvPatchScalarField::fixedRhoFvPatchScalarField
-(
- const fixedRhoFvPatchScalarField& ptf,
- const fvPatch& p,
- const DimensionedField& iF,
- const fvPatchFieldMapper& mapper
-)
-:
- fixedValueFvPatchScalarField(ptf, p, iF, mapper)
-{}
-
-
-fixedRhoFvPatchScalarField::fixedRhoFvPatchScalarField
-(
- const fvPatch& p,
- const DimensionedField& iF,
- const dictionary& dict
-)
-:
- fixedValueFvPatchScalarField(p, iF)
-{}
-
-
-fixedRhoFvPatchScalarField::fixedRhoFvPatchScalarField
-(
- const fixedRhoFvPatchScalarField& tppsf
-)
-:
- fixedValueFvPatchScalarField(tppsf)
-{}
-
-
-fixedRhoFvPatchScalarField::fixedRhoFvPatchScalarField
-(
- const fixedRhoFvPatchScalarField& tppsf,
- const DimensionedField& iF
-)
-:
- fixedValueFvPatchScalarField(tppsf, iF)
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
-
-void fixedRhoFvPatchScalarField::updateCoeffs()
-{
- if (updated())
- {
- return;
- }
-
- const fvPatchField& psip =
- patch().lookupPatchField("psi");
-
- const fvPatchField& pp =
- patch().lookupPatchField("p");
-
- operator==(psip*pp);
-
- fixedValueFvPatchScalarField::updateCoeffs();
-}
-
-
-void fixedRhoFvPatchScalarField::write(Ostream& os) const
-{
- fvPatchScalarField::write(os);
- writeEntry("value", os);
-}
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-makePatchTypeField(fvPatchScalarField, fixedRhoFvPatchScalarField);
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/rho/fixedRhoFvPatchScalarField.H b/applications/solvers/compressible/rhopSonicFoam/BCs/rho/fixedRhoFvPatchScalarField.H
deleted file mode 100644
index 4c2519f3b1..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/rho/fixedRhoFvPatchScalarField.H
+++ /dev/null
@@ -1,135 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef fixedRhoFvPatchScalarField_H
-#define fixedRhoFvPatchScalarField_H
-
-#include "fixedValueFvPatchFields.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-/*---------------------------------------------------------------------------*\
- Class fixedRhoFvPatch Declaration
-\*---------------------------------------------------------------------------*/
-
-class fixedRhoFvPatchScalarField
-:
- public fixedValueFvPatchScalarField
-{
-
-public:
-
- //- Runtime type information
- TypeName("fixedRho");
-
-
- // Constructors
-
- //- Construct from patch and internal field
- fixedRhoFvPatchScalarField
- (
- const fvPatch&,
- const DimensionedField&
- );
-
- //- Construct from patch, internal field and dictionary
- fixedRhoFvPatchScalarField
- (
- const fvPatch&,
- const DimensionedField&,
- const dictionary&
- );
-
- //- Construct by mapping given fixedRhoFvPatchScalarField
- // onto a new patch
- fixedRhoFvPatchScalarField
- (
- const fixedRhoFvPatchScalarField&,
- const fvPatch&,
- const DimensionedField&,
- const fvPatchFieldMapper&
- );
-
- //- Construct as copy
- fixedRhoFvPatchScalarField
- (
- const fixedRhoFvPatchScalarField&
- );
-
- //- Construct and return a clone
- virtual tmp clone() const
- {
- return tmp
- (
- new fixedRhoFvPatchScalarField(*this)
- );
- }
-
- //- Construct as copy setting internal field reference
- fixedRhoFvPatchScalarField
- (
- const fixedRhoFvPatchScalarField&,
- const DimensionedField&
- );
-
- //- Construct and return a clone setting internal field reference
- virtual tmp clone
- (
- const DimensionedField& iF
- ) const
- {
- return tmp
- (
- new fixedRhoFvPatchScalarField(*this, iF)
- );
- }
-
-
- // Member functions
-
- // Access
-
- // Evaluation functions
-
- //- Update the coefficients associated with the patch field
- virtual void updateCoeffs();
-
- //- Write
- virtual void write(Ostream&) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/rho/gradientRhoFvPatchScalarField.C b/applications/solvers/compressible/rhopSonicFoam/BCs/rho/gradientRhoFvPatchScalarField.C
deleted file mode 100644
index f874f86df4..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/rho/gradientRhoFvPatchScalarField.C
+++ /dev/null
@@ -1,139 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#include "gradientRhoFvPatchScalarField.H"
-#include "fvPatchFieldMapper.H"
-#include "volFields.H"
-#include "surfaceFields.H"
-#include "addToRunTimeSelectionTable.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
-
-gradientRhoFvPatchScalarField::gradientRhoFvPatchScalarField
-(
- const fvPatch& p,
- const DimensionedField& iF
-)
-:
- fixedGradientFvPatchScalarField(p, iF)
-{}
-
-
-gradientRhoFvPatchScalarField::gradientRhoFvPatchScalarField
-(
- const gradientRhoFvPatchScalarField& ptf,
- const fvPatch& p,
- const DimensionedField& iF,
- const fvPatchFieldMapper& mapper
-)
-:
- fixedGradientFvPatchScalarField(ptf, p, iF, mapper)
-{}
-
-
-gradientRhoFvPatchScalarField::gradientRhoFvPatchScalarField
-(
- const fvPatch& p,
- const DimensionedField& iF,
- const dictionary& dict
-)
-:
- fixedGradientFvPatchScalarField(p, iF)
-{
- if (dict.found("gradient"))
- {
- gradient() = scalarField("gradient", dict, p.size());
- fixedGradientFvPatchScalarField::updateCoeffs();
- fixedGradientFvPatchScalarField::evaluate();
- }
- else
- {
- fvPatchField::operator=(patchInternalField());
- gradient() = 0.0;
- }
-}
-
-
-gradientRhoFvPatchScalarField::gradientRhoFvPatchScalarField
-(
- const gradientRhoFvPatchScalarField& wbppsf
-)
-:
- fixedGradientFvPatchScalarField(wbppsf)
-{}
-
-
-gradientRhoFvPatchScalarField::gradientRhoFvPatchScalarField
-(
- const gradientRhoFvPatchScalarField& wbppsf,
- const DimensionedField& iF
-)
-:
- fixedGradientFvPatchScalarField(wbppsf, iF)
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
-
-void gradientRhoFvPatchScalarField::updateCoeffs()
-{
- if (updated())
- {
- return;
- }
-
- const fvPatchField& psip =
- patch().lookupPatchField("psi");
-
- const fvPatchField& pp =
- patch().lookupPatchField("p");
-
- gradient() = psip*pp.snGrad() + psip.snGrad()*pp;
-
- fixedGradientFvPatchScalarField::updateCoeffs();
-}
-
-
-void gradientRhoFvPatchScalarField::write(Ostream& os) const
-{
- fixedGradientFvPatchScalarField::write(os);
- writeEntry("value", os);
-}
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-makePatchTypeField(fvPatchScalarField, gradientRhoFvPatchScalarField);
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/rho/gradientRhoFvPatchScalarField.H b/applications/solvers/compressible/rhopSonicFoam/BCs/rho/gradientRhoFvPatchScalarField.H
deleted file mode 100644
index 5795fbc3d4..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/rho/gradientRhoFvPatchScalarField.H
+++ /dev/null
@@ -1,132 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef gradientRhoFvPatchScalarFields_H
-#define gradientRhoFvPatchScalarFields_H
-
-#include "fvPatchFields.H"
-#include "fixedGradientFvPatchFields.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-/*---------------------------------------------------------------------------*\
- Class gradientRhoFvPatch Declaration
-\*---------------------------------------------------------------------------*/
-
-class gradientRhoFvPatchScalarField
-:
- public fixedGradientFvPatchScalarField
-{
-
-public:
-
- //- Runtime type information
- TypeName("gradientRho");
-
-
- // Constructors
-
- //- Construct from patch and internal field
- gradientRhoFvPatchScalarField
- (
- const fvPatch&,
- const DimensionedField&
- );
-
- //- Construct from patch, internal field and dictionary
- gradientRhoFvPatchScalarField
- (
- const fvPatch&,
- const DimensionedField&,
- const dictionary&
- );
-
- //- Construct by mapping given gradientRhoFvPatchScalarField onto
- // a new patch
- gradientRhoFvPatchScalarField
- (
- const gradientRhoFvPatchScalarField&,
- const fvPatch&,
- const DimensionedField&,
- const fvPatchFieldMapper&
- );
-
- //- Construct as copy
- gradientRhoFvPatchScalarField
- (
- const gradientRhoFvPatchScalarField&x
- );
-
- //- Construct and return a clone
- virtual tmp clone() const
- {
- return tmp
- (
- new gradientRhoFvPatchScalarField(*this)
- );
- }
-
- //- Construct as copy setting internal field reference
- gradientRhoFvPatchScalarField
- (
- const gradientRhoFvPatchScalarField&,
- const DimensionedField&
- );
-
- //- Construct and return a clone setting internal field reference
- virtual tmp clone
- (
- const DimensionedField& iF
- ) const
- {
- return tmp
- (
- new gradientRhoFvPatchScalarField(*this, iF)
- );
- }
-
-
- // Member functions
-
- //- Update the coefficients associated with the patch field
- virtual void updateCoeffs();
-
- //- Write
- virtual void write(Ostream&) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/fixedRhoEFvPatchScalarField.C b/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/fixedRhoEFvPatchScalarField.C
deleted file mode 100644
index 9bf4a4c1a8..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/fixedRhoEFvPatchScalarField.C
+++ /dev/null
@@ -1,136 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#include "fixedRhoEFvPatchScalarField.H"
-#include "addToRunTimeSelectionTable.H"
-#include "fvPatchFieldMapper.H"
-#include "volFields.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
-
-fixedRhoEFvPatchScalarField::fixedRhoEFvPatchScalarField
-(
- const fvPatch& p,
- const DimensionedField& iF
-)
-:
- fixedValueFvPatchScalarField(p, iF)
-{}
-
-
-fixedRhoEFvPatchScalarField::fixedRhoEFvPatchScalarField
-(
- const fixedRhoEFvPatchScalarField& ptf,
- const fvPatch& p,
- const DimensionedField& iF,
- const fvPatchFieldMapper& mapper
-)
-:
- fixedValueFvPatchScalarField(ptf, p, iF, mapper)
-{}
-
-
-fixedRhoEFvPatchScalarField::fixedRhoEFvPatchScalarField
-(
- const fvPatch& p,
- const DimensionedField& iF,
- const dictionary& dict
-)
-:
- fixedValueFvPatchScalarField(p, iF)
-{}
-
-
-fixedRhoEFvPatchScalarField::fixedRhoEFvPatchScalarField
-(
- const fixedRhoEFvPatchScalarField& tppsf
-)
-:
- fixedValueFvPatchScalarField(tppsf)
-{}
-
-
-fixedRhoEFvPatchScalarField::fixedRhoEFvPatchScalarField
-(
- const fixedRhoEFvPatchScalarField& tppsf,
- const DimensionedField& iF
-)
-:
- fixedValueFvPatchScalarField(tppsf, iF)
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
-
-void fixedRhoEFvPatchScalarField::updateCoeffs()
-{
- if (updated())
- {
- return;
- }
-
- const dictionary& thermodynamicProperties = db().lookupObject
- (
- "thermodynamicProperties"
- );
-
- dimensionedScalar Cv(thermodynamicProperties.lookup("Cv"));
-
- const fvPatchScalarField& rhop =
- patch().lookupPatchField("rho");
-
- const fvPatchVectorField& rhoUp =
- patch().lookupPatchField("rhoU");
-
- const fvPatchScalarField& Tp =
- patch().lookupPatchField("T");
-
- operator==(rhop*(Cv.value()*Tp + 0.5*magSqr(rhoUp/rhop)));
-
- fixedValueFvPatchScalarField::updateCoeffs();
-}
-
-
-void fixedRhoEFvPatchScalarField::write(Ostream& os) const
-{
- fvPatchScalarField::write(os);
- writeEntry("value", os);
-}
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-makePatchTypeField(fvPatchScalarField, fixedRhoEFvPatchScalarField);
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/fixedRhoEFvPatchScalarField.H b/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/fixedRhoEFvPatchScalarField.H
deleted file mode 100644
index 8f40703be0..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/fixedRhoEFvPatchScalarField.H
+++ /dev/null
@@ -1,135 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef fixedRhoEFvPatchScalarField_H
-#define fixedRhoEFvPatchScalarField_H
-
-#include "fixedValueFvPatchFields.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-/*---------------------------------------------------------------------------*\
- Class fixedRhoEFvPatch Declaration
-\*---------------------------------------------------------------------------*/
-
-class fixedRhoEFvPatchScalarField
-:
- public fixedValueFvPatchScalarField
-{
-
-public:
-
- //- Runtime type information
- TypeName("fixedRhoE");
-
-
- // Constructors
-
- //- Construct from patch and internal field
- fixedRhoEFvPatchScalarField
- (
- const fvPatch&,
- const DimensionedField&
- );
-
- //- Construct from patch, internal field and dictionary
- fixedRhoEFvPatchScalarField
- (
- const fvPatch&,
- const DimensionedField&,
- const dictionary&
- );
-
- //- Construct by mapping given fixedRhoEFvPatchScalarField
- // onto a new patch
- fixedRhoEFvPatchScalarField
- (
- const fixedRhoEFvPatchScalarField&,
- const fvPatch&,
- const DimensionedField&,
- const fvPatchFieldMapper&
- );
-
- //- Construct as copy
- fixedRhoEFvPatchScalarField
- (
- const fixedRhoEFvPatchScalarField&
- );
-
- //- Construct and return a clone
- virtual tmp clone() const
- {
- return tmp
- (
- new fixedRhoEFvPatchScalarField(*this)
- );
- }
-
- //- Construct as copy setting internal field reference
- fixedRhoEFvPatchScalarField
- (
- const fixedRhoEFvPatchScalarField&,
- const DimensionedField&
- );
-
- //- Construct and return a clone setting internal field reference
- virtual tmp clone
- (
- const DimensionedField& iF
- ) const
- {
- return tmp
- (
- new fixedRhoEFvPatchScalarField(*this, iF)
- );
- }
-
-
- // Member functions
-
- // Access
-
- // Evaluation functions
-
- //- Update the coefficients associated with the patch field
- virtual void updateCoeffs();
-
- //- Write
- virtual void write(Ostream&) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/mixedRhoEFvPatchScalarField.C b/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/mixedRhoEFvPatchScalarField.C
deleted file mode 100644
index 08e001240c..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/mixedRhoEFvPatchScalarField.C
+++ /dev/null
@@ -1,194 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#include "mixedRhoEFvPatchScalarField.H"
-#include "addToRunTimeSelectionTable.H"
-#include "fvPatchFieldMapper.H"
-#include "volFields.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
-
-mixedRhoEFvPatchScalarField::mixedRhoEFvPatchScalarField
-(
- const fvPatch& p,
- const DimensionedField& iF
-)
-:
- mixedFvPatchScalarField(p, iF)
-{
- refValue() = 0.0;
- refGrad() = 0.0;
- valueFraction() = 0.0;
-}
-
-
-mixedRhoEFvPatchScalarField::mixedRhoEFvPatchScalarField
-(
- const mixedRhoEFvPatchScalarField& ptf,
- const fvPatch& p,
- const DimensionedField& iF,
- const fvPatchFieldMapper& mapper
-)
-:
- mixedFvPatchScalarField(ptf, p, iF, mapper)
-{}
-
-
-mixedRhoEFvPatchScalarField::mixedRhoEFvPatchScalarField
-(
- const fvPatch& p,
- const DimensionedField& iF,
- const dictionary& dict
-)
-:
- mixedFvPatchScalarField(p, iF)
-{
- if (dict.found("value"))
- {
- fvPatchField::operator=
- (
- scalarField("value", dict, p.size())
- );
- }
- else
- {
- fvPatchField::operator=(patchInternalField());
- }
-
- refValue() = *this;
- refGrad() = 0.0;
- valueFraction() = 0.0;
-}
-
-
-mixedRhoEFvPatchScalarField::mixedRhoEFvPatchScalarField
-(
- const mixedRhoEFvPatchScalarField& ptpsf
-)
-:
- mixedFvPatchScalarField(ptpsf)
-{}
-
-
-mixedRhoEFvPatchScalarField::mixedRhoEFvPatchScalarField
-(
- const mixedRhoEFvPatchScalarField& ptpsf,
- const DimensionedField& iF
-)
-:
- mixedFvPatchScalarField(ptpsf, iF)
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
-
-void mixedRhoEFvPatchScalarField::autoMap
-(
- const fvPatchFieldMapper& m
-)
-{
- mixedFvPatchScalarField::autoMap(m);
-}
-
-
-void mixedRhoEFvPatchScalarField::rmap
-(
- const fvPatchField& ptf,
- const labelList& addr
-)
-{
- mixedFvPatchField::rmap(ptf, addr);
-}
-
-
-void mixedRhoEFvPatchScalarField::updateCoeffs()
-{
- if (updated())
- {
- return;
- }
-
- const fvPatchField& rhop =
- patch().lookupPatchField("rho");
- const fvPatchField& rhoUp =
- patch().lookupPatchField("rhoU");
-// fvPatchField& Tp =
-// patch().lookupPatchField("T");
-
- const volScalarField& T = db().lookupObject("T");
- const label patchi = patch().index();
- fvPatchScalarField& Tp =
- const_cast(T.boundaryField()[patchi]);
-
- Tp.evaluate();
-
- const dictionary& thermodynamicProperties = db().lookupObject
- (
- "thermodynamicProperties"
- );
-
- dimensionedScalar Cv(thermodynamicProperties.lookup("Cv"));
-
- valueFraction() = rhop.snGrad()/
- (rhop.snGrad() - rhop*this->patch().deltaCoeffs());
-
- refValue() = 0.5*rhop*magSqr(rhoUp/rhop);
- refGrad() =
- rhop*Cv.value()*Tp.snGrad()
- + (
- refValue()
- - (0.5*rhop.patchInternalField()*
- magSqr(rhoUp.patchInternalField()/rhop.patchInternalField()))
- )*patch().deltaCoeffs();
-
- mixedFvPatchScalarField::updateCoeffs();
-}
-
-
-void mixedRhoEFvPatchScalarField::write(Ostream& os) const
-{
- fvPatchScalarField::write(os);
- os.writeKeyword("valueFraction") << valueFraction()
- << token::END_STATEMENT << endl;
- os.writeKeyword("refValue") << refValue() << token::END_STATEMENT << endl;
- os.writeKeyword("refGrad") << refGrad() << token::END_STATEMENT << endl;
- writeEntry("value", os);
-}
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-makePatchTypeField(fvPatchScalarField, mixedRhoEFvPatchScalarField);
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/mixedRhoEFvPatchScalarField.H b/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/mixedRhoEFvPatchScalarField.H
deleted file mode 100644
index 19fc700411..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoE/mixedRhoEFvPatchScalarField.H
+++ /dev/null
@@ -1,155 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-Class
- Foam::mixedRhoEFvPatchScalarField
-
-Description
-
-SourceFiles
- mixedRhoEFvPatchScalarField.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef mixedRhoEFvPatchScalarFields_H
-#define mixedRhoEFvPatchScalarFields_H
-
-#include "mixedFvPatchFields.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-/*---------------------------------------------------------------------------*\
- Class mixedRhoEFvPatch Declaration
-\*---------------------------------------------------------------------------*/
-
-class mixedRhoEFvPatchScalarField
-:
- public mixedFvPatchScalarField
-{
-
-public:
-
- //- Runtime type information
- TypeName("mixedRhoE");
-
-
- // Constructors
-
- //- Construct from patch and internal field
- mixedRhoEFvPatchScalarField
- (
- const fvPatch&,
- const DimensionedField&
- );
-
- //- Construct from patch, internal field and dictionary
- mixedRhoEFvPatchScalarField
- (
- const fvPatch&,
- const DimensionedField&,
- const dictionary&
- );
-
- //- Construct by mapping given mixedRhoEFvPatchScalarField
- // onto a new patch
- mixedRhoEFvPatchScalarField
- (
- const mixedRhoEFvPatchScalarField&,
- const fvPatch&,
- const DimensionedField&,
- const fvPatchFieldMapper&
- );
-
- //- Construct as copy
- mixedRhoEFvPatchScalarField
- (
- const mixedRhoEFvPatchScalarField&
- );
-
- //- Construct and return a clone
- virtual tmp clone() const
- {
- return tmp
- (
- new mixedRhoEFvPatchScalarField(*this)
- );
- }
-
- //- Construct as copy setting internal field reference
- mixedRhoEFvPatchScalarField
- (
- const mixedRhoEFvPatchScalarField&,
- const DimensionedField&
- );
-
- //- Construct and return a clone setting internal field reference
- virtual tmp clone
- (
- const DimensionedField& iF
- ) const
- {
- return tmp
- (
- new mixedRhoEFvPatchScalarField(*this, iF)
- );
- }
-
- // Mapping functions
-
- //- Map (and resize as needed) from self given a mapping object
- virtual void autoMap
- (
- const fvPatchFieldMapper&
- );
-
- //- Reverse map the given fvPatchField onto this fvPatchField
- virtual void rmap
- (
- const fvPatchField&,
- const labelList&
- );
-
-
- // Evaluation functions
-
- //- Update the coefficients associated with the patch field
- virtual void updateCoeffs();
-
-
- //- Write
- virtual void write(Ostream&) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoU/fixedRhoUFvPatchVectorField.C b/applications/solvers/compressible/rhopSonicFoam/BCs/rhoU/fixedRhoUFvPatchVectorField.C
deleted file mode 100644
index 0daa0dd2d5..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoU/fixedRhoUFvPatchVectorField.C
+++ /dev/null
@@ -1,126 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#include "fixedRhoUFvPatchVectorField.H"
-#include "addToRunTimeSelectionTable.H"
-#include "fvPatchFieldMapper.H"
-#include "volFields.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
-
-fixedRhoUFvPatchVectorField::fixedRhoUFvPatchVectorField
-(
- const fvPatch& p,
- const DimensionedField& iF
-)
-:
- fixedValueFvPatchVectorField(p, iF)
-{}
-
-
-fixedRhoUFvPatchVectorField::fixedRhoUFvPatchVectorField
-(
- const fixedRhoUFvPatchVectorField& ptf,
- const fvPatch& p,
- const DimensionedField& iF,
- const fvPatchFieldMapper& mapper
-)
-:
- fixedValueFvPatchVectorField(ptf, p, iF, mapper)
-{}
-
-
-fixedRhoUFvPatchVectorField::fixedRhoUFvPatchVectorField
-(
- const fvPatch& p,
- const DimensionedField& iF,
- const dictionary& dict
-)
-:
- fixedValueFvPatchVectorField(p, iF)
-{}
-
-
-fixedRhoUFvPatchVectorField::fixedRhoUFvPatchVectorField
-(
- const fixedRhoUFvPatchVectorField& tppsf
-)
-:
- fixedValueFvPatchVectorField(tppsf)
-{}
-
-
-fixedRhoUFvPatchVectorField::fixedRhoUFvPatchVectorField
-(
- const fixedRhoUFvPatchVectorField& tppsf,
- const DimensionedField& iF
-)
-:
- fixedValueFvPatchVectorField(tppsf, iF)
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
-
-void fixedRhoUFvPatchVectorField::updateCoeffs()
-{
- if (updated())
- {
- return;
- }
-
- const fvPatchScalarField& rhop =
- patch().lookupPatchField("rho");
-
- const fvPatchVectorField& Up =
- patch().lookupPatchField("U");
-
- operator==(rhop*Up);
-
- fixedValueFvPatchVectorField::updateCoeffs();
-}
-
-
-void fixedRhoUFvPatchVectorField::write(Ostream& os) const
-{
- fvPatchVectorField::write(os);
- writeEntry("value", os);
-}
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-makePatchTypeField(fvPatchVectorField, fixedRhoUFvPatchVectorField);
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoU/fixedRhoUFvPatchVectorField.H b/applications/solvers/compressible/rhopSonicFoam/BCs/rhoU/fixedRhoUFvPatchVectorField.H
deleted file mode 100644
index f548b7c3da..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/BCs/rhoU/fixedRhoUFvPatchVectorField.H
+++ /dev/null
@@ -1,135 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef fixedRhoUFvPatchVectorField_H
-#define fixedRhoUFvPatchVectorField_H
-
-#include "fixedValueFvPatchFields.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-/*---------------------------------------------------------------------------*\
- Class fixedRhoUFvPatch Declaration
-\*---------------------------------------------------------------------------*/
-
-class fixedRhoUFvPatchVectorField
-:
- public fixedValueFvPatchVectorField
-{
-
-public:
-
- //- Runtime type information
- TypeName("fixedRhoU");
-
-
- // Constructors
-
- //- Construct from patch and internal field
- fixedRhoUFvPatchVectorField
- (
- const fvPatch&,
- const DimensionedField&
- );
-
- //- Construct from patch, internal field and dictionary
- fixedRhoUFvPatchVectorField
- (
- const fvPatch&,
- const DimensionedField&,
- const dictionary&
- );
-
- //- Construct by mapping given fixedRhoUFvPatchVectorField
- // onto a new patch
- fixedRhoUFvPatchVectorField
- (
- const fixedRhoUFvPatchVectorField&,
- const fvPatch&,
- const DimensionedField&,
- const fvPatchFieldMapper&
- );
-
- //- Construct as copy
- fixedRhoUFvPatchVectorField
- (
- const fixedRhoUFvPatchVectorField&
- );
-
- //- Construct and return a clone
- virtual tmp clone() const
- {
- return tmp
- (
- new fixedRhoUFvPatchVectorField(*this)
- );
- }
-
- //- Construct as copy setting internal field reference
- fixedRhoUFvPatchVectorField
- (
- const fixedRhoUFvPatchVectorField&,
- const DimensionedField&
- );
-
- //- Construct and return a clone setting internal field reference
- virtual tmp clone
- (
- const DimensionedField& iF
- ) const
- {
- return tmp
- (
- new fixedRhoUFvPatchVectorField(*this, iF)
- );
- }
-
-
- // Member functions
-
- // Access
-
- // Evaluation functions
-
- //- Update the coefficients associated with the patch field
- virtual void updateCoeffs();
-
- //- Write
- virtual void write(Ostream&) const;
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/applications/solvers/compressible/rhopSonicFoam/Make/files b/applications/solvers/compressible/rhopSonicFoam/Make/files
deleted file mode 100644
index e751786c41..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/Make/files
+++ /dev/null
@@ -1,3 +0,0 @@
-rhopSonicFoam.C
-
-EXE = $(FOAM_APPBIN)/rhopSonicFoam
diff --git a/applications/solvers/compressible/rhopSonicFoam/Make/options b/applications/solvers/compressible/rhopSonicFoam/Make/options
deleted file mode 100644
index 31374b9af4..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/Make/options
+++ /dev/null
@@ -1,7 +0,0 @@
-EXE_INC = \
- -I$(LIB_SRC)/finiteVolume/lnInclude \
- -IBCs/lnInclude
-
-EXE_LIBS = \
- -lfiniteVolume \
- -lrhopSonicFoam
diff --git a/applications/solvers/compressible/rhopSonicFoam/boundaryTypes.H b/applications/solvers/compressible/rhopSonicFoam/boundaryTypes.H
deleted file mode 100644
index 7d314cd110..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/boundaryTypes.H
+++ /dev/null
@@ -1,7 +0,0 @@
-#include "fixedGradientFvPatchFields.H"
-#include "zeroGradientFvPatchFields.H"
-#include "fixedRhoFvPatchScalarField.H"
-#include "gradientRhoFvPatchScalarField.H"
-#include "fixedRhoEFvPatchScalarField.H"
-#include "mixedRhoEFvPatchScalarField.H"
-#include "fixedRhoUFvPatchVectorField.H"
diff --git a/applications/solvers/compressible/rhopSonicFoam/compressibleCreatePhi.H b/applications/solvers/compressible/rhopSonicFoam/compressibleCreatePhi.H
deleted file mode 100644
index 262ceebc05..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/compressibleCreatePhi.H
+++ /dev/null
@@ -1,54 +0,0 @@
- IOobject phiHeader
- (
- "phi",
- runTime.timeName(),
- mesh,
- IOobject::NO_READ
- );
-
-
- surfaceScalarField* phiPtr;
-
- if (phiHeader.headerOk())
- {
- Info<< "Reading face flux field phi\n" << endl;
-
- phiPtr = new surfaceScalarField
- (
- IOobject
- (
- "phi",
- runTime.timeName(),
- mesh,
- IOobject::MUST_READ,
- IOobject::AUTO_WRITE
- ),
- mesh
- );
- }
- else
- {
- Info<< "Calculating face flux field phi\n" << endl;
-
- wordList phiTypes
- (
- rhoU.boundaryField().size(),
- calculatedFvPatchScalarField::typeName
- );
-
- phiPtr = new surfaceScalarField
- (
- IOobject
- (
- "phi",
- runTime.timeName(),
- mesh,
- IOobject::NO_READ,
- IOobject::AUTO_WRITE
- ),
- linearInterpolate(rhoU) & mesh.Sf(),
- phiTypes
- );
- }
-
- surfaceScalarField& phi = *phiPtr;
diff --git a/applications/solvers/compressible/rhopSonicFoam/createFields.H b/applications/solvers/compressible/rhopSonicFoam/createFields.H
deleted file mode 100644
index fed8432711..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/createFields.H
+++ /dev/null
@@ -1,129 +0,0 @@
- Info<< "Reading field p\n" << endl;
- volScalarField p
- (
- IOobject
- (
- "p",
- runTime.timeName(),
- mesh,
- IOobject::MUST_READ,
- IOobject::AUTO_WRITE
- ),
- mesh
- );
- p.oldTime();
-
- Info<< "Reading field T\n" << endl;
- volScalarField T
- (
- IOobject
- (
- "T",
- runTime.timeName(),
- mesh,
- IOobject::MUST_READ,
- IOobject::AUTO_WRITE
- ),
- mesh
- );
- T.correctBoundaryConditions();
-
- volScalarField psi
- (
- IOobject
- (
- "psi",
- runTime.timeName(),
- mesh,
- IOobject::NO_READ,
- IOobject::AUTO_WRITE
- ),
- 1.0/(R*T)
- );
- psi.oldTime();
-
-# include "rhoBoundaryTypes.H"
- volScalarField rho
- (
- IOobject
- (
- "rho",
- runTime.timeName(),
- mesh,
- IOobject::NO_READ,
- IOobject::AUTO_WRITE
- ),
- p*psi,
- rhoBoundaryTypes
- );
-
- Info<< "Reading field U\n" << endl;
- volVectorField U
- (
- IOobject
- (
- "U",
- runTime.timeName(),
- mesh,
- IOobject::MUST_READ,
- IOobject::AUTO_WRITE
- ),
- mesh
- );
-
-# include "rhoUboundaryTypes.H"
- volVectorField rhoU
- (
- IOobject
- (
- "rhoU",
- runTime.timeName(),
- mesh,
- IOobject::NO_READ,
- IOobject::AUTO_WRITE
- ),
- rho*U,
- rhoUboundaryTypes
- );
-
-# include "rhoEboundaryTypes.H"
- volScalarField rhoE
- (
- IOobject
- (
- "rhoE",
- runTime.timeName(),
- mesh,
- IOobject::NO_READ,
- IOobject::AUTO_WRITE
- ),
- rho*Cv*T + 0.5*rho*magSqr(rhoU/rho),
- rhoEboundaryTypes
- );
-
-# include "compressibleCreatePhi.H"
- phi.oldTime();
-
- surfaceScalarField phiv
- (
- IOobject
- (
- "phiv",
- runTime.timeName(),
- mesh
- ),
- phi/linearInterpolate(rho),
- phi.boundaryField().types()
- );
-
- rhoU.correctBoundaryConditions();
-
- multivariateSurfaceInterpolationScheme::fieldTable fields;
-
- volScalarField magRhoU = mag(rhoU);
- volScalarField H("H", (rhoE + p)/rho);
-
- fields.add(rho);
- fields.add(magRhoU);
- fields.add(H);
-
diff --git a/applications/solvers/compressible/rhopSonicFoam/readThermodynamicProperties.H b/applications/solvers/compressible/rhopSonicFoam/readThermodynamicProperties.H
deleted file mode 100644
index 2064187a2f..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/readThermodynamicProperties.H
+++ /dev/null
@@ -1,38 +0,0 @@
- Info<< "Reading thermodynamicProperties\n" << endl;
-
- IOdictionary thermodynamicProperties
- (
- IOobject
- (
- "thermodynamicProperties",
- runTime.constant(),
- mesh,
- IOobject::MUST_READ_IF_MODIFIED,
- IOobject::NO_WRITE
- )
- );
-
- dimensionedScalar R
- (
- thermodynamicProperties.lookup("R")
- );
-
- dimensionedScalar Cv
- (
- thermodynamicProperties.lookup("Cv")
- );
-
- dimensionedScalar Cp = Cv + R;
-
- dimensionedScalar gamma = Cp/Cv;
-
- dimensionedScalar Pr
- (
- dimensionedScalar::lookupOrDefault
- (
- "Pr",
- thermodynamicProperties,
- 1.0
- )
- );
-
diff --git a/applications/solvers/compressible/rhopSonicFoam/resetPhiPatches.H b/applications/solvers/compressible/rhopSonicFoam/resetPhiPatches.H
deleted file mode 100644
index 2a8496ef4c..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/resetPhiPatches.H
+++ /dev/null
@@ -1,19 +0,0 @@
-surfaceScalarField::GeometricBoundaryField& phiPatches =
- phi.boundaryField();
-
-const volVectorField::GeometricBoundaryField& rhoUpatches =
- rhoU.boundaryField();
-
-const surfaceVectorField::GeometricBoundaryField& SfPatches =
- mesh.Sf().boundaryField();
-
-forAll(phiPatches, patchI)
-{
- if (phi.boundaryField().types()[patchI] == "calculated")
- {
- calculatedFvsPatchScalarField& phiPatch =
- refCast(phiPatches[patchI]);
-
- phiPatch == (rhoUpatches[patchI] & SfPatches[patchI]);
- }
-}
diff --git a/applications/solvers/compressible/rhopSonicFoam/rhoBoundaryTypes.H b/applications/solvers/compressible/rhopSonicFoam/rhoBoundaryTypes.H
deleted file mode 100644
index f54d066311..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/rhoBoundaryTypes.H
+++ /dev/null
@@ -1,21 +0,0 @@
-const volScalarField::GeometricBoundaryField& pbf = p.boundaryField();
-wordList rhoBoundaryTypes = pbf.types();
-
-forAll(rhoBoundaryTypes, patchi)
-{
- if
- (
- rhoBoundaryTypes[patchi] == "pressureTransmissive"
- )
- {
- rhoBoundaryTypes[patchi] = zeroGradientFvPatchScalarField::typeName;
- }
- else if (pbf[patchi].fixesValue())
- {
- rhoBoundaryTypes[patchi] = fixedRhoFvPatchScalarField::typeName;
- }
- else
- {
- rhoBoundaryTypes[patchi] = gradientRhoFvPatchScalarField::typeName;
- }
-}
diff --git a/applications/solvers/compressible/rhopSonicFoam/rhoEboundaryTypes.H b/applications/solvers/compressible/rhopSonicFoam/rhoEboundaryTypes.H
deleted file mode 100644
index 84e08b29ed..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/rhoEboundaryTypes.H
+++ /dev/null
@@ -1,14 +0,0 @@
-const volScalarField::GeometricBoundaryField& Tbf = T.boundaryField();
-wordList rhoEboundaryTypes = Tbf.types();
-
-forAll(rhoEboundaryTypes, patchi)
-{
- if (Tbf[patchi].fixesValue())
- {
- rhoEboundaryTypes[patchi] = fixedRhoEFvPatchScalarField::typeName;
- }
- else
- {
- rhoEboundaryTypes[patchi] = mixedRhoEFvPatchScalarField::typeName;
- }
-}
diff --git a/applications/solvers/compressible/rhopSonicFoam/rhoUboundaryTypes.H b/applications/solvers/compressible/rhopSonicFoam/rhoUboundaryTypes.H
deleted file mode 100644
index c03b959d26..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/rhoUboundaryTypes.H
+++ /dev/null
@@ -1,10 +0,0 @@
-const volVectorField::GeometricBoundaryField& Ubf = U.boundaryField();
-wordList rhoUboundaryTypes = Ubf.types();
-
-forAll(rhoUboundaryTypes, patchi)
-{
- if (Ubf[patchi].fixesValue())
- {
- rhoUboundaryTypes[patchi] = fixedRhoUFvPatchVectorField::typeName;
- }
-}
diff --git a/applications/solvers/compressible/rhopSonicFoam/rhopSonicFoam.C b/applications/solvers/compressible/rhopSonicFoam/rhopSonicFoam.C
deleted file mode 100644
index 1f561e0709..0000000000
--- a/applications/solvers/compressible/rhopSonicFoam/rhopSonicFoam.C
+++ /dev/null
@@ -1,191 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
- \\/ M anipulation |
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 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 .
-
-Application
- rhopSonicFoam
-
-Description
- Pressure-density-based compressible flow solver.
-
-\*---------------------------------------------------------------------------*/
-
-#include "fvCFD.H"
-#include "weighted.H"
-#include "gaussConvectionScheme.H"
-#include "multivariateGaussConvectionScheme.H"
-#include "MUSCL.H"
-#include "LimitedScheme.H"
-#include "boundaryTypes.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-int main(int argc, char *argv[])
-{
- #include "setRootCase.H"
- #include "createTime.H"
- #include "createMesh.H"
- #include "readThermodynamicProperties.H"
- #include "createFields.H"
-
- // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
- Info<< "\nStarting time loop\n" << endl;
-
- while (runTime.loop())
- {
- Info<< "Time = " << runTime.value() << nl << endl;
-
- #include "readPISOControls.H"
- scalar HbyAblend = readScalar(piso.lookup("HbyAblend"));
-
- #include "readTimeControls.H"
-
- scalar CoNum = max
- (
- mesh.surfaceInterpolation::deltaCoeffs()
- *mag(phiv)/mesh.magSf()
- ).value()*runTime.deltaTValue();
-
- Info<< "Max Courant Number = " << CoNum << endl;
-
- #include "setDeltaT.H"
-
- for (int outerCorr=0; outerCorr mvConvection
- (
- mesh,
- fields,
- phiv,
- mesh.divScheme("div(phiv,rhoUH)")
- );
-
- solve
- (
- fvm::ddt(rho)
- + mvConvection.fvmDiv(phiv, rho)
- );
-
- surfaceScalarField rhoUWeights =
- mvConvection.interpolationScheme()()(magRhoU)()
- .weights(magRhoU);
-
- weighted rhoUScheme(rhoUWeights);
-
- fvVectorMatrix rhoUEqn
- (
- fvm::ddt(rhoU)
- + fv::gaussConvectionScheme(mesh, phiv, rhoUScheme)
- .fvmDiv(phiv, rhoU)
- );
-
- solve(rhoUEqn == -fvc::grad(p));
-
- solve
- (
- fvm::ddt(rhoE)
- + mvConvection.fvmDiv(phiv, rhoE)
- ==
- - mvConvection.fvcDiv(phiv, p)
- );
-
- T = (rhoE - 0.5*rho*magSqr(rhoU/rho))/Cv/rho;
- psi = 1.0/(R*T);
- p = rho/psi;
-
- for (int corr=0; corr, limitFuncs::magSqr>
- (mesh, phi, IStringStream("HbyA")()).weights(HbyA);
-
- phi =
- (
- surfaceInterpolationScheme::interpolate
- (HbyA, HbyAWeights) & mesh.Sf()
- )
- + HbyAblend*fvc::ddtPhiCorr(rrhoUA, rho, rhoU, phi);
-
- p.boundaryField().updateCoeffs();
-
- surfaceScalarField phiGradp =
- rrhoUAf*mesh.magSf()*fvc::snGrad(p);
-
- phi -= phiGradp;
-
- #include "resetPhiPatches.H"
-
- surfaceScalarField rhof =
- mvConvection.interpolationScheme()()(rho)()
- .interpolate(rho);
-
- phiv = phi/rhof;
-
- fvScalarMatrix pEqn
- (
- fvm::ddt(psi, p)
- + mvConvection.fvcDiv(phiv, rho)
- + fvc::div(phiGradp)
- - fvm::laplacian(rrhoUAf, p)
- );
-
- pEqn.solve();
-
- phi += phiGradp + pEqn.flux();
- rho = psi*p;
- rhof =
- mvConvection.interpolationScheme()()(rho)()
- .interpolate(rho);
- phiv = phi/rhof;
-
- rhoU = HbyA - rrhoUA*fvc::grad(p);
- rhoU.correctBoundaryConditions();
- }
- }
-
- U = rhoU/rho;
-
- runTime.write();
-
- Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s"
- << " ClockTime = " << runTime.elapsedClockTime() << " s"
- << nl << endl;
- }
-
- Info<< "End\n" << endl;
-
- return 0;
-}
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/forwardStep/0/T b/tutorials/compressible/rhoSonicFoam/forwardStep/0/T
deleted file mode 100644
index 671ebd8290..0000000000
--- a/tutorials/compressible/rhoSonicFoam/forwardStep/0/T
+++ /dev/null
@@ -1,55 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object T;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 0 0 1 0 0 0];
-
-internalField uniform 1;
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform 1;
- }
-
- outlet
- {
- type zeroGradient;
- }
-
- bottom
- {
- type symmetryPlane;
- }
-
- top
- {
- type symmetryPlane;
- }
-
- obstacle
- {
- type zeroGradient;
- }
-
- defaultFaces
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/forwardStep/0/U b/tutorials/compressible/rhoSonicFoam/forwardStep/0/U
deleted file mode 100644
index 770dd65cac..0000000000
--- a/tutorials/compressible/rhoSonicFoam/forwardStep/0/U
+++ /dev/null
@@ -1,56 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- object U;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform (3 0 0);
- }
-
- outlet
- {
- type zeroGradient;
- }
-
- bottom
- {
- type symmetryPlane;
- }
-
- top
- {
- type symmetryPlane;
- }
-
- obstacle
- {
- type fixedValue;
- value uniform (0 0 0);
- }
-
- defaultFaces
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/forwardStep/0/p b/tutorials/compressible/rhoSonicFoam/forwardStep/0/p
deleted file mode 100644
index cc6d55668f..0000000000
--- a/tutorials/compressible/rhoSonicFoam/forwardStep/0/p
+++ /dev/null
@@ -1,55 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object p;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [1 -1 -2 0 0 0 0];
-
-internalField uniform 1;
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform 1;
- }
-
- outlet
- {
- type zeroGradient;
- }
-
- bottom
- {
- type symmetryPlane;
- }
-
- top
- {
- type symmetryPlane;
- }
-
- obstacle
- {
- type zeroGradient;
- }
-
- defaultFaces
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/forwardStep/constant/polyMesh/blockMeshDict b/tutorials/compressible/rhoSonicFoam/forwardStep/constant/polyMesh/blockMeshDict
deleted file mode 100644
index 4bd2ff24bb..0000000000
--- a/tutorials/compressible/rhoSonicFoam/forwardStep/constant/polyMesh/blockMeshDict
+++ /dev/null
@@ -1,81 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- object blockMeshDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-convertToMeters 1;
-
-vertices
-(
- (0 0 -0.05)
- (0.6 0 -0.05)
- (0 0.2 -0.05)
- (0.6 0.2 -0.05)
- (3 0.2 -0.05)
- (0 1 -0.05)
- (0.6 1 -0.05)
- (3 1 -0.05)
- (0 0 0.05)
- (0.6 0 0.05)
- (0 0.2 0.05)
- (0.6 0.2 0.05)
- (3 0.2 0.05)
- (0 1 0.05)
- (0.6 1 0.05)
- (3 1 0.05)
-);
-
-blocks
-(
- hex (0 1 3 2 8 9 11 10) (25 10 1) simpleGrading (1 1 1)
- hex (2 3 6 5 10 11 14 13) (25 40 1) simpleGrading (1 1 1)
- hex (3 4 7 6 11 12 15 14) (100 40 1) simpleGrading (1 1 1)
-);
-
-edges
-(
-);
-
-patches
-(
- patch inlet
- (
- (0 8 10 2)
- (2 10 13 5)
- )
- patch outlet
- (
- (4 7 15 12)
- )
- symmetryPlane bottom
- (
- (0 1 9 8)
- )
- symmetryPlane top
- (
- (5 13 14 6)
- (6 14 15 7)
- )
- patch obstacle
- (
- (1 3 11 9)
- (3 4 12 11)
- )
-);
-
-mergePatchPairs
-(
-);
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/forwardStep/constant/polyMesh/boundary b/tutorials/compressible/rhoSonicFoam/forwardStep/constant/polyMesh/boundary
deleted file mode 100644
index 2df2506419..0000000000
--- a/tutorials/compressible/rhoSonicFoam/forwardStep/constant/polyMesh/boundary
+++ /dev/null
@@ -1,58 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class polyBoundaryMesh;
- location "constant/polyMesh";
- object boundary;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-6
-(
- inlet
- {
- type patch;
- nFaces 50;
- startFace 10325;
- }
- outlet
- {
- type patch;
- nFaces 40;
- startFace 10375;
- }
- bottom
- {
- type symmetryPlane;
- nFaces 25;
- startFace 10415;
- }
- top
- {
- type symmetryPlane;
- nFaces 125;
- startFace 10440;
- }
- obstacle
- {
- type patch;
- nFaces 110;
- startFace 10565;
- }
- defaultFaces
- {
- type empty;
- nFaces 10500;
- startFace 10675;
- }
-)
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/forwardStep/constant/thermodynamicProperties b/tutorials/compressible/rhoSonicFoam/forwardStep/constant/thermodynamicProperties
deleted file mode 100644
index 7bd2784a27..0000000000
--- a/tutorials/compressible/rhoSonicFoam/forwardStep/constant/thermodynamicProperties
+++ /dev/null
@@ -1,25 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "constant";
- object thermodynamicProperties;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-// Note: these are the properties for a "normalised" inviscid gas
-// for which the speed of sound is 1 m/s at a temperature of 1K
-// and gamma = 7/5
-Cv Cv [ 0 2 -2 -1 0 0 0 ] 1.78571;
-R R [ 0 2 -2 -1 0 0 0 ] 0.714286;
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/forwardStep/system/controlDict b/tutorials/compressible/rhoSonicFoam/forwardStep/system/controlDict
deleted file mode 100644
index 6367d61bd9..0000000000
--- a/tutorials/compressible/rhoSonicFoam/forwardStep/system/controlDict
+++ /dev/null
@@ -1,49 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object controlDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-application rhoSonicFoam;
-
-startFrom latestTime;
-
-startTime 0;
-
-stopAt endTime;
-
-endTime 10;
-
-deltaT 0.002;
-
-writeControl runTime;
-
-writeInterval 0.5;
-
-purgeWrite 0;
-
-writeFormat ascii;
-
-writePrecision 6;
-
-writeCompression off;
-
-timeFormat general;
-
-timePrecision 6;
-
-runTimeModifiable true;
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/forwardStep/system/fvSchemes b/tutorials/compressible/rhoSonicFoam/forwardStep/system/fvSchemes
deleted file mode 100644
index ae636017e6..0000000000
--- a/tutorials/compressible/rhoSonicFoam/forwardStep/system/fvSchemes
+++ /dev/null
@@ -1,61 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSchemes;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-ddtSchemes
-{
- default Euler;
-}
-
-gradSchemes
-{
- default Gauss linear;
- grad(p) Gauss linear;
- grad(U) Gauss linear;
-}
-
-divSchemes
-{
- default none;
- div(phiv,rho) Gauss limitedLinear 1;
- div(phiv,rhoU) Gauss limitedLinearV 1;
- div(phiv2,p) Gauss limitedLinear 1;
- div(phiv,rhoE) Gauss limitedLinear 1;
-}
-
-laplacianSchemes
-{
- default none;
-}
-
-interpolationSchemes
-{
- default linear;
-}
-
-snGradSchemes
-{
- default corrected;
-}
-
-fluxRequired
-{
- default no;
- p ;
-}
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/forwardStep/system/fvSolution b/tutorials/compressible/rhoSonicFoam/forwardStep/system/fvSolution
deleted file mode 100644
index 5b4f5e1b3f..0000000000
--- a/tutorials/compressible/rhoSonicFoam/forwardStep/system/fvSolution
+++ /dev/null
@@ -1,36 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSolution;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-solvers
-{
- "(p|rho|rhoU|rhoE)"
- {
- solver PBiCG;
- preconditioner DILU;
- tolerance 1e-15;
- relTol 0;
- }
-}
-
-PISO
-{
- nCorrectors 2;
- nNonOrthogonalCorrectors 0;
-}
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/0.org/T b/tutorials/compressible/rhoSonicFoam/shockTube/0.org/T
deleted file mode 100644
index fd68f87eb2..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/0.org/T
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object T;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 0 0 1 0 0 0];
-
-internalField uniform 1;
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
-
- empty
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/0.org/U b/tutorials/compressible/rhoSonicFoam/shockTube/0.org/U
deleted file mode 100644
index 28f81e3419..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/0.org/U
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- object U;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
-
- empty
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/0.org/magU b/tutorials/compressible/rhoSonicFoam/shockTube/0.org/magU
deleted file mode 100644
index ba95542364..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/0.org/magU
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object magU;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform 0;
-
-boundaryField
-{
- sides
- {
- type calculated;
- value uniform 0;
- }
- empty
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/0.org/p b/tutorials/compressible/rhoSonicFoam/shockTube/0.org/p
deleted file mode 100644
index 1840a65651..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/0.org/p
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object p;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [1 -1 -2 0 0 0 0];
-
-internalField uniform 0;
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
-
- empty
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/0/T b/tutorials/compressible/rhoSonicFoam/shockTube/0/T
deleted file mode 100644
index ead0f78111..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/0/T
+++ /dev/null
@@ -1,1039 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- location "0";
- object T;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 0 0 1 0 0 0];
-
-internalField nonuniform List
-1000
-(
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-348.432
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-278.746
-)
-;
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
- empty
- {
- type empty;
- }
-}
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/0/U b/tutorials/compressible/rhoSonicFoam/shockTube/0/U
deleted file mode 100644
index 00e122b9c2..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/0/U
+++ /dev/null
@@ -1,35 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- location "0";
- object U;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
- empty
- {
- type empty;
- }
-}
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/0/magU b/tutorials/compressible/rhoSonicFoam/shockTube/0/magU
deleted file mode 100644
index ba95542364..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/0/magU
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object magU;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform 0;
-
-boundaryField
-{
- sides
- {
- type calculated;
- value uniform 0;
- }
- empty
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/0/p b/tutorials/compressible/rhoSonicFoam/shockTube/0/p
deleted file mode 100644
index 71626a5eff..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/0/p
+++ /dev/null
@@ -1,1039 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- location "0";
- object p;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [1 -1 -2 0 0 0 0];
-
-internalField nonuniform List
-1000
-(
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-100000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-10000
-)
-;
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
- empty
- {
- type empty;
- }
-}
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/Allrun b/tutorials/compressible/rhoSonicFoam/shockTube/Allrun
deleted file mode 100755
index de4d74c9da..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/Allrun
+++ /dev/null
@@ -1,15 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # run from this directory
-
-
-# Source tutorial run functions
-. $WM_PROJECT_DIR/bin/tools/RunFunctions
-
-# Get application name
-application=`getApplication`
-
-runApplication blockMesh
-runApplication setFields
-runApplication $application
-
-# ----------------------------------------------------------------- end-of-file
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/constant/initProperties b/tutorials/compressible/rhoSonicFoam/shockTube/constant/initProperties
deleted file mode 100644
index a5c8ff6346..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/constant/initProperties
+++ /dev/null
@@ -1,33 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "constant";
- object initProperties;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-x0 0;
-
-pL 100000;
-
-TL 348.432;
-
-UL ( 0 0 0 );
-
-pR 10000;
-
-TR 278.746;
-
-UR ( 0 0 0 );
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/constant/polyMesh/blockMeshDict b/tutorials/compressible/rhoSonicFoam/shockTube/constant/polyMesh/blockMeshDict
deleted file mode 100644
index e6c07638e4..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/constant/polyMesh/blockMeshDict
+++ /dev/null
@@ -1,60 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- object blockMeshDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-convertToMeters 1;
-
-vertices
-(
- (-5 -1 -1)
- (5 -1 -1)
- (5 1 -1)
- (-5 1 -1)
- (-5 -1 1)
- (5 -1 1)
- (5 1 1)
- (-5 1 1)
-);
-
-blocks
-(
- hex (0 1 2 3 4 5 6 7) (1000 1 1) simpleGrading (1 1 1)
-);
-
-edges
-(
-);
-
-patches
-(
- patch sides
- (
- (1 2 6 5)
- (0 4 7 3)
- )
- empty empty
- (
- (0 1 5 4)
- (5 6 7 4)
- (3 7 6 2)
- (0 3 2 1)
- )
-);
-
-mergePatchPairs
-(
-);
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/constant/polyMesh/boundary b/tutorials/compressible/rhoSonicFoam/shockTube/constant/polyMesh/boundary
deleted file mode 100644
index dc71e553cc..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/constant/polyMesh/boundary
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class polyBoundaryMesh;
- location "constant/polyMesh";
- object boundary;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-2
-(
- sides
- {
- type patch;
- nFaces 2;
- startFace 999;
- }
- empty
- {
- type empty;
- nFaces 4000;
- startFace 1001;
- }
-)
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/constant/thermodynamicProperties b/tutorials/compressible/rhoSonicFoam/shockTube/constant/thermodynamicProperties
deleted file mode 100644
index 991ed58a75..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/constant/thermodynamicProperties
+++ /dev/null
@@ -1,23 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "constant";
- object thermodynamicProperties;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-Cv Cv [ 0 2 -2 -1 0 0 0 ] 717.5;
-
-R R [ 0 2 -2 -1 0 0 0 ] 287;
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/system/controlDict b/tutorials/compressible/rhoSonicFoam/shockTube/system/controlDict
deleted file mode 100644
index 44ad467192..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/system/controlDict
+++ /dev/null
@@ -1,49 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object controlDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-application rhoSonicFoam;
-
-startFrom startTime;
-
-startTime 0;
-
-stopAt endTime;
-
-endTime 0.007;
-
-deltaT 1e-05;
-
-writeControl runTime;
-
-writeInterval 0.001;
-
-purgeWrite 0;
-
-writeFormat ascii;
-
-writePrecision 6;
-
-writeCompression off;
-
-timeFormat general;
-
-timePrecision 6;
-
-runTimeModifiable true;
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/system/fvSchemes b/tutorials/compressible/rhoSonicFoam/shockTube/system/fvSchemes
deleted file mode 100644
index ae636017e6..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/system/fvSchemes
+++ /dev/null
@@ -1,61 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSchemes;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-ddtSchemes
-{
- default Euler;
-}
-
-gradSchemes
-{
- default Gauss linear;
- grad(p) Gauss linear;
- grad(U) Gauss linear;
-}
-
-divSchemes
-{
- default none;
- div(phiv,rho) Gauss limitedLinear 1;
- div(phiv,rhoU) Gauss limitedLinearV 1;
- div(phiv2,p) Gauss limitedLinear 1;
- div(phiv,rhoE) Gauss limitedLinear 1;
-}
-
-laplacianSchemes
-{
- default none;
-}
-
-interpolationSchemes
-{
- default linear;
-}
-
-snGradSchemes
-{
- default corrected;
-}
-
-fluxRequired
-{
- default no;
- p ;
-}
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/system/fvSolution b/tutorials/compressible/rhoSonicFoam/shockTube/system/fvSolution
deleted file mode 100644
index 5b4f5e1b3f..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/system/fvSolution
+++ /dev/null
@@ -1,36 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSolution;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-solvers
-{
- "(p|rho|rhoU|rhoE)"
- {
- solver PBiCG;
- preconditioner DILU;
- tolerance 1e-15;
- relTol 0;
- }
-}
-
-PISO
-{
- nCorrectors 2;
- nNonOrthogonalCorrectors 0;
-}
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/system/sampleDict b/tutorials/compressible/rhoSonicFoam/shockTube/system/sampleDict
deleted file mode 100644
index 5c511b54cb..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/system/sampleDict
+++ /dev/null
@@ -1,39 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object sampleDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-interpolationScheme cellPoint;
-
-setFormat raw;
-
-sets
-(
- data
- {
- type uniform;
- axis x;
- start ( -4.995 0 0 );
- end ( 4.995 0 0 );
- nPoints 1000;
- }
-);
-
-surfaces ();
-
-fields ( T magU p );
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/system/setFieldsDict b/tutorials/compressible/rhoSonicFoam/shockTube/system/setFieldsDict
deleted file mode 100644
index 3274c7f7da..0000000000
--- a/tutorials/compressible/rhoSonicFoam/shockTube/system/setFieldsDict
+++ /dev/null
@@ -1,23 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object setFieldsDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-defaultFieldValues ( volVectorFieldValue U ( 0 0 0 ) volScalarFieldValue T 348.432 volScalarFieldValue p 100000 );
-
-regions ( boxToCell { box ( 0 -1 -1 ) ( 5 1 1 ) ; fieldValues ( volScalarFieldValue T 278.746 volScalarFieldValue p 10000 ) ; } );
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/0.org/T b/tutorials/compressible/rhopSonicFoam/shockTube/0.org/T
deleted file mode 100644
index fd68f87eb2..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/0.org/T
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object T;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 0 0 1 0 0 0];
-
-internalField uniform 1;
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
-
- empty
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/0.org/U b/tutorials/compressible/rhopSonicFoam/shockTube/0.org/U
deleted file mode 100644
index 28f81e3419..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/0.org/U
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- object U;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
-
- empty
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/0.org/p b/tutorials/compressible/rhopSonicFoam/shockTube/0.org/p
deleted file mode 100644
index 1840a65651..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/0.org/p
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object p;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [1 -1 -2 0 0 0 0];
-
-internalField uniform 0;
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
-
- empty
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/0/T b/tutorials/compressible/rhopSonicFoam/shockTube/0/T
deleted file mode 100644
index fd68f87eb2..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/0/T
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object T;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 0 0 1 0 0 0];
-
-internalField uniform 1;
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
-
- empty
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/0/U b/tutorials/compressible/rhopSonicFoam/shockTube/0/U
deleted file mode 100644
index 28f81e3419..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/0/U
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- object U;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform (0 0 0);
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
-
- empty
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/0/p b/tutorials/compressible/rhopSonicFoam/shockTube/0/p
deleted file mode 100644
index 1840a65651..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/0/p
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object p;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [1 -1 -2 0 0 0 0];
-
-internalField uniform 0;
-
-boundaryField
-{
- sides
- {
- type zeroGradient;
- }
-
- empty
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/Allclean b/tutorials/compressible/rhopSonicFoam/shockTube/Allclean
deleted file mode 100755
index 5c160040dc..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/Allclean
+++ /dev/null
@@ -1,11 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # run from this directory
-
-# Source tutorial clean functions
-. $WM_PROJECT_DIR/bin/tools/CleanFunctions
-
-rm -rf 0
-cp -r 0.org 0
-cleanCase
-
-# ----------------------------------------------------------------- end-of-file
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/Allrun b/tutorials/compressible/rhopSonicFoam/shockTube/Allrun
deleted file mode 100755
index 7b90a31601..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/Allrun
+++ /dev/null
@@ -1,13 +0,0 @@
-#!/bin/sh
-cd ${0%/*} || exit 1 # run from this directory
-
-# Source tutorial run functions
-. $WM_PROJECT_DIR/bin/tools/RunFunctions
-
-application=`getApplication`
-
-runApplication blockMesh
-runApplication setFields
-runApplication $application
-
-# ----------------------------------------------------------------- end-of-file
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/constant/polyMesh/blockMeshDict b/tutorials/compressible/rhopSonicFoam/shockTube/constant/polyMesh/blockMeshDict
deleted file mode 100644
index 46397257ae..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/constant/polyMesh/blockMeshDict
+++ /dev/null
@@ -1,60 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- object blockMeshDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-convertToMeters 1;
-
-vertices
-(
- (-5 -1 -1)
- (5 -1 -1)
- (5 1 -1)
- (-5 1 -1)
- (-5 -1 1)
- (5 -1 1)
- (5 1 1)
- (-5 1 1)
-);
-
-blocks
-(
- hex (0 1 2 3 4 5 6 7) (100 1 1) simpleGrading (1 1 1)
-);
-
-edges
-(
-);
-
-patches
-(
- patch sides
- (
- (1 2 6 5)
- (0 4 7 3)
- )
- empty empty
- (
- (0 1 5 4)
- (5 6 7 4)
- (3 7 6 2)
- (0 3 2 1)
- )
-);
-
-mergePatchPairs
-(
-);
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/constant/polyMesh/boundary b/tutorials/compressible/rhopSonicFoam/shockTube/constant/polyMesh/boundary
deleted file mode 100644
index d8672aafba..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/constant/polyMesh/boundary
+++ /dev/null
@@ -1,34 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class polyBoundaryMesh;
- location "constant/polyMesh";
- object boundary;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-2
-(
- sides
- {
- type patch;
- nFaces 2;
- startFace 99;
- }
- empty
- {
- type empty;
- nFaces 400;
- startFace 101;
- }
-)
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/constant/thermodynamicProperties b/tutorials/compressible/rhopSonicFoam/shockTube/constant/thermodynamicProperties
deleted file mode 100644
index 991ed58a75..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/constant/thermodynamicProperties
+++ /dev/null
@@ -1,23 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "constant";
- object thermodynamicProperties;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-Cv Cv [ 0 2 -2 -1 0 0 0 ] 717.5;
-
-R R [ 0 2 -2 -1 0 0 0 ] 287;
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/system/controlDict b/tutorials/compressible/rhopSonicFoam/shockTube/system/controlDict
deleted file mode 100644
index 58d457daef..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/system/controlDict
+++ /dev/null
@@ -1,55 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object controlDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-application rhopSonicFoam;
-
-startFrom startTime;
-
-startTime 0;
-
-stopAt endTime;
-
-endTime 0.007;
-
-deltaT 2e-05;
-
-writeControl runTime;
-
-writeInterval 0.001;
-
-purgeWrite 0;
-
-writeFormat ascii;
-
-writePrecision 6;
-
-writeCompression off;
-
-timeFormat general;
-
-timePrecision 6;
-
-runTimeModifiable true;
-
-adjustTimeStep no;
-
-maxCo 0.05;
-
-maxDeltaT 1;
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/system/fvSchemes b/tutorials/compressible/rhopSonicFoam/shockTube/system/fvSchemes
deleted file mode 100644
index 9906dc8189..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/system/fvSchemes
+++ /dev/null
@@ -1,56 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSchemes;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-ddtSchemes
-{
- default Euler;
-}
-
-gradSchemes
-{
- default Gauss linear;
-}
-
-divSchemes
-{
- default none;
- div(phiv,rhoUH) vanLeer;
-}
-
-laplacianSchemes
-{
- default Gauss linear corrected;
-}
-
-interpolationSchemes
-{
- default linear;
-}
-
-snGradSchemes
-{
- default corrected;
-}
-
-fluxRequired
-{
- default no;
- p ;
-}
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/system/fvSolution b/tutorials/compressible/rhopSonicFoam/shockTube/system/fvSolution
deleted file mode 100644
index 3c47388266..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/system/fvSolution
+++ /dev/null
@@ -1,45 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSolution;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-solvers
-{
- p
- {
- solver PCG;
- preconditioner DIC;
- tolerance 1e-15;
- relTol 0;
- }
-
- "(rho|rhoU|rhoE|rhoH)"
- {
- solver PBiCG;
- preconditioner DILU;
- tolerance 1e-15;
- relTol 0;
- }
-}
-
-PISO
-{
- nOuterCorrectors 3;
- nCorrectors 1;
- HbyAblend 0;
-}
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/system/setFieldsDict b/tutorials/compressible/rhopSonicFoam/shockTube/system/setFieldsDict
deleted file mode 100644
index 3274c7f7da..0000000000
--- a/tutorials/compressible/rhopSonicFoam/shockTube/system/setFieldsDict
+++ /dev/null
@@ -1,23 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object setFieldsDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-defaultFieldValues ( volVectorFieldValue U ( 0 0 0 ) volScalarFieldValue T 348.432 volScalarFieldValue p 100000 );
-
-regions ( boxToCell { box ( 0 -1 -1 ) ( 5 1 1 ) ; fieldValues ( volScalarFieldValue T 278.746 volScalarFieldValue p 10000 ) ; } );
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/0/T b/tutorials/compressible/rhopSonicFoam/wedge15Ma5/0/T
deleted file mode 100644
index 671ebd8290..0000000000
--- a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/0/T
+++ /dev/null
@@ -1,55 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object T;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 0 0 1 0 0 0];
-
-internalField uniform 1;
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform 1;
- }
-
- outlet
- {
- type zeroGradient;
- }
-
- bottom
- {
- type symmetryPlane;
- }
-
- top
- {
- type symmetryPlane;
- }
-
- obstacle
- {
- type zeroGradient;
- }
-
- defaultFaces
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/0/U b/tutorials/compressible/rhopSonicFoam/wedge15Ma5/0/U
deleted file mode 100644
index 1c80b16381..0000000000
--- a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/0/U
+++ /dev/null
@@ -1,57 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volVectorField;
- object U;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [0 1 -1 0 0 0 0];
-
-internalField uniform (5 0 0);
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform (5 0 0);
- }
-
- outlet
- {
- type zeroGradient;
- //type inletOutlet;
- //inletValue uniform (0 0 0);
- }
-
- bottom
- {
- type symmetryPlane;
- }
-
- top
- {
- type symmetryPlane;
- }
-
- obstacle
- {
- type slip;
- }
-
- defaultFaces
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/0/p b/tutorials/compressible/rhopSonicFoam/wedge15Ma5/0/p
deleted file mode 100644
index 2890a56400..0000000000
--- a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/0/p
+++ /dev/null
@@ -1,57 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class volScalarField;
- object p;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-dimensions [1 -1 -2 0 0 0 0];
-
-internalField uniform 1;
-
-boundaryField
-{
- inlet
- {
- type fixedValue;
- value uniform 1;
- }
-
- outlet
- {
- type zeroGradient;
- }
-
- bottom
- {
- type symmetryPlane;
- }
-
- top
- {
- type symmetryPlane;
- }
-
- obstacle
- {
- type inviscidWallP;
- fluxFraction 1.0;
- value uniform 1;
- }
-
- defaultFaces
- {
- type empty;
- }
-}
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/polyMesh/blockMeshDict b/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/polyMesh/blockMeshDict
deleted file mode 100644
index 4d2046ac8b..0000000000
--- a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/polyMesh/blockMeshDict
+++ /dev/null
@@ -1,76 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- object blockMeshDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-convertToMeters 1;
-
-vertices
-(
- (-0.15242 0 -0.005)
- ( 0 0 -0.005)
- ( 0.3048 0.081670913853 -0.005)
- (-0.15242 0.1524 -0.005)
- ( 0 0.1524 -0.005)
- ( 0.3048 0.1524 -0.005)
-
- (-0.15242 0 0.005)
- ( 0 0 0.005)
- ( 0.3048 0.081670913853 0.005)
- (-0.15242 0.1524 0.005)
- ( 0 0.1524 0.005)
- ( 0.3048 0.1524 0.005)
-
-);
-
-blocks
-(
- hex (0 1 4 3 6 7 10 9 ) (40 40 1) simpleGrading (1 1 1)
- hex (1 2 5 4 7 8 11 10) (80 40 1) simpleGrading (1 1 1)
-);
-
-edges
-(
-);
-
-patches
-(
- patch inlet
- (
- (0 6 9 3)
- )
- patch outlet
- (
- (2 5 11 8)
- )
- symmetryPlane bottom
- (
- (0 1 7 6)
- )
- symmetryPlane top
- (
- (3 9 10 4)
- (4 10 11 5)
- )
- patch obstacle
- (
- (1 2 8 7)
- )
-);
-
-mergePatchPairs
-(
-);
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/polyMesh/boundary b/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/polyMesh/boundary
deleted file mode 100644
index cee2af8597..0000000000
--- a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/polyMesh/boundary
+++ /dev/null
@@ -1,58 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class polyBoundaryMesh;
- location "constant/polyMesh";
- object boundary;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-6
-(
- inlet
- {
- type patch;
- nFaces 40;
- startFace 9440;
- }
- outlet
- {
- type patch;
- nFaces 40;
- startFace 9480;
- }
- bottom
- {
- type symmetryPlane;
- nFaces 40;
- startFace 9520;
- }
- top
- {
- type symmetryPlane;
- nFaces 120;
- startFace 9560;
- }
- obstacle
- {
- type patch;
- nFaces 80;
- startFace 9680;
- }
- defaultFaces
- {
- type empty;
- nFaces 9600;
- startFace 9760;
- }
-)
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/thermodynamicProperties b/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/thermodynamicProperties
deleted file mode 100644
index 64562b3ac0..0000000000
--- a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/thermodynamicProperties
+++ /dev/null
@@ -1,23 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "constant";
- object thermodynamicProperties;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-Cv Cv [ 0 2 -2 -1 0 0 0 ] 1.78571;
-
-R R [ 0 2 -2 -1 0 0 0 ] 0.714286;
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/system/controlDict b/tutorials/compressible/rhopSonicFoam/wedge15Ma5/system/controlDict
deleted file mode 100644
index 7273a8d4dc..0000000000
--- a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/system/controlDict
+++ /dev/null
@@ -1,55 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object controlDict;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-application rhopSonicFoam;
-
-startFrom startTime;
-
-startTime 0;
-
-stopAt endTime;
-
-endTime 0.2;
-
-deltaT 0.0001;
-
-writeControl runTime;
-
-writeInterval 0.02;
-
-purgeWrite 0;
-
-writeFormat ascii;
-
-writePrecision 6;
-
-writeCompression off;
-
-timeFormat general;
-
-timePrecision 6;
-
-runTimeModifiable true;
-
-adjustTimeStep no;
-
-maxCo 1;
-
-maxDeltaT 1e-06;
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/system/fvSchemes b/tutorials/compressible/rhopSonicFoam/wedge15Ma5/system/fvSchemes
deleted file mode 100644
index aeace6abdd..0000000000
--- a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/system/fvSchemes
+++ /dev/null
@@ -1,56 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSchemes;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-ddtSchemes
-{
- default Euler;
-}
-
-gradSchemes
-{
- default Gauss linear;
-}
-
-divSchemes
-{
- default none;
- div(phiv,rhoUH) vanLeer;
-}
-
-laplacianSchemes
-{
- default Gauss linear corrected;
-}
-
-interpolationSchemes
-{
- default linear;
-}
-
-snGradSchemes
-{
- default corrected;
-}
-
-fluxRequired
-{
- default yes;
- p ;
-}
-
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/system/fvSolution b/tutorials/compressible/rhopSonicFoam/wedge15Ma5/system/fvSolution
deleted file mode 100644
index 0ccefa0771..0000000000
--- a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/system/fvSolution
+++ /dev/null
@@ -1,45 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| ========= | |
-| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
-| \\ / O peration | Version: dev |
-| \\ / A nd | Web: www.OpenFOAM.com |
-| \\/ M anipulation | |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
- version 2.0;
- format ascii;
- class dictionary;
- location "system";
- object fvSolution;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-solvers
-{
- p
- {
- solver PCG;
- preconditioner DIC;
- tolerance 1e-15;
- relTol 0;
- }
-
- "(rho|rhoU|rhoE|rhoH)"
- {
- solver PBiCG;
- preconditioner DILU;
- tolerance 1e-15;
- relTol 0;
- }
-}
-
-PISO
-{
- nOuterCorrectors 2;
- nCorrectors 2;
- HbyAblend 0.95;
-}
-
-
-// ************************************************************************* //