diff --git a/applications/solvers/multiphase/compressibleInterFoam/createFields.H b/applications/solvers/multiphase/compressibleInterFoam/createFields.H
index 9a67dc5da5..1c22600170 100644
--- a/applications/solvers/multiphase/compressibleInterFoam/createFields.H
+++ b/applications/solvers/multiphase/compressibleInterFoam/createFields.H
@@ -161,8 +161,8 @@
volScalarField gh("gh", g & mesh.C());
surfaceScalarField ghf("ghf", g & mesh.Cf());
- volScalarField rho1(eos1->rho(p, T));
- volScalarField rho2(eos2->rho(p, T));
+ volScalarField rho1("rho1", eos1->rho(p, T));
+ volScalarField rho2("rho2", eos2->rho(p, T));
volScalarField rho
(
diff --git a/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/Make/files b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/Make/files
index 4984fb848c..e6e260c74a 100644
--- a/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/Make/files
+++ b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/Make/files
@@ -3,5 +3,6 @@ phaseEquationOfState/newPhaseEquationOfState.C
constant/constant.C
linear/linear.C
perfectFluid/perfectFluid.C
+adiabaticPerfectFluid/adiabaticPerfectFluid.C
LIB = $(FOAM_LIBBIN)/libphaseEquationsOfState
diff --git a/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/adiabaticPerfectFluid/adiabaticPerfectFluid.C b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/adiabaticPerfectFluid/adiabaticPerfectFluid.C
new file mode 100644
index 0000000000..82a195dca9
--- /dev/null
+++ b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/adiabaticPerfectFluid/adiabaticPerfectFluid.C
@@ -0,0 +1,124 @@
+/*---------------------------------------------------------------------------*\
+ ========= |
+ \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
+ \\ / O peration |
+ \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation
+ \\/ M anipulation |
+-------------------------------------------------------------------------------
+License
+ This file is part of OpenFOAM.
+
+ OpenFOAM is free software: you can redistribute it and/or modify it
+ under the terms of the GNU General Public License as published by
+ the Free Software Foundation, either version 3 of the License, or
+ (at your option) any later version.
+
+ OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+ ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+ FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
+ for more details.
+
+ You should have received a copy of the GNU General Public License
+ along with OpenFOAM. If not, see .
+
+\*---------------------------------------------------------------------------*/
+
+#include "adiabaticPerfectFluid.H"
+#include "volFields.H"
+#include "addToRunTimeSelectionTable.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace phaseEquationsOfState
+{
+ defineTypeNameAndDebug(adiabaticPerfectFluid, 0);
+
+ addToRunTimeSelectionTable
+ (
+ phaseEquationOfState,
+ adiabaticPerfectFluid,
+ dictionary
+ );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
+
+Foam::phaseEquationsOfState::adiabaticPerfectFluid::adiabaticPerfectFluid
+(
+ const dictionary& dict
+)
+:
+ phaseEquationOfState(dict),
+ p0_("p0", dimPressure, dict.lookup("p0")),
+ rho0_("rho0", dimDensity, dict.lookup("rho0")),
+ gamma_("gamma", dimless, dict.lookup("gamma")),
+ B_("B", dimPressure, dict.lookup("B"))
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * //
+
+Foam::phaseEquationsOfState::adiabaticPerfectFluid::~adiabaticPerfectFluid()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
+
+Foam::tmp
+Foam::phaseEquationsOfState::adiabaticPerfectFluid::rho
+(
+ const volScalarField& p,
+ const volScalarField& T
+) const
+{
+ return tmp
+ (
+ new volScalarField
+ (
+ IOobject
+ (
+ "rho",
+ p.time().timeName(),
+ p.mesh(),
+ IOobject::NO_READ,
+ IOobject::NO_WRITE,
+ false
+ ),
+ rho0_*pow((p + B_)/(p0_ + B_), 1.0/gamma_)
+ )
+ );
+}
+
+
+Foam::tmp
+Foam::phaseEquationsOfState::adiabaticPerfectFluid::psi
+(
+ const volScalarField& p,
+ const volScalarField& T
+) const
+{
+ return tmp
+ (
+ new volScalarField
+ (
+ IOobject
+ (
+ "psi",
+ p.time().timeName(),
+ p.mesh(),
+ IOobject::NO_READ,
+ IOobject::NO_WRITE,
+ false
+ ),
+ (rho0_/(gamma_*(p0_ + B_)))
+ *pow((p + B_)/(p0_ + B_), 1.0/gamma_ - 1.0)
+ )
+ );
+}
+
+
+// ************************************************************************* //
diff --git a/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/adiabaticPerfectFluid/adiabaticPerfectFluid.H b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/adiabaticPerfectFluid/adiabaticPerfectFluid.H
new file mode 100644
index 0000000000..49f5218e49
--- /dev/null
+++ b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/adiabaticPerfectFluid/adiabaticPerfectFluid.H
@@ -0,0 +1,115 @@
+/*---------------------------------------------------------------------------*\
+ ========= |
+ \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
+ \\ / O peration |
+ \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation
+ \\/ M anipulation |
+-------------------------------------------------------------------------------
+License
+ This file is part of OpenFOAM.
+
+ OpenFOAM is free software: you can redistribute it and/or modify it
+ under the terms of the GNU General Public License as published by
+ the Free Software Foundation, either version 3 of the License, or
+ (at your option) any later version.
+
+ OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+ ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+ FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
+ for more details.
+
+ You should have received a copy of the GNU General Public License
+ along with OpenFOAM. If not, see .
+
+Class
+ Foam::phaseEquationsOfState::adiabaticPerfectFluid
+
+Description
+ AdiabaticPerfectFluid phase density model.
+
+SourceFiles
+ adiabaticPerfectFluid.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef adiabaticPerfectFluid_H
+#define adiabaticPerfectFluid_H
+
+#include "phaseEquationOfState.H"
+#include "dimensionedTypes.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace phaseEquationsOfState
+{
+
+/*---------------------------------------------------------------------------*\
+ Class adiabaticPerfectFluid Declaration
+\*---------------------------------------------------------------------------*/
+
+class adiabaticPerfectFluid
+:
+ public phaseEquationOfState
+{
+ // Private data
+
+ //- Reference pressure
+ dimensionedScalar p0_;
+
+ //- Reference density
+ dimensionedScalar rho0_;
+
+ //- The isentropic exponent
+ dimensionedScalar gamma_;
+
+ //- Pressure offset for a stiffened gas
+ dimensionedScalar B_;
+
+
+public:
+
+ //- Runtime type information
+ TypeName("adiabaticPerfectFluid");
+
+
+ // Constructors
+
+ //- Construct from components
+ adiabaticPerfectFluid
+ (
+ const dictionary& dict
+ );
+
+
+ //- Destructor
+ virtual ~adiabaticPerfectFluid();
+
+
+ // Member Functions
+
+ tmp rho
+ (
+ const volScalarField& p,
+ const volScalarField& T
+ ) const;
+
+ tmp psi
+ (
+ const volScalarField& p,
+ const volScalarField& T
+ ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace phaseEquationsOfState
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/constant/constant.C b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/constant/constant.C
index a51d88233e..54b6705dd9 100644
--- a/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/constant/constant.C
+++ b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/constant/constant.C
@@ -79,7 +79,10 @@ Foam::tmp Foam::phaseEquationsOfState::constant::rho
(
"rho",
p.time().timeName(),
- p.mesh()
+ p.mesh(),
+ IOobject::NO_READ,
+ IOobject::NO_WRITE,
+ false
),
p.mesh(),
rho_
@@ -102,7 +105,10 @@ Foam::tmp Foam::phaseEquationsOfState::constant::psi
(
"psi",
p.time().timeName(),
- p.mesh()
+ p.mesh(),
+ IOobject::NO_READ,
+ IOobject::NO_WRITE,
+ false
),
p.mesh(),
dimensionedScalar("psi", dimDensity/dimPressure, 0)
diff --git a/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/linear/linear.C b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/linear/linear.C
index 6f27a878de..3680735a1b 100644
--- a/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/linear/linear.C
+++ b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/linear/linear.C
@@ -80,7 +80,10 @@ Foam::tmp Foam::phaseEquationsOfState::linear::rho
(
"rho",
p.time().timeName(),
- p.mesh()
+ p.mesh(),
+ IOobject::NO_READ,
+ IOobject::NO_WRITE,
+ false
),
rho0_ + psi_*p
)
@@ -102,7 +105,10 @@ Foam::tmp Foam::phaseEquationsOfState::linear::psi
(
"psi",
p.time().timeName(),
- p.mesh()
+ p.mesh(),
+ IOobject::NO_READ,
+ IOobject::NO_WRITE,
+ false
),
p.mesh(),
psi_
diff --git a/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/perfectFluid/perfectFluid.C b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/perfectFluid/perfectFluid.C
index 32327a5ffc..6a148d8d68 100644
--- a/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/perfectFluid/perfectFluid.C
+++ b/applications/solvers/multiphase/compressibleInterFoam/phaseEquationsOfState/perfectFluid/perfectFluid.C
@@ -80,7 +80,10 @@ Foam::tmp Foam::phaseEquationsOfState::perfectFluid::rho
(
"rho",
p.time().timeName(),
- p.mesh()
+ p.mesh(),
+ IOobject::NO_READ,
+ IOobject::NO_WRITE,
+ false
),
rho0_ + psi(p, T)*p
)
@@ -102,7 +105,10 @@ Foam::tmp Foam::phaseEquationsOfState::perfectFluid::psi
(
"psi",
p.time().timeName(),
- p.mesh()
+ p.mesh(),
+ IOobject::NO_READ,
+ IOobject::NO_WRITE,
+ false
),
1.0/(R_*T)
)
diff --git a/applications/test/syncTools/Test-syncTools.C b/applications/test/syncTools/Test-syncTools.C
index 83970e9ef2..cf68380952 100644
--- a/applications/test/syncTools/Test-syncTools.C
+++ b/applications/test/syncTools/Test-syncTools.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -214,7 +214,7 @@ void testSparseData(const polyMesh& mesh, Random& rndGen)
forAll(localPoints, i)
{
- const point pt = localPoints[i] + 1E-4*rndGen.vector01();
+ const point pt = localPoints[i] + 1e-4*rndGen.vector01();
label meshPointI = allBoundary.meshPoints()[i];
@@ -299,7 +299,7 @@ void testSparseData(const polyMesh& mesh, Random& rndGen)
{
const edge& e = edges[i];
- const point pt = e.centre(localPoints) + 1E-4*rndGen.vector01();
+ const point pt = e.centre(localPoints) + 1e-4*rndGen.vector01();
label meshEdgeI = meshEdges[i];
diff --git a/applications/utilities/mesh/advanced/autoRefineMesh/autoRefineMesh.C b/applications/utilities/mesh/advanced/autoRefineMesh/autoRefineMesh.C
index 2f99404f9a..22b757e861 100644
--- a/applications/utilities/mesh/advanced/autoRefineMesh/autoRefineMesh.C
+++ b/applications/utilities/mesh/advanced/autoRefineMesh/autoRefineMesh.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -58,7 +58,7 @@ using namespace Foam;
// Max cos angle for edges to be considered aligned with axis.
-static const scalar edgeTol = 1E-3;
+static const scalar edgeTol = 1e-3;
void writeSet(const cellSet& cells, const string& msg)
diff --git a/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C b/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C
index 0f32935fae..f1eb28e594 100644
--- a/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C
+++ b/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -528,7 +528,7 @@ int main(int argc, char *argv[])
(
mesh,
boundaryPoint,
- 1E-9, // factor of largest face area
+ 1e-9, // factor of largest face area
5, // factor between smallest and largest edge on
// face
collapser
diff --git a/applications/utilities/mesh/advanced/selectCells/edgeStats.C b/applications/utilities/mesh/advanced/selectCells/edgeStats.C
index 42627e7b6c..2affa40535 100644
--- a/applications/utilities/mesh/advanced/selectCells/edgeStats.C
+++ b/applications/utilities/mesh/advanced/selectCells/edgeStats.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -31,7 +31,7 @@ License
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-const Foam::scalar Foam::edgeStats::edgeTol_ = 1E-3;
+const Foam::scalar Foam::edgeStats::edgeTol_ = 1e-3;
diff --git a/applications/utilities/mesh/generation/cv2DMesh/cv2DMesh.C b/applications/utilities/mesh/generation/cv2DMesh/cv2DMesh.C
index 6233edcab3..b868d5c83c 100644
--- a/applications/utilities/mesh/generation/cv2DMesh/cv2DMesh.C
+++ b/applications/utilities/mesh/generation/cv2DMesh/cv2DMesh.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -209,7 +209,7 @@ int main(int argc, char *argv[])
const pointField& points = pMesh.points();
const boundBox& bb = pMesh.bounds();
- const scalar mergeDim = 1E-4 * bb.minDim();
+ const scalar mergeDim = 1e-4 * bb.minDim();
forAll(edges, edgeI)
{
diff --git a/applications/utilities/mesh/generation/cvMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshCalcDualMesh.C b/applications/utilities/mesh/generation/cvMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshCalcDualMesh.C
index e0fe697e88..ec81b1e944 100644
--- a/applications/utilities/mesh/generation/cvMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshCalcDualMesh.C
+++ b/applications/utilities/mesh/generation/cvMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshCalcDualMesh.C
@@ -561,7 +561,7 @@ Foam::label Foam::conformalVoronoiMesh::mergeCloseDualVertices
scalar closenessTolerance = cvMeshControls().mergeClosenessCoeff();
// Absolute distance for points to be considered coincident. Bit adhoc
- // but points were seen with distSqr ~ 1E-30 which is SMALL^2. Add a few
+ // but points were seen with distSqr ~ 1e-30 which is SMALL^2. Add a few
// digits to account for truncation errors.
scalar coincidentDistanceSqr = sqr
(
diff --git a/applications/utilities/mesh/generation/cvMesh/cvMeshBackgroundMesh/cvMeshBackgroundMesh.C b/applications/utilities/mesh/generation/cvMesh/cvMeshBackgroundMesh/cvMeshBackgroundMesh.C
index 72d05293b9..485c5568b4 100644
--- a/applications/utilities/mesh/generation/cvMesh/cvMeshBackgroundMesh/cvMeshBackgroundMesh.C
+++ b/applications/utilities/mesh/generation/cvMesh/cvMeshBackgroundMesh/cvMeshBackgroundMesh.C
@@ -51,7 +51,7 @@ using namespace Foam;
// Tolerance (as fraction of the bounding box). Needs to be fairly lax since
// usually meshes get written with limited precision (6 digits)
-static const scalar defaultMergeTol = 1E-6;
+static const scalar defaultMergeTol = 1e-6;
// Get merging distance when matching face centres
scalar getMergeDistance
@@ -397,7 +397,7 @@ int main(int argc, char *argv[])
"mergeTol",
"scalar",
"specify the merge distance relative to the bounding box size "
- "(default 1E-6)"
+ "(default 1e-6)"
);
#include "setRootCase.H"
diff --git a/applications/utilities/mesh/generation/extrude/extrudeMesh/extrudeMesh.C b/applications/utilities/mesh/generation/extrude/extrudeMesh/extrudeMesh.C
index 38a2430376..1c769a4346 100644
--- a/applications/utilities/mesh/generation/extrude/extrudeMesh/extrudeMesh.C
+++ b/applications/utilities/mesh/generation/extrude/extrudeMesh/extrudeMesh.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -666,7 +666,7 @@ int main(int argc, char *argv[])
const boundBox& bb = mesh.bounds();
const vector span = bb.span();
- const scalar mergeDim = 1E-4 * bb.minDim();
+ const scalar mergeDim = 1e-4 * bb.minDim();
Info<< "Mesh bounding box : " << bb << nl
<< " with span : " << span << nl
diff --git a/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMeshApp.C b/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMeshApp.C
index 5381c0b57a..667b0a9b2b 100644
--- a/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMeshApp.C
+++ b/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMeshApp.C
@@ -257,7 +257,7 @@ int main(int argc, char *argv[])
const pointField& points = mesh().points();
const boundBox& bb = mesh().bounds();
- const scalar mergeDim = 1E-4 * bb.minDim();
+ const scalar mergeDim = 1e-4 * bb.minDim();
forAll(edges, edgeI)
{
diff --git a/applications/utilities/mesh/manipulation/checkMesh/checkGeometry.C b/applications/utilities/mesh/manipulation/checkMesh/checkGeometry.C
index a2f6a84d17..443576601d 100644
--- a/applications/utilities/mesh/manipulation/checkMesh/checkGeometry.C
+++ b/applications/utilities/mesh/manipulation/checkMesh/checkGeometry.C
@@ -41,8 +41,8 @@ Foam::label Foam::findOppositeWedge
if
(
pp.size() == wpp.size()
- && mag(pp.axis() & wpp.axis()) >= (1-1E-3)
- && mag(ppCosAngle - wppCosAngle) >= 1E-3
+ && mag(pp.axis() & wpp.axis()) >= (1-1e-3)
+ && mag(ppCosAngle - wppCosAngle) >= 1e-3
)
{
return patchI;
@@ -106,7 +106,7 @@ bool Foam::checkWedges
);
- if (mag(opp.axis() & pp.axis()) < (1-1E-3))
+ if (mag(opp.axis() & pp.axis()) < (1-1e-3))
{
if (report)
{
diff --git a/applications/utilities/mesh/manipulation/polyDualMesh/meshDualiser.C b/applications/utilities/mesh/manipulation/polyDualMesh/meshDualiser.C
index 9ef58b47e4..e0dabffedb 100644
--- a/applications/utilities/mesh/manipulation/polyDualMesh/meshDualiser.C
+++ b/applications/utilities/mesh/manipulation/polyDualMesh/meshDualiser.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -52,7 +52,7 @@ void Foam::meshDualiser::checkPolyTopoChange(const polyTopoChange& meshMod)
label nUnique = mergePoints
(
points,
- 1E-6,
+ 1e-6,
false,
oldToNew
);
@@ -226,7 +226,7 @@ Foam::label Foam::meshDualiser::addInternalFace
label nUnique = mergePoints
(
facePoints,
- 1E-6,
+ 1e-6,
false,
oldToNew
);
diff --git a/applications/utilities/mesh/manipulation/refineMesh/refineMesh.C b/applications/utilities/mesh/manipulation/refineMesh/refineMesh.C
index f10fbde116..f8a206e651 100644
--- a/applications/utilities/mesh/manipulation/refineMesh/refineMesh.C
+++ b/applications/utilities/mesh/manipulation/refineMesh/refineMesh.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -52,7 +52,7 @@ using namespace Foam;
// Max cos angle for edges to be considered aligned with axis.
-static const scalar edgeTol = 1E-3;
+static const scalar edgeTol = 1e-3;
// Calculate some edge statistics on mesh.
@@ -206,7 +206,7 @@ label twoDNess(const polyMesh& mesh)
minLen = min(minLen, mesh.edges()[cEdges[i]].mag(mesh.points()));
}
- if (cellPlane.distance(ctrs[cellI]) > 1E-6*minLen)
+ if (cellPlane.distance(ctrs[cellI]) > 1e-6*minLen)
{
// Centres not in plane
return -1;
@@ -274,7 +274,7 @@ label twoDNess(const polyMesh& mesh)
const scalarField cosAngle(mag(n/mag(n) & cellPlane.normal()));
- if (mag(min(cosAngle) - max(cosAngle)) > 1E-6)
+ if (mag(min(cosAngle) - max(cosAngle)) > 1e-6)
{
// cosAngle should be either ~1 over all faces (2D front and
// back) or ~0 (all other patches perp to 2D)
diff --git a/applications/utilities/parallelProcessing/reconstructParMesh/reconstructParMesh.C b/applications/utilities/parallelProcessing/reconstructParMesh/reconstructParMesh.C
index 4526e79e08..3085ff1897 100644
--- a/applications/utilities/parallelProcessing/reconstructParMesh/reconstructParMesh.C
+++ b/applications/utilities/parallelProcessing/reconstructParMesh/reconstructParMesh.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -55,7 +55,7 @@ using namespace Foam;
// Tolerance (as fraction of the bounding box). Needs to be fairly lax since
// usually meshes get written with limited precision (6 digits)
-static const scalar defaultMergeTol = 1E-7;
+static const scalar defaultMergeTol = 1e-7;
static void renumber
@@ -290,7 +290,7 @@ int main(int argc, char *argv[])
"mergeTol",
"scalar",
"specify the merge distance relative to the bounding box size "
- "(default 1E-7)"
+ "(default 1e-7)"
);
argList::addBoolOption
(
diff --git a/applications/utilities/parallelProcessing/redistributePar/redistributePar.C b/applications/utilities/parallelProcessing/redistributePar/redistributePar.C
index 4d02655955..9a337d7573 100644
--- a/applications/utilities/parallelProcessing/redistributePar/redistributePar.C
+++ b/applications/utilities/parallelProcessing/redistributePar/redistributePar.C
@@ -60,7 +60,7 @@ Description
// Tolerance (as fraction of the bounding box). Needs to be fairly lax since
// usually meshes get written with limited precision (6 digits)
-static const scalar defaultMergeTol = 1E-6;
+static const scalar defaultMergeTol = 1e-6;
//// Read mesh if available. Otherwise create empty mesh with same non-proc
@@ -721,7 +721,7 @@ int main(int argc, char *argv[])
"mergeTol",
"scalar",
"specify the merge distance relative to the bounding box size "
- "(default 1E-6)"
+ "(default 1e-6)"
);
# include "setRootCase.H"
diff --git a/applications/utilities/preProcessing/mapFields/mapLagrangian.C b/applications/utilities/preProcessing/mapFields/mapLagrangian.C
index f73029529e..37ad7c26c2 100644
--- a/applications/utilities/preProcessing/mapFields/mapLagrangian.C
+++ b/applications/utilities/preProcessing/mapFields/mapLagrangian.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -32,7 +32,7 @@ License
namespace Foam
{
-static const scalar perturbFactor = 1E-6;
+static const scalar perturbFactor = 1e-6;
// Special version of findCell that generates a cell guaranteed to be
diff --git a/applications/utilities/preProcessing/viewFactorsGen/searchingEngine.H b/applications/utilities/preProcessing/viewFactorsGen/searchingEngine.H
index fad039b3b2..a48fd193f1 100644
--- a/applications/utilities/preProcessing/viewFactorsGen/searchingEngine.H
+++ b/applications/utilities/preProcessing/viewFactorsGen/searchingEngine.H
@@ -7,7 +7,7 @@ List meshBb
treeBoundBox
(
boundBox(coarseMesh.points(), false)
- ).extend(rndGen, 1E-3)
+ ).extend(rndGen, 1e-3)
);
// Dummy bounds dictionary
diff --git a/applications/utilities/surface/surfaceCheck/surfaceCheck.C b/applications/utilities/surface/surfaceCheck/surfaceCheck.C
index 09a030d77b..1000f84514 100644
--- a/applications/utilities/surface/surfaceCheck/surfaceCheck.C
+++ b/applications/utilities/surface/surfaceCheck/surfaceCheck.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -367,7 +367,7 @@ int main(int argc, char *argv[])
forAll(triQ, faceI)
{
- if (triQ[faceI] < 1E-11)
+ if (triQ[faceI] < 1e-11)
{
problemFaces.append(faceI);
}
@@ -427,9 +427,9 @@ int main(int argc, char *argv[])
const pointField& localPoints = surf.localPoints();
const boundBox bb(localPoints);
- scalar smallDim = 1E-6 * bb.mag();
+ scalar smallDim = 1e-6 * bb.mag();
- Info<< "Checking for points less than 1E-6 of bounding box ("
+ Info<< "Checking for points less than 1e-6 of bounding box ("
<< bb.span() << " meter) apart."
<< endl;
diff --git a/applications/utilities/surface/surfaceRedistributePar/surfaceRedistributePar.C b/applications/utilities/surface/surfaceRedistributePar/surfaceRedistributePar.C
index 98c56dabd6..76a385733e 100644
--- a/applications/utilities/surface/surfaceRedistributePar/surfaceRedistributePar.C
+++ b/applications/utilities/surface/surfaceRedistributePar/surfaceRedistributePar.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -159,7 +159,7 @@ int main(int argc, char *argv[])
treeBoundBox
(
boundBox(mesh.points(), false)
- ).extend(rndGen, 1E-3)
+ ).extend(rndGen, 1e-3)
);
Pstream::gatherList(meshBb);
Pstream::scatterList(meshBb);
diff --git a/applications/utilities/surface/surfaceSubset/surfaceSubset.C b/applications/utilities/surface/surfaceSubset/surfaceSubset.C
index 89f200283f..5ca325acba 100644
--- a/applications/utilities/surface/surfaceSubset/surfaceSubset.C
+++ b/applications/utilities/surface/surfaceSubset/surfaceSubset.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -254,7 +254,7 @@ int main(int argc, char *argv[])
selectSurf,
indexedOctree::perturbTol()
),
- bb.extend(rndGen, 1E-4), // slightly randomize bb
+ bb.extend(rndGen, 1e-4), // slightly randomize bb
8, // maxLevel
10, // leafsize
3.0 // duplicity
diff --git a/src/OSspecific/POSIX/clockTime/clockTime.C b/src/OSspecific/POSIX/clockTime/clockTime.C
index 1081019c4f..56b80ad505 100644
--- a/src/OSspecific/POSIX/clockTime/clockTime.C
+++ b/src/OSspecific/POSIX/clockTime/clockTime.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -36,7 +36,7 @@ void Foam::clockTime::getTime(timeType& t)
double Foam::clockTime::timeDifference(const timeType& beg, const timeType& end)
{
- return end.tv_sec - beg.tv_sec + 1E-6*(end.tv_usec - beg.tv_usec);
+ return end.tv_sec - beg.tv_sec + 1e-6*(end.tv_usec - beg.tv_usec);
}
diff --git a/src/OpenFOAM/meshes/polyMesh/globalMeshData/globalMeshData.C b/src/OpenFOAM/meshes/polyMesh/globalMeshData/globalMeshData.C
index 3ccbdd4043..2122b282d7 100644
--- a/src/OpenFOAM/meshes/polyMesh/globalMeshData/globalMeshData.C
+++ b/src/OpenFOAM/meshes/polyMesh/globalMeshData/globalMeshData.C
@@ -44,7 +44,7 @@ License
defineTypeNameAndDebug(Foam::globalMeshData, 0);
// Geometric matching tolerance. Factor of mesh bounding box.
-const Foam::scalar Foam::globalMeshData::matchTol_ = 1E-8;
+const Foam::scalar Foam::globalMeshData::matchTol_ = 1e-8;
namespace Foam
{
diff --git a/src/OpenFOAM/meshes/polyMesh/polyMesh.C b/src/OpenFOAM/meshes/polyMesh/polyMesh.C
index 8877cdafcf..cd4493c90c 100644
--- a/src/OpenFOAM/meshes/polyMesh/polyMesh.C
+++ b/src/OpenFOAM/meshes/polyMesh/polyMesh.C
@@ -893,7 +893,7 @@ Foam::polyMesh::cellTree() const
Random rndGen(261782);
- overallBb = overallBb.extend(rndGen, 1E-4);
+ overallBb = overallBb.extend(rndGen, 1e-4);
overallBb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
overallBb.max() += point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
diff --git a/src/OpenFOAM/meshes/polyMesh/polyPatches/basic/coupled/coupledPolyPatch.C b/src/OpenFOAM/meshes/polyMesh/polyPatches/basic/coupled/coupledPolyPatch.C
index ca7155704d..523cb99b0b 100644
--- a/src/OpenFOAM/meshes/polyMesh/polyPatches/basic/coupled/coupledPolyPatch.C
+++ b/src/OpenFOAM/meshes/polyMesh/polyPatches/basic/coupled/coupledPolyPatch.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -34,7 +34,7 @@ namespace Foam
{
defineTypeNameAndDebug(coupledPolyPatch, 0);
- const scalar coupledPolyPatch::defaultMatchTol_ = 1E-4;
+ const scalar coupledPolyPatch::defaultMatchTol_ = 1e-4;
template<>
const char* NamedEnum::names[] =
diff --git a/src/combustionModels/FSD/FSD.H b/src/combustionModels/FSD/FSD.H
index 0a132d04fe..e5c396329a 100644
--- a/src/combustionModels/FSD/FSD.H
+++ b/src/combustionModels/FSD/FSD.H
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -48,7 +48,7 @@ Description
release.
If the turbulent fluctuation of the mixture fraction at the sub-grid level
- is large (>1E-04) then a beta pdf is used for filtering.
+ is large (>1e-04) then a beta pdf is used for filtering.
At the moment the flame area combustion model is only fit to work in a LES
frame work. In RAS the subgrid fluctiuation has to be solved by an extra
diff --git a/src/dynamicMesh/boundaryMesh/boundaryMesh.C b/src/dynamicMesh/boundaryMesh/boundaryMesh.C
index 96906926cb..51be127dd7 100644
--- a/src/dynamicMesh/boundaryMesh/boundaryMesh.C
+++ b/src/dynamicMesh/boundaryMesh/boundaryMesh.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -43,7 +43,7 @@ defineTypeNameAndDebug(Foam::boundaryMesh, 0);
const Foam::vector Foam::boundaryMesh::splitNormal_(3, 2, 1);
// Distance to face tolerance for getNearest
-const Foam::scalar Foam::boundaryMesh::distanceTol_ = 1E-2;
+const Foam::scalar Foam::boundaryMesh::distanceTol_ = 1e-2;
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
@@ -871,11 +871,11 @@ Foam::labelList Foam::boundaryMesh::getNearest
{
scalar sign = mesh().faceNormals()[bFaceI] & splitNormal_;
- if (sign > -1E-5)
+ if (sign > -1e-5)
{
rightFaces.append(bFaceI);
}
- if (sign < 1E-5)
+ if (sign < 1e-5)
{
leftFaces.append(bFaceI);
}
@@ -909,7 +909,7 @@ Foam::labelList Foam::boundaryMesh::getNearest
// Extend domain slightly (also makes it 3D if was 2D)
// Note asymmetry to avoid having faces align with octree cubes.
- scalar tol = 1E-6 * overallBb.avgDim();
+ scalar tol = 1e-6 * overallBb.avgDim();
point& bbMin = overallBb.min();
bbMin.x() -= tol;
diff --git a/src/dynamicMesh/meshCut/cellLooper/geomCellLooper.C b/src/dynamicMesh/meshCut/cellLooper/geomCellLooper.C
index 394ca197ed..2b1310ab91 100644
--- a/src/dynamicMesh/meshCut/cellLooper/geomCellLooper.C
+++ b/src/dynamicMesh/meshCut/cellLooper/geomCellLooper.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -39,7 +39,7 @@ License
// Extension factor of edges to make sure we catch intersections through
// edge endpoints
-const Foam::scalar Foam::geomCellLooper::pointEqualTol_ = 1E-3;
+const Foam::scalar Foam::geomCellLooper::pointEqualTol_ = 1e-3;
// Snap cuts through edges onto edge endpoints. Fraction of edge length.
diff --git a/src/dynamicMesh/meshCut/directions/directions.C b/src/dynamicMesh/meshCut/directions/directions.C
index e35a8c0efd..35170e9007 100644
--- a/src/dynamicMesh/meshCut/directions/directions.C
+++ b/src/dynamicMesh/meshCut/directions/directions.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -125,7 +125,7 @@ void Foam::directions::check2D
{
if (correct2DPtr)
{
- if (mag(correct2DPtr->planeNormal() & vec) > 1E-6)
+ if (mag(correct2DPtr->planeNormal() & vec) > 1e-6)
{
FatalErrorIn("check2D") << "Specified vector " << vec
<< "is not normal to plane defined in dynamicMeshDict."
diff --git a/src/dynamicMesh/motionSmoother/motionSmoother.C b/src/dynamicMesh/motionSmoother/motionSmoother.C
index 6542432aea..cf686b7dd8 100644
--- a/src/dynamicMesh/motionSmoother/motionSmoother.C
+++ b/src/dynamicMesh/motionSmoother/motionSmoother.C
@@ -900,7 +900,7 @@ Foam::tmp Foam::motionSmoother::movePoints
{
Pout<< "motionSmoother::movePoints : testing sync of newPoints."
<< endl;
- testSyncPositions(newPoints, 1E-6*mesh_.bounds().mag());
+ testSyncPositions(newPoints, 1e-6*mesh_.bounds().mag());
}
// Move actual mesh points. Make sure to delete tetBasePtIs so it
@@ -1051,7 +1051,7 @@ bool Foam::motionSmoother::scaleMesh
totalDisplacement,
maxMagEqOp(),
vector::zero, // null value
- 1E-6*mesh_.bounds().mag()
+ 1e-6*mesh_.bounds().mag()
);
}
diff --git a/src/dynamicMesh/perfectInterface/perfectInterface.C b/src/dynamicMesh/perfectInterface/perfectInterface.C
index bbc9b6199a..36df880891 100644
--- a/src/dynamicMesh/perfectInterface/perfectInterface.C
+++ b/src/dynamicMesh/perfectInterface/perfectInterface.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -54,7 +54,7 @@ namespace Foam
// Tolerance used as fraction of minimum edge length.
-const Foam::scalar Foam::perfectInterface::tol_ = 1E-3;
+const Foam::scalar Foam::perfectInterface::tol_ = 1e-3;
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
diff --git a/src/dynamicMesh/polyMeshAdder/faceCoupleInfo.C b/src/dynamicMesh/polyMeshAdder/faceCoupleInfo.C
index 01d0103a64..8de21e2f08 100644
--- a/src/dynamicMesh/polyMeshAdder/faceCoupleInfo.C
+++ b/src/dynamicMesh/polyMeshAdder/faceCoupleInfo.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -36,7 +36,7 @@ License
defineTypeNameAndDebug(Foam::faceCoupleInfo, 0);
-const Foam::scalar Foam::faceCoupleInfo::angleTol_ = 1E-3;
+const Foam::scalar Foam::faceCoupleInfo::angleTol_ = 1e-3;
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
@@ -1014,7 +1014,7 @@ void Foam::faceCoupleInfo::findSlavesCoveringMaster
mesh0,
bndFaces // boundary faces only
),
- overallBb.extend(rndGen, 1E-4), // overall search domain
+ overallBb.extend(rndGen, 1e-4), // overall search domain
8, // maxLevel
10, // leafsize
3.0 // duplicity
diff --git a/src/dynamicMesh/polyTopoChange/polyTopoChange/faceCollapser.C b/src/dynamicMesh/polyTopoChange/polyTopoChange/faceCollapser.C
index b1e928e96b..8f579fc4f7 100644
--- a/src/dynamicMesh/polyTopoChange/polyTopoChange/faceCollapser.C
+++ b/src/dynamicMesh/polyTopoChange/polyTopoChange/faceCollapser.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -277,7 +277,7 @@ void Foam::faceCollapser::setRefinement
if (w <= dist[fpMin1])
{
// Offset.
- w = dist[fpMin1] + 1E-6*(dist[fpB] - dist[fpA]);
+ w = dist[fpMin1] + 1e-6*(dist[fpB] - dist[fpA]);
point newPoint
(
@@ -330,7 +330,7 @@ void Foam::faceCollapser::setRefinement
if (w <= dist[fpMin1])
{
// Offset.
- w = dist[fpMin1] + 1E-6*(dist[fpB] - dist[fpA]);
+ w = dist[fpMin1] + 1e-6*(dist[fpB] - dist[fpA]);
point newPoint
(
diff --git a/src/dynamicMesh/polyTopoChange/polyTopoChange/hexRef8.C b/src/dynamicMesh/polyTopoChange/polyTopoChange/hexRef8.C
index b577a17177..827913a1c1 100644
--- a/src/dynamicMesh/polyTopoChange/polyTopoChange/hexRef8.C
+++ b/src/dynamicMesh/polyTopoChange/polyTopoChange/hexRef8.C
@@ -4452,7 +4452,7 @@ void Foam::hexRef8::distribute(const mapDistributePolyMesh& map)
void Foam::hexRef8::checkMesh() const
{
- const scalar smallDim = 1E-6 * mesh_.bounds().mag();
+ const scalar smallDim = 1e-6 * mesh_.bounds().mag();
if (debug)
{
diff --git a/src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.C b/src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.C
index cd0ac4fc94..aa046d6ec6 100644
--- a/src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.C
+++ b/src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -923,7 +923,7 @@ Foam::extendedFeatureEdgeMesh::pointTree() const
// geometry there are less face/edge aligned items.
treeBoundBox bb
(
- treeBoundBox(points()).extend(rndGen, 1E-4)
+ treeBoundBox(points()).extend(rndGen, 1e-4)
);
bb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
@@ -963,7 +963,7 @@ Foam::extendedFeatureEdgeMesh::edgeTree() const
// geometry there are less face/edge aligned items.
treeBoundBox bb
(
- treeBoundBox(points()).extend(rndGen, 1E-4)
+ treeBoundBox(points()).extend(rndGen, 1e-4)
);
bb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
@@ -1007,7 +1007,7 @@ Foam::extendedFeatureEdgeMesh::edgeTreesByType() const
// geometry there are less face/edge aligned items.
treeBoundBox bb
(
- treeBoundBox(points()).extend(rndGen, 1E-4)
+ treeBoundBox(points()).extend(rndGen, 1e-4)
);
bb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
diff --git a/src/finiteVolume/fields/fvPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValueFvPatchField.C b/src/finiteVolume/fields/fvPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValueFvPatchField.C
index 1831bd903d..16704d4adc 100644
--- a/src/finiteVolume/fields/fvPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValueFvPatchField.C
+++ b/src/finiteVolume/fields/fvPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValueFvPatchField.C
@@ -93,7 +93,7 @@ timeVaryingMappedFixedValueFvPatchField
fixedValueFvPatchField(p, iF),
fieldTableName_(iF.name()),
setAverage_(readBool(dict.lookup("setAverage"))),
- perturb_(dict.lookupOrDefault("perturb", 1E-5)),
+ perturb_(dict.lookupOrDefault("perturb", 1e-5)),
mapperPtr_(NULL),
sampleTimes_(0),
startSampleTime_(-1),
diff --git a/src/finiteVolume/fields/fvPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValueFvPatchField.H b/src/finiteVolume/fields/fvPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValueFvPatchField.H
index 1494efec35..82525ec49a 100644
--- a/src/finiteVolume/fields/fvPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValueFvPatchField.H
+++ b/src/finiteVolume/fields/fvPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValueFvPatchField.H
@@ -45,7 +45,7 @@ Description
// Maintain average to that of the supplied values
setAverage false;
- // Optional: change perturbation (default 1E-5) to avoid any ties
+ // Optional: change perturbation (default 1e-5) to avoid any ties
// in triangulating regular geometries.
//perturb 0.0;
diff --git a/src/fvMotionSolver/pointPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValuePointPatchField.C b/src/fvMotionSolver/pointPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValuePointPatchField.C
index e1bdfc0910..1fa44b5d64 100644
--- a/src/fvMotionSolver/pointPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValuePointPatchField.C
+++ b/src/fvMotionSolver/pointPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValuePointPatchField.C
@@ -92,7 +92,7 @@ timeVaryingMappedFixedValuePointPatchField
fixedValuePointPatchField(p, iF),
fieldTableName_(iF.name()),
setAverage_(readBool(dict.lookup("setAverage"))),
- perturb_(dict.lookupOrDefault("perturb", 1E-5)),
+ perturb_(dict.lookupOrDefault("perturb", 1e-5)),
mapperPtr_(NULL),
sampleTimes_(0),
startSampleTime_(-1),
diff --git a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.C b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.C
index e12394624b..2890577c24 100644
--- a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.C
+++ b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.C
@@ -1881,7 +1881,7 @@ void Foam::meshRefinement::distribute(const mapDistributePolyMesh& map)
List meshBb(1);
treeBoundBox& bb = meshBb[0];
bb = treeBoundBox(mesh_.points());
- bb = bb.extend(rndGen, 1E-4);
+ bb = bb.extend(rndGen, 1e-4);
// Distribute all geometry (so refinementSurfaces and shellSurfaces)
searchableSurfaces& geometry =
diff --git a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementBaffles.C b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementBaffles.C
index 076fd11e2f..977f75dbd4 100644
--- a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementBaffles.C
+++ b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementBaffles.C
@@ -1073,7 +1073,7 @@ void Foam::meshRefinement::findCellZoneGeometric
label nei = faceNeighbour[faceI];
const point& neiCc = cellCentres[nei];
// Perturbed cc
- const vector d = 1E-4*(neiCc - ownCc);
+ const vector d = 1e-4*(neiCc - ownCc);
candidatePoints[nCandidates++] = ownCc-d;
candidatePoints[nCandidates++] = neiCc+d;
}
@@ -1081,7 +1081,7 @@ void Foam::meshRefinement::findCellZoneGeometric
{
const point& neiFc = mesh_.faceCentres()[faceI];
// Perturbed cc
- const vector d = 1E-4*(neiFc - ownCc);
+ const vector d = 1e-4*(neiFc - ownCc);
candidatePoints[nCandidates++] = ownCc-d;
}
}
diff --git a/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.C b/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.C
index 1c88348f99..56533c0b00 100644
--- a/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.C
+++ b/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -93,7 +93,7 @@ Foam::refinementFeatures::refinementFeatures
// Slightly extended bb. Slightly off-centred just so on symmetric
// geometry there are less face/edge aligned items.
- bb = bb.extend(rndGen, 1E-4);
+ bb = bb.extend(rndGen, 1e-4);
bb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
bb.max() += point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
diff --git a/src/meshTools/cellClassification/cellClassification.C b/src/meshTools/cellClassification/cellClassification.C
index 4a33b4321e..6fc2b15a97 100644
--- a/src/meshTools/cellClassification/cellClassification.C
+++ b/src/meshTools/cellClassification/cellClassification.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -146,7 +146,7 @@ Foam::boolList Foam::cellClassification::markFaces
treeBoundBox allBb(mesh_.points());
// Extend domain slightly (also makes it 3D if was 2D)
- scalar tol = 1E-6 * allBb.avgDim();
+ scalar tol = 1e-6 * allBb.avgDim();
point& bbMin = allBb.min();
bbMin.x() -= tol;
@@ -187,7 +187,7 @@ Foam::boolList Foam::cellClassification::markFaces
vector edgeNormal(end - start);
const scalar edgeMag = mag(edgeNormal);
- const vector smallVec = 1E-9*edgeNormal;
+ const vector smallVec = 1e-9*edgeNormal;
edgeNormal /= edgeMag+VSMALL;
diff --git a/src/meshTools/indexedOctree/treeDataFace.C b/src/meshTools/indexedOctree/treeDataFace.C
index daa968fd5c..ca928ab1c7 100644
--- a/src/meshTools/indexedOctree/treeDataFace.C
+++ b/src/meshTools/indexedOctree/treeDataFace.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -31,7 +31,7 @@ License
defineTypeNameAndDebug(Foam::treeDataFace, 0);
-Foam::scalar Foam::treeDataFace::tolSqr = sqr(1E-6);
+Foam::scalar Foam::treeDataFace::tolSqr = sqr(1e-6);
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
diff --git a/src/meshTools/indexedOctree/treeDataPrimitivePatch.C b/src/meshTools/indexedOctree/treeDataPrimitivePatch.C
index bc9c0d4287..6927cbaa50 100644
--- a/src/meshTools/indexedOctree/treeDataPrimitivePatch.C
+++ b/src/meshTools/indexedOctree/treeDataPrimitivePatch.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -38,7 +38,7 @@ template
>
Foam::scalar
Foam::treeDataPrimitivePatch::
-tolSqr = sqr(1E-6);
+tolSqr = sqr(1e-6);
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
diff --git a/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBase.C b/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBase.C
index 79db701887..73d64b40f3 100644
--- a/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBase.C
+++ b/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBase.C
@@ -265,7 +265,7 @@ void Foam::mappedPatchBase::findSamples
treeBoundBox(pp.points(), pp.meshPoints()).extend
(
rndGen,
- 1E-4
+ 1e-4
)
);
patchBb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
diff --git a/src/meshTools/meshSearch/meshSearch.C b/src/meshTools/meshSearch/meshSearch.C
index ab0975a43c..9524515531 100644
--- a/src/meshTools/meshSearch/meshSearch.C
+++ b/src/meshTools/meshSearch/meshSearch.C
@@ -35,7 +35,7 @@ License
defineTypeNameAndDebug(Foam::meshSearch, 0);
-Foam::scalar Foam::meshSearch::tol_ = 1E-3;
+Foam::scalar Foam::meshSearch::tol_ = 1e-3;
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
@@ -567,7 +567,7 @@ const Foam::indexedOctree& Foam::meshSearch::boundaryTree()
treeBoundBox& overallBb = overallBbPtr_();
// Extend slightly and make 3D
- overallBb = overallBb.extend(rndGen, 1E-4);
+ overallBb = overallBb.extend(rndGen, 1e-4);
overallBb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
overallBb.max() += point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
}
@@ -620,7 +620,7 @@ const
treeBoundBox& overallBb = overallBbPtr_();
// Extend slightly and make 3D
- overallBb = overallBb.extend(rndGen, 1E-4);
+ overallBb = overallBb.extend(rndGen, 1e-4);
overallBb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
overallBb.max() += point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
}
diff --git a/src/meshTools/searchableSurface/searchablePlate.C b/src/meshTools/searchableSurface/searchablePlate.C
index 604afc6f28..37404db051 100644
--- a/src/meshTools/searchableSurface/searchablePlate.C
+++ b/src/meshTools/searchableSurface/searchablePlate.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -185,8 +185,8 @@ Foam::pointIndexHit Foam::searchablePlate::findLine
if (info.hit())
{
treeBoundBox bb(origin_, origin_+span_);
- bb.min()[normalDir_] -= 1E-6;
- bb.max()[normalDir_] += 1E-6;
+ bb.min()[normalDir_] -= 1e-6;
+ bb.max()[normalDir_] += 1e-6;
if (!bb.contains(info.hitPoint()))
{
diff --git a/src/meshTools/searchableSurface/searchableSurfaceWithGaps.C b/src/meshTools/searchableSurface/searchableSurfaceWithGaps.C
index dd74c17135..93c95778b8 100644
--- a/src/meshTools/searchableSurface/searchableSurfaceWithGaps.C
+++ b/src/meshTools/searchableSurface/searchableSurfaceWithGaps.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -242,7 +242,7 @@ void Foam::searchableSurfaceWithGaps::findLine
// test in pairs: only if both perturbations hit something
// do we accept the hit.
- const vectorField smallVec(1E-6*(compactEnd-compactStart));
+ const vectorField smallVec(1e-6*(compactEnd-compactStart));
List plusInfo;
surface().findLine
@@ -296,7 +296,7 @@ void Foam::searchableSurfaceWithGaps::findLine
offset0.setSize(plusMissMap.size());
offset1.setSize(plusMissMap.size());
- const vectorField smallVec(1E-6*(compactEnd-compactStart));
+ const vectorField smallVec(1e-6*(compactEnd-compactStart));
surface().findLine
(
diff --git a/src/meshTools/searchableSurface/triSurfaceMesh.C b/src/meshTools/searchableSurface/triSurfaceMesh.C
index 703d8153d1..6bbfd22960 100644
--- a/src/meshTools/searchableSurface/triSurfaceMesh.C
+++ b/src/meshTools/searchableSurface/triSurfaceMesh.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -542,7 +542,7 @@ Foam::triSurfaceMesh::tree() const
// Slightly extended bb. Slightly off-centred just so on symmetric
// geometry there are less face/edge aligned items.
- bb = bb.extend(rndGen, 1E-4);
+ bb = bb.extend(rndGen, 1e-4);
bb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
bb.max() += point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
@@ -594,7 +594,7 @@ Foam::triSurfaceMesh::edgeTree() const
// Slightly extended bb. Slightly off-centred just so on symmetric
// geometry there are less face/edge aligned items.
- bb = bb.extend(rndGen, 1E-4);
+ bb = bb.extend(rndGen, 1e-4);
bb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
bb.max() += point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
diff --git a/src/meshTools/triSurface/booleanOps/surfaceIntersection/surfaceIntersection.C b/src/meshTools/triSurface/booleanOps/surfaceIntersection/surfaceIntersection.C
index 9830bd4e6f..394f796aa3 100644
--- a/src/meshTools/triSurface/booleanOps/surfaceIntersection/surfaceIntersection.C
+++ b/src/meshTools/triSurface/booleanOps/surfaceIntersection/surfaceIntersection.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -569,7 +569,7 @@ void Foam::surfaceIntersection::doCutEdges
List >& surfEdgeCuts
)
{
- scalar oldTol = intersection::setPlanarTol(1E-3);
+ scalar oldTol = intersection::setPlanarTol(1e-3);
const pointField& surf1Pts = surf1.localPoints();
diff --git a/src/meshTools/triSurface/triSurfaceSearch/triSurfaceSearch.C b/src/meshTools/triSurface/triSurfaceSearch/triSurfaceSearch.C
index e72ed09c8d..28f6393b2c 100644
--- a/src/meshTools/triSurface/triSurfaceSearch/triSurfaceSearch.C
+++ b/src/meshTools/triSurface/triSurfaceSearch/triSurfaceSearch.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -54,7 +54,7 @@ Foam::triSurfaceSearch::triSurfaceSearch(const triSurface& surface)
treeBoundBox(surface_.points(), surface_.meshPoints()).extend
(
rndGen,
- 1E-4
+ 1e-4
)
);
treeBb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL);
diff --git a/src/meshTools/triSurface/triSurfaceTools/triSurfaceTools.C b/src/meshTools/triSurface/triSurfaceTools/triSurfaceTools.C
index 022d6fb821..96794adaac 100644
--- a/src/meshTools/triSurface/triSurfaceTools/triSurfaceTools.C
+++ b/src/meshTools/triSurface/triSurfaceTools/triSurfaceTools.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -870,7 +870,7 @@ Foam::surfaceLocation Foam::triSurfaceTools::cutEdge
{
d[i] /= norm;
- if (mag(d[i]) < 1E-6)
+ if (mag(d[i]) < 1e-6)
{
d[i] = 0.0;
}
diff --git a/src/parallel/decompose/decompositionMethods/hierarchGeomDecomp/hierarchGeomDecomp.C b/src/parallel/decompose/decompositionMethods/hierarchGeomDecomp/hierarchGeomDecomp.C
index 5380ad40bd..1098dfd828 100644
--- a/src/parallel/decompose/decompositionMethods/hierarchGeomDecomp/hierarchGeomDecomp.C
+++ b/src/parallel/decompose/decompositionMethods/hierarchGeomDecomp/hierarchGeomDecomp.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
- \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@@ -701,7 +701,7 @@ Foam::labelList Foam::hierarchGeomDecomp::decompose
label allSize = points.size();
reduce(allSize, sumOp